diff --git a/requirements/base.pip b/requirements/base.pip index 696c645..f543783 100644 --- a/requirements/base.pip +++ b/requirements/base.pip @@ -17,7 +17,7 @@ neurom>=3,<4 pandas placement_algorithm>=2.2.0 PyYAML -region_grower>=0.3.1 +region_grower>=0.4.0 scipy seaborn tmd diff --git a/src/synthesis_workflow/circuit.py b/src/synthesis_workflow/circuit.py index c8ea157..3714be9 100644 --- a/src/synthesis_workflow/circuit.py +++ b/src/synthesis_workflow/circuit.py @@ -3,18 +3,20 @@ import numpy as np import pandas as pd +import yaml from atlas_analysis.planes.planes import create_planes as _create_planes from brainbuilder.app.cells import _place as place +from region_grower.atlas_helper import AtlasHelper from tqdm import tqdm from voxcell import CellCollection from voxcell.nexus.voxelbrain import LocalAtlas L = logging.getLogger(__name__) -LEFT = 0 -RIGHT = 1 +LEFT = "left" +RIGHT = "right" -def halve_atlas(annotated_volume, axis=0, side=LEFT): +def halve_atlas(annotated_volume, axis=2, side=LEFT): """Return the half of the annotated volume along the x-axis. The identifiers of the voxels located on the left half or the right half @@ -24,8 +26,8 @@ def halve_atlas(annotated_volume, axis=0, side=LEFT): annotated_volume: integer array of shape (W, L, D) holding the annotation of a brain region. axis: (Optional) axis along which to halve. Either 0, 1 or 2. - Defaults to 0. - side: (Optional) Either LEFT or RIGHT, depending on which half is requested. + Defaults to 2. + side: (Optional) Either 'left' or 'right', depending on which half is requested. Defaults to LEFT. Returns: @@ -85,6 +87,22 @@ def create_atlas_thickness_mask(atlas_dir): return brain_regions.with_data(np.logical_and(~too_thick, isocortex_mask).astype(np.uint8)) +def get_regions_from_composition(cell_composition_path): + """Get list of region regex from cell_composition.""" + with open(cell_composition_path, "r") as comp_p: + cell_composition = yaml.safe_load(comp_p) + + region_regex = "@" + for reg in set(entry["region"] for entry in cell_composition["neurons"]): + if reg[-1] != "|": + reg += "|" + if reg[0] == "@": + region_regex += reg[1:] + else: + region_regex += reg + return region_regex[:-1] + + def build_circuit( cell_composition_path, mtype_taxonomy_path, @@ -109,7 +127,7 @@ def build_circuit( atlas_url=atlas_path, mini_frequencies_path=None, atlas_cache=None, - region=region, + region=region or get_regions_from_composition(cell_composition_path), mask_dset=mask, density_factor=density_factor, soma_placement="basic", @@ -153,8 +171,12 @@ def circuit_slicer(cells, n_cells, mtypes=None, planes=None, hemisphere=None): if mtypes is not None: cells = slice_per_mtype(cells, mtypes) - if hemisphere is not None and "hemisphere" in cells: - cells = cells[cells.hemisphere == hemisphere] + # TODO: rough way to split hemisphere, maybe there is a better way, to investigate if needed + if hemisphere is not None: + if hemisphere == "left": + cells = cells[cells.z < cells.z.mean()] + if hemisphere == "right": + cells = cells[cells.z >= cells.z.mean()] if planes is not None: # between each pair of planes, select n_cells @@ -198,31 +220,25 @@ def _get_principal_direction(points): return v[:, w.argmax()] -def get_centerline_bounds(atlas, layer, region=None, central_layer=5, hemisphere=None): +def get_centerline_bounds(layer): """Find centerline bounds using PCA of the voxell position of a given layer in the region.""" - if region is not None: - mask = atlas.get_region_mask(region) - mask.raw = np.array(mask.raw, dtype=int) - layer.raw = layer.raw * mask.raw - - _ids = np.where(layer.raw == central_layer) - ids = np.column_stack(_ids) + _ls = np.unique(layer.raw[layer.raw > 0]) + central_layer = _ls[int(len(_ls) / 2)] + ids = np.column_stack(np.where(layer.raw == central_layer)) points = layer.indices_to_positions(ids) - - ids = np.array(ids) - points = np.array(points) - if hemisphere is not None: - if hemisphere == "left": - point_mask = points[:, 2] < points[:, 2].mean() - if hemisphere == "right": - point_mask = points[:, 2] > points[:, 2].mean() - ids = ids[point_mask] - points = points[point_mask] - direction = _get_principal_direction(points) - _align = points.dot(direction) + _align = points.dot(_get_principal_direction(points)) return ids[_align.argmin()], ids[_align.argmax()] +def get_local_bbox(annotation): + """Compute bbox where annotation file is strictly positive.""" + ids = np.where(annotation.raw > 0) + dim = annotation.voxel_dimensions + return annotation.offset + np.array( + [np.min(ids, axis=1) * dim, (np.max(ids, axis=1) + 1) * dim] + ) + + def create_planes( layer_annotation, plane_type="aligned", @@ -254,6 +270,8 @@ def create_planes( centerline_axis (str): (for plane_type = aligned) axis along which to create planes """ if plane_type == "centerline": + if centerline_first_bound is None and centerline_last_bound is None: + centerline_first_bound, centerline_last_bound = get_centerline_bounds(layer_annotation) centerline = np.array( [ layer_annotation.indices_to_positions(centerline_first_bound), @@ -262,13 +280,10 @@ def create_planes( ) elif plane_type == "aligned": - _n_points = 10 - centerline = np.zeros([_n_points, 3]) - bbox = layer_annotation.bbox + centerline = np.zeros([2, 3]) + bbox = get_local_bbox(layer_annotation) centerline[:, centerline_axis] = np.linspace( - bbox[0, centerline_axis], - bbox[1, centerline_axis], - _n_points, + bbox[0, centerline_axis], bbox[1, centerline_axis], 2 ) else: raise Exception(f"Please set plane_type to 'aligned' or 'centerline', not {plane_type}.") @@ -285,3 +300,28 @@ def create_planes( planes_select_ids += list(planes_all_ids[int(id_shift / 2) - 1 :: id_shift]) planes_select_ids += list(planes_all_ids[int(id_shift / 2) + 1 :: id_shift]) return [planes[i] for i in sorted(planes_select_ids)], centerline + + +def get_layer_tags(atlas_dir, region_structure_path, region=None): + """Create a VoxelData with layer tags.""" + atlas_helper = AtlasHelper(LocalAtlas(atlas_dir), region_structure_path=region_structure_path) + + brain_regions = atlas_helper.brain_regions + layers_data = np.zeros_like(brain_regions.raw, dtype="uint8") + + region_mask = None + if region is not None: + region_mask = atlas_helper.atlas.get_region_mask(region).raw + + layer_mapping = {} + for layer_id, layer in enumerate(atlas_helper.layers): + layer_mapping[layer_id] = atlas_helper.region_structure["names"].get(layer, str(layer)) + region_query = atlas_helper.region_structure["region_queries"].get(layer, None) + mask = atlas_helper.atlas.get_region_mask(region_query).raw + if region_mask is not None: + mask *= region_mask + layers_data[mask] = layer_id + 1 + if not len(layers_data[mask]): + L.warning("No voxel found for layer %s.", layer) + brain_regions.raw = layers_data + return brain_regions, layer_mapping diff --git a/src/synthesis_workflow/extra/insitu_validation.py b/src/synthesis_workflow/extra/insitu_validation.py index a804e8b..7bf8d9f 100644 --- a/src/synthesis_workflow/extra/insitu_validation.py +++ b/src/synthesis_workflow/extra/insitu_validation.py @@ -17,7 +17,7 @@ from voxcell import CellCollection from voxcell.nexus.voxelbrain import Atlas -from synthesis_workflow.tools import get_layer_tags +from synthesis_workflow.circuit import get_layer_tags matplotlib.use("Agg") @@ -72,6 +72,7 @@ def plot_extents(results_df, pdf_name="extents.pdf", bins=200): pdf.savefig() +# pylint: disable=too-many-locals def get_layer_morpho_counts( sonata_path, morphology_path, @@ -81,6 +82,7 @@ def get_layer_morpho_counts( region=None, hemisphere="right", ext=".h5", + region_structure_path="region_structure.yaml", ): """For each layer, compute the fraction of crossing morphologies. @@ -93,6 +95,7 @@ def get_layer_morpho_counts( region (str): is not None, must be the name of a region to filter morphologies hemisphere (str): left/right hemisphere ext (str): extension of morphology files + region_structure_path (str): path to region_structure.yaml file Returns: pandas.DataFrame: dafaframe with the counts, mtype and layers information @@ -101,7 +104,7 @@ def get_layer_morpho_counts( cells = CellCollection.load(sonata_path).as_dataframe() morph_path = Path(morphology_path) - layer_annotation, _ = get_layer_tags(atlas_path) + layer_annotation, _ = get_layer_tags(atlas_path, region_structure_path) dfs = [] for mtype in tqdm(cells.mtype.unique()): @@ -205,6 +208,7 @@ def plot_layer_collage( shift=200, dpi=200, ext=".h5", + region_structure_path="region_structure.yaml", ): """Plot morphologies next to each other with points colored by layer. @@ -221,6 +225,7 @@ def plot_layer_collage( shift (float): x-shift between morphologies dpi (int): dpi to save rasterized pdf ext (str): extension of morphology files + region_structure_path (str): path to region_structure.yaml file """ if section_types is None: section_types = ["basal_dendrite", "apical_dendrite"] @@ -228,8 +233,8 @@ def plot_layer_collage( cells = CellCollection.load(sonata_path).as_dataframe() morph_path = Path(morphology_path) - layer_annotation, _ = get_layer_tags(atlas_path) - atlas = AtlasHelper(Atlas().open(atlas_path)) + layer_annotation, _ = get_layer_tags(atlas_path, region_structure_path) + atlas = AtlasHelper(Atlas().open(atlas_path), region_structure_path=region_structure_path) cmap = matplotlib.colors.ListedColormap(["C0", "C1", "C2", "C3", "C4", "C5", "C6"]) with PdfPages(pdf_name) as pdf: diff --git a/src/synthesis_workflow/synthesis.py b/src/synthesis_workflow/synthesis.py index 1d02504..ff90007 100644 --- a/src/synthesis_workflow/synthesis.py +++ b/src/synthesis_workflow/synthesis.py @@ -8,11 +8,14 @@ import matplotlib import numpy as np import pandas as pd +import yaml from joblib import Parallel from joblib import delayed from morphio.mut import Morphology from neuroc.scale import ScaleParameters from neuroc.scale import scale_section +from neurom import load_morphology +from neurom.check.morphology_checks import has_apical_dendrite from neurom.core.dataformat import COLS from neurots import extract_input from placement_algorithm.app import utils @@ -29,14 +32,25 @@ matplotlib.use("Agg") -def get_neurite_types(morphs_df, mtypes): - """Get the neurite types to consider for PC or IN cells.""" - return { - mtype: ["basal", "axon"] - if morphs_df.loc[morphs_df.mtype == mtype, "morph_class"].tolist()[0] == "IN" - else ["basal", "apical", "axon"] - for mtype in mtypes - } +def get_neurite_types(morphs_df): + """Get the neurite types to consider for PC or IN cells by checking if apical exists.""" + + def _get_morph_class(path): + return "PC" if has_apical_dendrite(load_morphology(path)) else "IN" + + morphs_df["morph_class"] = morphs_df["path"].apply(_get_morph_class) + neurite_types = {} + for mtype, _df in morphs_df.groupby("mtype"): + morph_class = list(set(_df["morph_class"])) + + if len(morph_class) > 1: + raise Exception("f{mtype} has not consistent morph_class, we stop here") + + if morph_class[0] == "IN": + neurite_types[mtype] = ["basal"] + if morph_class[0] == "PC": + neurite_types[mtype] = ["basal", "apical"] + return neurite_types def apply_substitutions(original_morphs_df, substitution_rules=None): @@ -72,16 +86,27 @@ def _build_distributions_single_mtype( trunk_method="simple", ): """Internal function for multiprocessing of tmd_distribution building.""" - morphology_paths = morphs_df.loc[morphs_df.mtype == mtype, morphology_path].to_list() - kwargs = { - "neurite_types": neurite_types[mtype], - "diameter_input_morph": morphology_paths, - "diameter_model": diameter_model_function, - } - if trunk_method != "simple": - kwargs["trunk_method"] = trunk_method + data = {} + for neurite_type in neurite_types[mtype]: + if "use_axon" in morphs_df.columns: + morphology_paths = morphs_df.loc[ + (morphs_df.mtype == mtype) & morphs_df.use_axon, morphology_path + ].to_list() + else: + morphology_paths = morphs_df.loc[morphs_df.mtype == mtype, morphology_path].to_list() + kwargs = { + "neurite_types": neurite_types[mtype], + "diameter_input_morph": morphology_paths, + "diameter_model": diameter_model_function, + } + if trunk_method != "simple": + kwargs["trunk_method"] = trunk_method - return mtype, extract_input.distributions(morphology_paths, **kwargs) + _data = extract_input.distributions(morphology_paths, **kwargs) + data[neurite_type] = _data[neurite_type] + data["diameter"] = _data["diameter"] + data["soma"] = _data["soma"] + return mtype, data def build_distributions( @@ -90,7 +115,7 @@ def build_distributions( neurite_types, diameter_model_function, morphology_path, - cortical_thickness, + region_structure_path, nb_jobs=-1, joblib_verbose=10, trunk_method="simple", @@ -102,7 +127,10 @@ def build_distributions( morphs_df (DataFrame): morphology dataframe with reconstruction to use diameter_model_function (function): diametrizer function (from diameter-synthesis) morphology_path (str): name of the column in morphs_df to use for paths to morphologies - cortical_thickness (list): list of cortical thicknesses for reference scaling + region_structure_path (str): path to region_structure yaml file with thicknesses + nb_jobs (int): number of jobs to run in parallal with joblib + joblib_verbose (int): verbose level of joblib + trunk_method (str): method to set trunk on soma for synthesis (simple|3d_angle) Returns: dict: dict to save to tmd_distribution.json @@ -115,11 +143,15 @@ def build_distributions( morphology_path=morphology_path, trunk_method=trunk_method, ) + thicknesses = [] + if Path(region_structure_path).exists(): + with open(region_structure_path, "r") as r_p: + region_structure = yaml.safe_load(r_p) + thicknesses = [ + region_structure["thicknesses"][layer] for layer in region_structure["layers"] + ] - tmd_distributions = { - "mtypes": {}, - "metadata": {"cortical_thickness": cortical_thickness}, - } + tmd_distributions = {"mtypes": {}, "metadata": {"cortical_thickness": thicknesses}} for mtype, distribution in Parallel(nb_jobs, verbose=joblib_verbose)( delayed(build_distributions_single_mtype)(mtype) for mtype in mtypes ): diff --git a/src/synthesis_workflow/tasks/circuit.py b/src/synthesis_workflow/tasks/circuit.py index 671bc46..20845f3 100644 --- a/src/synthesis_workflow/tasks/circuit.py +++ b/src/synthesis_workflow/tasks/circuit.py @@ -6,31 +6,26 @@ from atlas_analysis.planes.planes import load_planes_centerline from atlas_analysis.planes.planes import save_planes_centerline from voxcell import VoxelData -from voxcell.nexus.voxelbrain import LocalAtlas from synthesis_workflow.circuit import build_circuit from synthesis_workflow.circuit import circuit_slicer from synthesis_workflow.circuit import create_atlas_thickness_mask from synthesis_workflow.circuit import create_planes -from synthesis_workflow.circuit import get_centerline_bounds +from synthesis_workflow.circuit import get_layer_tags from synthesis_workflow.circuit import halve_atlas from synthesis_workflow.circuit import slice_circuit from synthesis_workflow.tasks.config import AtlasLocalTarget from synthesis_workflow.tasks.config import CircuitConfig from synthesis_workflow.tasks.config import CircuitLocalTarget -from synthesis_workflow.tasks.config import PathConfig +from synthesis_workflow.tasks.config import GetCellComposition +from synthesis_workflow.tasks.config import GetSynthesisInputs from synthesis_workflow.tasks.config import SynthesisConfig -from synthesis_workflow.tasks.luigi_tools import BoolParameter -from synthesis_workflow.tasks.luigi_tools import OptionalChoiceParameter from synthesis_workflow.tasks.luigi_tools import OptionalPathParameter -from synthesis_workflow.tasks.luigi_tools import OptionalStrParameter from synthesis_workflow.tasks.luigi_tools import ParamRef from synthesis_workflow.tasks.luigi_tools import PathParameter from synthesis_workflow.tasks.luigi_tools import RatioParameter from synthesis_workflow.tasks.luigi_tools import WorkflowTask from synthesis_workflow.tasks.luigi_tools import copy_params -from synthesis_workflow.tasks.utils import GetSynthesisInputs -from synthesis_workflow.tools import get_layer_tags class CreateAtlasLayerAnnotations(WorkflowTask): @@ -40,25 +35,19 @@ class CreateAtlasLayerAnnotations(WorkflowTask): default="layer_annotation.nrrd", description=":str: Path to save layer annotations constructed from atlas.", ) - use_half = BoolParameter( - default=False, - description=":bool: Set to True to use half of the atlas (left or right hemisphere).", - ) - half_axis = luigi.IntParameter( - default=0, - description=":int: Direction to select half of the atlas (can be 0, 1 or 2).", - ) - half_side = luigi.IntParameter( - default=0, - description=":int: Side to choose to halve the atlas (0=left, 1=right).", - ) + + def requires(self): + return GetSynthesisInputs() def run(self): """ """ - annotation, layer_mapping = get_layer_tags(CircuitConfig().atlas_path) - - if self.use_half: - annotation.raw = halve_atlas(annotation.raw, axis=self.half_axis, side=self.half_side) + annotation, layer_mapping = get_layer_tags( + CircuitConfig().atlas_path, + self.input().pathlib_path / CircuitConfig().region_structure_path, + CircuitConfig().region, + ) + if CircuitConfig().hemisphere is not None: + annotation.raw = halve_atlas(annotation.raw, side=CircuitConfig().hemisphere) annotation_path = self.output()["annotations"].path annotation.save_nrrd(annotation_path) @@ -119,10 +108,6 @@ class CreateAtlasPlanes(WorkflowTask): atlas_planes_path = PathParameter( default="atlas_planes", description=":str: Path to save atlas planes." ) - region = luigi.Parameter(default=None, description=":str: Name of region to consider") - hemisphere = luigi.Parameter( - default=None, description=":str: Hemisphere to considere (left/right)" - ) def requires(self): """ """ @@ -130,17 +115,10 @@ def requires(self): def run(self): """ """ - if self.plane_count < 1: raise Exception("Number of planes should be larger than one") layer_annotation = VoxelData.load_nrrd(self.input()["annotations"].path) - - atlas = LocalAtlas(CircuitConfig().atlas_path) - if self.centerline_first_bound is None and self.centerline_last_bound is None: - self.centerline_first_bound, self.centerline_last_bound = get_centerline_bounds( - atlas, layer_annotation, self.region, hemisphere=self.hemisphere - ) planes, centerline = create_planes( layer_annotation, self.plane_type, @@ -155,23 +133,16 @@ def run(self): def output(self): """ """ - return AtlasLocalTarget(f"{self.atlas_planes_path}_{self.region}.npz") + if CircuitConfig().region is not None: + suffix = f"_{CircuitConfig().region}" + else: + suffix = "" + return AtlasLocalTarget(f"{self.atlas_planes_path}{suffix}.npz") -@copy_params( - mtype_taxonomy_path=ParamRef(PathConfig), -) class BuildCircuit(WorkflowTask): - """Generate cell positions and me-types from atlas, compositions and taxonomy. - - Attributes: - mtype_taxonomy_path (str): Path to the taxonomy file (TSV). - """ + """Generate cell positions and me-types from atlas, compositions and taxonomy.""" - cell_composition_path = PathParameter( - default="cell_composition.yaml", - description=":str: Path to the cell composition file (YAML).", - ) density_factor = RatioParameter( default=0.01, left_op=luigi.parameter.operator.lt, @@ -181,16 +152,18 @@ class BuildCircuit(WorkflowTask): default=None, description=":str: Path to save thickness mask (NCx only)." ) seed = luigi.IntParameter(default=None, description=":int: Pseudo-random generator seed.") - region = OptionalStrParameter(default=None, description=":str: Region to use.") + mtype_taxonomy_file = luigi.Parameter( + default="mtype_taxonomy.tsv", + description=":str: Filename of taxonomy file to provide to BrainBuilder", + ) def requires(self): """ """ - return GetSynthesisInputs() + return {"synthesis": GetSynthesisInputs(), "composition": GetCellComposition()} def run(self): """ """ - cell_composition_path = self.input().pathlib_path / self.cell_composition_path - mtype_taxonomy_path = self.input().pathlib_path / self.mtype_taxonomy_path + mtype_taxonomy_path = self.input()["synthesis"].pathlib_path / self.mtype_taxonomy_file thickness_mask_path = None if self.mask_path is not None: @@ -199,13 +172,13 @@ def run(self): thickness_mask_path = self.mask_path.stem cells = build_circuit( - cell_composition_path, + self.input()["composition"].path, mtype_taxonomy_path, CircuitConfig().atlas_path, self.density_factor, mask=thickness_mask_path, seed=self.seed, - region=self.region, + region=CircuitConfig().region, ) cells.save(self.output().path) @@ -231,11 +204,6 @@ class SliceCircuit(WorkflowTask): n_cells = luigi.IntParameter( default=10, description=":int: Number of cells per mtype to consider." ) - hemisphere = OptionalChoiceParameter( - default=None, - choices=["left", "right"], - description=":str: The hemisphere side.", - ) def requires(self): """ """ @@ -253,7 +221,7 @@ def run(self): n_cells=self.n_cells, mtypes=self.mtypes, planes=planes, - hemisphere=self.hemisphere, + hemisphere=CircuitConfig().hemisphere, ) cells = slice_circuit(self.input()["circuit"].path, self.output().path, _slicer) diff --git a/src/synthesis_workflow/tasks/config.py b/src/synthesis_workflow/tasks/config.py index f628aa1..912e39e 100644 --- a/src/synthesis_workflow/tasks/config.py +++ b/src/synthesis_workflow/tasks/config.py @@ -1,12 +1,19 @@ """Configurations for luigi tasks.""" import logging +import shutil import warnings +from pathlib import Path +from tempfile import TemporaryDirectory import luigi +import yaml +from git import Repo from synthesis_workflow.tasks.luigi_tools import ExtParameter +from synthesis_workflow.tasks.luigi_tools import OptionalChoiceParameter from synthesis_workflow.tasks.luigi_tools import OptionalIntParameter from synthesis_workflow.tasks.luigi_tools import OutputLocalTarget +from synthesis_workflow.tasks.luigi_tools import WorkflowTask # Add some warning filters warnings.filterwarnings("ignore", module="diameter_synthesis.build_diameters") @@ -22,6 +29,72 @@ logging.getLogger("neurots").propagate = False +class GitClone(WorkflowTask): + """Task to clone a git repository.""" + + url = luigi.Parameter( + description=( + ":str: Url of repository. If None, git_synthesis_input_path should be an existing " + "folder." + ) + ) + dest = luigi.Parameter(description=":str: Path to the destination directory.") + branch = luigi.Parameter(default="main") + + def run(self): + """ """ + Repo.clone_from(self.url, self.output().path, branch=self.branch) + + def output(self): + """ """ + return OutputLocalTarget(self.dest) + + +class GetSynthesisInputs(WorkflowTask): + """Task to get synthesis input files from a folder on git repository. + + If no url is provided, this task will copy an existing folder to the target location. + + Attributes: + local_synthesis_input_path (str): Path to local folder to copy these files. + """ + + url = luigi.OptionalParameter( + default=None, + description=( + ":str: Url of repository. If None, git_synthesis_input_path should be an " + "existing folder." + ), + ) + version = luigi.OptionalParameter( + default=None, description=":str: Version of repo to checkout." + ) + git_synthesis_input_path = luigi.Parameter( + default="synthesis_input", + description=":str: Path to folder in git repo with synthesis files.", + ) + branch = luigi.Parameter(default="main") + + def run(self): + """ """ + if self.url is None: + shutil.copytree(self.git_synthesis_input_path, self.output().path) + else: + with TemporaryDirectory() as tmpdir: + dest = Path(tmpdir) / "tmp_repo" + # Note: can not be called with yield here because of the TemporaryDirectory + GitClone(url=self.url, dest=dest, branch=self.branch).run() + if self.version is not None: + r = Repo(dest) + r.git.checkout(self.version) + shutil.copytree(dest / self.git_synthesis_input_path, self.output().path) + + def output(self): + """ """ + # TODO: it would probably be better to have a specific target for each file + return OutputLocalTarget(PathConfig().local_synthesis_input_path) + + class DiametrizerConfig(luigi.Config): """Diametrizer configuration.""" @@ -88,10 +161,6 @@ class SynthesisConfig(luigi.Config): default="neurots_input/tmd_distributions.json", description=":str: The path to the TMD distributions.", ) - cortical_thickness = luigi.ListParameter( - default=[165, 149, 353, 190, 525, 700], - description=":list(int): The list of cortical thicknesses.", - ) mtypes = luigi.ListParameter( default=None, description=( @@ -99,6 +168,9 @@ class SynthesisConfig(luigi.Config): "found mtypes are taken)." ), ) + with_axons = luigi.BoolParameter( + default=False, description=":bool: Set to True to synthesize local axons" + ) class CircuitConfig(luigi.Config): @@ -108,16 +180,63 @@ class CircuitConfig(luigi.Config): default="circuit_somata.mvd3", description=":str: Path to the circuit somata." ) atlas_path = luigi.Parameter(default=None, description=":str: Path to the atlas directory.") + cell_composition_path = luigi.Parameter( + default="cell_composition.yaml", description=":str: Path to cell_compoistion.yaml file." + ) + region_structure_path = luigi.Parameter( + default="region_structure.yaml", + description=":str: Path to the file containing the layer structure data.", + ) + region = luigi.OptionalParameter(default=None) + hemisphere = OptionalChoiceParameter( + default=None, + choices=["left", "right"], + description=":str: The hemisphere side.", + ) + + +class GetCellComposition(luigi.Task): + """Get cell_composition with adapted entries.""" + + new_cell_composition = luigi.Parameter( + default="new_cell_composition.yaml", + description=":str: Filename to the new cell composition file with modified entries.", + ) + + def requires(self): + """ """ + return GetSynthesisInputs() + + def run(self): + """ """ + if not Path(CircuitConfig().cell_composition_path).exists(): + cell_composition_path = str( + self.input().pathlib_path / CircuitConfig().cell_composition_path + ) + else: + cell_composition_path = CircuitConfig().cell_composition_path + + with open(cell_composition_path) as comp_p: + cell_comp = yaml.safe_load(comp_p) + if SynthesisConfig().mtypes is not None: + new_cell_comp = {"version": cell_comp["version"], "neurons": []} + for entry in cell_comp["neurons"]: + if entry["traits"]["mtype"] in SynthesisConfig().mtypes: + new_cell_comp["neurons"].append(entry) + else: + new_cell_comp = cell_comp + with open(self.output().path, "w") as comp_p: + yaml.safe_dump(new_cell_comp, comp_p) + + def output(self): + """ """ + return OutputLocalTarget(self.new_cell_composition) class PathConfig(luigi.Config): """Morphology path configuration.""" # Input paths - mtype_taxonomy_path = luigi.Parameter( - default="mtype_taxonomy.tsv", - description=":str: Path to the taxonomy file (TSV).", - ) local_synthesis_input_path = luigi.Parameter( default="synthesis_input", description=":str: Path to the synthesis input directory.", diff --git a/src/synthesis_workflow/tasks/synthesis.py b/src/synthesis_workflow/tasks/synthesis.py index 71d5c4a..b17ef7e 100644 --- a/src/synthesis_workflow/tasks/synthesis.py +++ b/src/synthesis_workflow/tasks/synthesis.py @@ -10,6 +10,7 @@ import yaml from diameter_synthesis.build_models import build as build_diameter_models from neurots import extract_input +from placement_algorithm.app.compact_annotations import _collect_annotations from region_grower.synthesize_morphologies import SynthesizeMorphologies from region_grower.utils import NumpyEncoder @@ -23,6 +24,8 @@ from synthesis_workflow.tasks.circuit import SliceCircuit from synthesis_workflow.tasks.config import CircuitConfig from synthesis_workflow.tasks.config import DiametrizerConfig +from synthesis_workflow.tasks.config import GetCellComposition +from synthesis_workflow.tasks.config import GetSynthesisInputs from synthesis_workflow.tasks.config import MorphsDfLocalTarget from synthesis_workflow.tasks.config import PathConfig from synthesis_workflow.tasks.config import RunnerConfig @@ -30,13 +33,12 @@ from synthesis_workflow.tasks.config import SynthesisLocalTarget from synthesis_workflow.tasks.luigi_tools import BoolParameter from synthesis_workflow.tasks.luigi_tools import OptionalPathParameter +from synthesis_workflow.tasks.luigi_tools import OutputLocalTarget from synthesis_workflow.tasks.luigi_tools import ParamRef from synthesis_workflow.tasks.luigi_tools import PathParameter from synthesis_workflow.tasks.luigi_tools import RatioParameter from synthesis_workflow.tasks.luigi_tools import WorkflowTask from synthesis_workflow.tasks.luigi_tools import copy_params -from synthesis_workflow.tasks.utils import CreateAnnotationsFile -from synthesis_workflow.tasks.utils import GetSynthesisInputs from synthesis_workflow.tools import find_case_insensitive_file from synthesis_workflow.tools import load_neurondb_to_dataframe @@ -45,15 +47,8 @@ L = logging.getLogger(__name__) -@copy_params( - mtype_taxonomy_path=ParamRef(PathConfig), -) class BuildMorphsDF(WorkflowTask): - """Generate the list of morphologies with their mtypes and paths. - - Attributes: - mtype_taxonomy_path (str): Path to the mtype_taxonomy.tsv file. - """ + """Generate the list of morphologies with their mtypes and paths.""" neurondb_path = luigi.Parameter(description=":str: Path to the neuronDB file (XML).") morphology_dirs = luigi.DictParameter( @@ -75,16 +70,12 @@ def run(self): L.debug("Build morphology dataframe from %s", neurondb_path) - mtype_taxonomy_path = self.input().pathlib_path / self.mtype_taxonomy_path morphs_df = load_neurondb_to_dataframe( - neurondb_path, - self.morphology_dirs, - mtype_taxonomy_path, - self.apical_points_path, + neurondb_path, self.morphology_dirs, self.apical_points_path ) - # Remove duplicated morphologies in L23 - morphs_df.drop_duplicates(subset=["name"], inplace=True) + # Remove possibly duplicated morphologies + morphs_df = morphs_df.drop_duplicates(subset=["name"]) # Only use wanted mtypes if SynthesisConfig().mtypes is not None: @@ -120,13 +111,13 @@ def run(self): substitution_rules_path = ( self.input()["synthesis_input"].pathlib_path / self.substitution_rules_path ) - with open(substitution_rules_path, "rb") as sub_file: - substitution_rules = yaml.full_load(sub_file) + df = pd.read_csv(self.input()["morphs_df"].path) + if substitution_rules_path.exists(): + with open(substitution_rules_path, "rb") as sub_file: + substitution_rules = yaml.full_load(sub_file) + df = apply_substitutions(df, substitution_rules) - substituted_morphs_df = apply_substitutions( - pd.read_csv(self.input()["morphs_df"].path), substitution_rules - ) - substituted_morphs_df.to_csv(self.output().path, index=False) + df.to_csv(self.output().path, index=False) def output(self): """ """ @@ -161,7 +152,10 @@ def run(self): """ """ morphs_df = pd.read_csv(self.input()["morphologies"].path) mtypes = sorted(morphs_df.mtype.unique()) - neurite_types = get_neurite_types(morphs_df, mtypes) + neurite_types = get_neurite_types(morphs_df) + if SynthesisConfig().with_axons: + for neurite_type in neurite_types.items(): + neurite_type.append("axon") if self.input_tmd_parameters_path is not None: L.info("Using custom tmd parameters") @@ -214,30 +208,31 @@ class BuildSynthesisDistributions(WorkflowTask): def requires(self): """ """ - return ApplySubstitutionRules() + return {"rules": ApplySubstitutionRules(), "synthesis": GetSynthesisInputs()} def run(self): """ """ - L.debug("reading morphs df from: %s", self.input().path) - morphs_df = pd.read_csv(self.input().path) + morphs_df = pd.read_csv(self.input()["rules"].path) mtypes = sorted(morphs_df.mtype.unique()) L.debug("mtypes found: %s", mtypes) - neurite_types = get_neurite_types(morphs_df, mtypes) + neurite_types = get_neurite_types(morphs_df) + if SynthesisConfig().with_axons: + for neurite_type in neurite_types.items(): + neurite_type.append("axon") L.debug("neurite_types found: %s", neurite_types) diameter_model_function = partial( build_diameter_models, config=DiametrizerConfig().config_model ) - tmd_distributions = build_distributions( mtypes, morphs_df, neurite_types, diameter_model_function, self.morphology_path, - SynthesisConfig().cortical_thickness, + self.input()["synthesis"].pathlib_path / CircuitConfig().region_structure_path, nb_jobs=self.nb_jobs, trunk_method=self.trunk_method, ) @@ -263,6 +258,26 @@ def output(self): return MorphsDfLocalTarget(self.axon_morphs_df_path) +class CreateAnnotationsFile(WorkflowTask): + """Task to compact annotations into a single JSON file.""" + + annotation_dir = luigi.Parameter(description=(":str: Path to annotations folder.")) + morph_db = luigi.OptionalParameter(default=None, description=":str: Path to MorphDB file.") + destination = luigi.Parameter(description=":str: Path to output JSON file.") + + def run(self): + """ """ + # pylint: disable=protected-access + annotations = _collect_annotations(self.annotation_dir, self.morph_db) + + with open(self.destination, "w") as f: + json.dump(annotations, f, indent=4, sort_keys=True) + + def output(self): + """ """ + return OutputLocalTarget(self.destination) + + class BuildAxonMorphologies(WorkflowTask): """Run choose-morphologies to synthesize axon morphologies. @@ -472,22 +487,34 @@ class Synthesize(WorkflowTask): description=":float: The std value of the scaling jitter to apply (in degrees).", ) seed = luigi.IntParameter(default=0, description=":int: Pseudo-random generator seed.") + axon_method = luigi.ChoiceParameter( + default="reconstructed", + description=":str: The method used to handle axons.", + choices=["no_axon", "reconstructed", "synthesis"], + ) def requires(self): """ """ - return { + tasks = { + "synthesis_input": GetSynthesisInputs(), "substituted_cells": ApplySubstitutionRules(), - "circuit": SliceCircuit(), "tmd_parameters": AddScalingRulesToParameters(), "tmd_distributions": BuildSynthesisDistributions(), - "axons": BuildAxonMorphologies(), + "circuit": SliceCircuit(), + "composition": GetCellComposition(), } + if self.axon_method == "reconstructed": + tasks["axons"] = BuildAxonMorphologies() + tasks["axon_cells"] = BuildAxonMorphsDF( + neurondb_path=BuildAxonMorphologies().get_neuron_db_path("xml"), + morphology_dirs={"clone_path": BuildAxonMorphologies().axon_cells_path}, + ) + + return tasks def run(self): """ """ - - axon_morphs_path = self.input()["axons"]["morphs"].path out_mvd3 = self.output()["out_mvd3"] out_morphologies = self.output()["out_morphologies"] out_apical_points = self.output()["apical_points"] @@ -498,18 +525,18 @@ def run(self): else: debug_scales_path = None - # Get base-morph-dir argument value - if self.axon_morphs_base_dir is None: - axon_morphs_base_dir = get_axon_base_dir( - pd.read_csv(self.requires()["axons"].input()["axon_cells"].path), - "clone_path", - ) - else: - axon_morphs_base_dir = self.axon_morphs_base_dir - - L.debug("axon_morphs_base_dir = %s", axon_morphs_base_dir) + axon_morphs_path = None + axon_morphs_base_dir = None + if self.axon_method == "reconstructed": + axon_morphs_path = self.input()["axons"]["morphs"].path + if self.axon_morphs_base_dir is None: + axon_morphs_base_dir = get_axon_base_dir( + pd.read_csv(self.input()["axon_cells"].path), "clone_path" + ) + else: + axon_morphs_base_dir = self.axon_morphs_base_dir + L.debug("axon_morphs_base_dir = %s", axon_morphs_base_dir) - # Build arguments for region_grower.synthesize_morphologies.SynthesizeMorphologies kwargs = { "input_cells": self.input()["circuit"].path, "tmd_parameters": self.input()["tmd_parameters"].path, @@ -526,9 +553,10 @@ def run(self): "max_drop_ratio": self.max_drop_ratio, "seed": self.seed, "nb_processes": self.nb_jobs, + "region_structure": self.input()["synthesis_input"].pathlib_path + / CircuitConfig().region_structure_path, } - - if self.apply_jitter: + if self.axon_method == "reconstructed" and self.apply_jitter: kwargs["scaling_jitter_std"] = self.scaling_jitter_std kwargs["rotational_jitter_std"] = self.rotational_jitter_std @@ -584,15 +612,15 @@ def run(self): """ """ tmd_parameters = json.load(self.input()["tmd_parameters"].open("r")) + scaling_rules = {} if self.scaling_rules_path is not None: scaling_rules_path = ( self.input()["synthesis_input"].pathlib_path / self.scaling_rules_path ) - L.debug("Load scaling rules from %s", scaling_rules_path) - with open(scaling_rules_path, "r") as f: - scaling_rules = yaml.full_load(f) - else: - scaling_rules = {} + if scaling_rules_path.exists(): + L.debug("Load scaling rules from %s", scaling_rules_path) + with open(scaling_rules_path, "r") as f: + scaling_rules = yaml.full_load(f) add_scaling_rules_to_parameters( tmd_parameters, diff --git a/src/synthesis_workflow/tasks/utils.py b/src/synthesis_workflow/tasks/utils.py deleted file mode 100644 index 2b883e1..0000000 --- a/src/synthesis_workflow/tasks/utils.py +++ /dev/null @@ -1,97 +0,0 @@ -"""Utils luigi tasks.""" -import json -import shutil -from pathlib import Path -from tempfile import TemporaryDirectory - -import luigi -from git import Repo -from placement_algorithm.app.compact_annotations import _collect_annotations - -from synthesis_workflow.tasks.config import PathConfig -from synthesis_workflow.tasks.luigi_tools import OutputLocalTarget -from synthesis_workflow.tasks.luigi_tools import WorkflowTask - - -class GitClone(WorkflowTask): - """Task to clone a git repository.""" - - url = luigi.Parameter( - description=( - ":str: Url of repository. If None, git_synthesis_input_path should be an existing " - "folder." - ) - ) - dest = luigi.Parameter(description=":str: Path to the destination directory.") - - def run(self): - """ """ - Repo.clone_from(self.url, self.output().path) - - def output(self): - """ """ - return OutputLocalTarget(self.dest) - - -class GetSynthesisInputs(WorkflowTask): - """Task to get synthesis input files from a folder on git it repository. - - If no url is provided, this task will copy an existing folder to the target location. - - Attributes: - local_synthesis_input_path (str): Path to local folder to copy these files. - """ - - url = luigi.OptionalParameter( - default=None, - description=( - ":str: Url of repository. If None, git_synthesis_input_path should be an " - "existing folder." - ), - ) - version = luigi.OptionalParameter( - default=None, description=":str: Version of repo to checkout." - ) - git_synthesis_input_path = luigi.Parameter( - default="synthesis_input", - description=":str: Path to folder in git repo with synthesis files.", - ) - - def run(self): - """ """ - if self.url is None: - shutil.copytree(self.git_synthesis_input_path, self.output().path) - else: - with TemporaryDirectory() as tmpdir: - dest = Path(tmpdir) / "tmp_repo" - # Note: can not be called with yield here because of the TemporaryDirectory - GitClone(url=self.url, dest=dest).run() - if self.version is not None: - r = Repo(dest) - r.git.checkout(self.version) - shutil.copytree(dest / self.git_synthesis_input_path, self.output().path) - - def output(self): - """ """ - # TODO: it would probably be better to have a specific target for each file - return OutputLocalTarget(PathConfig().local_synthesis_input_path) - - -class CreateAnnotationsFile(WorkflowTask): - """Task to compact annotations into a single JSON file.""" - - annotation_dir = luigi.Parameter(description=(":str: Path to annotations folder.")) - morph_db = luigi.OptionalParameter(default=None, description=":str: Path to MorphDB file.") - destination = luigi.Parameter(description=":str: Path to output JSON file.") - - def run(self): - """ """ - # pylint: disable=protected-access - annotations = _collect_annotations(self.annotation_dir, self.morph_db) - - with open(self.destination, "w") as f: - json.dump(annotations, f, indent=4, sort_keys=True) - - def output(self): - """ """ - return OutputLocalTarget(self.destination) diff --git a/src/synthesis_workflow/tasks/vacuum_synthesis.py b/src/synthesis_workflow/tasks/vacuum_synthesis.py index 3e5de44..6cb26ac 100644 --- a/src/synthesis_workflow/tasks/vacuum_synthesis.py +++ b/src/synthesis_workflow/tasks/vacuum_synthesis.py @@ -54,6 +54,11 @@ class VacuumSynthesize(WorkflowTask): description=":str: Diametrizer model to use.", ) n_cells = luigi.IntParameter(default=10, description=":int: Number of cells to synthesize.") + axon_method = luigi.ChoiceParameter( + default="no_axon", + description=":str: The method used to handle axons.", + choices=["no_axon", "synthesis"], + ) def requires(self): """ """ diff --git a/src/synthesis_workflow/tasks/validation.py b/src/synthesis_workflow/tasks/validation.py index 6f281f6..e8f0177 100644 --- a/src/synthesis_workflow/tasks/validation.py +++ b/src/synthesis_workflow/tasks/validation.py @@ -16,6 +16,8 @@ from synthesis_workflow.tasks.circuit import CreateAtlasLayerAnnotations from synthesis_workflow.tasks.circuit import CreateAtlasPlanes from synthesis_workflow.tasks.config import CircuitConfig +from synthesis_workflow.tasks.config import GetCellComposition +from synthesis_workflow.tasks.config import GetSynthesisInputs from synthesis_workflow.tasks.config import MorphsDfLocalTarget from synthesis_workflow.tasks.config import PathConfig from synthesis_workflow.tasks.config import RunnerConfig @@ -315,6 +317,8 @@ def requires(self): "synthesis": Synthesize(), "planes": CreateAtlasPlanes(), "layers": CreateAtlasLayerAnnotations(), + "composition": GetCellComposition(), + "synthesis_input": GetSynthesisInputs(), } def run(self): @@ -336,6 +340,7 @@ def run(self): planes = load_planes_centerline(planes_path)["planes"] layer_annotation_path = self.input()["layers"]["annotations"].path + layer_mappings = yaml.safe_load(self.input()["layers"]["layer_mapping"].open()) L.debug("Load layer annotations from %s", layer_annotation_path) layer_annotation = VoxelData.load_nrrd(layer_annotation_path) @@ -355,6 +360,9 @@ def run(self): "linewidth": self.linewidth, "diameter_scale": self.diameter_scale, }, + layer_mappings=layer_mappings, + region_structure_path=self.input()["synthesis_input"].pathlib_path + / CircuitConfig().region_structure_path, ) def output(self): @@ -807,8 +815,6 @@ def run(self): "linewidth": self.linewidth, "diameter_scale": self.diameter_scale, }, - region=self.region, - hemisphere=self.hemisphere, with_y_field=self.with_y_field, with_cells=self.with_cells, ) diff --git a/src/synthesis_workflow/tasks/workflows.py b/src/synthesis_workflow/tasks/workflows.py index 75191ad..75174db 100644 --- a/src/synthesis_workflow/tasks/workflows.py +++ b/src/synthesis_workflow/tasks/workflows.py @@ -2,12 +2,12 @@ import luigi import pandas as pd +from synthesis_workflow.tasks.config import GetSynthesisInputs from synthesis_workflow.tasks.config import ValidationLocalTarget from synthesis_workflow.tasks.luigi_tools import BoolParameter from synthesis_workflow.tasks.luigi_tools import WorkflowTask from synthesis_workflow.tasks.luigi_tools import WorkflowWrapperTask from synthesis_workflow.tasks.synthesis import ApplySubstitutionRules -from synthesis_workflow.tasks.utils import GetSynthesisInputs from synthesis_workflow.tasks.vacuum_synthesis import PlotVacuumMorphologies from synthesis_workflow.tasks.validation import MorphologyValidationReports from synthesis_workflow.tasks.validation import PlotCollage diff --git a/src/synthesis_workflow/tools.py b/src/synthesis_workflow/tools.py index f9d74dd..9a4f3c6 100644 --- a/src/synthesis_workflow/tools.py +++ b/src/synthesis_workflow/tools.py @@ -17,26 +17,10 @@ from joblib import delayed from morph_tool.morphdb import MorphDB from morph_tool.utils import find_morph -from voxcell import VoxelData -from voxcell.nexus.voxelbrain import LocalAtlas L = logging.getLogger(__name__) -def add_mtype_taxonomy(morphs_df, mtype_taxonomy): - """From a dict with mtype to morph_class, fill in the morphs_df dataframe. - - Args: - morphs_df (pandas.DataFrame): the morphs_df DataFrame - mtype_taxonomy (pandas.DataFrame): with columns mtype and mClass - """ - morphs_df = morphs_df[morphs_df["mtype"].isin(mtype_taxonomy.mtype)] - morphs_df["morph_class"] = morphs_df["mtype"].map( - lambda mtype: mtype_taxonomy.loc[mtype_taxonomy.mtype == mtype, "mClass"].to_list()[0] - ) - return morphs_df - - def add_morphology_paths(morphs_df, morphology_dirs): """Same as the path loader of morph_tool.utils.neurondb_dataframe, but add multiple columns. @@ -66,16 +50,13 @@ def add_apical_points(morphs_df, apical_points): return morphs_df -def load_neurondb_to_dataframe( - neurondb_path, morphology_dirs=None, pc_in_types_path=None, apical_points_path=None -): +def load_neurondb_to_dataframe(neurondb_path, morphology_dirs=None, apical_points_path=None): """Loads morphology release to a dataframe. Args: neurondb_path (str): path to a neurondb.xml file morphology_dirs (dict): If passed, a column with the path to each morphology file will be added for each entry of the dict, where the column name is the dict key - pc_in_types_path (str): path to mtype_taxonomy.tsv file apical_points_path (str): path to JSON file containing apical points """ morphs_df = MorphDB.from_neurondb(neurondb_path).df[ @@ -90,16 +71,9 @@ def load_neurondb_to_dataframe( apical_points = json.load(f) morphs_df = add_apical_points(morphs_df, apical_points) - if pc_in_types_path is not None: - mtype_taxonomy = pd.read_csv(pc_in_types_path, sep="\t") - morphs_df = add_mtype_taxonomy(morphs_df, mtype_taxonomy) - return morphs_df -L = logging.getLogger(__name__) - - def load_circuit( path_to_mvd3=None, path_to_morphologies=None, @@ -164,21 +138,6 @@ def update_morphs_df(morphs_df_path, new_morphs_df): return pd.read_csv(morphs_df_path).merge(new_morphs_df, how="left") -def get_layer_tags(atlas_dir): - """Creates a VoxelData with layer tags.""" - atlas = LocalAtlas(atlas_dir) - - names, ids = atlas.get_layers() # pylint: disable=no-member - br = VoxelData.load_nrrd(Path(atlas_dir) / "brain_regions.nrrd") - layers = np.zeros_like(br.raw, dtype="uint8") - layer_mapping = {} - for layer_id, (ids_set, layer) in enumerate(zip(ids, names)): - layer_mapping[layer_id] = layer - layers[np.isin(br.raw, list(ids_set))] = layer_id + 1 - br.raw = layers - return br, layer_mapping - - class IdProcessingFormatter(logging.Formatter): """Logging formatter class.""" diff --git a/src/synthesis_workflow/vacuum_synthesis.py b/src/synthesis_workflow/vacuum_synthesis.py index 12df1ba..9615680 100644 --- a/src/synthesis_workflow/vacuum_synthesis.py +++ b/src/synthesis_workflow/vacuum_synthesis.py @@ -1,4 +1,6 @@ """Functions for synthesis in vacuum to be used by luigi tasks.""" +import itertools + import matplotlib.pyplot as plt import numpy as np import pandas as pd @@ -43,21 +45,10 @@ def _grow_morphology( vacuum_synth_morphs_df.loc[gid, "name"] = name vacuum_synth_morphs_df.loc[gid, "mtype"] = mtype vacuum_synth_morphs_df.loc[gid, vacuum_morphology_path] = morphology_path - # vacuum_synth_morphs_df.loc[gid, 'apical_point'] = grower.apical_points return vacuum_synth_morphs_df -def _external_diametrizer(neuron, neurite_type, model_all, random_generator, diameter_params=None): - return build_diameters.build( - neuron, - model_all, - [neurite_type], - diameter_params, - random_generator, - ) - - def grow_vacuum_morphologies( mtypes, n_cells, @@ -111,16 +102,30 @@ def grow_vacuum_morphologies( def plot_vacuum_morphologies(vacuum_synth_morphs_df, pdf_filename, morphology_path): """Plot synthesized morphologies on top of each others.""" + # pylint: disable=cell-var-from-loop with PdfPages(pdf_filename) as pdf: for mtype in tqdm(sorted(vacuum_synth_morphs_df.mtype.unique())): + + ids = vacuum_synth_morphs_df[vacuum_synth_morphs_df.mtype == mtype].index + if len(ids) <= 5: + sqrt_n = len(ids) + sqrt_m = 1 + else: + sqrt_n = int(np.sqrt(len(ids)) + 1) + sqrt_m = sqrt_n plt.figure() ax = plt.gca() - for gid in vacuum_synth_morphs_df[vacuum_synth_morphs_df.mtype == mtype].index: + for gid, (n, m) in zip(ids, itertools.product(range(sqrt_n), range(sqrt_m))): morphology = load_morphology(vacuum_synth_morphs_df.loc[gid, morphology_path]) - matplotlib_impl.plot_morph(morphology, ax, plane="zy") + matplotlib_impl.plot_morph( + morphology.transform(lambda p: p + np.array([500 * n, 500 * m, 0])), + ax, + realistic_diameters=True, + soma_outline=False, + ) ax.set_title(mtype) - ax.set_rasterized(True) - plt.axis([-800, 800, -800, 2000]) + plt.axis("equal") + plt.tight_layout() with DisableLogger(): pdf.savefig() plt.close() diff --git a/src/synthesis_workflow/validation.py b/src/synthesis_workflow/validation.py index 8001bad..9f2f4ba 100644 --- a/src/synthesis_workflow/validation.py +++ b/src/synthesis_workflow/validation.py @@ -24,6 +24,7 @@ from joblib import delayed from matplotlib import cm from matplotlib.backends.backend_pdf import PdfPages +from morph_tool.resampling import resample_linear_density from morphio.mut import Morphology from neurom import load_morphologies from neurom.apps import morph_stats @@ -40,7 +41,7 @@ from scipy.optimize import fmin from tmd.io.io import load_population from voxcell import CellCollection -from voxcell import VoxelData +from voxcell.exceptions import VoxcellError from synthesis_workflow.circuit import get_cells_between_planes from synthesis_workflow.fit_utils import clean_outliers @@ -591,7 +592,7 @@ def get_plane_rotation_matrix(plane, current_rotation, target=None): current_direction = current_rotation.dot(target) - rotation_matrix = plane.get_quaternion().rotation_matrix + rotation_matrix = plane.get_quaternion().rotation_matrix.T def _get_rot_matrix(angle): """Get rotation matrix for a given angle along [0, 0, 1].""" @@ -604,13 +605,30 @@ def _cost(angle): return _get_rot_matrix(angle).dot(rotation_matrix) -def get_annotation_info( - annotation, - plane_origin, - rotation_matrix, - n_pixels=1024, - bbox=None, -): +def _get_plane_grid(annotation, plane_origin, rotation_matrix, n_pixels): + ids = np.vstack(np.where(annotation.raw > 0)).T + pts = annotation.indices_to_positions(ids) + pts = (pts - plane_origin).dot(rotation_matrix.T) + pts_dot_x = pts.dot([1.0, 0.0, 0.0]) + pts_dot_y = pts.dot([0.0, 1.0, 0.0]) + x_min = pts[np.argmin(pts_dot_x)][0] + x_max = pts[np.argmax(pts_dot_x)][0] + y_min = pts[np.argmin(pts_dot_y)][1] + y_max = pts[np.argmax(pts_dot_y)][1] + + xs_plane = np.linspace(x_min, x_max, n_pixels) + ys_plane = np.linspace(y_min, y_max, n_pixels) + X, Y = np.meshgrid(xs_plane, ys_plane) + points = np.array( + [ + np.array([x, y, 0]).dot(rotation_matrix) + plane_origin + for x, y in zip(X.flatten(), Y.flatten()) + ] + ) + return X, Y, points + + +def get_annotation_info(annotation, plane_origin, rotation_matrix, n_pixels=1024): """Get information to plot annotation on a plane. Args: @@ -619,56 +637,26 @@ def get_annotation_info( rotation_matrix (3*3 np.ndarray): rotation matrix to transform from real coordinates to plane coordinates n_pixels (int): number of pixel on each axis of the plane for plotting layers - bbox (ndarray): bbox to use, is None, annotation.bbox is used """ - if bbox is None: - bbox = annotation.bbox - - bbox_min = rotation_matrix.dot(bbox[0] - plane_origin) - bbox_max = rotation_matrix.dot(bbox[1] - plane_origin) - - xs_plane = np.linspace(min(bbox_min[0], bbox_max[0]), max(bbox_min[0], bbox_max[0]), n_pixels) - ys_plane = np.linspace(min(bbox_min[1], bbox_max[1]), max(bbox_min[1], bbox_max[1]), n_pixels) - - X, Y = np.meshgrid(xs_plane, ys_plane) - rot_T = rotation_matrix.T - points = [rot_T.dot([x, y, 0]) + plane_origin for x, y in zip(X.flatten(), Y.flatten())] - - data = annotation.lookup(points, outer_value=-1).astype(float).reshape(n_pixels, n_pixels) - data[data < 1] = np.nan + X, Y, points = _get_plane_grid(annotation, plane_origin, rotation_matrix, n_pixels) + data = annotation.lookup(points, outer_value=0).astype(float).reshape(n_pixels, n_pixels) return X, Y, data -def get_y_info(atlas, plane_origin, rotation_matrix, n_pixels=64, bbox=None): +def get_y_info(annotation, atlas, plane_origin, rotation_matrix, n_pixels=64): """Get direction of y axis on a grid on the atlas planes.""" - if bbox is None: - bbox = atlas.orientations.bbox - - bbox_min = rotation_matrix.dot(bbox[0] - plane_origin) - bbox_max = rotation_matrix.dot(bbox[1] - plane_origin) - - xs_plane = np.linspace(min(bbox_min[0], bbox_max[0]), max(bbox_min[0], bbox_max[0]), n_pixels) - ys_plane = np.linspace(min(bbox_min[1], bbox_max[1]), max(bbox_min[1], bbox_max[1]), n_pixels) - - X, Y = np.meshgrid(xs_plane, ys_plane) - - rot_T = rotation_matrix.T - points = np.array( - [rot_T.dot([x, y, 0]) + plane_origin for x, y in zip(X.flatten(), Y.flatten())] - ) - # create a mask of outer voxels so it can lookup orientations safely - voxel_idx = atlas.orientations.positions_to_indices(points, strict=False) - outer_mask = np.any(voxel_idx == VoxelData.OUT_OF_BOUNDS, axis=-1) - points[outer_mask] = plane_origin - - orientations = np.dot(atlas.orientations.lookup(points), [0.0, 1.0, 0.0]).dot(rotation_matrix.T) - - if len(outer_mask[outer_mask]) > 0: - orientations[outer_mask] = len(outer_mask[outer_mask]) * [np.zeros(3)] - + X, Y, points = _get_plane_grid(annotation, plane_origin, rotation_matrix, n_pixels) + orientations = [] + for point in points: + try: + orientations.append( + rotation_matrix.dot(np.dot(atlas.orientations.lookup(point)[0], [0.0, 1.0, 0.0])) + ) + except VoxcellError: + orientations.append([0.0, 1.0, 0.0]) + orientations = np.array(orientations) orientation_u = orientations[:, 0].reshape(n_pixels, n_pixels) orientation_v = orientations[:, 1].reshape(n_pixels, n_pixels) - return X, Y, orientation_u, orientation_v @@ -682,8 +670,8 @@ def plot_cells( mtype=None, sample=10, plot_neuron_kwargs=None, - region=None, - hemisphere=None, + linear_density=None, + wire_plot=False, ): """Plot cells for collage.""" if mtype is not None: @@ -691,68 +679,38 @@ def plot_cells( else: cells = circuit.cells.get() - if len(cells) == 0: - raise Exception(f"No cell of that mtype ({mtype})") - if plot_neuron_kwargs is None: plot_neuron_kwargs = {} - if region is not None: - if hemisphere is None: - cells = cells[(cells.region == f"{region}@left") & (cells.region == f"{region}@right")] - else: - cells = cells[cells.region == f"{region}@{hemisphere}"] _cells = get_cells_between_planes(cells, plane_left, plane_right) + gids = [] if len(_cells.index) > 0: _cells = _cells.sample(n=min(sample, len(_cells.index))) gids = _cells.index - else: - gids = [] - - atlas = AtlasHelper(circuit.atlas) - vec = [0, 1, 0] - all_pos_orig = cells.loc[gids, ["x", "y", "z"]].values - all_orientations = atlas.orientations.lookup(all_pos_orig) - all_lookups = np.einsum("ijk, k", all_orientations, vec) - all_pos_final = all_pos_orig + all_lookups * 300 - all_dist_plane_orig = all_pos_orig - plane_left.point - all_dist_plane_final = all_pos_final - plane_left.point - all_pos_orig_plane_coord = np.tensordot(all_dist_plane_orig, rotation_matrix.T, axes=1) - all_pos_final_plane_coord = np.tensordot(all_dist_plane_final, rotation_matrix.T, axes=1) - - for num, gid in enumerate(gids): - morphology = neurom.core.Morphology(circuit.morph.get(gid, transform=True, source="ascii")) + + def _wire_plot(morph, ax, lw=0.1): + for sec in morph.sections: + ax.plot(*sec.points.T[:2], c=matplotlib_impl.TREE_COLOR[sec.type], lw=lw) + + for gid in gids: + m = circuit.morph.get(gid, transform=True, source="ascii") + if linear_density is not None: + m = resample_linear_density(m, linear_density) + morphology = neurom.core.Morphology(m) def _to_plane_coord(p): return np.dot(p - plane_left.point, rotation_matrix.T) # transform morphology in the plane coordinates morphology = morphology.transform(_to_plane_coord) - - plt.plot( - [all_pos_orig_plane_coord[num, 0], all_pos_final_plane_coord[num, 0]], - [all_pos_orig_plane_coord[num, 1], all_pos_final_plane_coord[num, 1]], - c="0.5", - lw=0.1, - ) - matplotlib_impl.plot_morph(morphology, ax, plane="xy", **plot_neuron_kwargs) - - -def _get_region_mask(region, atlas, hemisphere=None): - """Get a region mask with hemisphere filter.""" - region_mask = atlas.get_region_mask(region) - region_mask.raw = np.array(region_mask.raw, dtype=float) - - if hemisphere is not None: - ids = np.array(np.where(region_mask.raw == 1)).T - pos = region_mask.indices_to_positions(ids) - if hemisphere == "left": - ids = ids[pos[:, 2] > pos[:, 2].mean()] - if hemisphere == "right": - ids = ids[pos[:, 2] < pos[:, 2].mean()] - region_mask.raw[tuple(ids.T.tolist())] = 0 - return region_mask + if wire_plot: + ax.scatter( + *_to_plane_coord([_cells.loc[gid, ["x", "y", "z"]].values])[0, :2], c="k", s=5 + ) + _wire_plot(morphology, ax=ax) + else: + matplotlib_impl.plot_morph(morphology, ax, plane="xy", **plot_neuron_kwargs) # pylint: disable=too-many-arguments,too-many-locals @@ -767,47 +725,37 @@ def _plot_collage( with_y_field=True, with_cells=True, plot_neuron_kwargs=None, - region=None, - hemisphere="right", figsize=(20, 20), + layer_mappings=None, + cells_linear_density=None, + cells_wire_plot=False, + region_structure_path="region_structure.yaml", ): """Internal plot collage for multiprocessing.""" left_plane, right_plane = planes plane_point = left_plane.point + atlas = AtlasHelper(circuit.atlas, region_structure_path=region_structure_path) rotation_matrix = get_plane_rotation_matrix( - left_plane, AtlasHelper(circuit.atlas).orientations.lookup(plane_point)[0] + left_plane, atlas.orientations.lookup(plane_point)[0] ) - fig = plt.figure(figsize=figsize) - - if region is not None: - region_mask = _get_region_mask(region, circuit.atlas, hemisphere=hemisphere) - - # get the bbox of the region - _pos = region_mask.indices_to_positions(np.array(np.where(region_mask.raw == 1)).T) - bbox = np.array([0.9 * np.min(_pos, axis=0), 1.1 * np.max(_pos, axis=0)]) - - # get the data to plot the mask - region_mask.raw = 1 - region_mask.raw - region_mask.raw[layer_annotation.raw < 1] = np.nan # so that it is white outside atlas - X, Y, region_mask = get_annotation_info( - region_mask, plane_point, rotation_matrix, n_pixels, bbox=bbox - ) - - cmap = matplotlib.colors.ListedColormap(["k"]) - plt.pcolormesh(X, Y, region_mask, shading="nearest", cmap=cmap, alpha=0.8) - else: - bbox = None + X, Y, layers = get_annotation_info(layer_annotation, plane_point, rotation_matrix, n_pixels) + layer_ids = np.array([-1] + list(layer_mappings.keys())) + 1 - # get the data to plot the layers - X, Y, layers = get_annotation_info( - layer_annotation, plane_point, rotation_matrix, n_pixels, bbox=bbox - ) + cmap = matplotlib.colors.ListedColormap(["0.8"] + [f"C{i}" for i in layer_mappings]) - cmap = matplotlib.colors.ListedColormap(["C0", "C1", "C2", "C3", "C4", "C5"]) + fig = plt.figure(figsize=figsize) plt.pcolormesh(X, Y, layers, shading="nearest", cmap=cmap, alpha=0.3) - - plt.colorbar() + bounds = list(layer_ids - 0.5) + [layer_ids[-1] + 0.5] + norm = matplotlib.colors.BoundaryNorm(bounds, cmap.N) + cbar = plt.colorbar( + matplotlib.cm.ScalarMappable(cmap=cmap, norm=norm), + ticks=layer_ids, + boundaries=bounds, + shrink=0.3, + alpha=0.3, + ) + cbar.ax.set_yticklabels(["outside"] + list(layer_mappings.values())) if with_cells: plot_cells( @@ -819,13 +767,12 @@ def _plot_collage( mtype=mtype, sample=sample, plot_neuron_kwargs=plot_neuron_kwargs, - region=region, - hemisphere=hemisphere, + linear_density=cells_linear_density, + wire_plot=cells_wire_plot, ) - if with_y_field: X_y, Y_y, orientation_u, orientation_v = get_y_info( - AtlasHelper(circuit.atlas), left_plane.point, rotation_matrix, n_pixels_y, bbox=bbox + layer_annotation, atlas, left_plane.point, rotation_matrix, n_pixels_y ) arrow_len = abs(X_y[0, 1] - X_y[0, 0]) * 0.5 plt.quiver( @@ -843,7 +790,6 @@ def _plot_collage( ax.set_aspect("equal") ax.set_rasterized(True) ax.set_title(f"plane coord: {left_plane.point}") - plt.axis([X[0, 0], X[0, -1], Y[0, 0], Y[-1, 0]]) return fig @@ -864,8 +810,10 @@ def plot_collage( n_pixels_y=20, plot_neuron_kwargs=None, with_cells=True, - region=None, - hemisphere=None, + layer_mappings=None, + cells_linear_density=None, + cells_wire_plot=False, + region_structure_path="region_structure.yaml", ): """Plot collage of an mtype and a list of planes. @@ -884,8 +832,10 @@ def plot_collage( n_pixels_y (int): number of pixels for plotting y field plot_neuron_kwargs (dict): dict given to ``neurom.viewer.plot_neuron`` as kwargs with_cells (bool): plot cells or not - region (str): region to consider, if None, all atlas will be used - hemisphere (str): left/right hemisphere to consider + layer_mappings (dict): mapping between layer id and layer names to display + cells_linear_density (float): apply resampling to plot less points + cells_wire_plot (bool): if true, do not use neurom.view, but plt.plot + region_structure_path (str): path to region_structure.yaml file """ ensure_dir(pdf_filename) with PdfPages(pdf_filename) as pdf: @@ -900,8 +850,10 @@ def plot_collage( with_y_field=with_y_field, plot_neuron_kwargs=plot_neuron_kwargs, with_cells=with_cells, - region=region, - hemisphere=hemisphere, + layer_mappings=layer_mappings, + cells_linear_density=cells_linear_density, + cells_wire_plot=cells_wire_plot, + region_structure_path=region_structure_path, ) for fig in Parallel(nb_jobs, verbose=joblib_verbose)( delayed(f)(planes) for planes in zip(planes[:-1:3], planes[2::3]) diff --git a/tests/conftest.py b/tests/conftest.py index a15bec8..b39c837 100644 --- a/tests/conftest.py +++ b/tests/conftest.py @@ -13,8 +13,8 @@ import numpy as np import pytest +from synthesis_workflow.circuit import get_layer_tags from synthesis_workflow.tasks import config -from synthesis_workflow.tools import get_layer_tags dir_content_diff.pandas.register() dir_content_diff_plugins.voxcell.register() @@ -62,7 +62,9 @@ def small_O1(tmp_path): shutil.copyfile(DATA / "in_small_O1" / "metadata.json", atlas_dir / "metadata.json") # Add dummy cell density files for L1_DAC and L3_TPC:A - br, _ = get_layer_tags(atlas_dir) + br, _ = get_layer_tags( + atlas_dir, region_structure_path=DATA / "synthesis_input" / "region_structure.yaml" + ) layer_tags = br.raw.copy() br.raw[np.where(layer_tags == 1)] = 1000 br.raw[np.where(layer_tags != 1)] = 0 diff --git a/tests/data/in_small_O1/out/atlas/atlas_planes.npz b/tests/data/in_small_O1/out/atlas/atlas_planes.npz new file mode 100644 index 0000000..9424121 Binary files /dev/null and b/tests/data/in_small_O1/out/atlas/atlas_planes.npz differ diff --git a/tests/data/in_small_O1/out/atlas/atlas_planes_None.npz b/tests/data/in_small_O1/out/atlas/atlas_planes_None.npz deleted file mode 100644 index 71c2fe0..0000000 Binary files a/tests/data/in_small_O1/out/atlas/atlas_planes_None.npz and /dev/null differ diff --git a/tests/data/in_small_O1/out/circuit/sliced_circuit_somata.mvd3 b/tests/data/in_small_O1/out/circuit/sliced_circuit_somata.mvd3 index cc7d625..2275958 100644 Binary files a/tests/data/in_small_O1/out/circuit/sliced_circuit_somata.mvd3 and b/tests/data/in_small_O1/out/circuit/sliced_circuit_somata.mvd3 differ diff --git a/tests/data/in_small_O1/out/morphs_df/axon_morphs_df.csv b/tests/data/in_small_O1/out/morphs_df/axon_morphs_df.csv index 92e8317..667d5fa 100644 --- a/tests/data/in_small_O1/out/morphs_df/axon_morphs_df.csv +++ b/tests/data/in_small_O1/out/morphs_df/axon_morphs_df.csv @@ -1,5 +1,5 @@ -,name,layer,mtype,use_axon,path,clone_path,morph_class -0,C270106A,1,L1_DAC,True,input_cells/C270106A.h5,input_cells/C270106A.h5,INT -1,C170797A-P2,3,L3_TPC:A,False,input_cells/C170797A-P2.h5,input_cells/C170797A-P2.h5,PYR -2,rat_20160908_E3_LH2_cell2,3,L3_TPC:A,True,input_cells/rat_20160908_E3_LH2_cell2.h5,input_cells/rat_20160908_E3_LH2_cell2.h5,PYR -3,sm080625a1-6_idD,1,L1_DAC,True,input_cells/sm080625a1-6_idD.h5,input_cells/sm080625a1-6_idD.h5,INT +,name,layer,mtype,use_axon,path,clone_path +0,C270106A,1,L1_DAC,True,input_cells/C270106A.h5,input_cells/C270106A.h5 +1,C170797A-P2,3,L3_TPC:A,False,input_cells/C170797A-P2.h5,input_cells/C170797A-P2.h5 +2,rat_20160908_E3_LH2_cell2,3,L3_TPC:A,True,input_cells/rat_20160908_E3_LH2_cell2.h5,input_cells/rat_20160908_E3_LH2_cell2.h5 +3,sm080625a1-6_idD,1,L1_DAC,True,input_cells/sm080625a1-6_idD.h5,input_cells/sm080625a1-6_idD.h5 diff --git a/tests/data/in_small_O1/out/morphs_df/morphs_df.csv b/tests/data/in_small_O1/out/morphs_df/morphs_df.csv index cd34f5a..2104c73 100644 --- a/tests/data/in_small_O1/out/morphs_df/morphs_df.csv +++ b/tests/data/in_small_O1/out/morphs_df/morphs_df.csv @@ -1,5 +1,5 @@ -,name,layer,mtype,use_axon,path,morphology_path,morph_class -0,C270106A,1,L1_DAC,True,input_cells/C270106A.h5,input_cells/C270106A.h5,INT -1,C170797A-P2,3,L3_TPC:A,False,input_cells/C170797A-P2.h5,input_cells/C170797A-P2.h5,PYR -2,rat_20160908_E3_LH2_cell2,3,L3_TPC:A,True,input_cells/rat_20160908_E3_LH2_cell2.h5,input_cells/rat_20160908_E3_LH2_cell2.h5,PYR -3,sm080625a1-6_idD,1,L1_DAC,True,input_cells/sm080625a1-6_idD.h5,input_cells/sm080625a1-6_idD.h5,INT +,name,layer,mtype,use_axon,path,morphology_path +0,C270106A,1,L1_DAC,True,input_cells/C270106A.h5,input_cells/C270106A.h5 +1,C170797A-P2,3,L3_TPC:A,False,input_cells/C170797A-P2.h5,input_cells/C170797A-P2.h5 +2,rat_20160908_E3_LH2_cell2,3,L3_TPC:A,True,input_cells/rat_20160908_E3_LH2_cell2.h5,input_cells/rat_20160908_E3_LH2_cell2.h5 +3,sm080625a1-6_idD,1,L1_DAC,True,input_cells/sm080625a1-6_idD.h5,input_cells/sm080625a1-6_idD.h5 diff --git a/tests/data/in_small_O1/out/morphs_df/substituted_morphs_df.csv b/tests/data/in_small_O1/out/morphs_df/substituted_morphs_df.csv index 70ce60c..97110c4 100644 --- a/tests/data/in_small_O1/out/morphs_df/substituted_morphs_df.csv +++ b/tests/data/in_small_O1/out/morphs_df/substituted_morphs_df.csv @@ -1,5 +1,5 @@ -Unnamed: 0,name,layer,mtype,use_axon,path,morphology_path,morph_class -0,C270106A,1,L1_DAC,True,input_cells/C270106A.h5,input_cells/C270106A.h5,INT -1,C170797A-P2,3,L3_TPC:A,False,input_cells/C170797A-P2.h5,input_cells/C170797A-P2.h5,PYR -2,rat_20160908_E3_LH2_cell2,3,L3_TPC:A,True,input_cells/rat_20160908_E3_LH2_cell2.h5,input_cells/rat_20160908_E3_LH2_cell2.h5,PYR -3,sm080625a1-6_idD,1,L1_DAC,True,input_cells/sm080625a1-6_idD.h5,input_cells/sm080625a1-6_idD.h5,INT +Unnamed: 0,name,layer,mtype,use_axon,path,morphology_path +0,C270106A,1,L1_DAC,True,input_cells/C270106A.h5,input_cells/C270106A.h5 +1,C170797A-P2,3,L3_TPC:A,False,input_cells/C170797A-P2.h5,input_cells/C170797A-P2.h5 +2,rat_20160908_E3_LH2_cell2,3,L3_TPC:A,True,input_cells/rat_20160908_E3_LH2_cell2.h5,input_cells/rat_20160908_E3_LH2_cell2.h5 +3,sm080625a1-6_idD,1,L1_DAC,True,input_cells/sm080625a1-6_idD.h5,input_cells/sm080625a1-6_idD.h5 diff --git a/tests/data/in_small_O1/out/morphs_df/synth_morphs_df.csv b/tests/data/in_small_O1/out/morphs_df/synth_morphs_df.csv index a7a6dab..7cea5f7 100644 --- a/tests/data/in_small_O1/out/morphs_df/synth_morphs_df.csv +++ b/tests/data/in_small_O1/out/morphs_df/synth_morphs_df.csv @@ -1,61 +1,61 @@ etype,layer,morph_class,mtype,synapse_class,x,y,z,orientation,synth_morphology_path,name -bNAC,1,INT,L1_DAC,INH,161.80154289988423,742.8768700945767,-786.4525935777549,"[[1. 0. 0.] +cNAC,1,INT,L1_DAC,INH,106.80740739747216,625.1940988246093,122.11609153460836,"[[1. 0. 0.] [0. 1. 0.] [0. 0. 1.]]",synthesis/synthesized_morphologies/e3e70682c2094cac629f6fbed82c07cd.asc,e3e70682c2094cac629f6fbed82c07cd -cNAC,1,INT,L1_DAC,INH,458.990997635457,673.012202951677,731.1944995479603,"[[1. 0. 0.] +bNAC,1,INT,L1_DAC,INH,56.910073861459296,640.7183297226001,606.9166995455139,"[[1. 0. 0.] [0. 1. 0.] [0. 0. 1.]]",synthesis/synthesized_morphologies/cd613e30d8f16adf91b7584a2265b1f5.asc,cd613e30d8f16adf91b7584a2265b1f5 -cNAC,1,INT,L1_DAC,INH,-531.8607489396162,627.7596097731765,12.886056546632062,"[[1. 0. 0.] +bNAC,1,INT,L1_DAC,INH,-609.1156281587262,781.5523818768568,15.941446344895553,"[[1. 0. 0.] [0. 1. 0.] [0. 0. 1.]]",synthesis/synthesized_morphologies/d95bafc8f2a4d27bdcf4bb99f4bea973.asc,d95bafc8f2a4d27bdcf4bb99f4bea973 -cNAC,1,INT,L1_DAC,INH,-377.5682971025261,609.7844484494035,286.2191517421684,"[[1. 0. 0.] +bNAC,1,INT,L1_DAC,INH,161.80154289988423,742.8768700945767,-786.4525935777549,"[[1. 0. 0.] [0. 1. 0.] [0. 0. 1.]]",synthesis/synthesized_morphologies/216363698b529b4a97b750923ceb3ffd.asc,216363698b529b4a97b750923ceb3ffd -cNAC,1,INT,L1_DAC,INH,-367.32991182317403,723.2744129279057,461.4464706476874,"[[1. 0. 0.] +cNAC,1,INT,L1_DAC,INH,-178.31030156015254,766.3078203100101,-73.6677623262849,"[[1. 0. 0.] [0. 1. 0.] [0. 0. 1.]]",synthesis/synthesized_morphologies/b8a1abcd1a6916c74da4f9fc3c6da5d7.asc,b8a1abcd1a6916c74da4f9fc3c6da5d7 -bNAC,1,INT,L1_DAC,INH,255.21924699224064,658.4476068955769,896.193637854723,"[[1. 0. 0.] +cNAC,1,INT,L1_DAC,INH,-176.225817398436,650.2389457489262,794.258359969793,"[[1. 0. 0.] [0. 1. 0.] [0. 0. 1.]]",synthesis/synthesized_morphologies/5bc8fbbcbde5c0994164d8399f767c45.asc,5bc8fbbcbde5c0994164d8399f767c45 -cNAC,1,INT,L1_DAC,INH,-457.94605333199013,655.7368791323917,886.0551173828792,"[[1. 0. 0.] +cNAC,1,INT,L1_DAC,INH,240.67333458357484,655.2078276691971,-372.8347232393854,"[[1. 0. 0.] [0. 1. 0.] [0. 0. 1.]]",synthesis/synthesized_morphologies/14a03569d26b949692e5dfe8cb1855fe.asc,14a03569d26b949692e5dfe8cb1855fe -bNAC,1,INT,L1_DAC,INH,-322.59526673013613,633.3145152028642,-191.88986100120042,"[[1. 0. 0.] +cNAC,1,INT,L1_DAC,INH,570.3888583540365,710.0226887312301,591.9482613744674,"[[1. 0. 0.] [0. 1. 0.] [0. 0. 1.]]",synthesis/synthesized_morphologies/6513270e269e0d37f2a74de452e6b438.asc,6513270e269e0d37f2a74de452e6b438 -bNAC,1,INT,L1_DAC,INH,-4.904738894460706,623.3420255468096,-131.02317349222494,"[[1. 0. 0.] +cNAC,1,INT,L1_DAC,INH,562.1478401499764,757.7228588604167,-576.2107178625491,"[[1. 0. 0.] [0. 1. 0.] [0. 0. 1.]]",synthesis/synthesized_morphologies/6018366cf658f7a75ed34fe53a096533.asc,6018366cf658f7a75ed34fe53a096533 -cNAC,1,INT,L1_DAC,INH,240.67333458357484,655.2078276691971,-372.8347232393854,"[[1. 0. 0.] +cNAC,1,INT,L1_DAC,INH,263.87617573665284,749.0305346548737,-301.05902227155684,"[[1. 0. 0.] [0. 1. 0.] [0. 0. 1.]]",synthesis/synthesized_morphologies/4462ebfc5f915ef09cfbac6e7687a66e.asc,4462ebfc5f915ef09cfbac6e7687a66e cADpyr,3,PYR,L3_TPC:A,EXC,-159.16970916602543,437.74065725888875,680.9364971489199,"[[1. 0. 0.] [0. 1. 0.] [0. 0. 1.]]",synthesis/synthesized_morphologies/7b89296c6dcbac5008577eb1924770d3.asc,7b89296c6dcbac5008577eb1924770d3 -cADpyr,3,PYR,L3_TPC:A,EXC,248.76763235382077,400.0545964896996,42.54017253550546,"[[1. 0. 0.] +cADpyr,3,PYR,L3_TPC:A,EXC,-60.82030614353357,424.2178594126085,-274.9601787146428,"[[1. 0. 0.] [0. 1. 0.] [0. 0. 1.]]",synthesis/synthesized_morphologies/db5b5fab8f4d3e27dda1494c73cf256d.asc,db5b5fab8f4d3e27dda1494c73cf256d -cADpyr,3,PYR,L3_TPC:A,EXC,-337.83345635467424,428.8569957651696,187.4399917074843,"[[1. 0. 0.] +cADpyr,3,PYR,L3_TPC:A,EXC,248.76763235382077,400.0545964896996,42.54017253550546,"[[1. 0. 0.] [0. 1. 0.] [0. 0. 1.]]",synthesis/synthesized_morphologies/87751d4ca8501e2c44dcda6a797d76de.asc,87751d4ca8501e2c44dcda6a797d76de -cADpyr,3,PYR,L3_TPC:A,EXC,501.912289744869,451.8149813791174,684.2776862684843,"[[1. 0. 0.] +cADpyr,3,PYR,L3_TPC:A,EXC,-78.35427390557902,416.6047824521246,892.2756610225367,"[[1. 0. 0.] [0. 1. 0.] [0. 0. 1.]]",synthesis/synthesized_morphologies/e8d79f49af6d114c4a6f188a424e617b.asc,e8d79f49af6d114c4a6f188a424e617b -cADpyr,3,PYR,L3_TPC:A,EXC,-173.27929681376816,487.73987891741194,-562.8081251487538,"[[1. 0. 0.] +cADpyr,3,PYR,L3_TPC:A,EXC,-165.05597079514655,478.1479600234661,875.1021648856397,"[[1. 0. 0.] [0. 1. 0.] [0. 0. 1.]]",synthesis/synthesized_morphologies/c15521b1b3dca50a9daa37e51b591d75.asc,c15521b1b3dca50a9daa37e51b591d75 -cADpyr,3,PYR,L3_TPC:A,EXC,92.72118073731167,402.895254902696,-310.4308708789796,"[[1. 0. 0.] +cADpyr,3,PYR,L3_TPC:A,EXC,295.91422519779735,410.32981550851383,-813.28328408948,"[[1. 0. 0.] [0. 1. 0.] [0. 0. 1.]]",synthesis/synthesized_morphologies/8575062102fbcd4f357fbc5af71a1bfc.asc,8575062102fbcd4f357fbc5af71a1bfc -cADpyr,3,PYR,L3_TPC:A,EXC,388.90599531897305,473.7278579714168,-299.4847035730976,"[[1. 0. 0.] +cADpyr,3,PYR,L3_TPC:A,EXC,-588.2474357096362,497.5883868418533,-406.7438796142659,"[[1. 0. 0.] [0. 1. 0.] [0. 0. 1.]]",synthesis/synthesized_morphologies/48f165d57b00c7f4781ef86f5c8cc1ab.asc,48f165d57b00c7f4781ef86f5c8cc1ab -cADpyr,3,PYR,L3_TPC:A,EXC,-188.75726827876883,421.24343612940413,118.30332920799219,"[[1. 0. 0.] +cADpyr,3,PYR,L3_TPC:A,EXC,-203.68027047396197,414.7801334065391,-274.3083356313331,"[[1. 0. 0.] [0. 1. 0.] [0. 0. 1.]]",synthesis/synthesized_morphologies/4dad2986ce8349606a06e9ab85a0bcc1.asc,4dad2986ce8349606a06e9ab85a0bcc1 -cADpyr,3,PYR,L3_TPC:A,EXC,129.40766623831655,445.30942454488786,-550.6042166012777,"[[1. 0. 0.] +cADpyr,3,PYR,L3_TPC:A,EXC,-599.8616650001001,424.7685022492316,331.8233509177062,"[[1. 0. 0.] [0. 1. 0.] [0. 0. 1.]]",synthesis/synthesized_morphologies/72e63ac7a95383221f70d5dc2e675fc7.asc,72e63ac7a95383221f70d5dc2e675fc7 -cADpyr,3,PYR,L3_TPC:A,EXC,-165.05597079514655,478.1479600234661,875.1021648856397,"[[1. 0. 0.] +cADpyr,3,PYR,L3_TPC:A,EXC,-171.7163147823918,433.9631044166199,160.02128681312934,"[[1. 0. 0.] [0. 1. 0.] [0. 0. 1.]]",synthesis/synthesized_morphologies/e539a78bc8eff3460b12ae6ead581e57.asc,e539a78bc8eff3460b12ae6ead581e57 diff --git a/tests/data/in_small_O1/out/synthesis/apical_points.yaml b/tests/data/in_small_O1/out/synthesis/apical_points.yaml index 3feb04d..b92be2c 100644 --- a/tests/data/in_small_O1/out/synthesis/apical_points.yaml +++ b/tests/data/in_small_O1/out/synthesis/apical_points.yaml @@ -2,49 +2,49 @@ 216363698b529b4a97b750923ceb3ffd: null 4462ebfc5f915ef09cfbac6e7687a66e: null 48f165d57b00c7f4781ef86f5c8cc1ab: -- -0.4680538475513458 -- 198.25662231445312 -- -8.388245582580566 +- -7.582686424255371 +- 191.33596801757812 +- -37.68757629394531 4dad2986ce8349606a06e9ab85a0bcc1: -- -4.403373718261719 -- 136.6024627685547 -- -7.630804061889648 +- 7.036743640899658 +- 192.56198120117188 +- 5.714080810546875 5bc8fbbcbde5c0994164d8399f767c45: null 6018366cf658f7a75ed34fe53a096533: null 6513270e269e0d37f2a74de452e6b438: null 72e63ac7a95383221f70d5dc2e675fc7: -- -2.708533525466919 -- 199.09312438964844 -- -7.201815605163574 +- 22.429237365722656 +- 195.77279663085938 +- -18.43511390686035 7b89296c6dcbac5008577eb1924770d3: -- -15.83535099029541 -- 196.03489685058594 -- 1.0543631315231323 +- 6.158751487731934 +- 194.30145263671875 +- -11.033774375915527 8575062102fbcd4f357fbc5af71a1bfc: -- -4.238313674926758 -- 139.07034301757812 -- -6.794010162353516 +- 3.7870986461639404 +- 197.109619140625 +- -16.717546463012695 87751d4ca8501e2c44dcda6a797d76de: -- 12.631799697875977 -- 135.9075469970703 -- -4.667287826538086 +- -0.02146044373512268 +- 196.42794799804688 +- 14.575016021728516 b8a1abcd1a6916c74da4f9fc3c6da5d7: null c15521b1b3dca50a9daa37e51b591d75: -- 14.715275764465332 -- 132.83018493652344 -- -13.455227851867676 +- 2.402620315551758 +- 191.1907958984375 +- 17.717042922973633 cd613e30d8f16adf91b7584a2265b1f5: null d95bafc8f2a4d27bdcf4bb99f4bea973: null db5b5fab8f4d3e27dda1494c73cf256d: -- -5.762476921081543 -- 196.08946228027344 -- -0.19906087219715118 +- -9.867453575134277 +- 197.05661010742188 +- -12.531447410583496 e3e70682c2094cac629f6fbed82c07cd: null e539a78bc8eff3460b12ae6ead581e57: -- 0.6656373739242554 -- 137.11642456054688 -- -0.09093667566776276 +- 0.14039519429206848 +- 197.3130340576172 +- 5.079026222229004 e8d79f49af6d114c4a6f188a424e617b: -- -4.303969860076904 -- 139.21133422851562 -- 2.201572895050049 +- -4.53495454788208 +- 192.60043334960938 +- -3.3029251098632812 diff --git a/tests/data/in_small_O1/out/synthesis/neurots_input/tmd_distributions.json b/tests/data/in_small_O1/out/synthesis/neurots_input/tmd_distributions.json index da8c70a..fe2b7cf 100644 --- a/tests/data/in_small_O1/out/synthesis/neurots_input/tmd_distributions.json +++ b/tests/data/in_small_O1/out/synthesis/neurots_input/tmd_distributions.json @@ -1,4624 +1,542 @@ { "metadata": { "cortical_thickness": [ - 165, - 149, - 353, - 190, - 525, - 700 + 200, + 100, + 100, + 100, + 100, + 200 ] }, "mtypes": { "L1_DAC": { - "apical": { + "basal": { "filtration_metric": "path_distances", "num_trees": { "data": { "bins": [ - 0 + 3, + 4, + 5, + 6, + 7 ], "weights": [ - 2 - ] - } - }, - "persistence_diagram": [], - "trunk": { - "absolute_elevation_deviation": { - "data": { - "bins": [ - 0.016666666666666666, - 0.05, - 0.08333333333333334, - 0.11666666666666667, - 0.15, - 0.18333333333333335, - 0.21666666666666667, - 0.25, - 0.2833333333333333, - 0.31666666666666665, - 0.35, - 0.3833333333333333, - 0.4166666666666667, - 0.45, - 0.48333333333333334, - 0.5166666666666666, - 0.55, - 0.5833333333333333, - 0.6166666666666667, - 0.6499999999999999, - 0.6833333333333333, - 0.7166666666666666, - 0.75, - 0.7833333333333333, - 0.8166666666666667, - 0.8500000000000001, - 0.8833333333333333, - 0.9166666666666667, - 0.95, - 0.9833333333333334 - ], - "weights": [ - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0 - ] - } - }, - "azimuth": { - "uniform": { - "max": 0.0, - "min": 3.141592653589793 - } - }, - "orientation_deviation": { - "data": { - "bins": [ - 0.016666666666666666, - 0.05, - 0.08333333333333334, - 0.11666666666666667, - 0.15, - 0.18333333333333335, - 0.21666666666666667, - 0.25, - 0.2833333333333333, - 0.31666666666666665, - 0.35, - 0.3833333333333333, - 0.4166666666666667, - 0.45, - 0.48333333333333334, - 0.5166666666666666, - 0.55, - 0.5833333333333333, - 0.6166666666666667, - 0.6499999999999999, - 0.6833333333333333, - 0.7166666666666666, - 0.75, - 0.7833333333333333, - 0.8166666666666667, - 0.8500000000000001, - 0.8833333333333333, - 0.9166666666666667, - 0.95, - 0.9833333333333334 - ], - "weights": [ - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0 - ] - } - } - } - }, - "axon": { - "filtration_metric": "path_distances", - "num_trees": { - "data": { - "bins": [ + 1, + 0, + 0, + 0, 1 - ], - "weights": [ - 2 ] } }, "persistence_diagram": [ [ [ - 391.6643151640892, - 205.59939855337143, - -0.3105885684490204, - 0.6373369693756104, - 3.0071640014648438, - 0.22063040733337402 + 224.38319063186646, + 219.2606019973755, + -0.4379599988460541, + -0.005312800407409668, + -0.8848207592964172, + 0.0901557207107544 ], [ - 501.36823135614395, - 444.02188271284103, - -0.07756775617599487, - -0.45922040939331055, - -0.16126471757888794, - -0.1740485429763794 + 400.9616605043411, + 384.7926591038704, + -0.057923853397369385, + -0.289974570274353, + -2.5282816886901855, + -0.1570836901664734 ], [ - 534.684856235981, - 522.7951191067696, - 0.04284811019897461, - 0.4852858781814575, - 0.1878809928894043, - -0.5559974908828735 + 192.41142231225967, + 178.48044949769974, + 0.9341675639152527, + 0.13731682300567627, + -1.9108004570007324, + -0.36382102966308594 ], [ - 492.82649260759354, - 481.0672774910927, - -0.34110140800476074, - -0.33774352073669434, - 1.5547916889190674, - 0.7355847358703613 + 212.02685528993607, + 204.79348236322403, + -1.037257194519043, + 0.6260798573493958, + -4.952030658721924, + 0.0439608097076416 ], [ - 518.1814951300621, - 487.58488017320633, - 0.7537035942077637, - 0.9112626314163208, - 3.4106173515319824, - -0.21315884590148926 + 174.49314105510712, + 166.01364123821259, + 0.8455920219421387, + 1.9787335395812988, + -2.6705470085144043, + -2.1493306159973145 ], [ - 420.4260097146034, - 288.1535434126854, - 0.024590253829956055, - 0.6091045141220093, - 3.700061321258545, - -0.6539413928985596 + 280.87815886735916, + 72.90992110967636, + 0.05115431547164917, + -0.25066912174224854, + -1.0350282192230225, + -0.10089123249053955 ], [ - 327.13714480400085, - 273.29231119155884, - -0.1077195405960083, - -0.35118699073791504, - 0.960407555103302, - 0.34968459606170654 + 124.64597976207733, + 116.80670726299286, + -0.04528069496154785, + -0.6709880828857422, + 5.494875907897949, + 0.6105341911315918 ], [ - 447.8922420144081, - 446.59567254781723, - 0.27133941650390625, - -0.025693655014038086, - -1.3016613721847534, - 0.48911964893341064 + 221.2086187005043, + 111.25251829624176, + 0.2337489128112793, + 1.069451093673706, + -5.322473049163818, + -0.8068923950195312 ], [ - 426.21355444192886, - 362.74098378419876, - 0.07443857192993164, - 0.002101421356201172, - 0.06515216827392578, - 0.43577253818511963 + 180.18831837177277, + 51.97151494026184, + 0.39078283309936523, + 0.09945124387741089, + -1.4081227779388428, + 0.10724365711212158 ], [ - 467.3602465763688, - 432.2146715298295, - -0.03435063362121582, - 0.21426290273666382, - 4.253576755523682, - 0.0980568528175354 + 416.0371113419533, + 38.79454827308655, + 0.46909475326538086, + 1.0566465854644775, + 1.8869953155517578, + -1.014134168624878 ], [ - 581.3387487009168, - 559.6290861442685, - 0.07716751098632812, - 0.04823172092437744, - 5.421203136444092, - -0.02567446231842041 - ], + 416.89264065027237, + 0, + NaN, + NaN, + NaN, + NaN + ] + ], + [ [ - 723.451112754643, - 717.5159635618329, - 1.112695574760437, - 0.9053986072540283, - -2.236431360244751, - -1.028096318244934 + 138.14135348796844, + 91.25013053417206, + 0.15326452255249023, + -1.7054016590118408, + -1.867674469947815, + 0.8106865286827087 ], [ - 703.434056289494, - 701.024477250874, - 0.3070218563079834, - 0.18580704927444458, - -0.9293392300605774, - 0.5588480234146118 + 131.90395653247833, + 63.07564151287079, + 0.8644651174545288, + 0.2718007564544678, + -3.7785184383392334, + -0.3544933795928955 ], [ - 679.5220037773252, - 655.9753478839993, - 0.043497711420059204, - -0.05016040802001953, - -0.28335684537887573, - 0.0026072263717651367 + 138.06671458482742, + 63.07564151287079, + 0.8644651174545288, + 0.2718007564544678, + -3.7785184383392334, + -0.3544933795928955 ], [ - 560.8058109357953, - 553.6319077089429, - -0.5190410614013672, - 0.3952946662902832, - -4.371852874755859, - -0.3444945812225342 + 242.68944704532623, + 58.60613238811493, + 0.0914769172668457, + -0.7802326679229736, + -1.4150129556655884, + 0.4885904788970947 ], [ - 593.1914836242795, - 480.6256971433759, - 0.06302762031555176, - 0.03621947765350342, - 0.006815910339355469, - 0.2512493133544922 - ], + 293.2285534143448, + 0, + NaN, + NaN, + NaN, + NaN + ] + ], + [ [ - 359.0491527989507, - 333.06846088916063, - -0.25638747215270996, - 0.8555448055267334, - 1.0500061511993408, - -0.7104394435882568 + 175.22094976902008, + 97.96781897544861, + -0.919957160949707, + -0.007689237594604492, + 2.2741498947143555, + -0.6524972319602966 ], [ - 413.2583177238703, - 396.5980608612299, - 0.27146363258361816, - -0.1288679838180542, - -5.993398666381836, - -1.1805989742279053 + 106.60009527206421, + 96.86709189414978, + 0.06461894512176514, + -0.3159041404724121, + -1.6893795728683472, + -0.534130334854126 ], [ - 380.90009893476963, - 319.6859582811594, - 0.4627852439880371, - -0.26988279819488525, - -5.836581707000732, - 0.4813361167907715 + 136.90290075540543, + 48.16596841812134, + 0.6720576882362366, + 0.32939839363098145, + -1.657493233680725, + 0.22861850261688232 ], [ - 555.4565243273973, - 526.1095866709948, - 5.675025939941406, - -0.20517969131469727, - 0.3246958255767822, - 0.6551369428634644 + 160.5392016172409, + 41.71347534656525, + -0.581010103225708, + -0.6343587636947632, + 1.4430261850357056, + 1.1310218572616577 ], [ - 330.4351618438959, - 251.73456443846226, - -0.24874114990234375, - -0.1901768445968628, - 0.8500969409942627, - 0.6632006168365479 + 330.51422041654587, + 317.4096869826317, + 0.016859177500009537, + 0.4976717233657837, + -0.8041179180145264, + 0.09304702281951904 ], [ - 418.4140371233225, - 347.36012245714664, - -0.012700557708740234, - -0.028427600860595703, - 0.8050352931022644, - -0.6476027965545654 + 230.81945234537125, + 224.8626189827919, + 5.3906145095825195, + 0.3347291946411133, + 0.22713875770568848, + -0.06444251537322998 ], [ - 341.14056123793125, - 317.8057948499918, - -0.4150514602661133, - -1.2889974117279053, - 1.281440258026123, - -0.3736797273159027 + 232.18228441476822, + 224.8626189827919, + 5.3906145095825195, + 0.3347291946411133, + 0.22713875770568848, + -0.06444251537322998 ], [ - 332.8875829577446, - 330.78175562620163, - 1.1426564455032349, - -0.5442644357681274, - -2.3491456508636475, - 0.1292353868484497 + 233.41182553768158, + 218.31597769260406, + 0.35965001583099365, + 1.197317123413086, + -1.1293777227401733, + -1.1000134944915771 ], [ - 712.8440843224525, - 630.302704513073, - -1.2033538818359375, - 0.6265941262245178, - -2.055356979370117, - 0.23139822483062744 + 148.39162427186966, + 106.62211829423904, + 0.03068673610687256, + 0.09539532661437988, + -0.47842979431152344, + -0.462985634803772 ], [ - 659.6967459321022, - 590.584341943264, - 0.7254352569580078, - -1.2573022842407227, - 2.197282314300537, - 1.9233837127685547 + 245.6610078215599, + 98.33350950479507, + -0.26952099800109863, + -0.19012248516082764, + 1.4764792919158936, + -0.32550323009490967 ], [ - 577.5527169704437, - 542.9537179470062, - -0.01964402198791504, - -0.05793309211730957, - 5.771877288818359, - 0.48503339290618896 - ], - [ - 1237.2817437648773, - 1226.2430627346039, - 0.28566765785217285, - 1.8477199077606201, - -5.391575336456299, - 0.941411018371582 - ], - [ - 1241.1228246688843, - 1213.2713706493378, - 0.2540316581726074, - -2.027486562728882, - -1.540087342262268, - 1.8781726360321045 - ], - [ - 1246.9417842626572, - 1099.2095458507538, - 0.2269577980041504, - -0.40735840797424316, - 0.8068182468414307, - 1.4334988594055176 - ], - [ - 1154.9186086654663, - 1088.1004952192307, - -0.26997601985931396, - 0.1393885612487793, - -3.4403371810913086, - 0.20603835582733154 - ], - [ - 1082.5348316431046, - 1072.6468831300735, - 0.11066305637359619, - -0.05033266544342041, - -0.9682888388633728, - -0.4501892328262329 - ], - [ - 1330.8443789482117, - 1320.8362548351288, - -0.04307115077972412, - 0.9399316310882568, - -0.527582585811615, - -0.7627354860305786 - ], - [ - 1326.5587750673294, - 1299.9582016468048, - 0.9590237140655518, - 0.3115323781967163, - -3.1760473251342773, - 1.5994620323181152 - ], - [ - 1161.1925387382507, - 1153.133340716362, - -0.08445072174072266, - -0.011340498924255371, - 0.7437705993652344, - -0.0006668567657470703 - ], - [ - 1149.277049422264, - 1147.313728928566, - -0.7485276460647583, - -0.6065174341201782, - 2.659425973892212, - 0.015801548957824707 - ], - [ - 1213.437897324562, - 1196.1278299093246, - -0.04448568820953369, - 0.5285284519195557, - 1.0576950311660767, - -0.7774084806442261 - ], - [ - 330.9513193964958, - 297.9802319407463, - -0.323108434677124, - -0.6237986087799072, - 2.258716583251953, - -0.21225571632385254 - ], - [ - 536.0556625425816, - 506.14273777604103, - 0.31564009189605713, - 0.39138808846473694, - -5.163415908813477, - 0.7835062146186829 - ], - [ - 512.0620410144329, - 509.16740986704826, - 0.2834511995315552, - -0.17493581771850586, - -0.9028503894805908, - 0.16018342971801758 - ], - [ - 448.51154044270515, - 441.08003571629524, - 0.0718390941619873, - 0.236688494682312, - -4.851255416870117, - -0.3110882043838501 - ], - [ - 406.2205645740032, - 361.67308816313744, - 0.09113931655883789, - -0.42406535148620605, - -0.21634411811828613, - 0.28481805324554443 - ], - [ - 285.96104231476784, - 255.81826904416084, - -0.411960244178772, - -0.40056121349334717, - 4.246186256408691, - -0.9286206960678101 - ], - [ - 546.4992916435003, - 493.50320969522, - 0.281110554933548, - -0.39116430282592773, - 0.08857545256614685, - 0.40661656856536865 - ], - [ - 491.2471744865179, - 489.42756305634975, - -0.00993424654006958, - -0.4921175241470337, - -1.1643989086151123, - -0.15346300601959229 - ], - [ - 511.6716139167547, - 507.36118207871914, - -0.7582223415374756, - -0.2180694341659546, - -0.13481241464614868, - 0.09306275844573975 - ], - [ - 386.6816099733114, - 310.118008479476, - -0.26031744480133057, - -0.4900439977645874, - -1.0878667831420898, - 0.07257795333862305 - ], - [ - 253.56987443566322, - 239.5443414747715, - -0.32273411750793457, - -0.3048008680343628, - 0.9438730478286743, - -0.35787200927734375 - ], - [ - 505.46117144823074, - 437.4643825888634, - 0.7896569967269897, - 0.2585862874984741, - -1.621761441230774, - -0.5738904476165771 - ], - [ - 449.5876085162163, - 417.2840823531151, - 0.0809178352355957, - -0.10232794284820557, - 4.132901191711426, - -0.11136782169342041 - ], - [ - 524.5276002287865, - 434.30917233228683, - -0.5067455768585205, - -0.03432774543762207, - -1.0170711278915405, - -1.0980607271194458 - ], - [ - 304.41231459379196, - 217.74276226758957, - -0.10338020324707031, - -0.11517202854156494, - -0.06354892253875732, - 1.3602665662765503 - ], - [ - 439.8023081421852, - 309.1407307982445, - 0.3117513656616211, - 0.06860756874084473, - 0.3517138957977295, - 0.1676257848739624 - ], - [ - 463.4370996132493, - 410.64176098257303, - -0.33307743072509766, - 0.28580403327941895, - -4.9158124923706055, - -1.5446724891662598 - ], - [ - 504.81983137875795, - 474.1135616376996, - -0.7749050259590149, - -0.1494460105895996, - -3.0760133266448975, - 0.6442000865936279 + 150.77250838279724, + 75.29946810007095, + -0.16319847106933594, + 0.46047377586364746, + -0.026409029960632324, + -0.5883064270019531 ], [ - 744.5144279077649, - 693.3376424387097, - -0.23845341801643372, - -0.1162574291229248, - 0.7020441293716431, - -0.5778297781944275 + 376.89122742414474, + 33.44520962238312, + -0.4075583219528198, + -0.08236527442932129, + 1.3664050102233887, + 0.30290937423706055 ], [ - 742.9534775093198, - 633.6948682144284, - -0.3027532696723938, - -0.4881715774536133, - -0.2344352900981903, - 0.3046071529388428 - ], + 444.9628998041153, + 0, + NaN, + NaN, + NaN, + NaN + ] + ], + [ [ - 411.2304784208536, - 254.86773981153965, - 0.3701070547103882, - 0.21142053604125977, - 0.2701907157897949, - 0.7664796113967896 + 72.2456042766571, + 59.06572461128235, + -0.22719597816467285, + -0.47536635398864746, + 0.8639277815818787, + 0.7764732837677002 ], [ - 452.51901914179325, - 239.05078710615635, - -0.812308669090271, - -0.15795576572418213, - -4.8262529373168945, - 0.20534741878509521 + 50.22136551141739, + 20.470713138580322, + -0.23022526502609253, + 0.6774135828018188, + -0.7766646146774292, + -0.6992179155349731 ], [ - 481.8575470596552, - 294.52743877470493, - -1.2115097045898438, - 0.27341747283935547, - 3.2677388191223145, - -0.1858605146408081 - ], + 81.19914650917053, + 0, + NaN, + NaN, + NaN, + NaN + ] + ], + [ [ - 339.869593039155, - 283.4148928076029, - -0.3123602271080017, - 0.668095052242279, - -3.172121047973633, - -0.18362689018249512 + 84.11102020740509, + 69.41187500953674, + 0.3717796504497528, + -0.1665174961090088, + -1.3758314847946167, + -1.1515417098999023 ], [ - 343.5693847090006, - 279.3701678663492, - 1.1298609972000122, - -0.6351744532585144, - -3.0982165336608887, - 1.1378037929534912 + 110.07177996635437, + 33.85714316368103, + 0.35795435309410095, + 0.8591107726097107, + -0.979204535484314, + -0.7297892570495605 ], [ - 280.5856255441904, - 216.19232000410557, - 1.1611676216125488, - -0.46498870849609375, - 3.3051581382751465, - 0.10467886924743652 + 111.95093750953674, + 22.643285810947418, + 0.5289139747619629, + -0.26415038108825684, + -1.2796070575714111, + -0.08773636817932129 ], [ - 333.4087043404579, - 311.4097766280174, - -0.19609379768371582, - -0.4466681480407715, - -2.134889602661133, - 0.3255305290222168 + 135.23777049779892, + 15.699183404445648, + 0.5204403400421143, + -1.4032387733459473, + -1.1998522281646729, + 1.5046007633209229 ], [ - 505.0792779326439, - 495.0857512354851, - -2.7991626262664795, - 1.6007640361785889, - -3.2649552822113037, - -0.19291400909423828 - ], + 213.82325011491776, + 0, + NaN, + NaN, + NaN, + NaN + ] + ], + [ [ - 1207.4347109794617, - 1035.8786796331406, - -0.7741373181343079, - 0.12536799907684326, - 3.139136791229248, - -0.8887691497802734 + 66.89137238264084, + 21.836929082870483, + -0.9248316287994385, + -0.8310908079147339, + 2.4072179794311523, + 0.39566969871520996 ], [ - 1167.39683842659, - 975.4905508756638, - -0.3818192481994629, - -0.15393340587615967, - 1.2431955337524414, - 0.3615773916244507 + 118.18798178434372, + 20.19943106174469, + -0.12483343482017517, + -0.31730806827545166, + 0.34404516220092773, + 0.9239671230316162 ], [ - 1135.804107785225, - 972.7882989645004, - -0.6661558747291565, - -0.08356666564941406, - 3.0764517784118652, - -0.5893446207046509 - ], + 142.4676097035408, + 0, + NaN, + NaN, + NaN, + NaN + ] + ], + [ [ - 1338.5253624916077, - 1268.9782551527023, - 0.06809753179550171, - 0.10750234127044678, - -1.6390962600708008, - -1.090397834777832 + 44.37714385986328, + 38.24695086479187, + 0.12432551383972168, + 1.591630458831787, + -5.294160842895508, + -1.1023013591766357 ], [ - 1250.8296763896942, - 1250.0863655805588, - 0.4822995066642761, - -0.15399408340454102, - 1.1549112796783447, - -0.06375455856323242 + 28.54021382331848, + 21.25880318880081, + 0.05682194232940674, + 0.2225041389465332, + 0.1521090269088745, + 0.036199092864990234 ], [ - 1201.772768855095, - 1119.6034734249115, - 0.4709078073501587, - 0.07164812088012695, - 4.386058807373047, - -0.3478360176086426 + 48.9872065782547, + 31.529403746128082, + 0.7658979892730713, + -0.0608752965927124, + 4.620903968811035, + -0.3677207827568054 ], [ - 1206.9717539548874, - 1168.757693886757, - -0.24715948104858398, - -0.25804567337036133, - -4.846056938171387, - -0.8275249004364014 + 37.087240397930145, + 5.02096688747406, + 0.06502676010131836, + -0.6435762643814087, + -1.624915361404419, + 0.2976648807525635 ], [ - 523.8271051347256, - 445.4762599170208, - -0.12939918041229248, - 0.16483473777770996, - -0.06283378601074219, - -1.2729331254959106 - ], + 54.37259578704834, + 0, + NaN, + NaN, + NaN, + NaN + ] + ], + [ [ - 489.234316021204, - 403.9384836256504, - -0.12605595588684082, - -0.2118680477142334, - -0.7448382377624512, - -0.18331170082092285 + 176.18674612045288, + 43.43481993675232, + 0.2355484962463379, + -0.35823583602905273, + 4.983081817626953, + 0.544741153717041 ], [ - 406.77224096655846, - 210.6119331419468, - -0.25264763832092285, - -0.06586050987243652, - 0.9708173274993896, - -0.35116755962371826 + 138.93788081407547, + 30.439549565315247, + -0.17574119567871094, + 0.249129056930542, + 0.775327205657959, + -0.08188307285308838 ], [ - 522.6349979490042, - 485.828329667449, - 0.10555094480514526, - 0.5007915496826172, - 0.8971192240715027, - -0.27347469329833984 + 133.23228877782822, + 21.987082839012146, + -0.017199993133544922, + 0.000544428825378418, + 1.9876739978790283, + 0.8526766300201416 ], [ - 372.13186794519424, - 328.75505274534225, - 1.2654435634613037, - 1.3434795141220093, - 4.22633171081543, - -0.2576329708099365 + 143.35193115472794, + 47.03661274909973, + -0.7615440487861633, + -0.43014848232269287, + 1.8479251861572266, + 1.1096972227096558 ], [ - 529.8648141026497, - 323.87332314252853, - -1.5498071908950806, - 0.736019492149353, - -3.15006947517395, - -1.1594338417053223 + 79.97001737356186, + 20.965715408325195, + -0.46784329414367676, + 0.9772166013717651, + -0.4411565661430359, + -1.0391178131103516 ], [ - 595.7609773948789, - 444.7416764572263, - -0.07209694385528564, - -0.15704381465911865, - -0.9267933368682861, - 0.5723998546600342 + 147.88678711652756, + 86.89016622304916, + -0.0009177923202514648, + -0.09192109107971191, + -0.8409171104431152, + 0.5593113899230957 ], [ - 672.1536797359586, - 423.29223669320345, - 0.36229491233825684, - -0.7251378297805786, - 1.147707223892212, - 0.028244376182556152 + 153.6545004248619, + 21.672676980495453, + 0.5867823362350464, + -0.04882550239562988, + 3.3548412322998047, + -0.16812491416931152 ], [ - 385.1935703828931, - 366.20057464390993, - -0.38830530643463135, - -0.6420385241508484, - 2.6253175735473633, - 1.3204622268676758 + 108.86449658870697, + 64.82152760028839, + 0.5701639652252197, + -0.32665538787841797, + 5.032402992248535, + -0.6722074151039124 ], [ - 619.2985356003046, - 209.4487675577402, - 0.017409324645996094, - -0.2414720058441162, - -4.161455154418945, - 0.6856579780578613 + 119.12391728162766, + 98.12603759765625, + 0.5060263872146606, + -0.6781753301620483, + -1.087803602218628, + 0.8182147741317749 ], [ - 1220.7848707437515, - 1063.484298825264, - -0.13229727745056152, - 0.2528233528137207, - 4.63056755065918, - -0.6138623952865601 + 115.00392335653305, + 89.66676431894302, + 0.148756742477417, + -0.007477164268493652, + 0.9419937133789062, + -1.1371755599975586 ], [ - 538.1290606558323, - 171.80048814415932, - -0.03301525115966797, - 0.17964506149291992, - 4.677309989929199, - -0.19953429698944092 + 107.24125277996063, + 93.00947052240372, + -4.619806289672852, + 1.1005070209503174, + -0.3160839080810547, + -0.7212274074554443 ], [ - 557.4273832887411, - 424.3069122880697, - -0.012624204158782959, - 0.017889022827148438, - 0.8110083937644958, - 0.31941545009613037 + 128.907168507576, + 44.549468994140625, + -0.5933791399002075, + 0.8483631610870361, + 1.7678580284118652, + -1.061244249343872 ], [ - 407.6094107031822, - 192.4009820818901, - -0.9037628173828125, - -0.020832419395446777, - 1.9167841672897339, - -0.34120869636535645 + 111.77084845304489, + 28.975962698459625, + -0.7289518117904663, + -0.23721611499786377, + -4.8148980140686035, + 0.40409648418426514 ], [ - 453.5709282755852, - 189.12252324819565, - 0.8855904340744019, - 0.11572325229644775, - -2.1486358642578125, - -0.048367857933044434 + 130.01863545179367, + 14.322330832481384, + -0.14277911186218262, + -0.9099459648132324, + -4.649206161499023, + 1.3262591361999512 ], [ - 538.7945826426148, - 309.05075634270906, - -0.270033597946167, - 0.3122434616088867, - -3.8341968059539795, - -0.5259748697280884 + 153.43824982643127, + 7.123000621795654, + 0.48526978492736816, + 0.5985463857650757, + -1.3093960285186768, + -1.123914122581482 ], [ - 384.95306903868914, - 303.43503005057573, - -0.11096477508544922, - -0.42187047004699707, - -1.635056734085083, - -0.6621150970458984 + 187.5597729086876, + 5.280042052268982, + -0.25231218338012695, + -1.2801045179367065, + -4.306180477142334, + 0.16622376441955566 ], [ - 1088.6029832363129, - 977.3188534975052, - -0.26398468017578125, - -0.7205466032028198, - -4.064508438110352, - 0.9245483875274658 - ], - [ - 436.9545448869467, - 333.1420448869467, - 0.14156994223594666, - -0.607445478439331, - -0.7924558520317078, - 0.20295202732086182 - ], - [ - 558.1829724162817, - 333.1420448869467, - 0.14156994223594666, - -0.607445478439331, - -0.7924558520317078, - 0.20295202732086182 - ], - [ - 420.6231018155813, - 287.85812126100063, - -0.32483217120170593, - 0.06547045707702637, - -0.3822765350341797, - 0.15304875373840332 - ], - [ - 344.5803770124912, - 284.8747070133686, - 0.250479519367218, - -1.553009033203125, - 0.4336937367916107, - 1.1547245979309082 - ], - [ - 288.3604076206684, - 243.27550747990608, - -0.7282581329345703, - 0.07996654510498047, - -2.8481998443603516, - -0.7275570631027222 - ], - [ - 403.0813057720661, - 243.27550747990608, - -0.7282581329345703, - 0.07996654510498047, - -2.8481998443603516, - -0.7275570631027222 - ], - [ - 269.64356461167336, - 228.96951213479042, - 0.4197250008583069, - 0.059418678283691406, - -2.2036654949188232, - -0.6322793960571289 - ], - [ - 529.3427245020866, - 254.39769023656845, - 0.09240150451660156, - 0.21433758735656738, - -1.200314998626709, - -0.947068452835083 - ], - [ - 1288.9329624772072, - 970.5552941560745, - -0.4528627395629883, - -0.504736065864563, - -1.8033961057662964, - 0.04539179801940918 - ], - [ - 225.1044843494892, - 161.1487036049366, - 0.8957173824310303, - 0.21791481971740723, - -2.5683956146240234, - -0.023125410079956055 - ], - [ - 409.4956251382828, - 193.2449667453766, - 0.1368027925491333, - 0.3341562747955322, - 4.540215969085693, - 0.46527671813964844 - ], - [ - 1317.2449485063553, - 945.037259221077, - -0.5198729038238525, - -0.028039932250976562, - 3.384089946746826, - 0.4992135763168335 - ], - [ - 606.3041869699955, - 85.16004970669746, - -0.20531070232391357, - 0.4385908842086792, - 3.7252230644226074, - 0.042945146560668945 - ], - [ - 536.6020142436028, - 178.17844343185425, - 0.05603320896625519, - 0.3782665729522705, - -1.5141615867614746, - -0.2546658515930176 - ], - [ - 745.7912800312042, - 495.0275366306305, - -2.35388445854187, - 0.45787644386291504, - -2.647423028945923, - 0.20815563201904297 - ], - [ - 716.8663714528084, - 460.0534674525261, - -0.007689952850341797, - -1.0955625772476196, - 0.9894769191741943, - -0.9086135625839233 - ], - [ - 456.0470775961876, - 442.9488200545311, - 5.139568328857422, - 0.9967501163482666, - 0.9419887065887451, - -1.2761722803115845 - ], - [ - 358.40972417593, - 271.36242431402206, - -0.37357473373413086, - -0.19354677200317383, - -5.611996650695801, - -0.9128594398498535 - ], - [ - 286.96299093961716, - 243.98135417699814, - -0.2286221981048584, - 0.15703296661376953, - -1.1040807962417603, - -1.21611750125885 - ], - [ - 378.96382945775986, - 243.98135417699814, - -0.2286221981048584, - 0.15703296661376953, - -1.1040807962417603, - -1.21611750125885 - ], - [ - 676.6378134042025, - 174.37069338560104, - 5.87470817565918, - -0.7370781898498535, - 0.33743977546691895, - 0.763629674911499 - ], - [ - 764.9826234653592, - 86.26955485343933, - 0.11350247263908386, - 0.06860315799713135, - -2.8641035556793213, - 1.2456836700439453 - ], - [ - 649.0219939798117, - 81.81765568256378, - 0.00759202241897583, - -0.160802960395813, - -1.2374593019485474, - 0.6389224529266357 - ], - [ - 1382.9450635910034, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 320.3464569747448, - 312.8800956904888, - -5.107377529144287, - -1.1473329067230225, - -0.17608284950256348, - -0.31628185510635376 - ], - [ - 273.83666238188744, - 205.67351964116096, - 0.754423975944519, - -0.2705498933792114, - -2.4659018516540527, - 0.92705237865448 - ], - [ - 562.1967021524906, - 519.5781470835209, - 0.11833453178405762, - 0.49973583221435547, - -0.4897525906562805, - -0.8269169330596924 - ], - [ - 554.8353033661842, - 533.8870105147362, - -0.09026670455932617, - 0.13237524032592773, - 5.382619380950928, - -0.964556097984314 - ], - [ - 494.4641035795212, - 456.243500828743, - 0.06076765060424805, - 0.6302964687347412, - 4.996323585510254, - 0.4667534828186035 - ], - [ - 446.33694928884506, - 416.1738634109497, - -5.060272693634033, - -0.4810500144958496, - -0.8750579357147217, - 0.9501380920410156 - ], - [ - 299.5315877199173, - 231.48046299815178, - -0.002225637435913086, - 1.1405787467956543, - -4.531327247619629, - -1.8515856266021729 - ], - [ - 273.11859384179115, - 205.50657132267952, - -0.5817697048187256, - 0.7180514931678772, - 1.4914058446884155, - -0.528008759021759 - ], - [ - 585.851346373558, - 571.1616952419281, - 0.2893420457839966, - -0.10520976781845093, - -0.9443706274032593, - -0.07954573631286621 - ], - [ - 306.58141899108887, - 282.03421771526337, - 0.36527812480926514, - -0.1337440013885498, - 2.6584715843200684, - -0.41457700729370117 - ], - [ - 392.5217110514641, - 355.2770085930824, - -0.6584032773971558, - -0.05862891674041748, - 1.3515360355377197, - 0.8760770559310913 - ], - [ - 845.2809689044952, - 840.1326499581337, - -0.03219103813171387, - 0.567402184009552, - 0.537311315536499, - -0.23481690883636475 - ], - [ - 890.7013285756111, - 833.9982312321663, - 0.443426251411438, - -0.8665639758110046, - 0.276688814163208, - 1.2458157539367676 - ], - [ - 812.8720337748528, - 806.4785344004631, - -1.359341025352478, - 0.5086686611175537, - -4.014031887054443, - -0.6510103940963745 - ], - [ - 572.9515442848206, - 556.4453747868538, - 1.2256730794906616, - -0.33808743953704834, - 4.483767032623291, - -0.0753781795501709 - ], - [ - 505.10947251319885, - 492.20502722263336, - -0.023506879806518555, - -0.06028163433074951, - 5.677853584289551, - -0.0916205644607544 - ], - [ - 503.03195852041245, - 484.90466022491455, - 0.3559532165527344, - -0.2355656623840332, - 0.8704935312271118, - 0.2772397994995117 - ], - [ - 520.9930582642555, - 513.6256061196327, - 4.034934043884277, - 0.18383875489234924, - 1.242362141609192, - 0.22955432534217834 - ], - [ - 467.6294862627983, - 462.6310903429985, - -5.397040367126465, - -0.5732532143592834, - -0.0824894905090332, - 1.3090171813964844 - ], - [ - 443.2171590477228, - 375.2113288193941, - 0.8381065130233765, - 0.3630943298339844, - -3.625174045562744, - -0.9038658142089844 - ], - [ - 901.2466291189194, - 891.0937949419022, - -0.04304635524749756, - 0.15884685516357422, - -0.7646319270133972, - -0.18069350719451904 - ], - [ - 904.2390102148056, - 883.1796106696129, - -0.533449649810791, - 0.7491567134857178, - 1.5187758207321167, - -0.612513542175293 - ], - [ - 509.57519076764584, - 501.4014223664999, - -0.12575095891952515, - 0.09796029329299927, - 2.5484280586242676, - 0.6821891069412231 - ], - [ - 444.27020750939846, - 435.59934101998806, - -0.5187702178955078, - 0.3887614607810974, - -0.5200493335723877, - 1.0738255977630615 - ], - [ - 362.21130584180355, - 348.5810320228338, - 0.01580333709716797, - 0.3101426362991333, - 2.1951022148132324, - 0.5036535263061523 - ], - [ - 703.9301252961159, - 597.1940866112709, - 4.473799705505371, - 0.28486642241477966, - 0.9092385768890381, - 0.12856972217559814 - ], - [ - 642.4737839698792, - 628.562950015068, - -1.3676097393035889, - 1.0253013372421265, - -0.029550552368164062, - -1.197189450263977 - ], - [ - 536.9837630987167, - 509.43430787324905, - 0.5389299392700195, - 1.0132337808609009, - -1.1472400426864624, - -1.055070161819458 - ], - [ - 362.66158071160316, - 352.46830835938454, - -0.1721898317337036, - -0.4464971423149109, - -0.2942624092102051, - -0.046103060245513916 - ], - [ - 656.2402014732361, - 613.9543146491051, - -0.04403078556060791, - 0.14354705810546875, - 0.13154816627502441, - -0.7997232675552368 - ], - [ - 677.9811907708645, - 663.3935803472996, - 0.11724638938903809, - 0.6455438137054443, - -0.2624102830886841, - -0.12325811386108398 - ], - [ - 703.7304964065552, - 656.1149581372738, - -0.1772019863128662, - -0.30472785234451294, - -2.006072998046875, - -0.020757198333740234 - ], - [ - 594.6949522197247, - 582.6366399228573, - -0.2529144287109375, - -0.23423010110855103, - 0.5134745836257935, - 1.112865924835205 - ], - [ - 509.0212150812149, - 500.2984557747841, - -0.1947118043899536, - 0.9427560567855835, - 4.992748737335205, - -0.8904646039009094 - ], - [ - 536.396862924099, - 495.0316031575203, - 0.4269890785217285, - -0.16871732473373413, - -1.87299382686615, - -0.20498782396316528 - ], - [ - 502.97176653146744, - 489.75214076042175, - -0.7729141712188721, - 1.8195408582687378, - -0.006287872791290283, - -1.4698379039764404 - ], - [ - 586.4416650757194, - 544.6446471437812, - -0.06072187423706055, - 0.27334827184677124, - -1.1635090112686157, - -0.41077226400375366 - ], - [ - 591.0120231583714, - 488.6886534616351, - -0.7576846480369568, - 1.1240260601043701, - 2.677934169769287, - -1.8263847827911377 - ], - [ - 470.07882160693407, - 462.49043453484774, - 0.04785871505737305, - -0.4719064235687256, - 1.3529880046844482, - -0.4384195804595947 - ], - [ - 485.49106577038765, - 478.33815255761147, - 0.10837197303771973, - 0.36653125286102295, - -0.5206942558288574, - -0.7427181005477905 - ], - [ - 342.0540819466114, - 334.1646640598774, - -0.027652740478515625, - 0.39720892906188965, - -0.4610757827758789, - -1.1105496883392334 - ], - [ - 405.41985979676247, - 392.42167672514915, - -0.050931453704833984, - 0.27894651889801025, - -4.543083190917969, - -1.5881189107894897 - ], - [ - 594.9674071967602, - 590.4756289422512, - 0.11196517944335938, - -0.018851518630981445, - 1.289534568786621, - 0.2430657148361206 - ], - [ - 565.1406097412109, - 556.6664479970932, - -4.352602005004883, - 1.0919770002365112, - -1.2929354906082153, - 0.23965203762054443 - ], - [ - 600.1461707353592, - 538.5948777198792, - 0.03950858116149902, - -0.1410306692123413, - -0.33491039276123047, - -0.6306273937225342 - ], - [ - 436.8815557062626, - 412.41330364346504, - -0.2670772075653076, - -0.7776139974594116, - 5.51232385635376, - 0.7928510904312134 - ], - [ - 310.2755993902683, - 297.7873822748661, - -0.0803835391998291, - -0.1478126049041748, - 1.4072415828704834, - -0.12383651733398438 - ], - [ - 532.7295295596123, - 513.4996159672737, - 0.11623668670654297, - 0.20304560661315918, - -0.25636565685272217, - 0.3543708324432373 - ], - [ - 516.5118299126625, - 499.0560172200203, - -0.018142104148864746, - -0.7833807468414307, - -0.8557678461074829, - -0.33608710765838623 - ], - [ - 298.24267715215683, - 290.0253981947899, - 1.0345361232757568, - 0.05056476593017578, - -5.148209095001221, - -1.2784479856491089 - ], - [ - 543.7829799950123, - 489.7655251324177, - 0.17055153846740723, - 0.8553866147994995, - 6.023222923278809, - -0.9072554707527161 - ], - [ - 372.7175350189209, - 350.6302925348282, - -1.635932207107544, - 1.0338164567947388, - -3.9592719078063965, - -1.4678726196289062 - ], - [ - 361.30132138729095, - 297.74939900636673, - 0.019849300384521484, - -0.3910808563232422, - -1.3059635162353516, - 1.1705931425094604 - ], - [ - 307.2927964925766, - 279.7945621609688, - -0.061165809631347656, - 0.02742946147918701, - 0.22481608390808105, - -0.39707159996032715 - ], - [ - 811.8773409426212, - 756.8151675760746, - 1.1993250846862793, - -0.33489853143692017, - 0.671198844909668, - 1.1470541954040527 - ], - [ - 824.9439314305782, - 770.2611808478832, - 0.22420954704284668, - 0.5312252044677734, - 0.6101512908935547, - -0.5232303738594055 - ], - [ - 819.0477968156338, - 812.4576264321804, - 0.4474886655807495, - -0.37633204460144043, - 0.5757046937942505, - -0.42168086767196655 - ], - [ - 684.3750420808792, - 676.8824261426926, - 0.029855847358703613, - -0.10791134834289551, - 3.747415542602539, - 1.608600378036499 - ], - [ - 680.1656913161278, - 534.4634956121445, - 0.04093453288078308, - -0.2880604863166809, - -0.5943617820739746, - 0.9271889328956604 - ], - [ - 532.8960741758347, - 527.9619092941284, - 0.2651550769805908, - -0.43554258346557617, - -1.805037260055542, - 1.068558692932129 - ], - [ - 556.6898472011089, - 423.39235281944275, - 0.11129692941904068, - 0.13991129398345947, - 0.9909278750419617, - -1.3364601135253906 - ], - [ - 390.0802319049835, - 385.12963968515396, - 0.02774141915142536, - -0.1164546012878418, - -1.128602385520935, - 0.020031094551086426 - ], - [ - 339.20814311504364, - 332.67198717594147, - -0.5640588998794556, - 1.2914249897003174, - -0.29561471939086914, - -1.2582833766937256 - ], - [ - 336.9299746751785, - 326.6454519033432, - -0.030564308166503906, - 0.15578055381774902, - 1.3146982192993164, - -0.9078660011291504 - ], - [ - 333.6278060078621, - 316.1319270133972, - -0.08822394907474518, - -0.29916125535964966, - 0.6429253816604614, - 0.9649935364723206 - ], - [ - 317.71212288737297, - 310.2992636859417, - -5.465391159057617, - -0.4779726266860962, - -0.3804452419281006, - 1.3179168701171875 - ], - [ - 300.22669246792793, - 288.40954354405403, - 0.23598432540893555, - -0.9510177373886108, - -0.5872988700866699, - 0.8295367956161499 - ], - [ - 476.10570192337036, - 458.7086236476898, - -5.146993637084961, - 1.2638994455337524, - -0.48028564453125, - -0.44745707511901855 - ], - [ - 283.127902507782, - 223.0388627052307, - -0.2123889923095703, - 0.22208166122436523, - 0.6201012134552002, - -0.4055604934692383 - ], - [ - 329.06014573574066, - 305.46025371551514, - 0.036249637603759766, - -0.3254518508911133, - 4.956445217132568, - 0.15610623359680176 - ], - [ - 263.8231199979782, - 240.56853330135345, - -0.019487380981445312, - 0.11257457733154297, - -0.5425256490707397, - -0.4408383369445801 - ], - [ - 455.60105642676353, - 435.7141250669956, - -0.03681230545043945, - 0.6183809041976929, - -0.3877429962158203, - -0.12994933128356934 - ], - [ - 420.9566167294979, - 406.5592941939831, - -0.3773375451564789, - 0.4121124744415283, - -2.322108268737793, - -1.3184843063354492 - ], - [ - 430.2689261138439, - 391.509185642004, - -0.04487895220518112, - -0.043259620666503906, - 0.3666713237762451, - 0.8513878583908081 - ], - [ - 288.05452701449394, - 283.31949660182, - -0.09230554103851318, - 0.0512242317199707, - -0.8728966116905212, - -0.9893016815185547 - ], - [ - 337.4359505325556, - 295.8237657248974, - 0.21932291984558105, - 0.3719440698623657, - -0.6703360080718994, - 0.02317047119140625 - ], - [ - 366.7719793021679, - 338.24975940585136, - -1.0730972290039062, - -0.5015574097633362, - 2.7137532234191895, - 0.8058267831802368 - ], - [ - 369.3227424919605, - 335.9236018359661, - -0.23302659392356873, - -0.13678157329559326, - -1.2225770950317383, - -0.45872098207473755 - ], - [ - 333.93554696440697, - 285.1927603185177, - 0.4681313633918762, - 0.4044250249862671, - -1.8258031606674194, - -0.45158636569976807 - ], - [ - 215.14788708090782, - 182.48132106661797, - 0.12448066473007202, - 0.4419472813606262, - -2.9645016193389893, - -0.8564066290855408 - ], - [ - 437.41756895184517, - 279.57405230402946, - 0.16560769081115723, - 0.4457952380180359, - 5.4883246421813965, - 0.4236034154891968 - ], - [ - 420.491332501173, - 187.30364832282066, - 0.7704950571060181, - -0.4501793384552002, - -2.1371636390686035, - 0.0974244475364685 - ], - [ - 278.56224822998047, - 185.31965926289558, - 0.22443699836730957, - -0.6723436117172241, - 0.07637906074523926, - 0.22660672664642334 - ], - [ - 611.6889958530664, - 557.6222232729197, - -0.05518350005149841, - -0.3526870012283325, - -0.04796242713928223, - 1.0795725584030151 - ], - [ - 525.4925582259893, - 502.6770264953375, - -0.166950523853302, - -0.13059020042419434, - -0.005825638771057129, - 0.6808124780654907 - ], - [ - 531.333074554801, - 481.1883826106787, - -0.03580266237258911, - -0.22152721881866455, - 0.45391207933425903, - 0.0239410400390625 - ], - [ - 682.9499835669994, - 678.6794438064098, - -0.1588151454925537, - 1.4608007669448853, - 1.4288513660430908, - -1.5553327798843384 - ], - [ - 746.6456324756145, - 648.2389428913593, - -0.10385773330926895, - -0.37840723991394043, - -1.0841870307922363, - -0.7673598527908325 - ], - [ - 636.0059399902821, - 630.2587849199772, - 0.3203558027744293, - 0.12082433700561523, - 1.5124356746673584, - -0.45213866233825684 - ], - [ - 565.3150130212307, - 553.9432717263699, - 0.05454146862030029, - 0.05360567569732666, - -0.6293324828147888, - -0.09754586219787598 - ], - [ - 445.70317700505257, - 436.6249612867832, - 0.18865644931793213, - 0.033087849617004395, - -1.487210988998413, - 0.2945793867111206 - ], - [ - 401.40692111849785, - 394.17862489819527, - -0.2163836807012558, - 0.12056756019592285, - -1.396072506904602, - -0.8094987869262695 - ], - [ - 377.0609104335308, - 373.5440556704998, - -0.6724022626876831, - -0.09867089986801147, - -0.05707120895385742, - 1.1748559474945068 - ], - [ - 524.3542577326298, - 516.9022450745106, - 0.4246804118156433, - 0.31155693531036377, - -0.997633695602417, - 0.11777281761169434 - ], - [ - 529.7752377092838, - 498.6109965145588, - 0.141877219080925, - -0.5780361294746399, - 0.23730923235416412, - 1.2374131679534912 - ], - [ - 496.6440621316433, - 487.25287160277367, - -0.17437861859798431, - -0.544419527053833, - -0.6395970582962036, - -0.5280840396881104 - ], - [ - 467.47288593649864, - 462.37153324484825, - -0.33149465918540955, - -0.02524280548095703, - -0.1623561680316925, - 0.166051983833313 - ], - [ - 302.73261511325836, - 287.90786385536194, - -0.6949591636657715, - -0.25949156284332275, - -5.2384138107299805, - -0.2741647958755493 - ], - [ - 419.2388049066067, - 262.06746247410774, - -1.9993066787719727, - -0.5872381925582886, - -3.795130968093872, - 0.4630012512207031 - ], - [ - 330.36129528284073, - 232.8944917023182, - -0.8330996036529541, - -0.2574196457862854, - 5.972322463989258, - 0.49082666635513306 - ], - [ - 250.96090379357338, - 171.4908383190632, - -0.5257514715194702, - 0.5505855083465576, - -3.7318387031555176, - 0.30981874465942383 - ], - [ - 272.22547349333763, - 257.5730523765087, - 0.9568884372711182, - 0.37945854663848877, - -2.6137211322784424, - 0.4444441795349121 - ], - [ - 383.22921484708786, - 334.4846359491348, - -5.5164642333984375, - 0.08372759819030762, - -0.02308797836303711, - -0.30536091327667236 - ], - [ - 364.9861871600151, - 297.3220666050911, - 0.07955622673034668, - 0.1935194730758667, - -1.0182501077651978, - -0.25470495223999023 - ], - [ - 536.5194078087807, - 474.80888402462006, - 0.03780508041381836, - -0.10720175504684448, - -5.913273811340332, - 0.5160459280014038 - ], - [ - 604.020510405302, - 416.68431693315506, - -0.15678763389587402, - -0.8756027817726135, - -0.11988401412963867, - 1.4353904724121094 - ], - [ - 827.5006309747696, - 720.7646347880363, - 0.4194881319999695, - 0.2602057456970215, - 0.02855086326599121, - -0.4338364601135254 - ], - [ - 766.044330984354, - 752.1334886848927, - -0.11082909256219864, - 0.1716686487197876, - 1.2994353771209717, - 0.3187674283981323 - ], - [ - 728.0854970216751, - 688.3291877508163, - -0.48276567459106445, - 0.5263398885726929, - -5.432369232177734, - -0.7359595894813538 - ], - [ - 649.3336458802223, - 565.0314924120903, - -0.3012681007385254, - 0.3047950267791748, - -1.2371430397033691, - -1.3149114847183228 - ], - [ - 718.6711642444134, - 634.2495162189007, - 0.3238494098186493, - -0.42908549308776855, - 0.3517581820487976, - 1.2535018920898438 - ], - [ - 704.1391363441944, - 686.6980423033237, - -0.23761165142059326, - 0.5069948434829712, - -3.601022243499756, - -1.1536762714385986 - ], - [ - 835.2291916310787, - 730.4103346765041, - 0.003788590431213379, - 0.11014270782470703, - -1.1577098369598389, - 0.19246435165405273 - ], - [ - 674.3151278793812, - 667.1089641153812, - -1.7077490091323853, - -0.8339712023735046, - -3.628788948059082, - 0.29637008905410767 - ], - [ - 744.2465295791626, - 736.4866359233856, - -0.8993609547615051, - 0.766395092010498, - -0.58983314037323, - -1.622721552848816 - ], - [ - 737.5970296859741, - 631.3433438539505, - 0.37509462237358093, - 0.8257656097412109, - 0.7884525060653687, - -2.1699137687683105 - ], - [ - 763.4025711715221, - 662.4634579122066, - 1.045809030532837, - -0.33758431673049927, - 1.4757390022277832, - 0.7180729508399963 - ], - [ - 831.4905944764614, - 730.6935635507107, - 0.05394858121871948, - -0.021983623504638672, - 1.9066474437713623, - -0.1754448413848877 - ], - [ - 730.9653262794018, - 723.0066872537136, - -0.33519482612609863, - 0.8298007249832153, - -0.5961706638336182, - -0.26453447341918945 - ], - [ - 663.3231185972691, - 593.725710183382, - -0.0161898136138916, - 0.1566866636276245, - 0.18344151973724365, - 0.3135885000228882 - ], - [ - 943.9304618835449, - 809.6879720389843, - 0.03132982552051544, - -0.5016813278198242, - 1.544755458831787, - 1.6691755056381226 - ], - [ - 827.8074230849743, - 736.0525115430355, - -0.16927863657474518, - -0.03888297080993652, - 0.46307235956192017, - -0.17196321487426758 - ], - [ - 624.2213913202286, - 557.5661880970001, - 0.29258501529693604, - 0.37694263458251953, - 1.670609951019287, - 0.06817626953125 - ], - [ - 656.8397889137268, - 604.1808642148972, - 0.5457745790481567, - 0.17392468452453613, - -2.217473030090332, - -0.870223879814148 - ], - [ - 499.57932072877884, - 463.5859929919243, - 0.3396928906440735, - 0.3201415538787842, - -0.9704627990722656, - 0.04229021072387695 - ], - [ - 583.1678632199764, - 449.7943726181984, - 0.01649066060781479, - -0.01540994644165039, - 0.6603179574012756, - -0.7880933284759521 - ], - [ - 416.4668741822243, - 406.5863981246948, - -0.030530579388141632, - -0.2581073045730591, - -2.6894850730895996, - 0.6015787124633789 - ], - [ - 469.06352710723877, - 401.72473895549774, - 0.0750969648361206, - -0.5221878290176392, - -0.15197938680648804, - 0.8262218236923218 - ], - [ - 404.46923780441284, - 382.31468093395233, - 0.0812416598200798, - -0.4490569829940796, - -1.348215937614441, - -1.0160892009735107 - ], - [ - 585.610869705677, - 199.80334189534187, - 1.002305507659912, - -0.11048257350921631, - -2.0129072666168213, - 1.5515646934509277 - ], - [ - 521.1493827104568, - 503.42281901836395, - 0.5338666439056396, - -0.17545616626739502, - 2.0797858238220215, - -0.440778523683548 - ], - [ - 464.7202842235565, - 447.6945024728775, - 1.1222033500671387, - 2.7889344692230225, - 0.37468981742858887, - -2.24837064743042 - ], - [ - 432.1681345254183, - 364.56264205276966, - 0.3111744523048401, - -0.5358055830001831, - -0.7772567272186279, - 0.49767589569091797 - ], - [ - 356.75424967706203, - 309.48003198206425, - 0.5755603313446045, - 0.23699072003364563, - 2.9042530059814453, - 0.52659010887146 - ], - [ - 886.8718758225441, - 879.4192969202995, - 0.2587853968143463, - -0.17124927043914795, - 0.47101378440856934, - -0.23404169082641602 - ], - [ - 371.93303595483303, - 326.3270680755377, - 0.21263694763183594, - 0.32143843173980713, - 2.0074286460876465, - -1.110871434211731 - ], - [ - 724.2932702302933, - 418.9989911913872, - -0.4203815460205078, - -0.7886154651641846, - 5.63485050201416, - 0.06257043778896332 - ], - [ - 526.0129725337029, - 490.1452496647835, - 0.21875715255737305, - -0.24206650257110596, - -1.0466164350509644, - -1.0578551292419434 - ], - [ - 393.64851024746895, - 287.1291548907757, - -1.2000555992126465, - -0.27128374576568604, - -0.3436877727508545, - -0.35879719257354736 - ], - [ - 344.52999874949455, - 261.5657069385052, - -0.21845054626464844, - 0.31288766860961914, - 1.9131803512573242, - 0.3329501152038574 - ], - [ - 255.49033400416374, - 211.01950773596764, - -0.531984806060791, - -0.23747670650482178, - -0.6860430836677551, - 0.4582841396331787 - ], - [ - 677.942422658205, - 544.3719761967659, - -0.14550089836120605, - 0.8279582858085632, - -0.5745668411254883, - -0.5552501678466797 - ], - [ - 467.193902105093, - 459.6576592028141, - 0.1161605715751648, - -0.1849495768547058, - 2.003462553024292, - 0.8066540956497192 - ], - [ - 626.0453197881579, - 485.4377184808254, - -0.033666253089904785, - 0.3378664255142212, - 1.7742364406585693, - 0.13965487480163574 - ], - [ - 473.73088193684816, - 456.45974672585726, - 0.3107544183731079, - 0.3740873336791992, - 0.12795233726501465, - -0.7448750138282776 - ], - [ - 476.22450269013643, - 406.13281724601984, - 0.7220313549041748, - 0.26624077558517456, - 4.146862983703613, - -0.42082661390304565 - ], - [ - 451.733634442091, - 323.0886377990246, - -0.06682872772216797, - 0.0065572261810302734, - -0.06719613075256348, - -0.5979875326156616 - ], - [ - 345.73977956175804, - 317.46313259005547, - 0.20272541046142578, - 0.035331010818481445, - -6.119463920593262, - -1.402334451675415 - ], - [ - 491.6442443430424, - 305.02466574311256, - 0.46866345405578613, - 0.6142400503158569, - 0.20316362380981445, - -0.9160399436950684 - ], - [ - 438.74801579117775, - 249.65697339177132, - 0.3487398624420166, - 0.21662187576293945, - 4.639161109924316, - -0.9037367105484009 - ], - [ - 236.05680963397026, - 221.59485098719597, - 0.1295793056488037, - -0.058242082595825195, - 0.6593929529190063, - -1.5028061866760254 - ], - [ - 301.6659318804741, - 284.79929316043854, - 0.11171817779541016, - -0.31121599674224854, - 3.0002527236938477, - 1.0962570905685425 - ], - [ - 790.0428938567638, - 781.3025670349598, - -0.5258222818374634, - -0.23623037338256836, - 2.198922872543335, - -0.5071533918380737 - ], - [ - 607.6959058046341, - 603.1657596826553, - -0.1287233829498291, - -0.05560016632080078, - 1.3380460739135742, - -0.3173176646232605 - ], - [ - 383.4959858059883, - 255.86057895421982, - 0.494128942489624, - -0.40226995944976807, - -3.0771427154541016, - -0.532323956489563 - ], - [ - 397.95507913827896, - 272.3556728363037, - 0.4504685401916504, - 0.7695231437683105, - 0.2246037721633911, - -2.0268192291259766 - ], - [ - 296.6996202468872, - 260.4006417989731, - 0.21277117729187012, - 0.45549046993255615, - -0.7146314978599548, - 0.9330289363861084 - ], - [ - 370.00240352749825, - 305.840389251709, - 0.3526172637939453, - 0.7999547719955444, - 2.0119681358337402, - -0.8855571150779724 - ], - [ - 255.52648636698723, - 239.7862478196621, - -0.0032656192779541016, - -0.23157954216003418, - 0.4174656867980957, - 0.6339941024780273 - ], - [ - 450.2063548564911, - 256.4986158013344, - 0.008210182189941406, - 0.3786356449127197, - -5.925825119018555, - -0.15215790271759033 - ], - [ - 226.94981813430786, - 211.0277373790741, - -0.6997908353805542, - 0.7672833204269409, - 1.4924119710922241, - -0.1559581756591797 - ], - [ - 359.2434683442116, - 299.8238896727562, - -0.05244565010070801, - 0.3366813659667969, - -6.015974044799805, - 0.5102560520172119 - ], - [ - 249.865667283535, - 240.33509266376495, - -0.040174245834350586, - -0.9195233583450317, - -0.33282899856567383, - 0.7731598615646362 - ], - [ - 292.6389615237713, - 274.3972118794918, - -0.11903560161590576, - -0.04093575477600098, - -1.5786783695220947, - -1.0259101390838623 - ], - [ - 292.295990139246, - 286.28061440587044, - -0.03433153033256531, - -0.010070085525512695, - -1.859474539756775, - 0.12272405624389648 - ], - [ - 342.59814634919167, - 174.68789753317833, - 0.5922969579696655, - 0.5771080255508423, - 1.5011707544326782, - -0.5221728682518005 - ], - [ - 398.8309471309185, - 159.56948694586754, - -1.6101479530334473, - 2.4061927795410156, - -2.4645590782165527, - -1.8640292882919312 - ], - [ - 544.0210441797972, - 522.8335934430361, - -0.28614914417266846, - -0.11990594863891602, - -0.2694634795188904, - -0.9192067384719849 - ], - [ - 452.54102735221386, - 447.0487037152052, - -0.46763181686401367, - 0.3839017152786255, - 1.0333046913146973, - -0.38618743419647217 - ], - [ - 391.04040881991386, - 371.60505923628807, - 0.06593243777751923, - 0.4110301733016968, - 1.348207712173462, - -0.468447208404541 - ], - [ - 562.824738651514, - 339.56063535809517, - 0.1066540777683258, - 0.0959322452545166, - -0.5513086318969727, - -0.6424281597137451 - ], - [ - 290.3125708401203, - 253.73481366038322, - -0.11315727233886719, - 0.5012606382369995, - -0.8591241836547852, - 0.1818021535873413 - ], - [ - 847.8638243973255, - 542.5695118904114, - 0.3309548497200012, - 0.7400373816490173, - 0.126216858625412, - -0.009948968887329102 - ], - [ - 660.5542903542519, - 633.0048246383667, - 0.07713067531585693, - 0.5680239200592041, - 1.1241207122802734, - -0.4892209768295288 - ], - [ - 704.9145434200764, - 679.1845886409283, - -0.30295610427856445, - -0.4470309019088745, - -5.3303728103637695, - 0.29467833042144775 - ], - [ - 674.513499289751, - 650.5904190838337, - 0.3443402051925659, - -0.7644655704498291, - -0.8716645240783691, - 1.2070293426513672 - ], - [ - 727.4162160158157, - 695.8523522615433, - 0.8151386976242065, - -0.08125972747802734, - -2.107778310775757, - 0.29876089096069336 - ], - [ - 747.0234097838402, - 614.667312681675, - 0.22906744480133057, - 0.2503849267959595, - 0.5325063467025757, - 0.11982846260070801 - ], - [ - 814.9727681577206, - 655.934606641531, - 0.29963576793670654, - 0.9637887477874756, - -0.9278880953788757, - -1.5844323635101318 - ], - [ - 723.7196303904057, - 650.7252794802189, - 0.14338494837284088, - 0.1157999038696289, - 1.4279228448867798, - -0.9101704955101013 - ], - [ - 663.9623835086823, - 581.8428134918213, - 0.3312222957611084, - 0.6113955974578857, - -1.587320327758789, - -1.6294677257537842 - ], - [ - 329.92955657839775, - 154.39435422420502, - -0.3346109986305237, - 0.16928446292877197, - 0.7405552268028259, - 1.55775785446167 - ], - [ - 477.813545525074, - 443.9012184739113, - -0.08317668735980988, - -0.1507297158241272, - -0.9184658527374268, - 0.04937368631362915 - ], - [ - 479.4375132918358, - 331.0871024131775, - -0.3562614917755127, - -0.3768731355667114, - -0.4538119435310364, - 0.8382986783981323 - ], - [ - 315.1644480228424, - 252.72476375102997, - -0.12459588050842285, - 0.028559327125549316, - -1.8368690013885498, - 1.3354017734527588 - ], - [ - 256.87766259908676, - 187.19287490844727, - -0.20267879962921143, - -0.2773280143737793, - 2.0171711444854736, - -0.619411826133728 - ], - [ - 688.0351278781891, - 424.4783811569214, - -0.3096463680267334, - 1.1358799934387207, - 4.406667232513428, - -1.7707830667495728 - ], - [ - 246.80198986828327, - 225.4321414977312, - -4.03807258605957, - 0.9216694831848145, - -1.476455569267273, - -1.07590651512146 - ], - [ - 883.4394263625145, - 851.0392993092537, - 0.0710018202662468, - 0.5338476896286011, - 0.23313650488853455, - -0.9319287538528442 - ], - [ - 422.28269700706005, - 312.8555538505316, - -0.45554447174072266, - 0.5217916369438171, - 4.9146928787231445, - 0.4859619140625 - ], - [ - 343.8466091006994, - 282.4896771758795, - -4.58288049697876, - -1.2046265602111816, - -1.3228144645690918, - 1.27809476852417 - ], - [ - 544.5959624648094, - 414.8607470393181, - -0.6203498840332031, - 1.7008923292160034, - -4.592937469482422, - -1.2463572025299072 - ], - [ - 510.74267795681953, - 469.6673092544079, - -0.13392186164855957, - 0.02967602014541626, - -2.121971607208252, - -0.514745831489563 - ], - [ - 654.6015073657036, - 447.7178425490856, - 1.7675083875656128, - 0.5894231796264648, - 1.7183992862701416, - -0.1422235369682312 - ], - [ - 578.8807070925832, - 368.7561784982681, - 0.7702834606170654, - 0.057554423809051514, - -1.7760969400405884, - 0.07083410024642944 - ], - [ - 820.0457042753696, - 766.8304814994335, - 0.2288280725479126, - 1.1366281509399414, - 3.641812801361084, - -1.1621662378311157 - ], - [ - 414.3080683350563, - 249.3158906698227, - -0.26436465978622437, - -0.2379699945449829, - -1.0694200992584229, - 0.8634177446365356 - ], - [ - 299.3986122608185, - 288.9609271287918, - -0.23346251249313354, - -0.372352659702301, - 2.0942745208740234, - 0.6095876693725586 - ], - [ - 338.19502279162407, - 213.38814026117325, - -0.26771044731140137, - 0.8300786018371582, - 0.7412176132202148, - -0.7780119180679321 - ], - [ - 294.62473809719086, - 185.80892133712769, - 0.06580615043640137, - -0.01668834686279297, - -0.7520322799682617, - 0.6506437063217163 - ], - [ - 373.3454216122627, - 181.38157314062119, - 0.42221903800964355, - -0.17248201370239258, - 0.4581179618835449, - 0.7732229232788086 - ], - [ - 264.62252283096313, - 174.99761980772018, - 0.17837262153625488, - -0.015402555465698242, - 0.2503089904785156, - 0.37920594215393066 - ], - [ - 244.6029428243637, - 234.63337671756744, - 5.166302680969238, - -0.6002939343452454, - 0.838754415512085, - 1.4969658851623535 - ], - [ - 295.4333539903164, - 230.46244558691978, - 0.2841859757900238, - -0.46852385997772217, - 0.9973890781402588, - 0.9407006502151489 - ], - [ - 266.3034060895443, - 258.7418188750744, - 0.14230452477931976, - -0.03765583038330078, - -1.2343947887420654, - 0.050990939140319824 - ], - [ - 511.99838633835316, - 497.4933775216341, - 0.33116552233695984, - -1.210108995437622, - 0.5579907894134521, - 1.424198865890503 - ], - [ - 536.8776050657034, - 410.42683397233486, - -0.19024015963077545, - 0.04013872146606445, - -0.50516676902771, - -0.16156315803527832 - ], - [ - 326.44470474123955, - 164.99075999855995, - 0.3272932767868042, - -0.1665370762348175, - -0.8191413879394531, - 1.117356538772583 - ], - [ - 649.5834965705872, - 613.7157731056213, - -0.2808724641799927, - -0.16866421699523926, - -0.9652286767959595, - 1.1169919967651367 - ], - [ - 781.8323676884174, - 622.5319277942181, - 0.8093105554580688, - -0.11776924133300781, - -2.2324376106262207, - -0.192030668258667 - ], - [ - 853.5207880437374, - 567.963035851717, - 0.16325914859771729, - 0.6474634408950806, - -1.5194323062896729, - -0.04044961929321289 - ], - [ - 755.8712683916092, - 600.220652192831, - 0.37155580520629883, - -0.9831621646881104, - 0.31459298729896545, - 0.20438039302825928 - ], - [ - 778.2353332042694, - 603.3577270209789, - 0.1277403086423874, - -0.31143391132354736, - 0.2264683097600937, - 1.1564005613327026 - ], - [ - 667.8181719779968, - 521.8360546827316, - -0.05406954884529114, - -0.20566272735595703, - 1.5108911991119385, - -0.37602710723876953 - ], - [ - 327.4528507590294, - 306.60747998952866, - 0.007088899612426758, - -0.8695270419120789, - 4.575531959533691, - 1.7343182563781738 - ], - [ - 848.5299023389816, - 842.6282187104225, - -0.3652583062648773, - 0.21581971645355225, - 1.8463414907455444, - 0.047388315200805664 - ], - [ - 373.66102051734924, - 365.01498448848724, - 1.7148815393447876, - 1.480846643447876, - 3.8371448516845703, - -1.586581826210022 - ], - [ - 305.3426172733307, - 262.4381687641144, - -0.10183596611022949, - 0.2214204967021942, - 5.418609619140625, - 2.2401058673858643 - ], - [ - 374.2239090204239, - 361.94868725538254, - -1.464093565940857, - 0.31125831604003906, - -2.8093619346618652, - -0.5811236500740051 - ], - [ - 812.957916289568, - 744.1917037069798, - 0.21766018867492676, - 0.06432980298995972, - 2.7311015129089355, - -0.031996846199035645 - ], - [ - 731.875363111496, - 580.2275975942612, - -0.14327609539031982, - -0.18542063236236572, - -0.07671308517456055, - -0.6034493446350098 - ], - [ - 391.31144267320633, - 187.45804345607758, - -0.24210482835769653, - 0.4086127281188965, - -1.129225492477417, - -0.6712465882301331 - ], - [ - 258.9664328098297, - 219.51030099391937, - 0.6886005401611328, - -0.3968713879585266, - -2.329124927520752, - 0.5702096819877625 - ], - [ - 401.6159054338932, - 231.1150579750538, - 0.03753200173377991, - 0.5154622793197632, - -0.2880932092666626, - -0.4687730073928833 - ], - [ - 278.0991579592228, - 238.80187359452248, - -0.07345466315746307, - -0.1589183807373047, - 2.836517810821533, - -1.7115830183029175 - ], - [ - 743.7585079669952, - 538.4312614202499, - -0.7173507809638977, - -0.7085002064704895, - 2.4536283016204834, - 0.32205432653427124 - ], - [ - 837.2553814351559, - 525.2461910247803, - 0.38811132311820984, - -0.0760042667388916, - 1.6121129989624023, - 0.8730722665786743 - ], - [ - 724.5934523046017, - 585.7999987900257, - -0.9506974220275879, - -0.11714792251586914, - 2.4141178131103516, - -0.3410937786102295 - ], - [ - 766.9311166703701, - 575.0266081392765, - -0.010364517569541931, - -0.1356666088104248, - 1.1100701093673706, - -0.33395957946777344 - ], - [ - 543.7128033041954, - 471.5792188048363, - 0.029868431389331818, - -1.6263501644134521, - 0.07120189815759659, - 1.870969295501709 - ], - [ - 677.1609827578068, - 220.88982105255127, - 0.2744174003601074, - -0.01726377010345459, - 3.3465728759765625, - -0.206731915473938 - ], - [ - 836.4469905495644, - 814.6789902448654, - 0.3339310586452484, - 0.047425031661987305, - -0.8316378593444824, - -0.9908491373062134 - ], - [ - 659.1021650880575, - 198.55045384168625, - 0.2890205383300781, - -0.34227514266967773, - -5.44842529296875, - -1.4865732192993164 - ], - [ - 634.8928223699331, - 261.30136612057686, - 1.5038552284240723, - -0.07787752151489258, - 3.881056070327759, - 0.7278037071228027 - ], - [ - 624.2517829835415, - 202.49126902222633, - 0.011495351791381836, - 1.784647822380066, - -0.2686727046966553, - -1.8578548431396484 - ], - [ - 664.8659510612488, - 172.94489759206772, - -0.43091464042663574, - -0.047746241092681885, - 0.9919381141662598, - 1.5843311548233032 - ], - [ - 505.4363969564438, - 497.9596937894821, - 0.221541166305542, - 0.5178661346435547, - -1.1285669803619385, - -0.6801034212112427 - ], - [ - 659.0565729141235, - 496.6946156024933, - 0.7474480867385864, - 0.025191307067871094, - -1.725996494293213, - -0.08064937591552734 - ], - [ - 345.35271018743515, - 226.83221819996834, - 0.3368491530418396, - -0.2229846715927124, - 1.566259741783142, - 0.6694917678833008 - ], - [ - 227.781426101923, - 219.75605550408363, - -0.561697244644165, - 0.39565229415893555, - 2.0136077404022217, - -1.1091996431350708 - ], - [ - 266.53115010261536, - 196.72522827982903, - 0.037673354148864746, - 0.3947179317474365, - -0.9255232810974121, - -1.2747384309768677 - ], - [ - 325.80292361974716, - 188.67079910635948, - 0.7803943157196045, - 0.7232098579406738, - -1.8646854162216187, - -1.2256534099578857 - ], - [ - 586.8465299606323, - 429.3792122602463, - -0.41458216309547424, - -0.6818073987960815, - 0.9874414205551147, - 0.37975823879241943 - ], - [ - 837.3091332614422, - 492.5450328886509, - 0.3564126789569855, - 0.1795501708984375, - 1.1397773027420044, - -0.6575781106948853 - ], - [ - 552.6689546406269, - 515.7065512239933, - -0.11090891063213348, - 0.678532600402832, - 0.48890241980552673, - -0.6989336013793945 - ], - [ - 629.5581651926041, - 173.52561783790588, - -1.721213459968567, - -0.04096055030822754, - -1.841633915901184, - -0.5558876991271973 - ], - [ - 821.0324122905731, - 787.9913313388824, - -0.09687215834856033, - -0.21930372714996338, - 0.9114773273468018, - 0.27213573455810547 - ], - [ - 707.1201036572456, - 143.3252231478691, - -0.07641386985778809, - -0.5555512309074402, - 4.063166618347168, - 1.1929380893707275 - ], - [ - 263.70338010787964, - 256.81560373306274, - -0.02030324935913086, - -0.0691300630569458, - 0.1744328737258911, - -1.1747822761535645 - ], - [ - 728.8627271652222, - 171.11410266160965, - -1.019355297088623, - -0.14918625354766846, - 2.509315013885498, - -0.6593958139419556 - ], - [ - 228.74747815728188, - 223.64150193333626, - 0.12333643436431885, - 0.3265928030014038, - 2.0809035301208496, - -0.6460188627243042 - ], - [ - 218.36816748976707, - 203.30186572670937, - -0.6371698379516602, - 0.30095118284225464, - -0.12355108559131622, - -0.7756690979003906 - ], - [ - 295.81105503439903, - 161.94563326239586, - -0.21715980768203735, - 0.24996328353881836, - 1.8561538457870483, - 0.8774664402008057 - ], - [ - 853.6491158306599, - 461.58869430422783, - 1.3539254665374756, - 0.19415819644927979, - 0.01873665675520897, - 0.7858350276947021 - ], - [ - 503.5953744649887, - 442.0369231104851, - -0.5454213619232178, - 0.3945375680923462, - 1.4768630266189575, - 0.5292582511901855 - ], - [ - 720.0503506958485, - 714.4212194979191, - 0.08015500754117966, - -0.2349081039428711, - -1.0351293087005615, - 0.44011569023132324 - ], - [ - 555.9603625833988, - 145.2517747282982, - -0.19428503513336182, - 0.2901425361633301, - 3.0370824337005615, - -0.035386085510253906 - ], - [ - 437.6290730535984, - 198.77391746640205, - -0.05135461688041687, - 0.09419035911560059, - 0.851459264755249, - -1.1387276649475098 - ], - [ - 438.7884919345379, - 133.6015000641346, - -0.4959443211555481, - -0.008965134620666504, - 1.116037368774414, - -1.3985588550567627 - ], - [ - 621.5402746349573, - 128.5340098440647, - 0.5484337210655212, - 0.11469161510467529, - -1.2747710943222046, - 0.1478409767150879 - ], - [ - 486.0606123805046, - 437.6144353747368, - -0.35534441471099854, - 0.24326884746551514, - -1.1538710594177246, - -0.12790381908416748 - ], - [ - 828.4828617572784, - 434.53650015592575, - -0.21425104141235352, - 1.3819022178649902, - 0.8631695508956909, - -1.5522782802581787 - ], - [ - 589.8141059577465, - 564.7131807506084, - -0.08423511683940887, - 0.2734869718551636, - 1.6655694246292114, - 1.0310900211334229 - ], - [ - 825.4727962315083, - 124.84343045949936, - -0.16340041160583496, - 0.11030590534210205, - 1.968489408493042, - 0.41386282444000244 - ], - [ - 455.8486447632313, - 174.4477797150612, - -0.1937500536441803, - 0.15798616409301758, - -1.137331247329712, - -0.9982972145080566 - ], - [ - 913.5272924304008, - 408.63128650188446, - -0.4023706912994385, - 1.2953757047653198, - -0.23160713911056519, - -1.4734077453613281 - ], - [ - 403.6834453344345, - 398.03621739149094, - -0.15972258150577545, - 0.0513303279876709, - 1.5288535356521606, - 0.49658215045928955 - ], - [ - 489.3655930161476, - 140.50618332624435, - -0.026770342141389847, - -0.11036312580108643, - 1.8773857355117798, - -0.5619394779205322 - ], - [ - 434.0059335231781, - 375.4224897623062, - -0.17340266704559326, - -1.0454285144805908, - 2.310626983642578, - 0.795856773853302 - ], - [ - 443.2249014824629, - 212.1711524128914, - 0.060467854142189026, - 0.8970510959625244, - 2.658642292022705, - -0.919904351234436 - ], - [ - 648.4651457667351, - 340.5221952199936, - -1.1343908309936523, - -0.11404204368591309, - 4.423769950866699, - 0.39298343658447266 - ], - [ - 934.660780608654, - 164.8414422273636, - -0.19654209911823273, - -1.9759620428085327, - 0.48828721046447754, - 1.957950472831726 - ], - [ - 789.9567734003067, - 135.5168587565422, - 0.7125057578086853, - -0.6600463390350342, - 2.2071402072906494, - -0.21567416191101074 - ], - [ - 860.7215384542942, - 120.2981225848198, - -0.07292520999908447, - -0.737284779548645, - 1.6371577978134155, - 2.022134304046631 - ], - [ - 516.5651733279228, - 275.1032947897911, - -0.2336418330669403, - 0.20981156826019287, - 2.860910415649414, - -0.19827580451965332 - ], - [ - 707.7351241707802, - 106.91575193405151, - 0.5180634260177612, - -0.3195575475692749, - 3.258352756500244, - -1.277012825012207 - ], - [ - 393.4336379170418, - 227.5863333940506, - -0.1374874860048294, - 0.0997014045715332, - 2.7616350650787354, - -0.017386913299560547 - ], - [ - 419.6918982565403, - 124.08418571949005, - -0.04683937877416611, - 0.22421222925186157, - 1.7686994075775146, - -0.769890308380127 - ], - [ - 315.07461178302765, - 121.6561666727066, - 2.7151401042938232, - 0.6086741089820862, - 2.887399673461914, - 0.7751800417900085 - ], - [ - 791.2275979816914, - 115.21936237812042, - -0.6672149300575256, - 0.04169034957885742, - -3.4814772605895996, - -0.9741600751876831 - ], - [ - 562.4127712547779, - 109.80239820480347, - 0.08217954635620117, - -1.2035119533538818, - -1.473663330078125, - 0.6729074716567993 - ], - [ - 948.095840215683, - 90.92123872041702, - 0.5687556266784668, - -0.14505672454833984, - 3.9812850952148438, - 0.3693239688873291 - ], - [ - 1028.2522927820683, - 0, - NaN, - NaN, - NaN, - NaN - ] - ] - ], - "trunk": { - "absolute_elevation_deviation": { - "data": { - "bins": [ - -0.7257994413375854, - -0.6885373592376709, - -0.6512753367424011, - -0.6140133142471313, - -0.5767512321472168, - -0.539489209651947, - -0.5022271871566772, - -0.4649651348590851, - -0.4277031123638153, - -0.39044106006622314, - -0.35317903757095337, - -0.3159169852733612, - -0.27865496277809143, - -0.24139292538166046, - -0.2041308879852295, - -0.16686883568763733, - -0.12960681319236755, - -0.09234476834535599, - -0.05508273094892502, - -0.01782069355249405, - 0.01944134384393692, - 0.05670338124036789, - 0.09396541863679886, - 0.13122746348381042, - 0.1684894859790802, - 0.20575153827667236, - 0.24301357567310333, - 0.2802756130695343, - 0.3175376355648041, - 0.35479968786239624 - ], - "weights": [ - 1, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 1 - ] - } - }, - "azimuth": { - "uniform": { - "max": 0.0, - "min": 3.141592653589793 - } - }, - "orientation_deviation": { - "data": { - "bins": [ - -0.48333333333333334, - -0.45, - -0.4166666666666667, - -0.38333333333333336, - -0.35000000000000003, - -0.31666666666666665, - -0.2833333333333333, - -0.25, - -0.21666666666666667, - -0.18333333333333335, - -0.15000000000000002, - -0.11666666666666667, - -0.08333333333333331, - -0.04999999999999999, - -0.016666666666666663, - 0.016666666666666663, - 0.04999999999999999, - 0.08333333333333331, - 0.11666666666666664, - 0.14999999999999997, - 0.1833333333333333, - 0.21666666666666662, - 0.24999999999999994, - 0.2833333333333333, - 0.3166666666666667, - 0.35000000000000003, - 0.38333333333333336, - 0.4166666666666667, - 0.45, - 0.48333333333333334 - ], - "weights": [ - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 2, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0 - ] - } - } - } - }, - "basal": { - "filtration_metric": "path_distances", - "num_trees": { - "data": { - "bins": [ - 3, - 4, - 5, - 6, - 7 - ], - "weights": [ - 1, - 0, - 0, - 0, - 1 - ] - } - }, - "persistence_diagram": [ - [ - [ - 224.38319063186646, - 219.2606019973755, - -0.4379599988460541, - -0.005312919616699219, - -0.8848207592964172, - 0.09015583992004395 - ], - [ - 400.9616605043411, - 384.7926591038704, - -0.057923853397369385, - -0.289974570274353, - -2.5282816886901855, - -0.15708374977111816 - ], - [ - 192.41142231225967, - 178.48044949769974, - 0.9341675639152527, - 0.13731694221496582, - -1.9108004570007324, - -0.36382102966308594 - ], - [ - 212.02685528993607, - 204.79348236322403, - -1.037257194519043, - 0.6260798573493958, - -4.952030658721924, - 0.0439608097076416 - ], - [ - 174.49314105510712, - 166.01364123821259, - 0.8455920219421387, - 1.9787335395812988, - -2.6705470085144043, - -2.1493306159973145 - ], - [ - 280.87815886735916, - 72.90992110967636, - 0.05115431547164917, - -0.25066912174224854, - -1.0350282192230225, - -0.1008913516998291 - ], - [ - 124.64597976207733, - 116.80670726299286, - -0.04528069496154785, - -0.6709880828857422, - 5.494875907897949, - 0.6105341911315918 - ], - [ - 221.2086187005043, - 111.25251829624176, - 0.2337489128112793, - 1.069451093673706, - -5.322473049163818, - -0.8068923950195312 - ], - [ - 180.18831837177277, - 51.97151494026184, - 0.39078283309936523, - 0.09945124387741089, - -1.4081227779388428, - 0.10724371671676636 - ], - [ - 416.0371113419533, - 38.79454827308655, - 0.46909475326538086, - 1.056646704673767, - 1.8869953155517578, - -1.014134168624878 - ], - [ - 416.89264065027237, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 138.14135348796844, - 91.25013053417206, - 0.15326452255249023, - -1.7054014205932617, - -1.867674469947815, - 0.8106864094734192 - ], - [ - 131.90395653247833, - 63.07564151287079, - 0.8644651174545288, - 0.2718007564544678, - -3.7785184383392334, - -0.3544936180114746 - ], - [ - 138.06671458482742, - 63.07564151287079, - 0.8644651174545288, - 0.2718007564544678, - -3.7785184383392334, - -0.3544936180114746 - ], - [ - 242.68944704532623, - 58.60613238811493, - 0.0914769172668457, - -0.7802324295043945, - -1.4150129556655884, - 0.4885904788970947 - ], - [ - 293.2285534143448, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 175.22094976902008, - 97.96781897544861, - -0.919957160949707, - -0.007689356803894043, - 2.2741498947143555, - -0.6524971723556519 - ], - [ - 106.60009527206421, - 96.86709189414978, - 0.06461894512176514, - -0.3159041404724121, - -1.6893795728683472, - -0.534130334854126 - ], - [ - 136.90290075540543, - 48.16596841812134, - 0.6720576882362366, - 0.32939839363098145, - -1.657493233680725, - 0.22861850261688232 - ], - [ - 160.5392016172409, - 41.71347534656525, - -0.581010103225708, - -0.6343587636947632, - 1.4430261850357056, - 1.1310216188430786 - ], - [ - 330.51422041654587, - 317.4096869826317, - 0.016859177500009537, - 0.49767184257507324, - -0.8041179180145264, - 0.09304702281951904 - ], - [ - 230.81945234537125, - 224.8626189827919, - 5.3906145095825195, - 0.3347291946411133, - 0.22713875770568848, - -0.06444239616394043 - ], - [ - 232.18228441476822, - 224.8626189827919, - 5.3906145095825195, - 0.3347291946411133, - 0.22713875770568848, - -0.06444239616394043 - ], - [ - 233.41182553768158, - 218.31597769260406, - 0.35965001583099365, - 1.197317123413086, - -1.1293777227401733, - -1.1000136137008667 - ], - [ - 148.39162427186966, - 106.62211829423904, - 0.03068673610687256, - 0.09539532661437988, - -0.47842979431152344, - -0.462985634803772 - ], - [ - 245.6610078215599, - 98.33350950479507, - -0.26952099800109863, - -0.19012248516082764, - 1.4764792919158936, - -0.3255033493041992 - ], - [ - 150.77250838279724, - 75.29946810007095, - -0.16319847106933594, - 0.4604736566543579, - -0.026409029960632324, - -0.588306188583374 - ], - [ - 376.89122742414474, - 33.44520962238312, - -0.4075583219528198, - -0.08236527442932129, - 1.3664050102233887, - 0.3029094934463501 - ], - [ - 444.9628998041153, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 72.2456042766571, - 59.06572461128235, - -0.22719597816467285, - -0.47536635398864746, - 0.8639277815818787, - 0.7764732837677002 - ], - [ - 50.22136551141739, - 20.470713138580322, - -0.23022526502609253, - 0.6774137020111084, - -0.7766646146774292, - -0.6992179155349731 - ], - [ - 81.19914650917053, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 84.11102020740509, - 69.41187500953674, - 0.3717796504497528, - -0.16651737689971924, - -1.3758314847946167, - -1.1515417098999023 - ], - [ - 110.07177996635437, - 33.85714316368103, - 0.35795435309410095, - 0.8591106534004211, - -0.979204535484314, - -0.729789137840271 - ], - [ - 111.95093750953674, - 22.643285810947418, - 0.5289139747619629, - -0.26415061950683594, - -1.2796070575714111, - -0.08773636817932129 - ], - [ - 135.23777049779892, - 15.699183404445648, - 0.5204403400421143, - -1.4032387733459473, - -1.1998522281646729, - 1.5046007633209229 - ], - [ - 213.82325011491776, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 66.89137238264084, - 21.836929082870483, - -0.9248316287994385, - -0.8310905694961548, - 2.4072179794311523, - 0.39566969871520996 - ], - [ - 118.18798178434372, - 20.19943106174469, - -0.12483343482017517, - -0.3173079490661621, - 0.34404516220092773, - 0.9239668846130371 - ], - [ - 142.4676097035408, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 44.37714385986328, - 38.24695086479187, - 0.12432551383972168, - 1.591630458831787, - -5.294160842895508, - -1.1023013591766357 - ], - [ - 28.54021382331848, - 21.25880318880081, - 0.05682194232940674, - 0.22250407934188843, - 0.1521090269088745, - 0.036199212074279785 - ], - [ - 48.9872065782547, - 31.529403746128082, - 0.7658979892730713, - -0.0608752965927124, - 4.620903968811035, - -0.3677207827568054 - ], - [ - 37.087240397930145, - 5.02096688747406, - 0.06502676010131836, - -0.6435763239860535, - -1.624915361404419, - 0.29766494035720825 - ], - [ - 54.37259578704834, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 176.18674612045288, - 43.43481993675232, - 0.2355484962463379, - -0.35823583602905273, - 4.983081817626953, - 0.544741153717041 - ], - [ - 138.93788081407547, - 30.439549565315247, - -0.17574119567871094, - 0.249129056930542, - 0.775327205657959, - -0.08188307285308838 - ], - [ - 133.23228877782822, - 21.987082839012146, - -0.017199993133544922, - 0.0005445480346679688, - 1.9876739978790283, - 0.8526766300201416 - ], - [ - 143.35193115472794, - 47.03661274909973, - -0.7615440487861633, - -0.4301486015319824, - 1.8479251861572266, - 1.1096973419189453 - ], - [ - 79.97001737356186, - 20.965715408325195, - -0.46784329414367676, - 0.9772166013717651, - -0.4411565661430359, - -1.0391178131103516 - ], - [ - 147.88678711652756, - 86.89016622304916, - -0.0009177923202514648, - -0.09192109107971191, - -0.8409171104431152, - 0.5593111515045166 - ], - [ - 153.6545004248619, - 21.672676980495453, - 0.5867823362350464, - -0.04882526397705078, - 3.3548412322998047, - -0.16812491416931152 - ], - [ - 108.86449658870697, - 64.82152760028839, - 0.5701639652252197, - -0.32665538787841797, - 5.032402992248535, - -0.6722072958946228 - ], - [ - 119.12391728162766, - 98.12603759765625, - 0.5060263872146606, - -0.6781752109527588, - -1.087803602218628, - 0.8182147741317749 - ], - [ - 115.00392335653305, - 89.66676431894302, - 0.148756742477417, - -0.007477164268493652, - 0.9419937133789062, - -1.137175440788269 - ], - [ - 107.24125277996063, - 93.00947052240372, - -4.619806289672852, - 1.1005070209503174, - -0.3160839080810547, - -0.7212274074554443 - ], - [ - 128.907168507576, - 44.549468994140625, - -0.5933791399002075, - 0.8483630418777466, - 1.7678580284118652, - -1.061244010925293 - ], - [ - 111.77084845304489, - 28.975962698459625, - -0.7289518117904663, - -0.23721599578857422, - -4.8148980140686035, - 0.4040963649749756 - ], - [ - 130.01863545179367, - 14.322330832481384, - -0.14277911186218262, - -0.909946084022522, - -4.649206161499023, - 1.3262590169906616 - ], - [ - 153.43824982643127, - 7.123000621795654, - 0.48526978492736816, - 0.5985463857650757, - -1.3093960285186768, - -1.123914122581482 - ], - [ - 187.5597729086876, - 5.280042052268982, - -0.25231218338012695, - -1.2801045179367065, - -4.306180477142334, - 0.1662236452102661 - ], - [ - 210.67869347333908, - 0, - NaN, - NaN, - NaN, - NaN - ] - ] - ], - "trunk": { - "absolute_elevation_deviation": { - "data": { - "bins": [ - -1.2412248849868774, - -1.1823623180389404, - -1.1234996318817139, - -1.0646369457244873, - -1.0057743787765503, - -0.9469116926193237, - -0.8880491256713867, - -0.8291864395141602, - -0.7703238129615784, - -0.7114611864089966, - -0.65259850025177, - -0.593735933303833, - -0.5348732471466064, - -0.47601062059402466, - -0.41714799404144287, - -0.3582853376865387, - -0.2994227111339569, - -0.24056008458137512, - -0.18169742822647095, - -0.12283480167388916, - -0.06397216022014618, - -0.005109521560370922, - 0.053753115236759186, - 0.11261575669050217, - 0.17147839069366455, - 0.23034103214740753, - 0.2892036736011505, - 0.3480663001537323, - 0.4069289565086365, - 0.46579158306121826 - ], - "weights": [ - 1, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 1, - 0, - 0, - 0, - 0, - 0, - 1, - 2, - 0, - 0, - 0, - 1, - 1, - 1, - 0, - 0, - 0, - 2 - ] - } - }, - "azimuth": { - "uniform": { - "max": 0.0, - "min": 3.141592653589793 - } - }, - "orientation_deviation": { - "data": { - "bins": [ - 0.3906444293680087, - 0.45964219960320146, - 0.5286399698383943, - 0.597637740073587, - 0.6666355103087799, - 0.7356332805439727, - 0.8046310507791654, - 0.8736288210143582, - 0.9426265912495511, - 1.0116243614847438, - 1.0806221317199367, - 1.1496199019551294, - 1.2186176721903221, - 1.287615442425515, - 1.3566132126607078, - 1.4256109828959005, - 1.4946087531310934, - 1.5636065233662861, - 1.6326042936014789, - 1.7016020638366718, - 1.7705998340718647, - 1.8395976043070572, - 1.9085953745422501, - 1.977593144777443, - 2.0465909150126356, - 2.115588685247829, - 2.1845864554830214, - 2.253584225718214, - 2.3225819959534073, - 2.3915797661886 - ], - "weights": [ - 1, - 1, - 0, - 0, - 0, - 0, - 1, - 0, - 1, - 1, - 0, - 0, - 0, - 1, - 0, - 0, - 1, - 0, - 0, - 0, - 0, - 1, - 0, - 0, - 1, - 0, - 0, - 0, - 0, - 1 - ] - } - } - } - }, - "diameter": { - "diameter_power_relation": { - "apical": {}, - "basal": { - "distribution": "exponnorm", - "params": { - "a": 4.0, - "loc": 2.5908563288801734, - "max": 9.189130357830956, - "min": 2.5250375906714853, - "num_value": 51, - "scale": 0.5243368547854691 - }, - "sequential": null - } - }, - "method": "external", - "sibling_ratios": { - "apical": {}, - "basal": { - "distribution": "expon_rev", - "params": { - "loc": -1.0, - "max": 1.0, - "min": 0.38914811611175537, - "num_value": 51.0, - "scale": 0.2681257128715515 - }, - "sequential": null - } - }, - "tapers": { - "apical": {}, - "basal": { - "distribution": "expon_rev", - "params": { - "loc": -4.819307773455629e-16, - "max": 4.819307773455629e-16, - "min": -0.006207112688571215, - "num_value": 81.0, - "scale": 0.0017335106385871768 - }, - "sequential": null - } - }, - "terminal_diameters": { - "apical": {}, - "basal": { - "distribution": "exponnorm", - "params": { - "a": 2.5545662002746754, - "loc": 0.2836270950866221, - "max": 0.9799999952316284, - "min": 0.25, - "num_value": 65, - "scale": 0.08480139754424451 - }, - "sequential": null - } - }, - "trunk_diameters": { - "apical": {}, - "basal": { - "distribution": "exponnorm", - "params": { - "a": 4.0, - "loc": 0.7130976076221143, - "max": 3.432500028610228, - "min": 0.7835000157356262, - "num_value": 10, - "scale": 0.24388822746698835 - }, - "sequential": null - } - } - }, - "soma": { - "size": { - "norm": { - "mean": 6.8463239669799805, - "std": 1.1242210865020752 - } - } - } - }, - "L3_TPC:A": { - "apical": { - "filtration_metric": "path_distances", - "num_trees": { - "data": { - "bins": [ - 1 - ], - "weights": [ - 2 - ] - } - }, - "persistence_diagram": [ - [ - [ - 109.69773781299591, - 105.84351718425751, - 0.35893183946609497, - 1.0500389337539673, - -1.2730598449707031, - 0.08368444442749023 - ], - [ - 397.6659002304077, - 353.6781550645828, - -0.3453235626220703, - 0.3674764633178711, - 0.7171593904495239, - -0.5684151649475098 - ], - [ - 387.523503780365, - 315.595396399498, - -0.18420171737670898, - 0.6140093803405762, - 0.3818647861480713, - -0.6171480417251587 - ], - [ - 376.44524228572845, - 356.4452518224716, - 0.05703377723693848, - -0.05214214324951172, - 0.04322707653045654, - 0.13552099466323853 - ], - [ - 376.44526517391205, - 326.4452451467514, - -0.10551607608795166, - -0.06138032674789429, - -0.3862401247024536, - -0.04554927349090576 - ], - [ - 369.70683205127716, - 339.7068358659744, - 0.02450382709503174, - -0.06130841374397278, - -0.29559242725372314, - -0.02472272515296936 - ], - [ - 299.70684826374054, - 289.7068463563919, - -1.0158865451812744, - -0.00916224718093872, - -4.562684059143066, - 0.5681124329566956 - ], - [ - 291.56252896785736, - 289.3064259290695, - -0.08890795707702637, - -0.2529408931732178, - -3.887930154800415, - -0.7652496099472046 - ], - [ - 397.0879077911377, - 367.08790588378906, - 0.017078399658203125, - -0.002738356590270996, - 0.21483278274536133, - -0.09813660383224487 - ], - [ - 372.5858625173569, - 323.69258439540863, - 0.06862175464630127, - 0.3213644027709961, - 0.6824556589126587, - -0.42753028869628906 - ], - [ - 105.72084832191467, - 103.01951539516449, - -0.6732207536697388, - -0.09569168090820312, - -3.99937105178833, - 0.5294747352600098 - ], - [ - 122.535391330719, - 83.75930047035217, - 0.1472635269165039, - 0.39699625968933105, - 4.86012077331543, - -0.5160610675811768 - ], - [ - 80.1459676027298, - 33.87082636356354, - 2.8654139041900635, - 0.6077849268913269, - 2.5475969314575195, - -0.3491034209728241 - ], - [ - 376.0859581232071, - 273.903257727623, - 0.04709827899932861, - -0.4075509309768677, - 0.7092353701591492, - 0.3998638391494751 - ], - [ - 369.70684254169464, - 250.9039841890335, - 0.331329345703125, - 0.005659818649291992, - 0.8592648506164551, - -0.1830141544342041 - ], - [ - 376.4308784008026, - 316.06536173820496, - 0.3775200843811035, - -1.0812662839889526, - -0.8691344261169434, - 1.1530722379684448 - ], - [ - 386.4452508687973, - 240.98988020420074, - -0.02041339874267578, - -0.559205174446106, - -0.6154031157493591, - 0.9046450853347778 - ], - [ - 397.08791160583496, - 265.3080166578293, - -0.10634088516235352, - -0.1711130142211914, - 0.3891555070877075, - 0.8279526233673096 - ], - [ - 364.2152930498123, - 235.06765973567963, - 0.2370603084564209, - 0.014772891998291016, - -0.47945213317871094, - 0.30996251106262207 - ], - [ - 398.5050059556961, - 182.3675101995468, - -0.1353391408920288, - -0.45459067821502686, - 0.5847158432006836, - 0.35506510734558105 - ], - [ - 238.44787633419037, - 100.14066398143768, - -0.02804708480834961, - 0.2743295431137085, - 1.1200593709945679, - -0.5699241161346436 - ], - [ - 133.1070830821991, - 56.60226571559906, - -0.7532154321670532, - 0.3379720449447632, - -2.681727409362793, - -0.9721817970275879 - ], - [ - 186.36726033687592, - 43.29999303817749, - 0.7165430784225464, - -0.6293600797653198, - -5.033381462097168, - 1.1040304899215698 - ], - [ - 153.38708090782166, - 11.217400550842285, - 0.021857619285583496, - -0.10617756843566895, - -4.3105292320251465, - -1.5246721506118774 - ], - [ - 419.38870549201965, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 141.9892992824316, - 104.2619022578001, - -0.32691431045532227, - -0.2440202236175537, - -4.823974132537842, - -0.40711379051208496 - ], - [ - 161.27379678189754, - 53.86577667295933, - -0.03411436080932617, - 0.12199616432189941, - 0.6236710548400879, - 0.3026738166809082 - ], - [ - 169.68998586386442, - 101.54817747324705, - 5.253536224365234, - -0.9952888488769531, - 0.9528002738952637, - 1.0143115520477295 - ], - [ - 174.1102341338992, - 132.89022194594145, - 5.748910903930664, - -0.22517478466033936, - 0.20349693298339844, - 0.6408392190933228 - ], - [ - 596.0594476908445, - 472.4520082324743, - 0.09430587291717529, - -0.14840972423553467, - 0.16548633575439453, - 0.05655801296234131 - ], - [ - 531.3108677119017, - 431.27474592626095, - 0.017109036445617676, - 0.343428373336792, - -0.43335962295532227, - -0.9377040863037109 - ], - [ - 546.1151601672173, - 499.10419726371765, - -0.10761284828186035, - 0.3348112106323242, - -0.21776342391967773, - 0.01354837417602539 - ], - [ - 521.885817438364, - 491.35348376631737, - 0.08797740936279297, - 0.789778470993042, - -0.8848342895507812, - -0.6756605505943298 - ], - [ - 189.10875838249922, - 59.250320605933666, - -0.08237123489379883, - -0.23152518272399902, - -0.21730804443359375, - 1.2834991216659546 - ], - [ - 533.9792167544365, - 467.1930428445339, - -0.09165585041046143, - 0.5881975889205933, - 0.2650860548019409, - -0.9530400037765503 - ], - [ - 547.3421325087547, - 389.8166482895613, - 0.355399489402771, - -0.5106581449508667, - -0.7833064794540405, - 0.48953163623809814 - ], - [ - 265.5868006795645, - 189.52812607586384, - 0.01152336597442627, - -0.0029081106185913086, - -0.49273741245269775, - -0.034888505935668945 - ], - [ - 232.25666065514088, - 100.36052231490612, - 0.0353701114654541, - -0.001354813575744629, - -0.5916523933410645, - 0.06825339794158936 - ], - [ - 212.0061849206686, - 70.76226811110973, - 0.031258225440979004, - 0.32098257541656494, - 0.1346067190170288, - -0.6088486909866333 - ], - [ - 195.84333538264036, - 47.6777068823576, - -0.22231650352478027, - 0.476499080657959, - -4.251608848571777, - -0.4843301773071289 - ], - [ - 196.5892003029585, - 33.663908168673515, - -0.08870339393615723, - -0.046553850173950195, - 0.45634984970092773, - 0.7728453874588013 - ], - [ - 617.09835909307, + 210.67869347333908, 0, NaN, NaN, @@ -4631,36 +549,36 @@ "absolute_elevation_deviation": { "data": { "bins": [ - 1.312439203262329, - 1.3152077198028564, - 1.3179762363433838, - 1.3207447528839111, - 1.3235132694244385, - 1.3262817859649658, - 1.3290503025054932, - 1.3318188190460205, - 1.3345872163772583, - 1.3373557329177856, - 1.340124249458313, - 1.3428927659988403, - 1.3456612825393677, - 1.348429799079895, - 1.3511983156204224, - 1.3539668321609497, - 1.356735348701477, - 1.3595038652420044, - 1.3622723817825317, - 1.365040898323059, - 1.3678094148635864, - 1.3705779314041138, - 1.3733463287353516, - 1.376114845275879, - 1.3788833618164062, - 1.3816518783569336, - 1.384420394897461, - 1.3871889114379883, - 1.3899574279785156, - 1.392725944519043 + -1.2412249366257266, + -1.1823622985315625, + -1.123499660437398, + -1.0646370223432338, + -1.0057743842490694, + -0.946911746154905, + -0.8880491080607408, + -0.8291864699665764, + -0.770323831872412, + -0.7114611937782477, + -0.6525985556840834, + -0.5937359175899191, + -0.5348732794957547, + -0.4760106414015904, + -0.4171480033074261, + -0.3582853652132617, + -0.29942272711909734, + -0.24056008902493298, + -0.1816974509307686, + -0.12283481283660425, + -0.06397217474243999, + -0.0051095366482757365, + 0.05375310144588863, + 0.112615739540053, + 0.17147837763421736, + 0.23034101572838173, + 0.2892036538225461, + 0.34806629191671035, + 0.4069289300108746, + 0.46579156810503897 ], "weights": [ 1, @@ -4675,24 +593,24 @@ 0, 0, 0, + 1, 0, 0, 0, 0, 0, + 1, + 2, 0, 0, 0, + 1, + 1, + 1, 0, 0, 0, - 0, - 0, - 0, - 0, - 0, - 0, - 1 + 2 ] } }, @@ -4705,939 +623,303 @@ "orientation_deviation": { "data": { "bins": [ - -0.48333333333333334, - -0.45, - -0.4166666666666667, - -0.38333333333333336, - -0.35000000000000003, - -0.31666666666666665, - -0.2833333333333333, - -0.25, - -0.21666666666666667, - -0.18333333333333335, - -0.15000000000000002, - -0.11666666666666667, - -0.08333333333333331, - -0.04999999999999999, - -0.016666666666666663, - 0.016666666666666663, - 0.04999999999999999, - 0.08333333333333331, - 0.11666666666666664, - 0.14999999999999997, - 0.1833333333333333, - 0.21666666666666662, - 0.24999999999999994, - 0.2833333333333333, - 0.3166666666666667, - 0.35000000000000003, - 0.38333333333333336, - 0.4166666666666667, - 0.45, - 0.48333333333333334 + 0.3906444293680087, + 0.45964219960320146, + 0.5286399698383943, + 0.597637740073587, + 0.6666355103087799, + 0.7356332805439727, + 0.8046310507791654, + 0.8736288210143582, + 0.9426265912495511, + 1.0116243614847438, + 1.0806221317199367, + 1.1496199019551294, + 1.2186176721903221, + 1.287615442425515, + 1.3566132126607078, + 1.4256109828959005, + 1.4946087531310934, + 1.5636065233662861, + 1.6326042936014789, + 1.7016020638366718, + 1.7705998340718647, + 1.8395976043070572, + 1.9085953745422501, + 1.977593144777443, + 2.0465909150126356, + 2.115588685247829, + 2.1845864554830214, + 2.253584225718214, + 2.3225819959534073, + 2.3915797661886 ], "weights": [ + 1, + 1, 0, 0, 0, 0, + 1, 0, + 1, + 1, 0, 0, 0, + 1, 0, 0, + 1, 0, 0, 0, 0, - 0, - 2, - 0, - 0, - 0, - 0, - 0, - 0, - 0, + 1, 0, 0, + 1, 0, 0, 0, 0, - 0 + 1 ] } } } }, - "axon": { - "filtration_metric": "path_distances", - "num_trees": { - "data": { - "bins": [ - 1 - ], - "weights": [ - 2 - ] + "diameter": { + "diameter_power_relation": { + "apical": {}, + "basal": { + "distribution": "exponnorm", + "params": { + "a": 4.0, + "loc": 2.5908563288801734, + "max": 9.189130357830956, + "min": 2.5250375906714853, + "num_value": 51, + "scale": 0.5243368547854691 + }, + "sequential": null } }, - "persistence_diagram": [ - [ - [ - 240.37088459730148, - 121.13639110326767, - -0.9481592178344727, - 0.10728216171264648, - -3.993422508239746, - -0.7832211852073669 - ], - [ - 200.0916914343834, - 146.1905807852745, - 0.05858039855957031, - -1.1299968957901, - -5.586950302124023, - 0.3477208614349365 - ], - [ - 452.9000487923622, - 437.4966087937355, - 0.1818445324897766, - -0.13952398300170898, - 0.46104875206947327, - 0.2692596912384033 - ], - [ - 365.81649500131607, - 299.07576328516006, - 0.03663516044616699, - -0.1809391975402832, - 1.2949784994125366, - 0.32517218589782715 - ], - [ - 308.91885083913803, - 289.11834996938705, - -0.5319150686264038, - 0.336834192276001, - 1.5936737060546875, - -1.7446691989898682 - ], - [ - 244.90682643651962, - 126.3453716635704, - 0.5742647647857666, - -1.2131301164627075, - 1.2786340713500977, - 0.5421980619430542 - ], - [ - 303.30100470781326, - 120.4066898226738, - 0.6601635217666626, - -0.21145856380462646, - 1.867377519607544, - 0.010300278663635254 - ], - [ - 399.12028700113297, - 190.75894445180893, - 0.7077187299728394, - -0.02894008159637451, - -2.0518784523010254, - 0.8423409461975098 - ], - [ - 343.1328790783882, - 142.45730823278427, - -0.4350299835205078, - 0.34828102588653564, - 2.0810108184814453, - 0.35423266887664795 - ], - [ - 200.21358913183212, - 135.07028955221176, - 0.5623493194580078, - -0.3835430145263672, - 3.867237091064453, - 1.6287992000579834 - ], - [ - 373.3833882212639, - 116.06975358724594, - -0.641154408454895, - -0.9829444885253906, - 2.4374632835388184, - 1.1146478652954102 - ], - [ - 242.02043789625168, - 110.8842276930809, - 0.9704688787460327, - 1.283956527709961, - 3.8508152961730957, - -1.5521334409713745 - ], - [ - 376.8837220072746, - 105.6229493021965, - -0.5101491212844849, - -0.2567315101623535, - 2.3469531536102295, - 0.49477410316467285 - ], - [ - 455.8534100651741, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 693.2956436052918, - 582.1629847064614, - -0.06676673889160156, - 0.060852646827697754, - 1.0056411027908325, - -0.724223256111145 - ], - [ - 546.2076018676162, - 542.6792050823569, - 0.13229775428771973, - 0.0968242883682251, - -2.3360846042633057, - 0.0026183128356933594 - ], - [ - 774.5045281872153, - 772.027296744287, - -2.81783390045166, - 0.3903770446777344, - -0.278184175491333, - -0.8035371899604797 - ], - [ - 669.5799389258027, - 446.30874060839415, - 0.054990410804748535, - -0.36384856700897217, - 0.5785835981369019, - 0.2408742904663086 - ], - [ - 830.8037101998925, - 659.9235286787152, - -0.250080943107605, - -0.007918119430541992, - -0.604655921459198, - 0.7653335332870483 - ], - [ - 989.4400350376964, - 585.8035146966577, - 0.05003833770751953, - -0.044182419776916504, - -1.1609995365142822, - 0.4158130884170532 - ], - [ - 1178.353465743363, - 1129.5118404701352, - -0.1157083511352539, - -0.010590434074401855, - -0.1617419719696045, - 0.4887634515762329 - ], - [ - 1216.0548972561955, - 1023.7083174958825, - 0.2149667739868164, - 0.4188939332962036, - -5.915763854980469, - 0.2728828191757202 - ], - [ - 286.9680870398879, - 282.3301375731826, - 0.24825596809387207, - -0.16170716285705566, - 1.753455400466919, - 1.0442633628845215 - ], - [ - 783.5900832116604, - 778.7970456182957, - 0.8378596305847168, - -0.011311054229736328, - -2.4393255710601807, - -1.2320467233657837 - ], - [ - 824.2516462504864, - 821.2446957826614, - -0.219818115234375, - -0.18519341945648193, - 0.9252156019210815, - -0.5615888833999634 - ], - [ - 624.4977695345879, - 614.0386487692595, - -0.07965755462646484, - -0.03718709945678711, - 4.008501052856445, - 0.25725817680358887 - ], - [ - 762.3672753870487, - 752.0380352735519, - 0.24228212237358093, - -0.2419835329055786, - 0.23907232284545898, - 0.7925560474395752 - ], - [ - 602.3241576850414, - 599.7572419643402, - -1.4739395380020142, - 0.02080667018890381, - -3.2747185230255127, - 0.1502835750579834 - ], - [ - 668.7656317055225, - 656.0712141096592, - -0.014406479895114899, - -0.39035582542419434, - 2.3920061588287354, - 0.9942289590835571 - ], - [ - 771.9418592005968, - 748.4849425703287, - -0.5788612365722656, - -0.10929369926452637, - 1.302109956741333, - 0.3085007667541504 - ], - [ - 728.9690858125687, - 670.8134510815144, - -0.6833182573318481, - -0.5015501976013184, - 2.7938485145568848, - -0.022868871688842773 - ], - [ - 874.6854250431061, - 815.1586605012417, - -0.09661328792572021, - 0.5093525052070618, - -0.09995758533477783, - -1.0425111055374146 - ], - [ - 882.012137979269, - 778.4298721551895, - -0.2214193344116211, - -0.08870834112167358, - 0.45345616340637207, - 0.24386096000671387 - ], - [ - 702.2843584120274, - 699.7734062969685, - 0.1704409122467041, - -0.26286184787750244, - 0.4979550838470459, - 0.3485807180404663 - ], - [ - 888.9382729530334, - 886.0374568849802, - 0.15271830558776855, - -0.3707432746887207, - -4.100629806518555, - 0.028726696968078613 - ], - [ - 908.0336384177208, - 619.7192360013723, - -1.7398884296417236, - -0.44560766220092773, - -4.325351715087891, - 0.7946023941040039 - ], - [ - 906.5415843725204, - 647.344186425209, - -2.06358003616333, - 0.030972957611083984, - -2.023327350616455, - -1.2837400436401367 - ], - [ - 787.403838455677, - 785.1336852312088, - -0.021548718214035034, - 0.5285159349441528, - -2.5892183780670166, - -0.25592970848083496 - ], - [ - 935.046439498663, - 931.2854863703251, - -0.5939075350761414, - -0.27931785583496094, - 2.1804754734039307, - 0.9783922433853149 - ], - [ - 590.5266373455524, - 585.253583163023, - -0.31866008043289185, - -0.004419088363647461, - 1.4262633323669434, - 0.5049875974655151 - ], - [ - 877.5198203623295, - 776.86357447505, - 0.19522762298583984, - 0.4396095275878906, - -0.6921920776367188, - -1.2215157747268677 - ], - [ - 758.9722675085068, - 753.4483109116554, - -0.3673485517501831, - 0.057756662368774414, - 5.403219223022461, - 0.13386130332946777 - ], - [ - 695.7147368490696, - 692.8840683102608, - -0.2613348960876465, - 0.207200288772583, - 2.250312089920044, - -0.14171230792999268 - ], - [ - 673.7382985055447, - 670.2547269165516, - -0.12107300758361816, - 0.09517872333526611, - 1.532738447189331, - 0.2285599708557129 - ], - [ - 663.1826301813126, - 659.9606721997261, - 0.03516495227813721, - -0.32069408893585205, - 0.9811849594116211, - -0.19251251220703125 - ], - [ - 644.3979908823967, - 640.7315040081739, - -0.01939108967781067, - -0.00580286979675293, - 1.664764642715454, - -0.3881310224533081 - ], - [ - 643.8413933813572, - 639.1775194108486, - -0.24093306064605713, - -0.16318583488464355, - -0.6902909278869629, - 0.3740849494934082 - ], - [ - 771.7936328351498, - 748.0039113461971, - 0.2640816271305084, - 0.1714855432510376, - -0.8584207892417908, - -0.9144027233123779 - ], - [ - 714.3947398662567, - 654.151453524828, - -0.47152459621429443, - -0.7535151243209839, - 1.4752857685089111, - -0.7283550500869751 - ], - [ - 1035.1522533744574, - 713.2579710334539, - -0.15230512619018555, - -0.12422561645507812, - 0.6462752819061279, - -0.6062582731246948 - ], - [ - 998.1743398010731, - 684.4084361642599, - 0.1552412509918213, - -0.25331032276153564, - 4.307494163513184, - 0.938318133354187 - ], - [ - 631.9630630761385, - 623.003647044301, - 0.1585141122341156, - 0.3320509195327759, - -1.502419114112854, - -0.17170166969299316 - ], - [ - 663.7744689434767, - 656.2788918465376, - 0.353830486536026, - -0.3072478771209717, - -1.6387913227081299, - 1.7518658638000488 - ], - [ - 273.7783207446337, - 255.9904441088438, - -0.780676007270813, - 0.4180980920791626, - 2.9547033309936523, - -0.08389556407928467 - ], - [ - 677.2126061022282, - 625.3456887304783, - -0.39851921796798706, - -0.5020332336425781, - -0.8364763259887695, - -0.20840561389923096 - ], - [ - 696.8404068350792, - 635.5990340411663, - -0.014362215995788574, - 0.3149995803833008, - -0.7084431648254395, - -0.5660197734832764 - ], - [ - 1139.0644566714764, - 913.8716733157635, - -0.13741612434387207, - -0.22973573207855225, - -2.5406594276428223, - 0.18901729583740234 - ], - [ - 799.1147668063641, - 536.0693798959255, - -0.5047433376312256, - -0.12470555305480957, - -0.8041727542877197, - 0.29582643508911133 - ], - [ - 379.88965344429016, - 146.09066358208656, - 0.03279423713684082, - -0.10514986515045166, - -4.75140905380249, - -0.7811352014541626 - ], - [ - 335.4233263358474, - 331.298150382936, - 1.3923519849777222, - 1.5627113580703735, - 0.7997454404830933, - -0.612303614616394 - ], - [ - 856.3131907582283, - 577.1665659099817, - 1.1735010147094727, - -1.1183271408081055, - 0.3858516216278076, - 0.8235390186309814 - ], - [ - 671.6701237559319, - 609.051009953022, - -0.06678672134876251, - 0.3210911750793457, - -0.5296180248260498, - 0.2810779809951782 - ], - [ - 933.286318898201, - 679.0162887871265, - 0.05818188190460205, - -0.15972352027893066, - -1.2621227502822876, - 0.8096139430999756 - ], - [ - 795.7650966644287, - 544.1672978699207, - 0.5887634754180908, - 0.13713741302490234, - -2.07161283493042, - -1.4546045064926147 - ], - [ - 1150.2021892666817, - 659.439703464508, - -0.2174365222454071, - -0.12755215167999268, - -0.752092719078064, - -0.3099595308303833 - ], - [ - 621.8409988284111, - 618.1557657718658, - 0.5249611139297485, - -0.07094001770019531, - -1.5844594240188599, - -0.46037089824676514 - ], - [ - 986.9663816094398, - 574.0759018957615, - -0.07407328486442566, - -0.49598753452301025, - -0.036123812198638916, - 0.7621554136276245 - ], - [ - 542.3794503211975, - 536.7592020630836, - -0.050772495567798615, - -0.06464290618896484, - 1.2402034997940063, - 0.3238363265991211 - ], - [ - 890.022968351841, - 449.9677903354168, - -0.09003099799156189, - -0.1269209384918213, - -1.4378917217254639, - -0.5042673349380493 - ], - [ - 764.5853435695171, - 614.6661694347858, - 0.05313342809677124, - -0.006693601608276367, - -0.7878997325897217, - -0.4780144691467285 - ], - [ - 776.3854166865349, - 562.7274747490883, - 0.08991709351539612, - -0.04638814926147461, - 0.6758835911750793, - -0.12286722660064697 - ], - [ - 654.7619591653347, - 651.9274390637875, - 1.2327653169631958, - 0.6214115619659424, - 3.61550235748291, - 1.2910232543945312 - ], - [ - 777.0434999465942, - 580.6315727382898, - -0.146101713180542, - 0.33382081985473633, - -0.2735595703125, - -0.9326086044311523 - ], - [ - 652.696051761508, - 423.94468903541565, - -0.4327675700187683, - -0.3599706292152405, - 0.9191806316375732, - 0.28334343433380127 - ], - [ - 686.3980858772993, - 654.0852876156569, - 0.18759483098983765, - -0.25949954986572266, - -0.9007777571678162, - 0.0037664175033569336 - ], - [ - 429.5360727161169, - 425.54174552857876, - -0.034517765045166016, - -0.4578152894973755, - 1.1350466012954712, - -0.6985777616500854 - ], - [ - 685.5303767323494, - 449.108525454998, - 0.1533498764038086, - -0.14723610877990723, - -0.39873600006103516, - 0.3136749267578125 - ], - [ - 236.58438619971275, - 228.50051966309547, - 0.3502767086029053, - 0.01398324966430664, - -1.5890247821807861, - -1.1263041496276855 - ], - [ - 749.8820359408855, - 134.16781052947044, - 0.025074005126953125, - -0.04739677906036377, - -1.220162034034729, - 0.22754895687103271 - ], - [ - 1230.2466995194554, - 266.25675670057535, - -1.0494662523269653, - 1.4050612449645996, - -0.8987032175064087, - -1.407658338546753 - ], - [ - 745.1831213831902, - 594.1084425449371, - -0.21411731839179993, - -0.17826485633850098, - 1.6168488264083862, - -0.1377183198928833 - ], - [ - 1443.3102134913206, - 662.6148216426373, - 0.029779911041259766, - -0.7152389287948608, - -0.09906256198883057, - 0.5066136121749878 - ], - [ - 1036.0819641947746, - 539.0998658537865, - -0.044113993644714355, - -0.0015473365783691406, - 4.724297523498535, - 0.965087890625 - ], - [ - 920.8618301749229, - 433.1260893046856, - 0.17807328701019287, - -0.023955225944519043, - 3.128788948059082, - 1.3503453731536865 - ], - [ - 1164.2192679941654, - 374.0415062010288, - -0.27939677238464355, - 0.19942247867584229, - 1.7576332092285156, - 0.18185067176818848 - ], - [ - 672.7455983161926, - 441.8235781490803, - -0.3540385961532593, - -0.15720129013061523, - 2.058570623397827, - 0.10291171073913574 - ], - [ - 502.7334945499897, - 498.500708848238, - 0.10172152519226074, - -0.1994640827178955, - 4.855230331420898, - 1.3153998851776123 - ], - [ - 985.9907224327326, - 342.08337393403053, - -0.25650835037231445, - 0.0688779354095459, - 1.664003849029541, - -0.8102817535400391 - ], - [ - 346.52755858004093, - 340.2657393068075, - 0.22459274530410767, - -0.052823543548583984, - 1.289499044418335, - -1.5114572048187256 - ], - [ - 807.6563311517239, - 114.4550664126873, - 0.031212806701660156, - -0.3042435646057129, - -1.7042194604873657, - -0.26857447624206543 + "method": "external", + "sibling_ratios": { + "apical": {}, + "basal": { + "distribution": "expon_rev", + "params": { + "loc": -1.0, + "max": 1.0, + "min": 0.38914811611175537, + "num_value": 51.0, + "scale": 0.2681257128715515 + }, + "sequential": null + } + }, + "tapers": { + "apical": {}, + "basal": { + "distribution": "expon_rev", + "params": { + "loc": -4.1364226645387197e-16, + "max": 4.1364226645387197e-16, + "min": -0.006207112688571215, + "num_value": 81.0, + "scale": 0.0017335106385871768 + }, + "sequential": null + } + }, + "terminal_diameters": { + "apical": {}, + "basal": { + "distribution": "exponnorm", + "params": { + "a": 2.5545662002746754, + "loc": 0.2836270950866221, + "max": 0.9799999952316284, + "min": 0.25, + "num_value": 65, + "scale": 0.08480139754424451 + }, + "sequential": null + } + }, + "trunk_diameters": { + "apical": {}, + "basal": { + "distribution": "exponnorm", + "params": { + "a": 4.0, + "loc": 0.7130976076221143, + "max": 3.432500028610228, + "min": 0.7835000157356262, + "num_value": 10, + "scale": 0.24388822746698835 + }, + "sequential": null + } + } + }, + "soma": { + "size": { + "norm": { + "mean": 6.8463239669799805, + "std": 1.1242210865020752 + } + } + } + }, + "L3_TPC:A": { + "apical": { + "filtration_metric": "path_distances", + "num_trees": { + "data": { + "bins": [ + 1 ], + "weights": [ + 1 + ] + } + }, + "persistence_diagram": [ + [ [ - 1102.6198585554957, - 224.28225707262754, - 0.05747580528259277, - -0.11770974099636078, - -1.1371874809265137, - 1.5405482053756714 + 141.9892992824316, + 104.2619022578001, + -0.32691431045532227, + -0.2440204620361328, + -4.823974132537842, + -0.40711379051208496 ], [ - 805.1375606358051, - 516.5210703909397, - 0.20913182199001312, - -0.011237502098083496, - -3.1161980628967285, - 1.1886554956436157 + 161.27379678189754, + 53.86577667295933, + -0.03411436080932617, + 0.12199640274047852, + 0.6236710548400879, + 0.3026738166809082 ], [ - 454.056568980217, - 433.85469353199005, - 0.18713589012622833, - -0.18658411502838135, - 0.8860234618186951, - -0.015670299530029297 + 169.68998586386442, + 101.54817747324705, + 5.253536224365234, + -0.9952889680862427, + 0.9528002738952637, + 1.01431143283844 ], [ - 823.5938050895929, - 307.2670688331127, - 0.325355589389801, - 0.102530837059021, - -0.6600052118301392, - 0.8235489130020142 + 174.1102341338992, + 132.89022194594145, + 5.748910903930664, + -0.22517484426498413, + 0.20349693298339844, + 0.6408392786979675 ], [ - 861.698712900281, - 346.4688312113285, - -0.0677182674407959, - -0.21247875690460205, - 1.4186227321624756, - 0.7985072135925293 + 596.0594476908445, + 472.4520082324743, + 0.09430587291717529, + -0.14840972423553467, + 0.16548633575439453, + 0.05655801296234131 ], [ - 1677.5483415424824, - 332.62243631482124, - 0.3737889528274536, - 0.162453293800354, - -1.002897024154663, - -0.3161567449569702 + 531.3108677119017, + 431.27474592626095, + 0.017109036445617676, + 0.34342849254608154, + -0.43335962295532227, + -0.9377041459083557 ], [ - 268.7968203872442, - 259.9002790302038, - -0.28999650478363037, - -0.09070539474487305, - 1.1947028636932373, - -0.1532590389251709 + 546.1151601672173, + 499.10419726371765, + -0.10761284828186035, + 0.33481109142303467, + -0.21776342391967773, + 0.01354837417602539 ], [ - 743.819045253098, - 182.2380063161254, - 0.17232036590576172, - -0.8241897821426392, - -0.840149998664856, - 1.5787756443023682 + 521.885817438364, + 491.35348376631737, + 0.08797740936279297, + 0.789778470993042, + -0.8848342895507812, + -0.6756604909896851 ], [ - 626.8868456557393, - 166.5230278596282, - -0.9707677960395813, - 1.2685043811798096, - 4.005387306213379, - -0.3222212791442871 + 189.10875838249922, + 59.250320605933666, + -0.08237123489379883, + -0.23152518272399902, + -0.21730804443359375, + 1.2834993600845337 ], [ - 868.3833200931549, - 299.4239765703678, - -0.15244460105895996, - -0.013872385025024414, - 1.2557721138000488, - 0.3844485282897949 + 533.9792167544365, + 467.1930428445339, + -0.09165585041046143, + 0.5881977081298828, + 0.2650860548019409, + -0.9530401229858398 ], [ - 189.52398358285427, - 181.09129993617535, - -0.23631978034973145, - 0.3419067859649658, - 1.6321446895599365, - -0.44582951068878174 + 547.3421325087547, + 389.8166482895613, + 0.355399489402771, + -0.5106581449508667, + -0.7833064794540405, + 0.48953163623809814 ], [ - 408.50712798535824, - 169.58547501266003, - -0.09578758478164673, - -0.293381929397583, - -1.6255297660827637, - -0.8552508354187012 + 265.5868006795645, + 189.52812607586384, + 0.01152336597442627, + -0.0029081106185913086, + -0.49273741245269775, + -0.034888386726379395 ], [ - 1314.9724832847714, - 156.23844429850578, - -0.02969980239868164, - -0.22126567363739014, - 0.8039215207099915, - -1.315718173980713 + 232.25666065514088, + 100.36052231490612, + 0.0353701114654541, + -0.0013549327850341797, + -0.5916523933410645, + 0.06825339794158936 ], [ - 162.77128185331821, - 136.97572526335716, - 0.21744132041931152, - 0.2436208724975586, - -1.4933061599731445, - -1.6684391498565674 + 212.0061849206686, + 70.76226811110973, + 0.031258225440979004, + 0.3209826946258545, + 0.1346067190170288, + -0.6088488101959229 ], [ - 872.2433296591043, - 126.80256542563438, - -0.11874544620513916, - 0.01844620704650879, - 2.450878858566284, - 0.414068341255188 + 195.84333538264036, + 47.6777068823576, + -0.22231650352478027, + 0.476499080657959, + -4.251608848571777, + -0.48433029651641846 ], [ - 1219.1349280625582, - 101.07293078303337, - 0.10715901851654053, - 0.02522563934326172, - 4.082304954528809, - 0.7059136629104614 + 196.5892003029585, + 33.663908168673515, + -0.08870339393615723, + -0.046553850173950195, + 0.45634984970092773, + 0.7728452682495117 ], [ - 1931.3423718512058, + 617.09835909307, 0, NaN, NaN, @@ -5650,39 +932,38 @@ "absolute_elevation_deviation": { "data": { "bins": [ - -1.128167986869812, - -1.1276049613952637, - -1.1270418167114258, - -1.126478672027588, - -1.12591552734375, - -1.125352382659912, - -1.1247893571853638, - -1.1242262125015259, - -1.1236631870269775, - -1.1231000423431396, - -1.1225368976593018, - -1.1219737529754639, - -1.1214107275009155, - -1.1208475828170776, - -1.1202845573425293, - -1.1197214126586914, - -1.1191582679748535, - -1.1185951232910156, - -1.1180319786071777, - -1.1174689531326294, - -1.1169058084487915, - -1.1163427829742432, - -1.1157796382904053, - -1.1152164936065674, - -1.1146533489227295, - -1.1140902042388916, - -1.1135271787643433, - -1.1129640340805054, - -1.112401008605957, - -1.1118378639221191 + 0.8277215405773539, + 0.8610548739106874, + 0.8943882072440206, + 0.927721540577354, + 0.9610548739106872, + 0.9943882072440207, + 1.027721540577354, + 1.0610548739106873, + 1.0943882072440205, + 1.127721540577354, + 1.1610548739106874, + 1.1943882072440206, + 1.2277215405773538, + 1.2610548739106875, + 1.2943882072440207, + 1.327721540577354, + 1.3610548739106871, + 1.3943882072440208, + 1.427721540577354, + 1.4610548739106872, + 1.4943882072440204, + 1.527721540577354, + 1.5610548739106873, + 1.5943882072440205, + 1.6277215405773542, + 1.6610548739106874, + 1.6943882072440206, + 1.7277215405773538, + 1.7610548739106875, + 1.7943882072440207 ], "weights": [ - 1, 0, 0, 0, @@ -5698,6 +979,7 @@ 0, 0, 0, + 1, 0, 0, 0, @@ -5711,7 +993,7 @@ 0, 0, 0, - 1 + 0 ] } }, @@ -5771,7 +1053,7 @@ 0, 0, 0, - 2, + 1, 0, 0, 0, @@ -5796,192 +1078,14 @@ "num_trees": { "data": { "bins": [ - 3, - 4 + 3 ], "weights": [ - 1, 1 ] } }, "persistence_diagram": [ - [ - [ - 139.86553847789764, - 127.66342628002167, - 0.14974993467330933, - -0.29332607984542847, - -1.0830429792404175, - 1.4199836254119873 - ], - [ - 146.1609492301941, - 83.4933031797409, - 0.06223946809768677, - -1.3712399005889893, - -0.5036779046058655, - 0.8278759121894836 - ], - [ - 92.77127540111542, - 48.305373311042786, - 0.11318635940551758, - 1.0351157188415527, - -0.3758721351623535, - -1.2635045051574707 - ], - [ - 95.21088886260986, - 21.749937534332275, - -0.44544294476509094, - 0.2514001131057739, - 1.30238676071167, - -0.7274030447006226 - ], - [ - 158.72424161434174, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 149.2144205570221, - 135.00292468070984, - 0.5306221842765808, - -0.46240073442459106, - -1.574256181716919, - 0.875127375125885 - ], - [ - 74.12150204181671, - 50.79113805294037, - -0.1396866738796234, - 0.8529444336891174, - -0.49762141704559326, - 0.31866157054901123 - ], - [ - 142.69034147262573, - 34.696784257888794, - 0.16783545911312103, - -0.14487707614898682, - -0.4101612865924835, - -0.39537328481674194 - ], - [ - 159.1780618429184, - 23.569173336029053, - 0.02101808786392212, - -0.6281392574310303, - 0.5141335725784302, - -0.4529980421066284 - ], - [ - 191.89336395263672, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 49.94356179237366, - 41.361828088760376, - 0.42723512649536133, - -0.694365382194519, - 1.19692862033844, - 0.6116794347763062 - ], - [ - 59.580429553985596, - 27.09981071949005, - -0.30741560459136963, - -0.5864934921264648, - -0.20895624160766602, - 0.5212652683258057 - ], - [ - 91.87081813812256, - 6.105573296546936, - 0.8344888687133789, - 0.722583532333374, - -2.0563607215881348, - -0.14216184616088867 - ], - [ - 102.98714482784271, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 111.3294323682785, - 85.38660788536072, - 0.32865333557128906, - 0.454776406288147, - -1.270848274230957, - 0.15470337867736816 - ], - [ - 131.87277495861053, - 92.30185997486115, - 0.2054738998413086, - -0.23194384574890137, - 5.696390151977539, - -0.20328164100646973 - ], - [ - 112.64338058233261, - 59.922969937324524, - -0.6129698753356934, - 0.20901280641555786, - -5.494101524353027, - 0.18426144123077393 - ], - [ - 117.67971706390381, - 34.28444695472717, - 0.19789886474609375, - 0.3211359977722168, - 1.095170259475708, - -0.779013991355896 - ], - [ - 123.34376966953278, - 30.770858764648438, - 0.4361083507537842, - -0.9774636030197144, - -1.3248262405395508, - 0.35521066188812256 - ], - [ - 150.5048966407776, - 12.090131282806396, - 0.5465891361236572, - 1.7265498638153076, - 5.185709476470947, - -2.0522890090942383 - ], - [ - 172.09588181972504, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], [ [ 125.50713980197906, @@ -5989,7 +1093,7 @@ 0.010989874601364136, -0.14378678798675537, -0.680117666721344, - -0.2543219327926636 + -0.2543220520019531 ], [ 162.59803120791912, @@ -6005,7 +1109,7 @@ 0.24418501555919647, 0.32875680923461914, -0.652210533618927, - -0.6986445188522339 + -0.6986446380615234 ], [ 145.75945636630058, @@ -6019,15 +1123,15 @@ 170.81609624624252, 40.14634037017822, -0.3505692183971405, - 0.3406410217285156, + 0.3406411409378052, 1.0624732971191406, - 0.06724309921264648 + 0.06724298000335693 ], [ 176.6381877362728, 16.14008802175522, 0.019208360463380814, - -0.838232159614563, + -0.8382322788238525, 0.1426069736480713, 0.9485580921173096 ], @@ -6043,9 +1147,9 @@ 157.66627165675163, 7.919246971607208, -0.0030654072761535645, - -0.8795281648635864, + -0.879528284072876, -0.011970896273851395, - 1.163081169128418 + 1.1630812883377075 ], [ 177.7325423359871, @@ -6061,7 +1165,7 @@ 163.04124587774277, 59.72201764583588, 0.0060443878173828125, - -0.29369235038757324, + -0.29369258880615234, -6.097765922546387, 0.7071933746337891 ], @@ -6079,7 +1183,7 @@ 4.875744342803955, -0.18515551090240479, 0.8259241580963135, - 0.49929356575012207 + 0.49929380416870117 ], [ 207.53501072525978, @@ -6095,7 +1199,7 @@ 136.07094660401344, 40.19579041004181, 0.20971989631652832, - 0.1469430923461914, + 0.1469428539276123, -0.5196757316589355, 0.2783629894256592 ], @@ -6103,17 +1207,17 @@ 130.3481251001358, 34.40322929620743, 0.060836195945739746, - -0.0008164644241333008, + -0.00081634521484375, -0.5054937601089478, - 0.3540968894958496 + 0.35409677028656006 ], [ 143.610936075449, 23.716740667819977, -0.8882325887680054, - -0.1321098804473877, + -0.1321096420288086, -3.780949115753174, - -0.12599658966064453 + -0.12599682807922363 ], [ 160.72333320975304, @@ -6137,43 +1241,43 @@ "absolute_elevation_deviation": { "data": { "bins": [ - -1.1221983432769775, - -1.075115442276001, - -1.0280324220657349, - -0.9809495210647583, - -0.9338666200637817, - -0.8867835998535156, - -0.8397006988525391, - -0.7926177978515625, - -0.7455348372459412, - -0.6984518766403198, - -0.6513689756393433, - -0.6042860746383667, - -0.5572030544281006, - -0.510120153427124, - -0.4630372226238251, - -0.4159542918205261, - -0.3688713312149048, - -0.3217884302139282, - -0.2747054696083069, - -0.22762253880500793, - -0.18053960800170898, - -0.13345667719841003, - -0.08637373894453049, - -0.03929080441594124, - 0.0077921319752931595, - 0.05487506836652756, - 0.1019580066204071, - 0.14904093742370605, - 0.196123868227005, - 0.24320681393146515 + -0.5546633450358789, + -0.5268188832212267, + -0.4989744214065745, + -0.47112995959192233, + -0.4432854977772701, + -0.41544103596261794, + -0.3875965741479657, + -0.3597521123333135, + -0.33190765051866133, + -0.3040631887040091, + -0.2762187268893569, + -0.2483742650747047, + -0.2205298032600525, + -0.1926853414454003, + -0.16484087963074812, + -0.13699641781609592, + -0.1091519560014437, + -0.08130749418679148, + -0.053463032372139285, + -0.02561857055748712, + 0.0022258912571651024, + 0.030070353071817324, + 0.05791481488646949, + 0.08575927670112171, + 0.11360373851577393, + 0.1414482003304261, + 0.16929266214507827, + 0.1971371239597305, + 0.2249815857743827, + 0.2528260475890349 ], "weights": [ 1, 0, 0, 0, - 1, + 0, 0, 0, 0, @@ -6184,13 +1288,13 @@ 1, 0, 0, - 1, 0, 0, 0, - 1, 0, - 1, + 0, + 0, + 0, 0, 0, 0, @@ -6245,17 +1349,14 @@ "weights": [ 1, 0, - 1, 0, 0, 0, - 1, 0, 0, 0, 0, 0, - 1, 0, 0, 0, @@ -6265,7 +1366,10 @@ 0, 0, 0, - 1, + 0, + 0, + 0, + 0, 0, 0, 0, @@ -6283,24 +1387,24 @@ "apical": { "distribution": "exponnorm", "params": { - "a": 4.0, - "loc": 1.749150507496415, - "max": 8.11589818645372, - "min": 1.799509794016765, - "num_value": 40, - "scale": 0.46550659780691905 + "a": 3.025473974134832, + "loc": 2.6792316283590853, + "max": 6.8283410071195405, + "min": 2.59282536057285, + "num_value": 16, + "scale": 0.4946756034963907 }, "sequential": null }, "basal": { "distribution": "exponnorm", "params": { - "a": 1.065007332761786, - "loc": 3.062202144268822, - "max": 7.633991912789879, - "min": 2.0, - "num_value": 32, - "scale": 1.4450035873171894 + "a": 0.3, + "loc": 4.7481553671990335, + "max": 6.954199059768282, + "min": 3.298277053636806, + "num_value": 15, + "scale": 1.2588979761680408 }, "sequential": null } @@ -6310,22 +1414,22 @@ "apical": { "distribution": "expon_rev", "params": { - "loc": -1.0, - "max": 1.0, - "min": 0.42720422297716143, - "num_value": 40.0, - "scale": 0.23270714282989502 + "loc": -0.9813085794448853, + "max": 0.9813085794448853, + "min": 0.42478740215301514, + "num_value": 16.0, + "scale": 0.2519545555114746 }, "sequential": null }, "basal": { "distribution": "expon_rev", "params": { - "loc": -1.0, - "max": 1.0, - "min": 0.4827579155564308, - "num_value": 32.0, - "scale": 0.18857097625732422 + "loc": -0.9940024614334106, + "max": 0.9940024614334106, + "min": 0.5938866108655929, + "num_value": 15.0, + "scale": 0.17557752132415771 }, "sequential": null } @@ -6334,22 +1438,22 @@ "apical": { "distribution": "expon_rev", "params": { - "loc": -9.841953085089043e-17, - "max": 9.841953085089043e-17, - "min": -0.0043574234703555705, - "num_value": 64.0, - "scale": 0.0011933960486203432 + "loc": -6.408057363246223e-18, + "max": 6.408057363246223e-18, + "min": -0.004344724677503109, + "num_value": 25.0, + "scale": 0.001989777898415923 }, "sequential": null }, "basal": { "distribution": "expon_rev", "params": { - "loc": -1.5910334685490776e-16, - "max": 1.5910334685490776e-16, - "min": -0.005049924016930163, - "num_value": 56.0, - "scale": 0.001477402518503368 + "loc": -1.595922966237103e-16, + "max": 1.595922966237103e-16, + "min": -0.0037232576403766872, + "num_value": 25.0, + "scale": 0.0019644065760076046 }, "sequential": null } @@ -6359,23 +1463,23 @@ "distribution": "exponnorm", "params": { "a": 0.3, - "loc": 0.4407677174531953, - "max": 0.6000000238418579, - "min": 0.30057699233293533, - "num_value": 42, - "scale": 0.11020694467576098 + "loc": 0.3712710851761293, + "max": 0.46310911774635316, + "min": 0.3127447128295898, + "num_value": 17, + "scale": 0.04979673193593169 }, "sequential": null }, "basal": { "distribution": "exponnorm", "params": { - "a": 0.735877200480221, - "loc": 0.3958188345943584, - "max": 0.6000000357627868, - "min": 0.30000001192092896, - "num_value": 39, - "scale": 0.09078264848451095 + "a": 1.0308705775946878, + "loc": 0.34120020826448, + "max": 0.4988087698817253, + "min": 0.3039841204881668, + "num_value": 18, + "scale": 0.04537444854582963 }, "sequential": null } @@ -6384,12 +1488,12 @@ "apical": { "distribution": "exponnorm", "params": { - "a": 0.3, - "loc": 1.750200780295405, - "max": 2.3495000898838043, - "min": 1.4404999911785126, - "num_value": 2, - "scale": 0.4862531982490122 + "a": 1.3007585163212707, + "loc": 1.3899999969093868, + "max": 1.3899999856948853, + "min": 1.3899999856948853, + "num_value": 1, + "scale": 1.2917495160173924e-27 }, "sequential": null }, @@ -6397,11 +1501,11 @@ "distribution": "exponnorm", "params": { "a": 4.0, - "loc": 1.1620941987531457, - "max": 1.8140000224113464, - "min": 1.2000000476837158, - "num_value": 7, - "scale": 0.06211353248078659 + "loc": 1.3742617033956122, + "max": 1.7910000443458556, + "min": 1.4039999842643738, + "num_value": 3, + "scale": 0.04733665039362104 }, "sequential": null } @@ -6410,8 +1514,8 @@ "soma": { "size": { "norm": { - "mean": 7.052670478820801, - "std": 0.4954349994659424 + "mean": 6.557235240936279, + "std": 0.0 } } } diff --git a/tests/data/in_small_O1/out/synthesis/sliced_circuit_morphologies.mvd3 b/tests/data/in_small_O1/out/synthesis/sliced_circuit_morphologies.mvd3 index 67df255..e6dc2dd 100644 Binary files a/tests/data/in_small_O1/out/synthesis/sliced_circuit_morphologies.mvd3 and b/tests/data/in_small_O1/out/synthesis/sliced_circuit_morphologies.mvd3 differ diff --git a/tests/data/in_small_O1/out/validation/morphology_validation_reports/validation_config.json b/tests/data/in_small_O1/out/validation/morphology_validation_reports/validation_config.json index 3fe13af..eb25948 100644 --- a/tests/data/in_small_O1/out/validation/morphology_validation_reports/validation_config.json +++ b/tests/data/in_small_O1/out/validation/morphology_validation_reports/validation_config.json @@ -1,31 +1,31 @@ { "L1_DAC": { "basal_dendrite": { - "local_bifurcation_angles": { + "bifurcation_partitions": { "bins": 40, "criterion": "dist", "stat_test": "StatTests.ks", "threshold": 0.1 }, - "number_of_bifurcations": { + "local_bifurcation_angles": { "bins": 40, "criterion": "dist", "stat_test": "StatTests.ks", "threshold": 0.1 }, - "number_of_neurites": { + "number_of_bifurcations": { "bins": 40, "criterion": "dist", "stat_test": "StatTests.ks", "threshold": 0.1 }, - "number_of_sections_per_neurite": { + "number_of_neurites": { "bins": 40, "criterion": "dist", "stat_test": "StatTests.ks", "threshold": 0.1 }, - "bifurcation_partitions": { + "number_of_sections_per_neurite": { "bins": 40, "criterion": "dist", "stat_test": "StatTests.ks", @@ -89,31 +89,31 @@ }, "L3_TPC:A": { "basal_dendrite": { - "local_bifurcation_angles": { + "bifurcation_partitions": { "bins": 40, "criterion": "dist", "stat_test": "StatTests.ks", "threshold": 0.1 }, - "number_of_bifurcations": { + "local_bifurcation_angles": { "bins": 40, "criterion": "dist", "stat_test": "StatTests.ks", "threshold": 0.1 }, - "number_of_neurites": { + "number_of_bifurcations": { "bins": 40, "criterion": "dist", "stat_test": "StatTests.ks", "threshold": 0.1 }, - "number_of_sections_per_neurite": { + "number_of_neurites": { "bins": 40, "criterion": "dist", "stat_test": "StatTests.ks", "threshold": 0.1 }, - "bifurcation_partitions": { + "number_of_sections_per_neurite": { "bins": 40, "criterion": "dist", "stat_test": "StatTests.ks", diff --git a/tests/data/in_small_O1/out/validation/morphology_validation_reports/validation_results.json b/tests/data/in_small_O1/out/validation/morphology_validation_reports/validation_results.json index 6f9fbc9..bdc1efb 100644 --- a/tests/data/in_small_O1/out/validation/morphology_validation_reports/validation_results.json +++ b/tests/data/in_small_O1/out/validation/morphology_validation_reports/validation_results.json @@ -11,23 +11,23 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.22782976827094475, - 0.016086917813693955 + 0.2391934046345811, + 0.009856629271629891 ], "status": "FAIL" } }, "test_summary_statistics": { - "mean": 5.011741793559975, + "mean": 5.169239851058033, "median": 3.0, "sample_size": 352, - "std": 6.033799751563747 + "std": 6.023913202741387 }, "validation_criterion": { "criterion": "dist", "status": "FAIL", "threshold": 0.1, - "value": 0.22782976827094475 + "value": 0.2391934046345811 } }, "local_bifurcation_angles": { @@ -47,10 +47,10 @@ } }, "test_summary_statistics": { - "mean": 0.18105730286566946, - "median": 0.18421144583120402, + "mean": 0.18368355913134726, + "median": 0.18448228167166003, "sample_size": 352, - "std": 0.0849479740889235 + "std": 0.08513769086868977 }, "validation_criterion": { "criterion": "dist", @@ -148,10 +148,10 @@ }, "principal_direction_extents": { "ref_summary_statistics": { - "mean": 221.66647868118002, - "median": 171.45850917326825, + "mean": 221.66647868118008, + "median": 171.45850917326828, "sample_size": 10, - "std": 178.35529502137229 + "std": 178.3552950213723 }, "statistical_tests": { "StatTests.ks": { @@ -163,10 +163,10 @@ } }, "test_summary_statistics": { - "mean": 154.3949219776213, - "median": 167.32538745757566, + "mean": 126.33782025262299, + "median": 133.71810110970014, "sample_size": 50, - "std": 60.91153444959894 + "std": 61.69893569629977 }, "validation_criterion": { "criterion": "dist", @@ -185,23 +185,23 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.4786096256684492, - 7.510739254365386e-10 + 0.4743761140819964, + 1.131568227261706e-09 ], "status": "FAIL" } }, "test_summary_statistics": { - "mean": 0.8383033948957529, - "median": 0.7809544274404637, + "mean": 0.8487821998057786, + "median": 0.7597727790803787, "sample_size": 352, - "std": 0.5366114910349675 + "std": 0.5405893665040464 }, "validation_criterion": { "criterion": "dist", "status": "FAIL", "threshold": 0.1, - "value": 0.4786096256684492 + "value": 0.4743761140819964 } }, "section_branch_orders": { @@ -214,23 +214,23 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.17933731960616822, - 0.0024022490662272173 + 0.19163332284314166, + 0.0009276870161595637 ], "status": "FAIL" } }, "test_summary_statistics": { - "mean": 3.8938992042440317, + "mean": 3.9151193633952253, "median": 3.0, "sample_size": 754, - "std": 2.8470078146137068 + "std": 2.8139873348152067 }, "validation_criterion": { "criterion": "dist", "status": "FAIL", "threshold": 0.1, - "value": 0.17933731960616822 + "value": 0.19163332284314166 } }, "section_lengths": { @@ -243,23 +243,23 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.17652744683720722, - 0.002957207624508324 + 0.2428404441846873, + 8.801771599212393e-06 ], "status": "FAIL" } }, "test_summary_statistics": { - "mean": 33.925052642822266, - "median": 18.43250274658203, + "mean": 28.14206314086914, + "median": 14.805858612060547, "sample_size": 754, - "std": 39.770896911621094 + "std": 34.99922561645508 }, "validation_criterion": { "criterion": "dist", "status": "FAIL", "threshold": 0.1, - "value": 0.17652744683720722 + "value": 0.2428404441846873 } }, "section_path_distances": { @@ -272,23 +272,23 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.34026435283010387, - 5.064707231763582e-11 + 0.3880097109202895, + 2.7225594103096117e-14 ], "status": "FAIL" } }, "test_summary_statistics": { - "mean": 72.34872399124289, - "median": 60.95525538921356, + "mean": 60.90783993520376, + "median": 46.62140893936157, "sample_size": 754, - "std": 50.00799537294422 + "std": 46.94835057033127 }, "validation_criterion": { "criterion": "dist", "status": "FAIL", "threshold": 0.1, - "value": 0.34026435283010387 + "value": 0.3880097109202895 } }, "section_radial_distances": { @@ -301,23 +301,23 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.2756372791440004, - 2.445453919076133e-07 + 0.35154880187025134, + 9.45473807012205e-12 ], "status": "FAIL" } }, "test_summary_statistics": { - "mean": 60.2288932800293, - "median": 51.72051239013672, + "mean": 51.451175689697266, + "median": 40.475955963134766, "sample_size": 754, - "std": 41.16033172607422 + "std": 39.69499206542969 }, "validation_criterion": { "criterion": "dist", "status": "FAIL", "threshold": 0.1, - "value": 0.2756372791440004 + "value": 0.35154880187025134 } }, "section_tortuosity": { @@ -330,23 +330,23 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.4334846918131547, - 7.373936294357703e-18 + 0.4213909994155465, + 7.234582823470782e-17 ], "status": "FAIL" } }, "test_summary_statistics": { - "mean": 1.056825876235962, - "median": 1.0514146089553833, + "mean": 1.0571502447128296, + "median": 1.0494410991668701, "sample_size": 754, - "std": 0.04458966478705406 + "std": 0.04891562834382057 }, "validation_criterion": { "criterion": "dist", "status": "FAIL", "threshold": 0.1, - "value": 0.4334846918131547 + "value": 0.4213909994155465 } }, "total_length": { @@ -359,23 +359,23 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.7, - 0.30303030303030304 + 0.8, + 0.1818181818181818 ], "status": "PASS" } }, "test_summary_statistics": { - "mean": 2557.948915427923, - "median": 2637.074344098568, + "mean": 2121.911454859376, + "median": 1853.1837507486343, "sample_size": 10, - "std": 1044.906288124518 + "std": 1074.6422208985769 }, "validation_criterion": { "criterion": "dist", "status": "FAIL", "threshold": 0.1, - "value": 0.7 + "value": 0.8 } }, "total_length_per_neurite": { @@ -395,10 +395,10 @@ } }, "test_summary_statistics": { - "mean": 511.58978308558466, - "median": 460.86836671829224, + "mean": 424.3822909718752, + "median": 285.60294580459595, "sample_size": 50, - "std": 385.3649739113055 + "std": 347.2696610257364 }, "validation_criterion": { "criterion": "dist", @@ -421,23 +421,23 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.19854041916167664, - 0.20726651564746554 + 0.1751453488372093, + 0.36256485385385534 ], "status": "PASS" } }, "test_summary_statistics": { - "mean": 3.8862275449101795, + "mean": 3.694721299372462, "median": 3.0, - "sample_size": 167, - "std": 3.472376009279542 + "sample_size": 129, + "std": 3.2530521848561023 }, "validation_criterion": { "criterion": "dist", "status": "FAIL", "threshold": 0.1, - "value": 0.19854041916167664 + "value": 0.1751453488372093 } }, "local_bifurcation_angles": { @@ -451,16 +451,16 @@ "StatTests.ks": { "results": [ 1.0, - 2.0066895334767267e-37 + 3.4488112766546777e-34 ], "status": "FAIL" } }, "test_summary_statistics": { - "mean": 0.12820994662704333, - "median": 0.11281647324406271, - "sample_size": 167, - "std": 0.07333343817934274 + "mean": 0.13184547600404417, + "median": 0.12029453442379853, + "sample_size": 129, + "std": 0.07701230242651175 }, "validation_criterion": { "criterion": "dist", @@ -479,23 +479,23 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.3, - 1.0 + 0.5, + 0.7575757575757575 ], "status": "PASS" } }, "test_summary_statistics": { - "mean": 16.7, - "median": 16.0, + "mean": 12.9, + "median": 13.0, "sample_size": 10, - "std": 5.21632054229799 + "std": 2.773084924772409 }, "validation_criterion": { "criterion": "dist", "status": "FAIL", "threshold": 0.1, - "value": 0.3 + "value": 0.5 } }, "number_of_neurites": { @@ -508,23 +508,23 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.0, - 1.0 + 0.5, + 0.7575757575757575 ], "status": "PASS" } }, "test_summary_statistics": { - "mean": 3.5, - "median": 3.5, + "mean": 3.0, + "median": 3.0, "sample_size": 10, - "std": 0.5 + "std": 0.0 }, "validation_criterion": { "criterion": "dist", - "status": "PASS", + "status": "FAIL", "threshold": 0.1, - "value": 0.0 + "value": 0.5 } }, "number_of_sections_per_neurite": { @@ -537,23 +537,23 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.08571428571428572, - 1.0 + 0.11904761904761904, + 0.9999055895640336 ], "status": "PASS" } }, "test_summary_statistics": { - "mean": 10.542857142857143, + "mean": 9.6, "median": 9.0, - "sample_size": 35, - "std": 3.857037035585418 + "sample_size": 30, + "std": 3.431229128655406 }, "validation_criterion": { "criterion": "dist", - "status": "PASS", + "status": "FAIL", "threshold": 0.1, - "value": 0.08571428571428572 + "value": 0.11904761904761904 } }, "principal_direction_extents": { @@ -566,23 +566,23 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.7714285714285715, - 0.0006451845347865887 + 0.3904761904761905, + 0.2792602417839609 ], - "status": "FAIL" + "status": "PASS" } }, "test_summary_statistics": { - "mean": 101.49535599358411, - "median": 103.2337146427756, - "sample_size": 35, - "std": 19.961386104301198 + "mean": 202.49185229545276, + "median": 204.9572557006477, + "sample_size": 30, + "std": 35.82617880044781 }, "validation_criterion": { "criterion": "dist", "status": "FAIL", "threshold": 0.1, - "value": 0.7714285714285715 + "value": 0.3904761904761905 } }, "remote_bifurcation_angles": { @@ -595,23 +595,23 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.40550149700598803, - 0.00016875243632900771 + 0.3687015503875969, + 0.0013412802027484075 ], "status": "FAIL" } }, "test_summary_statistics": { - "mean": 0.5866043144258016, - "median": 0.5313645707152134, - "sample_size": 167, - "std": 0.324866626359222 + "mean": 0.6853282331893527, + "median": 0.5640708506453382, + "sample_size": 129, + "std": 0.42948410830842576 }, "validation_criterion": { "criterion": "dist", "status": "FAIL", "threshold": 0.1, - "value": 0.40550149700598803 + "value": 0.3687015503875969 } }, "section_branch_orders": { @@ -624,23 +624,23 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.14634146341463414, - 0.1395894950704489 + 0.09722222222222222, + 0.6122475409605344 ], "status": "PASS" } }, "test_summary_statistics": { - "mean": 2.5907859078590785, + "mean": 2.3958333333333335, "median": 2.0, - "sample_size": 369, - "std": 1.7601495625712718 + "sample_size": 288, + "std": 1.650836277971461 }, "validation_criterion": { "criterion": "dist", - "status": "FAIL", + "status": "PASS", "threshold": 0.1, - "value": 0.14634146341463414 + "value": 0.09722222222222222 } }, "section_lengths": { @@ -653,23 +653,23 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.23966563609298064, - 0.0017054803444536079 + 0.24667449139280126, + 0.0015259917982022256 ], "status": "FAIL" } }, "test_summary_statistics": { - "mean": 35.36289596557617, - "median": 23.26909065246582, - "sample_size": 369, - "std": 30.46419906616211 + "mean": 72.07017517089844, + "median": 80.30104064941406, + "sample_size": 288, + "std": 57.026634216308594 }, "validation_criterion": { "criterion": "dist", "status": "FAIL", "threshold": 0.1, - "value": 0.23966563609298064 + "value": 0.24667449139280126 } }, "section_path_distances": { @@ -682,23 +682,23 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.42684835299057217, - 2.5309810171951204e-10 + 0.14348591549295775, + 0.17106590178194514 ], - "status": "FAIL" + "status": "PASS" } }, "test_summary_statistics": { - "mean": 59.14822071419176, - "median": 60.73670816421509, - "sample_size": 369, - "std": 35.81123096410863 + "mean": 101.56173081778817, + "median": 128.83309268951416, + "sample_size": 288, + "std": 65.44143925097508 }, "validation_criterion": { "criterion": "dist", "status": "FAIL", "threshold": 0.1, - "value": 0.42684835299057217 + "value": 0.14348591549295775 } }, "section_radial_distances": { @@ -711,23 +711,23 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.42413832589030115, - 3.408421377599884e-10 + 0.13399843505477307, + 0.23258828404431103 ], - "status": "FAIL" + "status": "PASS" } }, "test_summary_statistics": { - "mean": 53.07786560058594, - "median": 54.04483413696289, - "sample_size": 369, - "std": 32.015254974365234 + "mean": 89.84906768798828, + "median": 107.05494689941406, + "sample_size": 288, + "std": 58.2266731262207 }, "validation_criterion": { "criterion": "dist", "status": "FAIL", "threshold": 0.1, - "value": 0.42413832589030115 + "value": 0.13399843505477307 } }, "section_tortuosity": { @@ -740,23 +740,23 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.48696515134165425, - 1.9082189099231458e-13 + 0.5249902190923318, + 5.5779783591933655e-15 ], "status": "FAIL" } }, "test_summary_statistics": { - "mean": 1.0501981973648071, - "median": 1.0466011762619019, - "sample_size": 369, - "std": 0.028381353244185448 + "mean": 1.0610288381576538, + "median": 1.0617560148239136, + "sample_size": 288, + "std": 0.03237013891339302 }, "validation_criterion": { "criterion": "dist", "status": "FAIL", "threshold": 0.1, - "value": 0.48696515134165425 + "value": 0.5249902190923318 } }, "total_length": { @@ -769,23 +769,23 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.8, - 0.1818181818181818 + 0.5, + 0.7575757575757575 ], "status": "PASS" } }, "test_summary_statistics": { - "mean": 1304.8909575223922, - "median": 1308.22296667099, + "mean": 2075.6210257291796, + "median": 2079.040284395218, "sample_size": 10, - "std": 410.7839462521683 + "std": 234.45267024547096 }, "validation_criterion": { "criterion": "dist", "status": "FAIL", "threshold": 0.1, - "value": 0.8 + "value": 0.5 } }, "total_length_per_neurite": { @@ -798,25 +798,25 @@ "statistical_tests": { "StatTests.ks": { "results": [ - 0.4857142857142857, - 0.10078541561211651 + 0.4380952380952381, + 0.16234748635128146 ], "status": "PASS" } }, "test_summary_statistics": { - "mean": 372.82598786354066, - "median": 358.7202024459839, - "sample_size": 35, - "std": 153.4661234360425 + "mean": 691.8736752430598, + "median": 637.0880763530731, + "sample_size": 30, + "std": 159.93954525494854 }, "validation_criterion": { "criterion": "dist", "status": "FAIL", "threshold": 0.1, - "value": 0.4857142857142857 + "value": 0.4380952380952381 } } } } -} +} \ No newline at end of file diff --git a/tests/data/in_small_O1/out/validation/path_distance_fit.pdf b/tests/data/in_small_O1/out/validation/path_distance_fit.pdf index e93ab3b..441a2b9 100644 Binary files a/tests/data/in_small_O1/out/validation/path_distance_fit.pdf and b/tests/data/in_small_O1/out/validation/path_distance_fit.pdf differ diff --git a/tests/data/in_small_O1/out/validation/scales/statistics.pdf b/tests/data/in_small_O1/out/validation/scales/statistics.pdf index 4f7915c..6626689 100644 Binary files a/tests/data/in_small_O1/out/validation/scales/statistics.pdf and b/tests/data/in_small_O1/out/validation/scales/statistics.pdf differ diff --git a/tests/data/in_small_O1/out/validation/score_matrix_reports.pdf b/tests/data/in_small_O1/out/validation/score_matrix_reports.pdf index f71f406..ea055b1 100644 Binary files a/tests/data/in_small_O1/out/validation/score_matrix_reports.pdf and b/tests/data/in_small_O1/out/validation/score_matrix_reports.pdf differ diff --git a/tests/data/in_vacuum/out/morphs_df/morphs_df.csv b/tests/data/in_vacuum/out/morphs_df/morphs_df.csv index cd34f5a..2104c73 100644 --- a/tests/data/in_vacuum/out/morphs_df/morphs_df.csv +++ b/tests/data/in_vacuum/out/morphs_df/morphs_df.csv @@ -1,5 +1,5 @@ -,name,layer,mtype,use_axon,path,morphology_path,morph_class -0,C270106A,1,L1_DAC,True,input_cells/C270106A.h5,input_cells/C270106A.h5,INT -1,C170797A-P2,3,L3_TPC:A,False,input_cells/C170797A-P2.h5,input_cells/C170797A-P2.h5,PYR -2,rat_20160908_E3_LH2_cell2,3,L3_TPC:A,True,input_cells/rat_20160908_E3_LH2_cell2.h5,input_cells/rat_20160908_E3_LH2_cell2.h5,PYR -3,sm080625a1-6_idD,1,L1_DAC,True,input_cells/sm080625a1-6_idD.h5,input_cells/sm080625a1-6_idD.h5,INT +,name,layer,mtype,use_axon,path,morphology_path +0,C270106A,1,L1_DAC,True,input_cells/C270106A.h5,input_cells/C270106A.h5 +1,C170797A-P2,3,L3_TPC:A,False,input_cells/C170797A-P2.h5,input_cells/C170797A-P2.h5 +2,rat_20160908_E3_LH2_cell2,3,L3_TPC:A,True,input_cells/rat_20160908_E3_LH2_cell2.h5,input_cells/rat_20160908_E3_LH2_cell2.h5 +3,sm080625a1-6_idD,1,L1_DAC,True,input_cells/sm080625a1-6_idD.h5,input_cells/sm080625a1-6_idD.h5 diff --git a/tests/data/in_vacuum/out/morphs_df/substituted_morphs_df.csv b/tests/data/in_vacuum/out/morphs_df/substituted_morphs_df.csv index 70ce60c..97110c4 100644 --- a/tests/data/in_vacuum/out/morphs_df/substituted_morphs_df.csv +++ b/tests/data/in_vacuum/out/morphs_df/substituted_morphs_df.csv @@ -1,5 +1,5 @@ -Unnamed: 0,name,layer,mtype,use_axon,path,morphology_path,morph_class -0,C270106A,1,L1_DAC,True,input_cells/C270106A.h5,input_cells/C270106A.h5,INT -1,C170797A-P2,3,L3_TPC:A,False,input_cells/C170797A-P2.h5,input_cells/C170797A-P2.h5,PYR -2,rat_20160908_E3_LH2_cell2,3,L3_TPC:A,True,input_cells/rat_20160908_E3_LH2_cell2.h5,input_cells/rat_20160908_E3_LH2_cell2.h5,PYR -3,sm080625a1-6_idD,1,L1_DAC,True,input_cells/sm080625a1-6_idD.h5,input_cells/sm080625a1-6_idD.h5,INT +Unnamed: 0,name,layer,mtype,use_axon,path,morphology_path +0,C270106A,1,L1_DAC,True,input_cells/C270106A.h5,input_cells/C270106A.h5 +1,C170797A-P2,3,L3_TPC:A,False,input_cells/C170797A-P2.h5,input_cells/C170797A-P2.h5 +2,rat_20160908_E3_LH2_cell2,3,L3_TPC:A,True,input_cells/rat_20160908_E3_LH2_cell2.h5,input_cells/rat_20160908_E3_LH2_cell2.h5 +3,sm080625a1-6_idD,1,L1_DAC,True,input_cells/sm080625a1-6_idD.h5,input_cells/sm080625a1-6_idD.h5 diff --git a/tests/data/in_vacuum/out/synthesis/neurots_input/tmd_distributions.json b/tests/data/in_vacuum/out/synthesis/neurots_input/tmd_distributions.json index da8c70a..fe2b7cf 100644 --- a/tests/data/in_vacuum/out/synthesis/neurots_input/tmd_distributions.json +++ b/tests/data/in_vacuum/out/synthesis/neurots_input/tmd_distributions.json @@ -1,4624 +1,542 @@ { "metadata": { "cortical_thickness": [ - 165, - 149, - 353, - 190, - 525, - 700 + 200, + 100, + 100, + 100, + 100, + 200 ] }, "mtypes": { "L1_DAC": { - "apical": { + "basal": { "filtration_metric": "path_distances", "num_trees": { "data": { "bins": [ - 0 + 3, + 4, + 5, + 6, + 7 ], "weights": [ - 2 - ] - } - }, - "persistence_diagram": [], - "trunk": { - "absolute_elevation_deviation": { - "data": { - "bins": [ - 0.016666666666666666, - 0.05, - 0.08333333333333334, - 0.11666666666666667, - 0.15, - 0.18333333333333335, - 0.21666666666666667, - 0.25, - 0.2833333333333333, - 0.31666666666666665, - 0.35, - 0.3833333333333333, - 0.4166666666666667, - 0.45, - 0.48333333333333334, - 0.5166666666666666, - 0.55, - 0.5833333333333333, - 0.6166666666666667, - 0.6499999999999999, - 0.6833333333333333, - 0.7166666666666666, - 0.75, - 0.7833333333333333, - 0.8166666666666667, - 0.8500000000000001, - 0.8833333333333333, - 0.9166666666666667, - 0.95, - 0.9833333333333334 - ], - "weights": [ - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0 - ] - } - }, - "azimuth": { - "uniform": { - "max": 0.0, - "min": 3.141592653589793 - } - }, - "orientation_deviation": { - "data": { - "bins": [ - 0.016666666666666666, - 0.05, - 0.08333333333333334, - 0.11666666666666667, - 0.15, - 0.18333333333333335, - 0.21666666666666667, - 0.25, - 0.2833333333333333, - 0.31666666666666665, - 0.35, - 0.3833333333333333, - 0.4166666666666667, - 0.45, - 0.48333333333333334, - 0.5166666666666666, - 0.55, - 0.5833333333333333, - 0.6166666666666667, - 0.6499999999999999, - 0.6833333333333333, - 0.7166666666666666, - 0.75, - 0.7833333333333333, - 0.8166666666666667, - 0.8500000000000001, - 0.8833333333333333, - 0.9166666666666667, - 0.95, - 0.9833333333333334 - ], - "weights": [ - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0 - ] - } - } - } - }, - "axon": { - "filtration_metric": "path_distances", - "num_trees": { - "data": { - "bins": [ + 1, + 0, + 0, + 0, 1 - ], - "weights": [ - 2 ] } }, "persistence_diagram": [ [ [ - 391.6643151640892, - 205.59939855337143, - -0.3105885684490204, - 0.6373369693756104, - 3.0071640014648438, - 0.22063040733337402 + 224.38319063186646, + 219.2606019973755, + -0.4379599988460541, + -0.005312800407409668, + -0.8848207592964172, + 0.0901557207107544 ], [ - 501.36823135614395, - 444.02188271284103, - -0.07756775617599487, - -0.45922040939331055, - -0.16126471757888794, - -0.1740485429763794 + 400.9616605043411, + 384.7926591038704, + -0.057923853397369385, + -0.289974570274353, + -2.5282816886901855, + -0.1570836901664734 ], [ - 534.684856235981, - 522.7951191067696, - 0.04284811019897461, - 0.4852858781814575, - 0.1878809928894043, - -0.5559974908828735 + 192.41142231225967, + 178.48044949769974, + 0.9341675639152527, + 0.13731682300567627, + -1.9108004570007324, + -0.36382102966308594 ], [ - 492.82649260759354, - 481.0672774910927, - -0.34110140800476074, - -0.33774352073669434, - 1.5547916889190674, - 0.7355847358703613 + 212.02685528993607, + 204.79348236322403, + -1.037257194519043, + 0.6260798573493958, + -4.952030658721924, + 0.0439608097076416 ], [ - 518.1814951300621, - 487.58488017320633, - 0.7537035942077637, - 0.9112626314163208, - 3.4106173515319824, - -0.21315884590148926 + 174.49314105510712, + 166.01364123821259, + 0.8455920219421387, + 1.9787335395812988, + -2.6705470085144043, + -2.1493306159973145 ], [ - 420.4260097146034, - 288.1535434126854, - 0.024590253829956055, - 0.6091045141220093, - 3.700061321258545, - -0.6539413928985596 + 280.87815886735916, + 72.90992110967636, + 0.05115431547164917, + -0.25066912174224854, + -1.0350282192230225, + -0.10089123249053955 ], [ - 327.13714480400085, - 273.29231119155884, - -0.1077195405960083, - -0.35118699073791504, - 0.960407555103302, - 0.34968459606170654 + 124.64597976207733, + 116.80670726299286, + -0.04528069496154785, + -0.6709880828857422, + 5.494875907897949, + 0.6105341911315918 ], [ - 447.8922420144081, - 446.59567254781723, - 0.27133941650390625, - -0.025693655014038086, - -1.3016613721847534, - 0.48911964893341064 + 221.2086187005043, + 111.25251829624176, + 0.2337489128112793, + 1.069451093673706, + -5.322473049163818, + -0.8068923950195312 ], [ - 426.21355444192886, - 362.74098378419876, - 0.07443857192993164, - 0.002101421356201172, - 0.06515216827392578, - 0.43577253818511963 + 180.18831837177277, + 51.97151494026184, + 0.39078283309936523, + 0.09945124387741089, + -1.4081227779388428, + 0.10724365711212158 ], [ - 467.3602465763688, - 432.2146715298295, - -0.03435063362121582, - 0.21426290273666382, - 4.253576755523682, - 0.0980568528175354 + 416.0371113419533, + 38.79454827308655, + 0.46909475326538086, + 1.0566465854644775, + 1.8869953155517578, + -1.014134168624878 ], [ - 581.3387487009168, - 559.6290861442685, - 0.07716751098632812, - 0.04823172092437744, - 5.421203136444092, - -0.02567446231842041 - ], + 416.89264065027237, + 0, + NaN, + NaN, + NaN, + NaN + ] + ], + [ [ - 723.451112754643, - 717.5159635618329, - 1.112695574760437, - 0.9053986072540283, - -2.236431360244751, - -1.028096318244934 + 138.14135348796844, + 91.25013053417206, + 0.15326452255249023, + -1.7054016590118408, + -1.867674469947815, + 0.8106865286827087 ], [ - 703.434056289494, - 701.024477250874, - 0.3070218563079834, - 0.18580704927444458, - -0.9293392300605774, - 0.5588480234146118 + 131.90395653247833, + 63.07564151287079, + 0.8644651174545288, + 0.2718007564544678, + -3.7785184383392334, + -0.3544933795928955 ], [ - 679.5220037773252, - 655.9753478839993, - 0.043497711420059204, - -0.05016040802001953, - -0.28335684537887573, - 0.0026072263717651367 + 138.06671458482742, + 63.07564151287079, + 0.8644651174545288, + 0.2718007564544678, + -3.7785184383392334, + -0.3544933795928955 ], [ - 560.8058109357953, - 553.6319077089429, - -0.5190410614013672, - 0.3952946662902832, - -4.371852874755859, - -0.3444945812225342 + 242.68944704532623, + 58.60613238811493, + 0.0914769172668457, + -0.7802326679229736, + -1.4150129556655884, + 0.4885904788970947 ], [ - 593.1914836242795, - 480.6256971433759, - 0.06302762031555176, - 0.03621947765350342, - 0.006815910339355469, - 0.2512493133544922 - ], + 293.2285534143448, + 0, + NaN, + NaN, + NaN, + NaN + ] + ], + [ [ - 359.0491527989507, - 333.06846088916063, - -0.25638747215270996, - 0.8555448055267334, - 1.0500061511993408, - -0.7104394435882568 + 175.22094976902008, + 97.96781897544861, + -0.919957160949707, + -0.007689237594604492, + 2.2741498947143555, + -0.6524972319602966 ], [ - 413.2583177238703, - 396.5980608612299, - 0.27146363258361816, - -0.1288679838180542, - -5.993398666381836, - -1.1805989742279053 + 106.60009527206421, + 96.86709189414978, + 0.06461894512176514, + -0.3159041404724121, + -1.6893795728683472, + -0.534130334854126 ], [ - 380.90009893476963, - 319.6859582811594, - 0.4627852439880371, - -0.26988279819488525, - -5.836581707000732, - 0.4813361167907715 + 136.90290075540543, + 48.16596841812134, + 0.6720576882362366, + 0.32939839363098145, + -1.657493233680725, + 0.22861850261688232 ], [ - 555.4565243273973, - 526.1095866709948, - 5.675025939941406, - -0.20517969131469727, - 0.3246958255767822, - 0.6551369428634644 + 160.5392016172409, + 41.71347534656525, + -0.581010103225708, + -0.6343587636947632, + 1.4430261850357056, + 1.1310218572616577 ], [ - 330.4351618438959, - 251.73456443846226, - -0.24874114990234375, - -0.1901768445968628, - 0.8500969409942627, - 0.6632006168365479 + 330.51422041654587, + 317.4096869826317, + 0.016859177500009537, + 0.4976717233657837, + -0.8041179180145264, + 0.09304702281951904 ], [ - 418.4140371233225, - 347.36012245714664, - -0.012700557708740234, - -0.028427600860595703, - 0.8050352931022644, - -0.6476027965545654 + 230.81945234537125, + 224.8626189827919, + 5.3906145095825195, + 0.3347291946411133, + 0.22713875770568848, + -0.06444251537322998 ], [ - 341.14056123793125, - 317.8057948499918, - -0.4150514602661133, - -1.2889974117279053, - 1.281440258026123, - -0.3736797273159027 + 232.18228441476822, + 224.8626189827919, + 5.3906145095825195, + 0.3347291946411133, + 0.22713875770568848, + -0.06444251537322998 ], [ - 332.8875829577446, - 330.78175562620163, - 1.1426564455032349, - -0.5442644357681274, - -2.3491456508636475, - 0.1292353868484497 + 233.41182553768158, + 218.31597769260406, + 0.35965001583099365, + 1.197317123413086, + -1.1293777227401733, + -1.1000134944915771 ], [ - 712.8440843224525, - 630.302704513073, - -1.2033538818359375, - 0.6265941262245178, - -2.055356979370117, - 0.23139822483062744 + 148.39162427186966, + 106.62211829423904, + 0.03068673610687256, + 0.09539532661437988, + -0.47842979431152344, + -0.462985634803772 ], [ - 659.6967459321022, - 590.584341943264, - 0.7254352569580078, - -1.2573022842407227, - 2.197282314300537, - 1.9233837127685547 + 245.6610078215599, + 98.33350950479507, + -0.26952099800109863, + -0.19012248516082764, + 1.4764792919158936, + -0.32550323009490967 ], [ - 577.5527169704437, - 542.9537179470062, - -0.01964402198791504, - -0.05793309211730957, - 5.771877288818359, - 0.48503339290618896 - ], - [ - 1237.2817437648773, - 1226.2430627346039, - 0.28566765785217285, - 1.8477199077606201, - -5.391575336456299, - 0.941411018371582 - ], - [ - 1241.1228246688843, - 1213.2713706493378, - 0.2540316581726074, - -2.027486562728882, - -1.540087342262268, - 1.8781726360321045 - ], - [ - 1246.9417842626572, - 1099.2095458507538, - 0.2269577980041504, - -0.40735840797424316, - 0.8068182468414307, - 1.4334988594055176 - ], - [ - 1154.9186086654663, - 1088.1004952192307, - -0.26997601985931396, - 0.1393885612487793, - -3.4403371810913086, - 0.20603835582733154 - ], - [ - 1082.5348316431046, - 1072.6468831300735, - 0.11066305637359619, - -0.05033266544342041, - -0.9682888388633728, - -0.4501892328262329 - ], - [ - 1330.8443789482117, - 1320.8362548351288, - -0.04307115077972412, - 0.9399316310882568, - -0.527582585811615, - -0.7627354860305786 - ], - [ - 1326.5587750673294, - 1299.9582016468048, - 0.9590237140655518, - 0.3115323781967163, - -3.1760473251342773, - 1.5994620323181152 - ], - [ - 1161.1925387382507, - 1153.133340716362, - -0.08445072174072266, - -0.011340498924255371, - 0.7437705993652344, - -0.0006668567657470703 - ], - [ - 1149.277049422264, - 1147.313728928566, - -0.7485276460647583, - -0.6065174341201782, - 2.659425973892212, - 0.015801548957824707 - ], - [ - 1213.437897324562, - 1196.1278299093246, - -0.04448568820953369, - 0.5285284519195557, - 1.0576950311660767, - -0.7774084806442261 - ], - [ - 330.9513193964958, - 297.9802319407463, - -0.323108434677124, - -0.6237986087799072, - 2.258716583251953, - -0.21225571632385254 - ], - [ - 536.0556625425816, - 506.14273777604103, - 0.31564009189605713, - 0.39138808846473694, - -5.163415908813477, - 0.7835062146186829 - ], - [ - 512.0620410144329, - 509.16740986704826, - 0.2834511995315552, - -0.17493581771850586, - -0.9028503894805908, - 0.16018342971801758 - ], - [ - 448.51154044270515, - 441.08003571629524, - 0.0718390941619873, - 0.236688494682312, - -4.851255416870117, - -0.3110882043838501 - ], - [ - 406.2205645740032, - 361.67308816313744, - 0.09113931655883789, - -0.42406535148620605, - -0.21634411811828613, - 0.28481805324554443 - ], - [ - 285.96104231476784, - 255.81826904416084, - -0.411960244178772, - -0.40056121349334717, - 4.246186256408691, - -0.9286206960678101 - ], - [ - 546.4992916435003, - 493.50320969522, - 0.281110554933548, - -0.39116430282592773, - 0.08857545256614685, - 0.40661656856536865 - ], - [ - 491.2471744865179, - 489.42756305634975, - -0.00993424654006958, - -0.4921175241470337, - -1.1643989086151123, - -0.15346300601959229 - ], - [ - 511.6716139167547, - 507.36118207871914, - -0.7582223415374756, - -0.2180694341659546, - -0.13481241464614868, - 0.09306275844573975 - ], - [ - 386.6816099733114, - 310.118008479476, - -0.26031744480133057, - -0.4900439977645874, - -1.0878667831420898, - 0.07257795333862305 - ], - [ - 253.56987443566322, - 239.5443414747715, - -0.32273411750793457, - -0.3048008680343628, - 0.9438730478286743, - -0.35787200927734375 - ], - [ - 505.46117144823074, - 437.4643825888634, - 0.7896569967269897, - 0.2585862874984741, - -1.621761441230774, - -0.5738904476165771 - ], - [ - 449.5876085162163, - 417.2840823531151, - 0.0809178352355957, - -0.10232794284820557, - 4.132901191711426, - -0.11136782169342041 - ], - [ - 524.5276002287865, - 434.30917233228683, - -0.5067455768585205, - -0.03432774543762207, - -1.0170711278915405, - -1.0980607271194458 - ], - [ - 304.41231459379196, - 217.74276226758957, - -0.10338020324707031, - -0.11517202854156494, - -0.06354892253875732, - 1.3602665662765503 - ], - [ - 439.8023081421852, - 309.1407307982445, - 0.3117513656616211, - 0.06860756874084473, - 0.3517138957977295, - 0.1676257848739624 - ], - [ - 463.4370996132493, - 410.64176098257303, - -0.33307743072509766, - 0.28580403327941895, - -4.9158124923706055, - -1.5446724891662598 - ], - [ - 504.81983137875795, - 474.1135616376996, - -0.7749050259590149, - -0.1494460105895996, - -3.0760133266448975, - 0.6442000865936279 + 150.77250838279724, + 75.29946810007095, + -0.16319847106933594, + 0.46047377586364746, + -0.026409029960632324, + -0.5883064270019531 ], [ - 744.5144279077649, - 693.3376424387097, - -0.23845341801643372, - -0.1162574291229248, - 0.7020441293716431, - -0.5778297781944275 + 376.89122742414474, + 33.44520962238312, + -0.4075583219528198, + -0.08236527442932129, + 1.3664050102233887, + 0.30290937423706055 ], [ - 742.9534775093198, - 633.6948682144284, - -0.3027532696723938, - -0.4881715774536133, - -0.2344352900981903, - 0.3046071529388428 - ], + 444.9628998041153, + 0, + NaN, + NaN, + NaN, + NaN + ] + ], + [ [ - 411.2304784208536, - 254.86773981153965, - 0.3701070547103882, - 0.21142053604125977, - 0.2701907157897949, - 0.7664796113967896 + 72.2456042766571, + 59.06572461128235, + -0.22719597816467285, + -0.47536635398864746, + 0.8639277815818787, + 0.7764732837677002 ], [ - 452.51901914179325, - 239.05078710615635, - -0.812308669090271, - -0.15795576572418213, - -4.8262529373168945, - 0.20534741878509521 + 50.22136551141739, + 20.470713138580322, + -0.23022526502609253, + 0.6774135828018188, + -0.7766646146774292, + -0.6992179155349731 ], [ - 481.8575470596552, - 294.52743877470493, - -1.2115097045898438, - 0.27341747283935547, - 3.2677388191223145, - -0.1858605146408081 - ], + 81.19914650917053, + 0, + NaN, + NaN, + NaN, + NaN + ] + ], + [ [ - 339.869593039155, - 283.4148928076029, - -0.3123602271080017, - 0.668095052242279, - -3.172121047973633, - -0.18362689018249512 + 84.11102020740509, + 69.41187500953674, + 0.3717796504497528, + -0.1665174961090088, + -1.3758314847946167, + -1.1515417098999023 ], [ - 343.5693847090006, - 279.3701678663492, - 1.1298609972000122, - -0.6351744532585144, - -3.0982165336608887, - 1.1378037929534912 + 110.07177996635437, + 33.85714316368103, + 0.35795435309410095, + 0.8591107726097107, + -0.979204535484314, + -0.7297892570495605 ], [ - 280.5856255441904, - 216.19232000410557, - 1.1611676216125488, - -0.46498870849609375, - 3.3051581382751465, - 0.10467886924743652 + 111.95093750953674, + 22.643285810947418, + 0.5289139747619629, + -0.26415038108825684, + -1.2796070575714111, + -0.08773636817932129 ], [ - 333.4087043404579, - 311.4097766280174, - -0.19609379768371582, - -0.4466681480407715, - -2.134889602661133, - 0.3255305290222168 + 135.23777049779892, + 15.699183404445648, + 0.5204403400421143, + -1.4032387733459473, + -1.1998522281646729, + 1.5046007633209229 ], [ - 505.0792779326439, - 495.0857512354851, - -2.7991626262664795, - 1.6007640361785889, - -3.2649552822113037, - -0.19291400909423828 - ], + 213.82325011491776, + 0, + NaN, + NaN, + NaN, + NaN + ] + ], + [ [ - 1207.4347109794617, - 1035.8786796331406, - -0.7741373181343079, - 0.12536799907684326, - 3.139136791229248, - -0.8887691497802734 + 66.89137238264084, + 21.836929082870483, + -0.9248316287994385, + -0.8310908079147339, + 2.4072179794311523, + 0.39566969871520996 ], [ - 1167.39683842659, - 975.4905508756638, - -0.3818192481994629, - -0.15393340587615967, - 1.2431955337524414, - 0.3615773916244507 + 118.18798178434372, + 20.19943106174469, + -0.12483343482017517, + -0.31730806827545166, + 0.34404516220092773, + 0.9239671230316162 ], [ - 1135.804107785225, - 972.7882989645004, - -0.6661558747291565, - -0.08356666564941406, - 3.0764517784118652, - -0.5893446207046509 - ], + 142.4676097035408, + 0, + NaN, + NaN, + NaN, + NaN + ] + ], + [ [ - 1338.5253624916077, - 1268.9782551527023, - 0.06809753179550171, - 0.10750234127044678, - -1.6390962600708008, - -1.090397834777832 + 44.37714385986328, + 38.24695086479187, + 0.12432551383972168, + 1.591630458831787, + -5.294160842895508, + -1.1023013591766357 ], [ - 1250.8296763896942, - 1250.0863655805588, - 0.4822995066642761, - -0.15399408340454102, - 1.1549112796783447, - -0.06375455856323242 + 28.54021382331848, + 21.25880318880081, + 0.05682194232940674, + 0.2225041389465332, + 0.1521090269088745, + 0.036199092864990234 ], [ - 1201.772768855095, - 1119.6034734249115, - 0.4709078073501587, - 0.07164812088012695, - 4.386058807373047, - -0.3478360176086426 + 48.9872065782547, + 31.529403746128082, + 0.7658979892730713, + -0.0608752965927124, + 4.620903968811035, + -0.3677207827568054 ], [ - 1206.9717539548874, - 1168.757693886757, - -0.24715948104858398, - -0.25804567337036133, - -4.846056938171387, - -0.8275249004364014 + 37.087240397930145, + 5.02096688747406, + 0.06502676010131836, + -0.6435762643814087, + -1.624915361404419, + 0.2976648807525635 ], [ - 523.8271051347256, - 445.4762599170208, - -0.12939918041229248, - 0.16483473777770996, - -0.06283378601074219, - -1.2729331254959106 - ], + 54.37259578704834, + 0, + NaN, + NaN, + NaN, + NaN + ] + ], + [ [ - 489.234316021204, - 403.9384836256504, - -0.12605595588684082, - -0.2118680477142334, - -0.7448382377624512, - -0.18331170082092285 + 176.18674612045288, + 43.43481993675232, + 0.2355484962463379, + -0.35823583602905273, + 4.983081817626953, + 0.544741153717041 ], [ - 406.77224096655846, - 210.6119331419468, - -0.25264763832092285, - -0.06586050987243652, - 0.9708173274993896, - -0.35116755962371826 + 138.93788081407547, + 30.439549565315247, + -0.17574119567871094, + 0.249129056930542, + 0.775327205657959, + -0.08188307285308838 ], [ - 522.6349979490042, - 485.828329667449, - 0.10555094480514526, - 0.5007915496826172, - 0.8971192240715027, - -0.27347469329833984 + 133.23228877782822, + 21.987082839012146, + -0.017199993133544922, + 0.000544428825378418, + 1.9876739978790283, + 0.8526766300201416 ], [ - 372.13186794519424, - 328.75505274534225, - 1.2654435634613037, - 1.3434795141220093, - 4.22633171081543, - -0.2576329708099365 + 143.35193115472794, + 47.03661274909973, + -0.7615440487861633, + -0.43014848232269287, + 1.8479251861572266, + 1.1096972227096558 ], [ - 529.8648141026497, - 323.87332314252853, - -1.5498071908950806, - 0.736019492149353, - -3.15006947517395, - -1.1594338417053223 + 79.97001737356186, + 20.965715408325195, + -0.46784329414367676, + 0.9772166013717651, + -0.4411565661430359, + -1.0391178131103516 ], [ - 595.7609773948789, - 444.7416764572263, - -0.07209694385528564, - -0.15704381465911865, - -0.9267933368682861, - 0.5723998546600342 + 147.88678711652756, + 86.89016622304916, + -0.0009177923202514648, + -0.09192109107971191, + -0.8409171104431152, + 0.5593113899230957 ], [ - 672.1536797359586, - 423.29223669320345, - 0.36229491233825684, - -0.7251378297805786, - 1.147707223892212, - 0.028244376182556152 + 153.6545004248619, + 21.672676980495453, + 0.5867823362350464, + -0.04882550239562988, + 3.3548412322998047, + -0.16812491416931152 ], [ - 385.1935703828931, - 366.20057464390993, - -0.38830530643463135, - -0.6420385241508484, - 2.6253175735473633, - 1.3204622268676758 + 108.86449658870697, + 64.82152760028839, + 0.5701639652252197, + -0.32665538787841797, + 5.032402992248535, + -0.6722074151039124 ], [ - 619.2985356003046, - 209.4487675577402, - 0.017409324645996094, - -0.2414720058441162, - -4.161455154418945, - 0.6856579780578613 + 119.12391728162766, + 98.12603759765625, + 0.5060263872146606, + -0.6781753301620483, + -1.087803602218628, + 0.8182147741317749 ], [ - 1220.7848707437515, - 1063.484298825264, - -0.13229727745056152, - 0.2528233528137207, - 4.63056755065918, - -0.6138623952865601 + 115.00392335653305, + 89.66676431894302, + 0.148756742477417, + -0.007477164268493652, + 0.9419937133789062, + -1.1371755599975586 ], [ - 538.1290606558323, - 171.80048814415932, - -0.03301525115966797, - 0.17964506149291992, - 4.677309989929199, - -0.19953429698944092 + 107.24125277996063, + 93.00947052240372, + -4.619806289672852, + 1.1005070209503174, + -0.3160839080810547, + -0.7212274074554443 ], [ - 557.4273832887411, - 424.3069122880697, - -0.012624204158782959, - 0.017889022827148438, - 0.8110083937644958, - 0.31941545009613037 + 128.907168507576, + 44.549468994140625, + -0.5933791399002075, + 0.8483631610870361, + 1.7678580284118652, + -1.061244249343872 ], [ - 407.6094107031822, - 192.4009820818901, - -0.9037628173828125, - -0.020832419395446777, - 1.9167841672897339, - -0.34120869636535645 + 111.77084845304489, + 28.975962698459625, + -0.7289518117904663, + -0.23721611499786377, + -4.8148980140686035, + 0.40409648418426514 ], [ - 453.5709282755852, - 189.12252324819565, - 0.8855904340744019, - 0.11572325229644775, - -2.1486358642578125, - -0.048367857933044434 + 130.01863545179367, + 14.322330832481384, + -0.14277911186218262, + -0.9099459648132324, + -4.649206161499023, + 1.3262591361999512 ], [ - 538.7945826426148, - 309.05075634270906, - -0.270033597946167, - 0.3122434616088867, - -3.8341968059539795, - -0.5259748697280884 + 153.43824982643127, + 7.123000621795654, + 0.48526978492736816, + 0.5985463857650757, + -1.3093960285186768, + -1.123914122581482 ], [ - 384.95306903868914, - 303.43503005057573, - -0.11096477508544922, - -0.42187047004699707, - -1.635056734085083, - -0.6621150970458984 + 187.5597729086876, + 5.280042052268982, + -0.25231218338012695, + -1.2801045179367065, + -4.306180477142334, + 0.16622376441955566 ], [ - 1088.6029832363129, - 977.3188534975052, - -0.26398468017578125, - -0.7205466032028198, - -4.064508438110352, - 0.9245483875274658 - ], - [ - 436.9545448869467, - 333.1420448869467, - 0.14156994223594666, - -0.607445478439331, - -0.7924558520317078, - 0.20295202732086182 - ], - [ - 558.1829724162817, - 333.1420448869467, - 0.14156994223594666, - -0.607445478439331, - -0.7924558520317078, - 0.20295202732086182 - ], - [ - 420.6231018155813, - 287.85812126100063, - -0.32483217120170593, - 0.06547045707702637, - -0.3822765350341797, - 0.15304875373840332 - ], - [ - 344.5803770124912, - 284.8747070133686, - 0.250479519367218, - -1.553009033203125, - 0.4336937367916107, - 1.1547245979309082 - ], - [ - 288.3604076206684, - 243.27550747990608, - -0.7282581329345703, - 0.07996654510498047, - -2.8481998443603516, - -0.7275570631027222 - ], - [ - 403.0813057720661, - 243.27550747990608, - -0.7282581329345703, - 0.07996654510498047, - -2.8481998443603516, - -0.7275570631027222 - ], - [ - 269.64356461167336, - 228.96951213479042, - 0.4197250008583069, - 0.059418678283691406, - -2.2036654949188232, - -0.6322793960571289 - ], - [ - 529.3427245020866, - 254.39769023656845, - 0.09240150451660156, - 0.21433758735656738, - -1.200314998626709, - -0.947068452835083 - ], - [ - 1288.9329624772072, - 970.5552941560745, - -0.4528627395629883, - -0.504736065864563, - -1.8033961057662964, - 0.04539179801940918 - ], - [ - 225.1044843494892, - 161.1487036049366, - 0.8957173824310303, - 0.21791481971740723, - -2.5683956146240234, - -0.023125410079956055 - ], - [ - 409.4956251382828, - 193.2449667453766, - 0.1368027925491333, - 0.3341562747955322, - 4.540215969085693, - 0.46527671813964844 - ], - [ - 1317.2449485063553, - 945.037259221077, - -0.5198729038238525, - -0.028039932250976562, - 3.384089946746826, - 0.4992135763168335 - ], - [ - 606.3041869699955, - 85.16004970669746, - -0.20531070232391357, - 0.4385908842086792, - 3.7252230644226074, - 0.042945146560668945 - ], - [ - 536.6020142436028, - 178.17844343185425, - 0.05603320896625519, - 0.3782665729522705, - -1.5141615867614746, - -0.2546658515930176 - ], - [ - 745.7912800312042, - 495.0275366306305, - -2.35388445854187, - 0.45787644386291504, - -2.647423028945923, - 0.20815563201904297 - ], - [ - 716.8663714528084, - 460.0534674525261, - -0.007689952850341797, - -1.0955625772476196, - 0.9894769191741943, - -0.9086135625839233 - ], - [ - 456.0470775961876, - 442.9488200545311, - 5.139568328857422, - 0.9967501163482666, - 0.9419887065887451, - -1.2761722803115845 - ], - [ - 358.40972417593, - 271.36242431402206, - -0.37357473373413086, - -0.19354677200317383, - -5.611996650695801, - -0.9128594398498535 - ], - [ - 286.96299093961716, - 243.98135417699814, - -0.2286221981048584, - 0.15703296661376953, - -1.1040807962417603, - -1.21611750125885 - ], - [ - 378.96382945775986, - 243.98135417699814, - -0.2286221981048584, - 0.15703296661376953, - -1.1040807962417603, - -1.21611750125885 - ], - [ - 676.6378134042025, - 174.37069338560104, - 5.87470817565918, - -0.7370781898498535, - 0.33743977546691895, - 0.763629674911499 - ], - [ - 764.9826234653592, - 86.26955485343933, - 0.11350247263908386, - 0.06860315799713135, - -2.8641035556793213, - 1.2456836700439453 - ], - [ - 649.0219939798117, - 81.81765568256378, - 0.00759202241897583, - -0.160802960395813, - -1.2374593019485474, - 0.6389224529266357 - ], - [ - 1382.9450635910034, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 320.3464569747448, - 312.8800956904888, - -5.107377529144287, - -1.1473329067230225, - -0.17608284950256348, - -0.31628185510635376 - ], - [ - 273.83666238188744, - 205.67351964116096, - 0.754423975944519, - -0.2705498933792114, - -2.4659018516540527, - 0.92705237865448 - ], - [ - 562.1967021524906, - 519.5781470835209, - 0.11833453178405762, - 0.49973583221435547, - -0.4897525906562805, - -0.8269169330596924 - ], - [ - 554.8353033661842, - 533.8870105147362, - -0.09026670455932617, - 0.13237524032592773, - 5.382619380950928, - -0.964556097984314 - ], - [ - 494.4641035795212, - 456.243500828743, - 0.06076765060424805, - 0.6302964687347412, - 4.996323585510254, - 0.4667534828186035 - ], - [ - 446.33694928884506, - 416.1738634109497, - -5.060272693634033, - -0.4810500144958496, - -0.8750579357147217, - 0.9501380920410156 - ], - [ - 299.5315877199173, - 231.48046299815178, - -0.002225637435913086, - 1.1405787467956543, - -4.531327247619629, - -1.8515856266021729 - ], - [ - 273.11859384179115, - 205.50657132267952, - -0.5817697048187256, - 0.7180514931678772, - 1.4914058446884155, - -0.528008759021759 - ], - [ - 585.851346373558, - 571.1616952419281, - 0.2893420457839966, - -0.10520976781845093, - -0.9443706274032593, - -0.07954573631286621 - ], - [ - 306.58141899108887, - 282.03421771526337, - 0.36527812480926514, - -0.1337440013885498, - 2.6584715843200684, - -0.41457700729370117 - ], - [ - 392.5217110514641, - 355.2770085930824, - -0.6584032773971558, - -0.05862891674041748, - 1.3515360355377197, - 0.8760770559310913 - ], - [ - 845.2809689044952, - 840.1326499581337, - -0.03219103813171387, - 0.567402184009552, - 0.537311315536499, - -0.23481690883636475 - ], - [ - 890.7013285756111, - 833.9982312321663, - 0.443426251411438, - -0.8665639758110046, - 0.276688814163208, - 1.2458157539367676 - ], - [ - 812.8720337748528, - 806.4785344004631, - -1.359341025352478, - 0.5086686611175537, - -4.014031887054443, - -0.6510103940963745 - ], - [ - 572.9515442848206, - 556.4453747868538, - 1.2256730794906616, - -0.33808743953704834, - 4.483767032623291, - -0.0753781795501709 - ], - [ - 505.10947251319885, - 492.20502722263336, - -0.023506879806518555, - -0.06028163433074951, - 5.677853584289551, - -0.0916205644607544 - ], - [ - 503.03195852041245, - 484.90466022491455, - 0.3559532165527344, - -0.2355656623840332, - 0.8704935312271118, - 0.2772397994995117 - ], - [ - 520.9930582642555, - 513.6256061196327, - 4.034934043884277, - 0.18383875489234924, - 1.242362141609192, - 0.22955432534217834 - ], - [ - 467.6294862627983, - 462.6310903429985, - -5.397040367126465, - -0.5732532143592834, - -0.0824894905090332, - 1.3090171813964844 - ], - [ - 443.2171590477228, - 375.2113288193941, - 0.8381065130233765, - 0.3630943298339844, - -3.625174045562744, - -0.9038658142089844 - ], - [ - 901.2466291189194, - 891.0937949419022, - -0.04304635524749756, - 0.15884685516357422, - -0.7646319270133972, - -0.18069350719451904 - ], - [ - 904.2390102148056, - 883.1796106696129, - -0.533449649810791, - 0.7491567134857178, - 1.5187758207321167, - -0.612513542175293 - ], - [ - 509.57519076764584, - 501.4014223664999, - -0.12575095891952515, - 0.09796029329299927, - 2.5484280586242676, - 0.6821891069412231 - ], - [ - 444.27020750939846, - 435.59934101998806, - -0.5187702178955078, - 0.3887614607810974, - -0.5200493335723877, - 1.0738255977630615 - ], - [ - 362.21130584180355, - 348.5810320228338, - 0.01580333709716797, - 0.3101426362991333, - 2.1951022148132324, - 0.5036535263061523 - ], - [ - 703.9301252961159, - 597.1940866112709, - 4.473799705505371, - 0.28486642241477966, - 0.9092385768890381, - 0.12856972217559814 - ], - [ - 642.4737839698792, - 628.562950015068, - -1.3676097393035889, - 1.0253013372421265, - -0.029550552368164062, - -1.197189450263977 - ], - [ - 536.9837630987167, - 509.43430787324905, - 0.5389299392700195, - 1.0132337808609009, - -1.1472400426864624, - -1.055070161819458 - ], - [ - 362.66158071160316, - 352.46830835938454, - -0.1721898317337036, - -0.4464971423149109, - -0.2942624092102051, - -0.046103060245513916 - ], - [ - 656.2402014732361, - 613.9543146491051, - -0.04403078556060791, - 0.14354705810546875, - 0.13154816627502441, - -0.7997232675552368 - ], - [ - 677.9811907708645, - 663.3935803472996, - 0.11724638938903809, - 0.6455438137054443, - -0.2624102830886841, - -0.12325811386108398 - ], - [ - 703.7304964065552, - 656.1149581372738, - -0.1772019863128662, - -0.30472785234451294, - -2.006072998046875, - -0.020757198333740234 - ], - [ - 594.6949522197247, - 582.6366399228573, - -0.2529144287109375, - -0.23423010110855103, - 0.5134745836257935, - 1.112865924835205 - ], - [ - 509.0212150812149, - 500.2984557747841, - -0.1947118043899536, - 0.9427560567855835, - 4.992748737335205, - -0.8904646039009094 - ], - [ - 536.396862924099, - 495.0316031575203, - 0.4269890785217285, - -0.16871732473373413, - -1.87299382686615, - -0.20498782396316528 - ], - [ - 502.97176653146744, - 489.75214076042175, - -0.7729141712188721, - 1.8195408582687378, - -0.006287872791290283, - -1.4698379039764404 - ], - [ - 586.4416650757194, - 544.6446471437812, - -0.06072187423706055, - 0.27334827184677124, - -1.1635090112686157, - -0.41077226400375366 - ], - [ - 591.0120231583714, - 488.6886534616351, - -0.7576846480369568, - 1.1240260601043701, - 2.677934169769287, - -1.8263847827911377 - ], - [ - 470.07882160693407, - 462.49043453484774, - 0.04785871505737305, - -0.4719064235687256, - 1.3529880046844482, - -0.4384195804595947 - ], - [ - 485.49106577038765, - 478.33815255761147, - 0.10837197303771973, - 0.36653125286102295, - -0.5206942558288574, - -0.7427181005477905 - ], - [ - 342.0540819466114, - 334.1646640598774, - -0.027652740478515625, - 0.39720892906188965, - -0.4610757827758789, - -1.1105496883392334 - ], - [ - 405.41985979676247, - 392.42167672514915, - -0.050931453704833984, - 0.27894651889801025, - -4.543083190917969, - -1.5881189107894897 - ], - [ - 594.9674071967602, - 590.4756289422512, - 0.11196517944335938, - -0.018851518630981445, - 1.289534568786621, - 0.2430657148361206 - ], - [ - 565.1406097412109, - 556.6664479970932, - -4.352602005004883, - 1.0919770002365112, - -1.2929354906082153, - 0.23965203762054443 - ], - [ - 600.1461707353592, - 538.5948777198792, - 0.03950858116149902, - -0.1410306692123413, - -0.33491039276123047, - -0.6306273937225342 - ], - [ - 436.8815557062626, - 412.41330364346504, - -0.2670772075653076, - -0.7776139974594116, - 5.51232385635376, - 0.7928510904312134 - ], - [ - 310.2755993902683, - 297.7873822748661, - -0.0803835391998291, - -0.1478126049041748, - 1.4072415828704834, - -0.12383651733398438 - ], - [ - 532.7295295596123, - 513.4996159672737, - 0.11623668670654297, - 0.20304560661315918, - -0.25636565685272217, - 0.3543708324432373 - ], - [ - 516.5118299126625, - 499.0560172200203, - -0.018142104148864746, - -0.7833807468414307, - -0.8557678461074829, - -0.33608710765838623 - ], - [ - 298.24267715215683, - 290.0253981947899, - 1.0345361232757568, - 0.05056476593017578, - -5.148209095001221, - -1.2784479856491089 - ], - [ - 543.7829799950123, - 489.7655251324177, - 0.17055153846740723, - 0.8553866147994995, - 6.023222923278809, - -0.9072554707527161 - ], - [ - 372.7175350189209, - 350.6302925348282, - -1.635932207107544, - 1.0338164567947388, - -3.9592719078063965, - -1.4678726196289062 - ], - [ - 361.30132138729095, - 297.74939900636673, - 0.019849300384521484, - -0.3910808563232422, - -1.3059635162353516, - 1.1705931425094604 - ], - [ - 307.2927964925766, - 279.7945621609688, - -0.061165809631347656, - 0.02742946147918701, - 0.22481608390808105, - -0.39707159996032715 - ], - [ - 811.8773409426212, - 756.8151675760746, - 1.1993250846862793, - -0.33489853143692017, - 0.671198844909668, - 1.1470541954040527 - ], - [ - 824.9439314305782, - 770.2611808478832, - 0.22420954704284668, - 0.5312252044677734, - 0.6101512908935547, - -0.5232303738594055 - ], - [ - 819.0477968156338, - 812.4576264321804, - 0.4474886655807495, - -0.37633204460144043, - 0.5757046937942505, - -0.42168086767196655 - ], - [ - 684.3750420808792, - 676.8824261426926, - 0.029855847358703613, - -0.10791134834289551, - 3.747415542602539, - 1.608600378036499 - ], - [ - 680.1656913161278, - 534.4634956121445, - 0.04093453288078308, - -0.2880604863166809, - -0.5943617820739746, - 0.9271889328956604 - ], - [ - 532.8960741758347, - 527.9619092941284, - 0.2651550769805908, - -0.43554258346557617, - -1.805037260055542, - 1.068558692932129 - ], - [ - 556.6898472011089, - 423.39235281944275, - 0.11129692941904068, - 0.13991129398345947, - 0.9909278750419617, - -1.3364601135253906 - ], - [ - 390.0802319049835, - 385.12963968515396, - 0.02774141915142536, - -0.1164546012878418, - -1.128602385520935, - 0.020031094551086426 - ], - [ - 339.20814311504364, - 332.67198717594147, - -0.5640588998794556, - 1.2914249897003174, - -0.29561471939086914, - -1.2582833766937256 - ], - [ - 336.9299746751785, - 326.6454519033432, - -0.030564308166503906, - 0.15578055381774902, - 1.3146982192993164, - -0.9078660011291504 - ], - [ - 333.6278060078621, - 316.1319270133972, - -0.08822394907474518, - -0.29916125535964966, - 0.6429253816604614, - 0.9649935364723206 - ], - [ - 317.71212288737297, - 310.2992636859417, - -5.465391159057617, - -0.4779726266860962, - -0.3804452419281006, - 1.3179168701171875 - ], - [ - 300.22669246792793, - 288.40954354405403, - 0.23598432540893555, - -0.9510177373886108, - -0.5872988700866699, - 0.8295367956161499 - ], - [ - 476.10570192337036, - 458.7086236476898, - -5.146993637084961, - 1.2638994455337524, - -0.48028564453125, - -0.44745707511901855 - ], - [ - 283.127902507782, - 223.0388627052307, - -0.2123889923095703, - 0.22208166122436523, - 0.6201012134552002, - -0.4055604934692383 - ], - [ - 329.06014573574066, - 305.46025371551514, - 0.036249637603759766, - -0.3254518508911133, - 4.956445217132568, - 0.15610623359680176 - ], - [ - 263.8231199979782, - 240.56853330135345, - -0.019487380981445312, - 0.11257457733154297, - -0.5425256490707397, - -0.4408383369445801 - ], - [ - 455.60105642676353, - 435.7141250669956, - -0.03681230545043945, - 0.6183809041976929, - -0.3877429962158203, - -0.12994933128356934 - ], - [ - 420.9566167294979, - 406.5592941939831, - -0.3773375451564789, - 0.4121124744415283, - -2.322108268737793, - -1.3184843063354492 - ], - [ - 430.2689261138439, - 391.509185642004, - -0.04487895220518112, - -0.043259620666503906, - 0.3666713237762451, - 0.8513878583908081 - ], - [ - 288.05452701449394, - 283.31949660182, - -0.09230554103851318, - 0.0512242317199707, - -0.8728966116905212, - -0.9893016815185547 - ], - [ - 337.4359505325556, - 295.8237657248974, - 0.21932291984558105, - 0.3719440698623657, - -0.6703360080718994, - 0.02317047119140625 - ], - [ - 366.7719793021679, - 338.24975940585136, - -1.0730972290039062, - -0.5015574097633362, - 2.7137532234191895, - 0.8058267831802368 - ], - [ - 369.3227424919605, - 335.9236018359661, - -0.23302659392356873, - -0.13678157329559326, - -1.2225770950317383, - -0.45872098207473755 - ], - [ - 333.93554696440697, - 285.1927603185177, - 0.4681313633918762, - 0.4044250249862671, - -1.8258031606674194, - -0.45158636569976807 - ], - [ - 215.14788708090782, - 182.48132106661797, - 0.12448066473007202, - 0.4419472813606262, - -2.9645016193389893, - -0.8564066290855408 - ], - [ - 437.41756895184517, - 279.57405230402946, - 0.16560769081115723, - 0.4457952380180359, - 5.4883246421813965, - 0.4236034154891968 - ], - [ - 420.491332501173, - 187.30364832282066, - 0.7704950571060181, - -0.4501793384552002, - -2.1371636390686035, - 0.0974244475364685 - ], - [ - 278.56224822998047, - 185.31965926289558, - 0.22443699836730957, - -0.6723436117172241, - 0.07637906074523926, - 0.22660672664642334 - ], - [ - 611.6889958530664, - 557.6222232729197, - -0.05518350005149841, - -0.3526870012283325, - -0.04796242713928223, - 1.0795725584030151 - ], - [ - 525.4925582259893, - 502.6770264953375, - -0.166950523853302, - -0.13059020042419434, - -0.005825638771057129, - 0.6808124780654907 - ], - [ - 531.333074554801, - 481.1883826106787, - -0.03580266237258911, - -0.22152721881866455, - 0.45391207933425903, - 0.0239410400390625 - ], - [ - 682.9499835669994, - 678.6794438064098, - -0.1588151454925537, - 1.4608007669448853, - 1.4288513660430908, - -1.5553327798843384 - ], - [ - 746.6456324756145, - 648.2389428913593, - -0.10385773330926895, - -0.37840723991394043, - -1.0841870307922363, - -0.7673598527908325 - ], - [ - 636.0059399902821, - 630.2587849199772, - 0.3203558027744293, - 0.12082433700561523, - 1.5124356746673584, - -0.45213866233825684 - ], - [ - 565.3150130212307, - 553.9432717263699, - 0.05454146862030029, - 0.05360567569732666, - -0.6293324828147888, - -0.09754586219787598 - ], - [ - 445.70317700505257, - 436.6249612867832, - 0.18865644931793213, - 0.033087849617004395, - -1.487210988998413, - 0.2945793867111206 - ], - [ - 401.40692111849785, - 394.17862489819527, - -0.2163836807012558, - 0.12056756019592285, - -1.396072506904602, - -0.8094987869262695 - ], - [ - 377.0609104335308, - 373.5440556704998, - -0.6724022626876831, - -0.09867089986801147, - -0.05707120895385742, - 1.1748559474945068 - ], - [ - 524.3542577326298, - 516.9022450745106, - 0.4246804118156433, - 0.31155693531036377, - -0.997633695602417, - 0.11777281761169434 - ], - [ - 529.7752377092838, - 498.6109965145588, - 0.141877219080925, - -0.5780361294746399, - 0.23730923235416412, - 1.2374131679534912 - ], - [ - 496.6440621316433, - 487.25287160277367, - -0.17437861859798431, - -0.544419527053833, - -0.6395970582962036, - -0.5280840396881104 - ], - [ - 467.47288593649864, - 462.37153324484825, - -0.33149465918540955, - -0.02524280548095703, - -0.1623561680316925, - 0.166051983833313 - ], - [ - 302.73261511325836, - 287.90786385536194, - -0.6949591636657715, - -0.25949156284332275, - -5.2384138107299805, - -0.2741647958755493 - ], - [ - 419.2388049066067, - 262.06746247410774, - -1.9993066787719727, - -0.5872381925582886, - -3.795130968093872, - 0.4630012512207031 - ], - [ - 330.36129528284073, - 232.8944917023182, - -0.8330996036529541, - -0.2574196457862854, - 5.972322463989258, - 0.49082666635513306 - ], - [ - 250.96090379357338, - 171.4908383190632, - -0.5257514715194702, - 0.5505855083465576, - -3.7318387031555176, - 0.30981874465942383 - ], - [ - 272.22547349333763, - 257.5730523765087, - 0.9568884372711182, - 0.37945854663848877, - -2.6137211322784424, - 0.4444441795349121 - ], - [ - 383.22921484708786, - 334.4846359491348, - -5.5164642333984375, - 0.08372759819030762, - -0.02308797836303711, - -0.30536091327667236 - ], - [ - 364.9861871600151, - 297.3220666050911, - 0.07955622673034668, - 0.1935194730758667, - -1.0182501077651978, - -0.25470495223999023 - ], - [ - 536.5194078087807, - 474.80888402462006, - 0.03780508041381836, - -0.10720175504684448, - -5.913273811340332, - 0.5160459280014038 - ], - [ - 604.020510405302, - 416.68431693315506, - -0.15678763389587402, - -0.8756027817726135, - -0.11988401412963867, - 1.4353904724121094 - ], - [ - 827.5006309747696, - 720.7646347880363, - 0.4194881319999695, - 0.2602057456970215, - 0.02855086326599121, - -0.4338364601135254 - ], - [ - 766.044330984354, - 752.1334886848927, - -0.11082909256219864, - 0.1716686487197876, - 1.2994353771209717, - 0.3187674283981323 - ], - [ - 728.0854970216751, - 688.3291877508163, - -0.48276567459106445, - 0.5263398885726929, - -5.432369232177734, - -0.7359595894813538 - ], - [ - 649.3336458802223, - 565.0314924120903, - -0.3012681007385254, - 0.3047950267791748, - -1.2371430397033691, - -1.3149114847183228 - ], - [ - 718.6711642444134, - 634.2495162189007, - 0.3238494098186493, - -0.42908549308776855, - 0.3517581820487976, - 1.2535018920898438 - ], - [ - 704.1391363441944, - 686.6980423033237, - -0.23761165142059326, - 0.5069948434829712, - -3.601022243499756, - -1.1536762714385986 - ], - [ - 835.2291916310787, - 730.4103346765041, - 0.003788590431213379, - 0.11014270782470703, - -1.1577098369598389, - 0.19246435165405273 - ], - [ - 674.3151278793812, - 667.1089641153812, - -1.7077490091323853, - -0.8339712023735046, - -3.628788948059082, - 0.29637008905410767 - ], - [ - 744.2465295791626, - 736.4866359233856, - -0.8993609547615051, - 0.766395092010498, - -0.58983314037323, - -1.622721552848816 - ], - [ - 737.5970296859741, - 631.3433438539505, - 0.37509462237358093, - 0.8257656097412109, - 0.7884525060653687, - -2.1699137687683105 - ], - [ - 763.4025711715221, - 662.4634579122066, - 1.045809030532837, - -0.33758431673049927, - 1.4757390022277832, - 0.7180729508399963 - ], - [ - 831.4905944764614, - 730.6935635507107, - 0.05394858121871948, - -0.021983623504638672, - 1.9066474437713623, - -0.1754448413848877 - ], - [ - 730.9653262794018, - 723.0066872537136, - -0.33519482612609863, - 0.8298007249832153, - -0.5961706638336182, - -0.26453447341918945 - ], - [ - 663.3231185972691, - 593.725710183382, - -0.0161898136138916, - 0.1566866636276245, - 0.18344151973724365, - 0.3135885000228882 - ], - [ - 943.9304618835449, - 809.6879720389843, - 0.03132982552051544, - -0.5016813278198242, - 1.544755458831787, - 1.6691755056381226 - ], - [ - 827.8074230849743, - 736.0525115430355, - -0.16927863657474518, - -0.03888297080993652, - 0.46307235956192017, - -0.17196321487426758 - ], - [ - 624.2213913202286, - 557.5661880970001, - 0.29258501529693604, - 0.37694263458251953, - 1.670609951019287, - 0.06817626953125 - ], - [ - 656.8397889137268, - 604.1808642148972, - 0.5457745790481567, - 0.17392468452453613, - -2.217473030090332, - -0.870223879814148 - ], - [ - 499.57932072877884, - 463.5859929919243, - 0.3396928906440735, - 0.3201415538787842, - -0.9704627990722656, - 0.04229021072387695 - ], - [ - 583.1678632199764, - 449.7943726181984, - 0.01649066060781479, - -0.01540994644165039, - 0.6603179574012756, - -0.7880933284759521 - ], - [ - 416.4668741822243, - 406.5863981246948, - -0.030530579388141632, - -0.2581073045730591, - -2.6894850730895996, - 0.6015787124633789 - ], - [ - 469.06352710723877, - 401.72473895549774, - 0.0750969648361206, - -0.5221878290176392, - -0.15197938680648804, - 0.8262218236923218 - ], - [ - 404.46923780441284, - 382.31468093395233, - 0.0812416598200798, - -0.4490569829940796, - -1.348215937614441, - -1.0160892009735107 - ], - [ - 585.610869705677, - 199.80334189534187, - 1.002305507659912, - -0.11048257350921631, - -2.0129072666168213, - 1.5515646934509277 - ], - [ - 521.1493827104568, - 503.42281901836395, - 0.5338666439056396, - -0.17545616626739502, - 2.0797858238220215, - -0.440778523683548 - ], - [ - 464.7202842235565, - 447.6945024728775, - 1.1222033500671387, - 2.7889344692230225, - 0.37468981742858887, - -2.24837064743042 - ], - [ - 432.1681345254183, - 364.56264205276966, - 0.3111744523048401, - -0.5358055830001831, - -0.7772567272186279, - 0.49767589569091797 - ], - [ - 356.75424967706203, - 309.48003198206425, - 0.5755603313446045, - 0.23699072003364563, - 2.9042530059814453, - 0.52659010887146 - ], - [ - 886.8718758225441, - 879.4192969202995, - 0.2587853968143463, - -0.17124927043914795, - 0.47101378440856934, - -0.23404169082641602 - ], - [ - 371.93303595483303, - 326.3270680755377, - 0.21263694763183594, - 0.32143843173980713, - 2.0074286460876465, - -1.110871434211731 - ], - [ - 724.2932702302933, - 418.9989911913872, - -0.4203815460205078, - -0.7886154651641846, - 5.63485050201416, - 0.06257043778896332 - ], - [ - 526.0129725337029, - 490.1452496647835, - 0.21875715255737305, - -0.24206650257110596, - -1.0466164350509644, - -1.0578551292419434 - ], - [ - 393.64851024746895, - 287.1291548907757, - -1.2000555992126465, - -0.27128374576568604, - -0.3436877727508545, - -0.35879719257354736 - ], - [ - 344.52999874949455, - 261.5657069385052, - -0.21845054626464844, - 0.31288766860961914, - 1.9131803512573242, - 0.3329501152038574 - ], - [ - 255.49033400416374, - 211.01950773596764, - -0.531984806060791, - -0.23747670650482178, - -0.6860430836677551, - 0.4582841396331787 - ], - [ - 677.942422658205, - 544.3719761967659, - -0.14550089836120605, - 0.8279582858085632, - -0.5745668411254883, - -0.5552501678466797 - ], - [ - 467.193902105093, - 459.6576592028141, - 0.1161605715751648, - -0.1849495768547058, - 2.003462553024292, - 0.8066540956497192 - ], - [ - 626.0453197881579, - 485.4377184808254, - -0.033666253089904785, - 0.3378664255142212, - 1.7742364406585693, - 0.13965487480163574 - ], - [ - 473.73088193684816, - 456.45974672585726, - 0.3107544183731079, - 0.3740873336791992, - 0.12795233726501465, - -0.7448750138282776 - ], - [ - 476.22450269013643, - 406.13281724601984, - 0.7220313549041748, - 0.26624077558517456, - 4.146862983703613, - -0.42082661390304565 - ], - [ - 451.733634442091, - 323.0886377990246, - -0.06682872772216797, - 0.0065572261810302734, - -0.06719613075256348, - -0.5979875326156616 - ], - [ - 345.73977956175804, - 317.46313259005547, - 0.20272541046142578, - 0.035331010818481445, - -6.119463920593262, - -1.402334451675415 - ], - [ - 491.6442443430424, - 305.02466574311256, - 0.46866345405578613, - 0.6142400503158569, - 0.20316362380981445, - -0.9160399436950684 - ], - [ - 438.74801579117775, - 249.65697339177132, - 0.3487398624420166, - 0.21662187576293945, - 4.639161109924316, - -0.9037367105484009 - ], - [ - 236.05680963397026, - 221.59485098719597, - 0.1295793056488037, - -0.058242082595825195, - 0.6593929529190063, - -1.5028061866760254 - ], - [ - 301.6659318804741, - 284.79929316043854, - 0.11171817779541016, - -0.31121599674224854, - 3.0002527236938477, - 1.0962570905685425 - ], - [ - 790.0428938567638, - 781.3025670349598, - -0.5258222818374634, - -0.23623037338256836, - 2.198922872543335, - -0.5071533918380737 - ], - [ - 607.6959058046341, - 603.1657596826553, - -0.1287233829498291, - -0.05560016632080078, - 1.3380460739135742, - -0.3173176646232605 - ], - [ - 383.4959858059883, - 255.86057895421982, - 0.494128942489624, - -0.40226995944976807, - -3.0771427154541016, - -0.532323956489563 - ], - [ - 397.95507913827896, - 272.3556728363037, - 0.4504685401916504, - 0.7695231437683105, - 0.2246037721633911, - -2.0268192291259766 - ], - [ - 296.6996202468872, - 260.4006417989731, - 0.21277117729187012, - 0.45549046993255615, - -0.7146314978599548, - 0.9330289363861084 - ], - [ - 370.00240352749825, - 305.840389251709, - 0.3526172637939453, - 0.7999547719955444, - 2.0119681358337402, - -0.8855571150779724 - ], - [ - 255.52648636698723, - 239.7862478196621, - -0.0032656192779541016, - -0.23157954216003418, - 0.4174656867980957, - 0.6339941024780273 - ], - [ - 450.2063548564911, - 256.4986158013344, - 0.008210182189941406, - 0.3786356449127197, - -5.925825119018555, - -0.15215790271759033 - ], - [ - 226.94981813430786, - 211.0277373790741, - -0.6997908353805542, - 0.7672833204269409, - 1.4924119710922241, - -0.1559581756591797 - ], - [ - 359.2434683442116, - 299.8238896727562, - -0.05244565010070801, - 0.3366813659667969, - -6.015974044799805, - 0.5102560520172119 - ], - [ - 249.865667283535, - 240.33509266376495, - -0.040174245834350586, - -0.9195233583450317, - -0.33282899856567383, - 0.7731598615646362 - ], - [ - 292.6389615237713, - 274.3972118794918, - -0.11903560161590576, - -0.04093575477600098, - -1.5786783695220947, - -1.0259101390838623 - ], - [ - 292.295990139246, - 286.28061440587044, - -0.03433153033256531, - -0.010070085525512695, - -1.859474539756775, - 0.12272405624389648 - ], - [ - 342.59814634919167, - 174.68789753317833, - 0.5922969579696655, - 0.5771080255508423, - 1.5011707544326782, - -0.5221728682518005 - ], - [ - 398.8309471309185, - 159.56948694586754, - -1.6101479530334473, - 2.4061927795410156, - -2.4645590782165527, - -1.8640292882919312 - ], - [ - 544.0210441797972, - 522.8335934430361, - -0.28614914417266846, - -0.11990594863891602, - -0.2694634795188904, - -0.9192067384719849 - ], - [ - 452.54102735221386, - 447.0487037152052, - -0.46763181686401367, - 0.3839017152786255, - 1.0333046913146973, - -0.38618743419647217 - ], - [ - 391.04040881991386, - 371.60505923628807, - 0.06593243777751923, - 0.4110301733016968, - 1.348207712173462, - -0.468447208404541 - ], - [ - 562.824738651514, - 339.56063535809517, - 0.1066540777683258, - 0.0959322452545166, - -0.5513086318969727, - -0.6424281597137451 - ], - [ - 290.3125708401203, - 253.73481366038322, - -0.11315727233886719, - 0.5012606382369995, - -0.8591241836547852, - 0.1818021535873413 - ], - [ - 847.8638243973255, - 542.5695118904114, - 0.3309548497200012, - 0.7400373816490173, - 0.126216858625412, - -0.009948968887329102 - ], - [ - 660.5542903542519, - 633.0048246383667, - 0.07713067531585693, - 0.5680239200592041, - 1.1241207122802734, - -0.4892209768295288 - ], - [ - 704.9145434200764, - 679.1845886409283, - -0.30295610427856445, - -0.4470309019088745, - -5.3303728103637695, - 0.29467833042144775 - ], - [ - 674.513499289751, - 650.5904190838337, - 0.3443402051925659, - -0.7644655704498291, - -0.8716645240783691, - 1.2070293426513672 - ], - [ - 727.4162160158157, - 695.8523522615433, - 0.8151386976242065, - -0.08125972747802734, - -2.107778310775757, - 0.29876089096069336 - ], - [ - 747.0234097838402, - 614.667312681675, - 0.22906744480133057, - 0.2503849267959595, - 0.5325063467025757, - 0.11982846260070801 - ], - [ - 814.9727681577206, - 655.934606641531, - 0.29963576793670654, - 0.9637887477874756, - -0.9278880953788757, - -1.5844323635101318 - ], - [ - 723.7196303904057, - 650.7252794802189, - 0.14338494837284088, - 0.1157999038696289, - 1.4279228448867798, - -0.9101704955101013 - ], - [ - 663.9623835086823, - 581.8428134918213, - 0.3312222957611084, - 0.6113955974578857, - -1.587320327758789, - -1.6294677257537842 - ], - [ - 329.92955657839775, - 154.39435422420502, - -0.3346109986305237, - 0.16928446292877197, - 0.7405552268028259, - 1.55775785446167 - ], - [ - 477.813545525074, - 443.9012184739113, - -0.08317668735980988, - -0.1507297158241272, - -0.9184658527374268, - 0.04937368631362915 - ], - [ - 479.4375132918358, - 331.0871024131775, - -0.3562614917755127, - -0.3768731355667114, - -0.4538119435310364, - 0.8382986783981323 - ], - [ - 315.1644480228424, - 252.72476375102997, - -0.12459588050842285, - 0.028559327125549316, - -1.8368690013885498, - 1.3354017734527588 - ], - [ - 256.87766259908676, - 187.19287490844727, - -0.20267879962921143, - -0.2773280143737793, - 2.0171711444854736, - -0.619411826133728 - ], - [ - 688.0351278781891, - 424.4783811569214, - -0.3096463680267334, - 1.1358799934387207, - 4.406667232513428, - -1.7707830667495728 - ], - [ - 246.80198986828327, - 225.4321414977312, - -4.03807258605957, - 0.9216694831848145, - -1.476455569267273, - -1.07590651512146 - ], - [ - 883.4394263625145, - 851.0392993092537, - 0.0710018202662468, - 0.5338476896286011, - 0.23313650488853455, - -0.9319287538528442 - ], - [ - 422.28269700706005, - 312.8555538505316, - -0.45554447174072266, - 0.5217916369438171, - 4.9146928787231445, - 0.4859619140625 - ], - [ - 343.8466091006994, - 282.4896771758795, - -4.58288049697876, - -1.2046265602111816, - -1.3228144645690918, - 1.27809476852417 - ], - [ - 544.5959624648094, - 414.8607470393181, - -0.6203498840332031, - 1.7008923292160034, - -4.592937469482422, - -1.2463572025299072 - ], - [ - 510.74267795681953, - 469.6673092544079, - -0.13392186164855957, - 0.02967602014541626, - -2.121971607208252, - -0.514745831489563 - ], - [ - 654.6015073657036, - 447.7178425490856, - 1.7675083875656128, - 0.5894231796264648, - 1.7183992862701416, - -0.1422235369682312 - ], - [ - 578.8807070925832, - 368.7561784982681, - 0.7702834606170654, - 0.057554423809051514, - -1.7760969400405884, - 0.07083410024642944 - ], - [ - 820.0457042753696, - 766.8304814994335, - 0.2288280725479126, - 1.1366281509399414, - 3.641812801361084, - -1.1621662378311157 - ], - [ - 414.3080683350563, - 249.3158906698227, - -0.26436465978622437, - -0.2379699945449829, - -1.0694200992584229, - 0.8634177446365356 - ], - [ - 299.3986122608185, - 288.9609271287918, - -0.23346251249313354, - -0.372352659702301, - 2.0942745208740234, - 0.6095876693725586 - ], - [ - 338.19502279162407, - 213.38814026117325, - -0.26771044731140137, - 0.8300786018371582, - 0.7412176132202148, - -0.7780119180679321 - ], - [ - 294.62473809719086, - 185.80892133712769, - 0.06580615043640137, - -0.01668834686279297, - -0.7520322799682617, - 0.6506437063217163 - ], - [ - 373.3454216122627, - 181.38157314062119, - 0.42221903800964355, - -0.17248201370239258, - 0.4581179618835449, - 0.7732229232788086 - ], - [ - 264.62252283096313, - 174.99761980772018, - 0.17837262153625488, - -0.015402555465698242, - 0.2503089904785156, - 0.37920594215393066 - ], - [ - 244.6029428243637, - 234.63337671756744, - 5.166302680969238, - -0.6002939343452454, - 0.838754415512085, - 1.4969658851623535 - ], - [ - 295.4333539903164, - 230.46244558691978, - 0.2841859757900238, - -0.46852385997772217, - 0.9973890781402588, - 0.9407006502151489 - ], - [ - 266.3034060895443, - 258.7418188750744, - 0.14230452477931976, - -0.03765583038330078, - -1.2343947887420654, - 0.050990939140319824 - ], - [ - 511.99838633835316, - 497.4933775216341, - 0.33116552233695984, - -1.210108995437622, - 0.5579907894134521, - 1.424198865890503 - ], - [ - 536.8776050657034, - 410.42683397233486, - -0.19024015963077545, - 0.04013872146606445, - -0.50516676902771, - -0.16156315803527832 - ], - [ - 326.44470474123955, - 164.99075999855995, - 0.3272932767868042, - -0.1665370762348175, - -0.8191413879394531, - 1.117356538772583 - ], - [ - 649.5834965705872, - 613.7157731056213, - -0.2808724641799927, - -0.16866421699523926, - -0.9652286767959595, - 1.1169919967651367 - ], - [ - 781.8323676884174, - 622.5319277942181, - 0.8093105554580688, - -0.11776924133300781, - -2.2324376106262207, - -0.192030668258667 - ], - [ - 853.5207880437374, - 567.963035851717, - 0.16325914859771729, - 0.6474634408950806, - -1.5194323062896729, - -0.04044961929321289 - ], - [ - 755.8712683916092, - 600.220652192831, - 0.37155580520629883, - -0.9831621646881104, - 0.31459298729896545, - 0.20438039302825928 - ], - [ - 778.2353332042694, - 603.3577270209789, - 0.1277403086423874, - -0.31143391132354736, - 0.2264683097600937, - 1.1564005613327026 - ], - [ - 667.8181719779968, - 521.8360546827316, - -0.05406954884529114, - -0.20566272735595703, - 1.5108911991119385, - -0.37602710723876953 - ], - [ - 327.4528507590294, - 306.60747998952866, - 0.007088899612426758, - -0.8695270419120789, - 4.575531959533691, - 1.7343182563781738 - ], - [ - 848.5299023389816, - 842.6282187104225, - -0.3652583062648773, - 0.21581971645355225, - 1.8463414907455444, - 0.047388315200805664 - ], - [ - 373.66102051734924, - 365.01498448848724, - 1.7148815393447876, - 1.480846643447876, - 3.8371448516845703, - -1.586581826210022 - ], - [ - 305.3426172733307, - 262.4381687641144, - -0.10183596611022949, - 0.2214204967021942, - 5.418609619140625, - 2.2401058673858643 - ], - [ - 374.2239090204239, - 361.94868725538254, - -1.464093565940857, - 0.31125831604003906, - -2.8093619346618652, - -0.5811236500740051 - ], - [ - 812.957916289568, - 744.1917037069798, - 0.21766018867492676, - 0.06432980298995972, - 2.7311015129089355, - -0.031996846199035645 - ], - [ - 731.875363111496, - 580.2275975942612, - -0.14327609539031982, - -0.18542063236236572, - -0.07671308517456055, - -0.6034493446350098 - ], - [ - 391.31144267320633, - 187.45804345607758, - -0.24210482835769653, - 0.4086127281188965, - -1.129225492477417, - -0.6712465882301331 - ], - [ - 258.9664328098297, - 219.51030099391937, - 0.6886005401611328, - -0.3968713879585266, - -2.329124927520752, - 0.5702096819877625 - ], - [ - 401.6159054338932, - 231.1150579750538, - 0.03753200173377991, - 0.5154622793197632, - -0.2880932092666626, - -0.4687730073928833 - ], - [ - 278.0991579592228, - 238.80187359452248, - -0.07345466315746307, - -0.1589183807373047, - 2.836517810821533, - -1.7115830183029175 - ], - [ - 743.7585079669952, - 538.4312614202499, - -0.7173507809638977, - -0.7085002064704895, - 2.4536283016204834, - 0.32205432653427124 - ], - [ - 837.2553814351559, - 525.2461910247803, - 0.38811132311820984, - -0.0760042667388916, - 1.6121129989624023, - 0.8730722665786743 - ], - [ - 724.5934523046017, - 585.7999987900257, - -0.9506974220275879, - -0.11714792251586914, - 2.4141178131103516, - -0.3410937786102295 - ], - [ - 766.9311166703701, - 575.0266081392765, - -0.010364517569541931, - -0.1356666088104248, - 1.1100701093673706, - -0.33395957946777344 - ], - [ - 543.7128033041954, - 471.5792188048363, - 0.029868431389331818, - -1.6263501644134521, - 0.07120189815759659, - 1.870969295501709 - ], - [ - 677.1609827578068, - 220.88982105255127, - 0.2744174003601074, - -0.01726377010345459, - 3.3465728759765625, - -0.206731915473938 - ], - [ - 836.4469905495644, - 814.6789902448654, - 0.3339310586452484, - 0.047425031661987305, - -0.8316378593444824, - -0.9908491373062134 - ], - [ - 659.1021650880575, - 198.55045384168625, - 0.2890205383300781, - -0.34227514266967773, - -5.44842529296875, - -1.4865732192993164 - ], - [ - 634.8928223699331, - 261.30136612057686, - 1.5038552284240723, - -0.07787752151489258, - 3.881056070327759, - 0.7278037071228027 - ], - [ - 624.2517829835415, - 202.49126902222633, - 0.011495351791381836, - 1.784647822380066, - -0.2686727046966553, - -1.8578548431396484 - ], - [ - 664.8659510612488, - 172.94489759206772, - -0.43091464042663574, - -0.047746241092681885, - 0.9919381141662598, - 1.5843311548233032 - ], - [ - 505.4363969564438, - 497.9596937894821, - 0.221541166305542, - 0.5178661346435547, - -1.1285669803619385, - -0.6801034212112427 - ], - [ - 659.0565729141235, - 496.6946156024933, - 0.7474480867385864, - 0.025191307067871094, - -1.725996494293213, - -0.08064937591552734 - ], - [ - 345.35271018743515, - 226.83221819996834, - 0.3368491530418396, - -0.2229846715927124, - 1.566259741783142, - 0.6694917678833008 - ], - [ - 227.781426101923, - 219.75605550408363, - -0.561697244644165, - 0.39565229415893555, - 2.0136077404022217, - -1.1091996431350708 - ], - [ - 266.53115010261536, - 196.72522827982903, - 0.037673354148864746, - 0.3947179317474365, - -0.9255232810974121, - -1.2747384309768677 - ], - [ - 325.80292361974716, - 188.67079910635948, - 0.7803943157196045, - 0.7232098579406738, - -1.8646854162216187, - -1.2256534099578857 - ], - [ - 586.8465299606323, - 429.3792122602463, - -0.41458216309547424, - -0.6818073987960815, - 0.9874414205551147, - 0.37975823879241943 - ], - [ - 837.3091332614422, - 492.5450328886509, - 0.3564126789569855, - 0.1795501708984375, - 1.1397773027420044, - -0.6575781106948853 - ], - [ - 552.6689546406269, - 515.7065512239933, - -0.11090891063213348, - 0.678532600402832, - 0.48890241980552673, - -0.6989336013793945 - ], - [ - 629.5581651926041, - 173.52561783790588, - -1.721213459968567, - -0.04096055030822754, - -1.841633915901184, - -0.5558876991271973 - ], - [ - 821.0324122905731, - 787.9913313388824, - -0.09687215834856033, - -0.21930372714996338, - 0.9114773273468018, - 0.27213573455810547 - ], - [ - 707.1201036572456, - 143.3252231478691, - -0.07641386985778809, - -0.5555512309074402, - 4.063166618347168, - 1.1929380893707275 - ], - [ - 263.70338010787964, - 256.81560373306274, - -0.02030324935913086, - -0.0691300630569458, - 0.1744328737258911, - -1.1747822761535645 - ], - [ - 728.8627271652222, - 171.11410266160965, - -1.019355297088623, - -0.14918625354766846, - 2.509315013885498, - -0.6593958139419556 - ], - [ - 228.74747815728188, - 223.64150193333626, - 0.12333643436431885, - 0.3265928030014038, - 2.0809035301208496, - -0.6460188627243042 - ], - [ - 218.36816748976707, - 203.30186572670937, - -0.6371698379516602, - 0.30095118284225464, - -0.12355108559131622, - -0.7756690979003906 - ], - [ - 295.81105503439903, - 161.94563326239586, - -0.21715980768203735, - 0.24996328353881836, - 1.8561538457870483, - 0.8774664402008057 - ], - [ - 853.6491158306599, - 461.58869430422783, - 1.3539254665374756, - 0.19415819644927979, - 0.01873665675520897, - 0.7858350276947021 - ], - [ - 503.5953744649887, - 442.0369231104851, - -0.5454213619232178, - 0.3945375680923462, - 1.4768630266189575, - 0.5292582511901855 - ], - [ - 720.0503506958485, - 714.4212194979191, - 0.08015500754117966, - -0.2349081039428711, - -1.0351293087005615, - 0.44011569023132324 - ], - [ - 555.9603625833988, - 145.2517747282982, - -0.19428503513336182, - 0.2901425361633301, - 3.0370824337005615, - -0.035386085510253906 - ], - [ - 437.6290730535984, - 198.77391746640205, - -0.05135461688041687, - 0.09419035911560059, - 0.851459264755249, - -1.1387276649475098 - ], - [ - 438.7884919345379, - 133.6015000641346, - -0.4959443211555481, - -0.008965134620666504, - 1.116037368774414, - -1.3985588550567627 - ], - [ - 621.5402746349573, - 128.5340098440647, - 0.5484337210655212, - 0.11469161510467529, - -1.2747710943222046, - 0.1478409767150879 - ], - [ - 486.0606123805046, - 437.6144353747368, - -0.35534441471099854, - 0.24326884746551514, - -1.1538710594177246, - -0.12790381908416748 - ], - [ - 828.4828617572784, - 434.53650015592575, - -0.21425104141235352, - 1.3819022178649902, - 0.8631695508956909, - -1.5522782802581787 - ], - [ - 589.8141059577465, - 564.7131807506084, - -0.08423511683940887, - 0.2734869718551636, - 1.6655694246292114, - 1.0310900211334229 - ], - [ - 825.4727962315083, - 124.84343045949936, - -0.16340041160583496, - 0.11030590534210205, - 1.968489408493042, - 0.41386282444000244 - ], - [ - 455.8486447632313, - 174.4477797150612, - -0.1937500536441803, - 0.15798616409301758, - -1.137331247329712, - -0.9982972145080566 - ], - [ - 913.5272924304008, - 408.63128650188446, - -0.4023706912994385, - 1.2953757047653198, - -0.23160713911056519, - -1.4734077453613281 - ], - [ - 403.6834453344345, - 398.03621739149094, - -0.15972258150577545, - 0.0513303279876709, - 1.5288535356521606, - 0.49658215045928955 - ], - [ - 489.3655930161476, - 140.50618332624435, - -0.026770342141389847, - -0.11036312580108643, - 1.8773857355117798, - -0.5619394779205322 - ], - [ - 434.0059335231781, - 375.4224897623062, - -0.17340266704559326, - -1.0454285144805908, - 2.310626983642578, - 0.795856773853302 - ], - [ - 443.2249014824629, - 212.1711524128914, - 0.060467854142189026, - 0.8970510959625244, - 2.658642292022705, - -0.919904351234436 - ], - [ - 648.4651457667351, - 340.5221952199936, - -1.1343908309936523, - -0.11404204368591309, - 4.423769950866699, - 0.39298343658447266 - ], - [ - 934.660780608654, - 164.8414422273636, - -0.19654209911823273, - -1.9759620428085327, - 0.48828721046447754, - 1.957950472831726 - ], - [ - 789.9567734003067, - 135.5168587565422, - 0.7125057578086853, - -0.6600463390350342, - 2.2071402072906494, - -0.21567416191101074 - ], - [ - 860.7215384542942, - 120.2981225848198, - -0.07292520999908447, - -0.737284779548645, - 1.6371577978134155, - 2.022134304046631 - ], - [ - 516.5651733279228, - 275.1032947897911, - -0.2336418330669403, - 0.20981156826019287, - 2.860910415649414, - -0.19827580451965332 - ], - [ - 707.7351241707802, - 106.91575193405151, - 0.5180634260177612, - -0.3195575475692749, - 3.258352756500244, - -1.277012825012207 - ], - [ - 393.4336379170418, - 227.5863333940506, - -0.1374874860048294, - 0.0997014045715332, - 2.7616350650787354, - -0.017386913299560547 - ], - [ - 419.6918982565403, - 124.08418571949005, - -0.04683937877416611, - 0.22421222925186157, - 1.7686994075775146, - -0.769890308380127 - ], - [ - 315.07461178302765, - 121.6561666727066, - 2.7151401042938232, - 0.6086741089820862, - 2.887399673461914, - 0.7751800417900085 - ], - [ - 791.2275979816914, - 115.21936237812042, - -0.6672149300575256, - 0.04169034957885742, - -3.4814772605895996, - -0.9741600751876831 - ], - [ - 562.4127712547779, - 109.80239820480347, - 0.08217954635620117, - -1.2035119533538818, - -1.473663330078125, - 0.6729074716567993 - ], - [ - 948.095840215683, - 90.92123872041702, - 0.5687556266784668, - -0.14505672454833984, - 3.9812850952148438, - 0.3693239688873291 - ], - [ - 1028.2522927820683, - 0, - NaN, - NaN, - NaN, - NaN - ] - ] - ], - "trunk": { - "absolute_elevation_deviation": { - "data": { - "bins": [ - -0.7257994413375854, - -0.6885373592376709, - -0.6512753367424011, - -0.6140133142471313, - -0.5767512321472168, - -0.539489209651947, - -0.5022271871566772, - -0.4649651348590851, - -0.4277031123638153, - -0.39044106006622314, - -0.35317903757095337, - -0.3159169852733612, - -0.27865496277809143, - -0.24139292538166046, - -0.2041308879852295, - -0.16686883568763733, - -0.12960681319236755, - -0.09234476834535599, - -0.05508273094892502, - -0.01782069355249405, - 0.01944134384393692, - 0.05670338124036789, - 0.09396541863679886, - 0.13122746348381042, - 0.1684894859790802, - 0.20575153827667236, - 0.24301357567310333, - 0.2802756130695343, - 0.3175376355648041, - 0.35479968786239624 - ], - "weights": [ - 1, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 1 - ] - } - }, - "azimuth": { - "uniform": { - "max": 0.0, - "min": 3.141592653589793 - } - }, - "orientation_deviation": { - "data": { - "bins": [ - -0.48333333333333334, - -0.45, - -0.4166666666666667, - -0.38333333333333336, - -0.35000000000000003, - -0.31666666666666665, - -0.2833333333333333, - -0.25, - -0.21666666666666667, - -0.18333333333333335, - -0.15000000000000002, - -0.11666666666666667, - -0.08333333333333331, - -0.04999999999999999, - -0.016666666666666663, - 0.016666666666666663, - 0.04999999999999999, - 0.08333333333333331, - 0.11666666666666664, - 0.14999999999999997, - 0.1833333333333333, - 0.21666666666666662, - 0.24999999999999994, - 0.2833333333333333, - 0.3166666666666667, - 0.35000000000000003, - 0.38333333333333336, - 0.4166666666666667, - 0.45, - 0.48333333333333334 - ], - "weights": [ - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 2, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0 - ] - } - } - } - }, - "basal": { - "filtration_metric": "path_distances", - "num_trees": { - "data": { - "bins": [ - 3, - 4, - 5, - 6, - 7 - ], - "weights": [ - 1, - 0, - 0, - 0, - 1 - ] - } - }, - "persistence_diagram": [ - [ - [ - 224.38319063186646, - 219.2606019973755, - -0.4379599988460541, - -0.005312919616699219, - -0.8848207592964172, - 0.09015583992004395 - ], - [ - 400.9616605043411, - 384.7926591038704, - -0.057923853397369385, - -0.289974570274353, - -2.5282816886901855, - -0.15708374977111816 - ], - [ - 192.41142231225967, - 178.48044949769974, - 0.9341675639152527, - 0.13731694221496582, - -1.9108004570007324, - -0.36382102966308594 - ], - [ - 212.02685528993607, - 204.79348236322403, - -1.037257194519043, - 0.6260798573493958, - -4.952030658721924, - 0.0439608097076416 - ], - [ - 174.49314105510712, - 166.01364123821259, - 0.8455920219421387, - 1.9787335395812988, - -2.6705470085144043, - -2.1493306159973145 - ], - [ - 280.87815886735916, - 72.90992110967636, - 0.05115431547164917, - -0.25066912174224854, - -1.0350282192230225, - -0.1008913516998291 - ], - [ - 124.64597976207733, - 116.80670726299286, - -0.04528069496154785, - -0.6709880828857422, - 5.494875907897949, - 0.6105341911315918 - ], - [ - 221.2086187005043, - 111.25251829624176, - 0.2337489128112793, - 1.069451093673706, - -5.322473049163818, - -0.8068923950195312 - ], - [ - 180.18831837177277, - 51.97151494026184, - 0.39078283309936523, - 0.09945124387741089, - -1.4081227779388428, - 0.10724371671676636 - ], - [ - 416.0371113419533, - 38.79454827308655, - 0.46909475326538086, - 1.056646704673767, - 1.8869953155517578, - -1.014134168624878 - ], - [ - 416.89264065027237, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 138.14135348796844, - 91.25013053417206, - 0.15326452255249023, - -1.7054014205932617, - -1.867674469947815, - 0.8106864094734192 - ], - [ - 131.90395653247833, - 63.07564151287079, - 0.8644651174545288, - 0.2718007564544678, - -3.7785184383392334, - -0.3544936180114746 - ], - [ - 138.06671458482742, - 63.07564151287079, - 0.8644651174545288, - 0.2718007564544678, - -3.7785184383392334, - -0.3544936180114746 - ], - [ - 242.68944704532623, - 58.60613238811493, - 0.0914769172668457, - -0.7802324295043945, - -1.4150129556655884, - 0.4885904788970947 - ], - [ - 293.2285534143448, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 175.22094976902008, - 97.96781897544861, - -0.919957160949707, - -0.007689356803894043, - 2.2741498947143555, - -0.6524971723556519 - ], - [ - 106.60009527206421, - 96.86709189414978, - 0.06461894512176514, - -0.3159041404724121, - -1.6893795728683472, - -0.534130334854126 - ], - [ - 136.90290075540543, - 48.16596841812134, - 0.6720576882362366, - 0.32939839363098145, - -1.657493233680725, - 0.22861850261688232 - ], - [ - 160.5392016172409, - 41.71347534656525, - -0.581010103225708, - -0.6343587636947632, - 1.4430261850357056, - 1.1310216188430786 - ], - [ - 330.51422041654587, - 317.4096869826317, - 0.016859177500009537, - 0.49767184257507324, - -0.8041179180145264, - 0.09304702281951904 - ], - [ - 230.81945234537125, - 224.8626189827919, - 5.3906145095825195, - 0.3347291946411133, - 0.22713875770568848, - -0.06444239616394043 - ], - [ - 232.18228441476822, - 224.8626189827919, - 5.3906145095825195, - 0.3347291946411133, - 0.22713875770568848, - -0.06444239616394043 - ], - [ - 233.41182553768158, - 218.31597769260406, - 0.35965001583099365, - 1.197317123413086, - -1.1293777227401733, - -1.1000136137008667 - ], - [ - 148.39162427186966, - 106.62211829423904, - 0.03068673610687256, - 0.09539532661437988, - -0.47842979431152344, - -0.462985634803772 - ], - [ - 245.6610078215599, - 98.33350950479507, - -0.26952099800109863, - -0.19012248516082764, - 1.4764792919158936, - -0.3255033493041992 - ], - [ - 150.77250838279724, - 75.29946810007095, - -0.16319847106933594, - 0.4604736566543579, - -0.026409029960632324, - -0.588306188583374 - ], - [ - 376.89122742414474, - 33.44520962238312, - -0.4075583219528198, - -0.08236527442932129, - 1.3664050102233887, - 0.3029094934463501 - ], - [ - 444.9628998041153, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 72.2456042766571, - 59.06572461128235, - -0.22719597816467285, - -0.47536635398864746, - 0.8639277815818787, - 0.7764732837677002 - ], - [ - 50.22136551141739, - 20.470713138580322, - -0.23022526502609253, - 0.6774137020111084, - -0.7766646146774292, - -0.6992179155349731 - ], - [ - 81.19914650917053, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 84.11102020740509, - 69.41187500953674, - 0.3717796504497528, - -0.16651737689971924, - -1.3758314847946167, - -1.1515417098999023 - ], - [ - 110.07177996635437, - 33.85714316368103, - 0.35795435309410095, - 0.8591106534004211, - -0.979204535484314, - -0.729789137840271 - ], - [ - 111.95093750953674, - 22.643285810947418, - 0.5289139747619629, - -0.26415061950683594, - -1.2796070575714111, - -0.08773636817932129 - ], - [ - 135.23777049779892, - 15.699183404445648, - 0.5204403400421143, - -1.4032387733459473, - -1.1998522281646729, - 1.5046007633209229 - ], - [ - 213.82325011491776, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 66.89137238264084, - 21.836929082870483, - -0.9248316287994385, - -0.8310905694961548, - 2.4072179794311523, - 0.39566969871520996 - ], - [ - 118.18798178434372, - 20.19943106174469, - -0.12483343482017517, - -0.3173079490661621, - 0.34404516220092773, - 0.9239668846130371 - ], - [ - 142.4676097035408, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 44.37714385986328, - 38.24695086479187, - 0.12432551383972168, - 1.591630458831787, - -5.294160842895508, - -1.1023013591766357 - ], - [ - 28.54021382331848, - 21.25880318880081, - 0.05682194232940674, - 0.22250407934188843, - 0.1521090269088745, - 0.036199212074279785 - ], - [ - 48.9872065782547, - 31.529403746128082, - 0.7658979892730713, - -0.0608752965927124, - 4.620903968811035, - -0.3677207827568054 - ], - [ - 37.087240397930145, - 5.02096688747406, - 0.06502676010131836, - -0.6435763239860535, - -1.624915361404419, - 0.29766494035720825 - ], - [ - 54.37259578704834, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 176.18674612045288, - 43.43481993675232, - 0.2355484962463379, - -0.35823583602905273, - 4.983081817626953, - 0.544741153717041 - ], - [ - 138.93788081407547, - 30.439549565315247, - -0.17574119567871094, - 0.249129056930542, - 0.775327205657959, - -0.08188307285308838 - ], - [ - 133.23228877782822, - 21.987082839012146, - -0.017199993133544922, - 0.0005445480346679688, - 1.9876739978790283, - 0.8526766300201416 - ], - [ - 143.35193115472794, - 47.03661274909973, - -0.7615440487861633, - -0.4301486015319824, - 1.8479251861572266, - 1.1096973419189453 - ], - [ - 79.97001737356186, - 20.965715408325195, - -0.46784329414367676, - 0.9772166013717651, - -0.4411565661430359, - -1.0391178131103516 - ], - [ - 147.88678711652756, - 86.89016622304916, - -0.0009177923202514648, - -0.09192109107971191, - -0.8409171104431152, - 0.5593111515045166 - ], - [ - 153.6545004248619, - 21.672676980495453, - 0.5867823362350464, - -0.04882526397705078, - 3.3548412322998047, - -0.16812491416931152 - ], - [ - 108.86449658870697, - 64.82152760028839, - 0.5701639652252197, - -0.32665538787841797, - 5.032402992248535, - -0.6722072958946228 - ], - [ - 119.12391728162766, - 98.12603759765625, - 0.5060263872146606, - -0.6781752109527588, - -1.087803602218628, - 0.8182147741317749 - ], - [ - 115.00392335653305, - 89.66676431894302, - 0.148756742477417, - -0.007477164268493652, - 0.9419937133789062, - -1.137175440788269 - ], - [ - 107.24125277996063, - 93.00947052240372, - -4.619806289672852, - 1.1005070209503174, - -0.3160839080810547, - -0.7212274074554443 - ], - [ - 128.907168507576, - 44.549468994140625, - -0.5933791399002075, - 0.8483630418777466, - 1.7678580284118652, - -1.061244010925293 - ], - [ - 111.77084845304489, - 28.975962698459625, - -0.7289518117904663, - -0.23721599578857422, - -4.8148980140686035, - 0.4040963649749756 - ], - [ - 130.01863545179367, - 14.322330832481384, - -0.14277911186218262, - -0.909946084022522, - -4.649206161499023, - 1.3262590169906616 - ], - [ - 153.43824982643127, - 7.123000621795654, - 0.48526978492736816, - 0.5985463857650757, - -1.3093960285186768, - -1.123914122581482 - ], - [ - 187.5597729086876, - 5.280042052268982, - -0.25231218338012695, - -1.2801045179367065, - -4.306180477142334, - 0.1662236452102661 - ], - [ - 210.67869347333908, - 0, - NaN, - NaN, - NaN, - NaN - ] - ] - ], - "trunk": { - "absolute_elevation_deviation": { - "data": { - "bins": [ - -1.2412248849868774, - -1.1823623180389404, - -1.1234996318817139, - -1.0646369457244873, - -1.0057743787765503, - -0.9469116926193237, - -0.8880491256713867, - -0.8291864395141602, - -0.7703238129615784, - -0.7114611864089966, - -0.65259850025177, - -0.593735933303833, - -0.5348732471466064, - -0.47601062059402466, - -0.41714799404144287, - -0.3582853376865387, - -0.2994227111339569, - -0.24056008458137512, - -0.18169742822647095, - -0.12283480167388916, - -0.06397216022014618, - -0.005109521560370922, - 0.053753115236759186, - 0.11261575669050217, - 0.17147839069366455, - 0.23034103214740753, - 0.2892036736011505, - 0.3480663001537323, - 0.4069289565086365, - 0.46579158306121826 - ], - "weights": [ - 1, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 0, - 1, - 0, - 0, - 0, - 0, - 0, - 1, - 2, - 0, - 0, - 0, - 1, - 1, - 1, - 0, - 0, - 0, - 2 - ] - } - }, - "azimuth": { - "uniform": { - "max": 0.0, - "min": 3.141592653589793 - } - }, - "orientation_deviation": { - "data": { - "bins": [ - 0.3906444293680087, - 0.45964219960320146, - 0.5286399698383943, - 0.597637740073587, - 0.6666355103087799, - 0.7356332805439727, - 0.8046310507791654, - 0.8736288210143582, - 0.9426265912495511, - 1.0116243614847438, - 1.0806221317199367, - 1.1496199019551294, - 1.2186176721903221, - 1.287615442425515, - 1.3566132126607078, - 1.4256109828959005, - 1.4946087531310934, - 1.5636065233662861, - 1.6326042936014789, - 1.7016020638366718, - 1.7705998340718647, - 1.8395976043070572, - 1.9085953745422501, - 1.977593144777443, - 2.0465909150126356, - 2.115588685247829, - 2.1845864554830214, - 2.253584225718214, - 2.3225819959534073, - 2.3915797661886 - ], - "weights": [ - 1, - 1, - 0, - 0, - 0, - 0, - 1, - 0, - 1, - 1, - 0, - 0, - 0, - 1, - 0, - 0, - 1, - 0, - 0, - 0, - 0, - 1, - 0, - 0, - 1, - 0, - 0, - 0, - 0, - 1 - ] - } - } - } - }, - "diameter": { - "diameter_power_relation": { - "apical": {}, - "basal": { - "distribution": "exponnorm", - "params": { - "a": 4.0, - "loc": 2.5908563288801734, - "max": 9.189130357830956, - "min": 2.5250375906714853, - "num_value": 51, - "scale": 0.5243368547854691 - }, - "sequential": null - } - }, - "method": "external", - "sibling_ratios": { - "apical": {}, - "basal": { - "distribution": "expon_rev", - "params": { - "loc": -1.0, - "max": 1.0, - "min": 0.38914811611175537, - "num_value": 51.0, - "scale": 0.2681257128715515 - }, - "sequential": null - } - }, - "tapers": { - "apical": {}, - "basal": { - "distribution": "expon_rev", - "params": { - "loc": -4.819307773455629e-16, - "max": 4.819307773455629e-16, - "min": -0.006207112688571215, - "num_value": 81.0, - "scale": 0.0017335106385871768 - }, - "sequential": null - } - }, - "terminal_diameters": { - "apical": {}, - "basal": { - "distribution": "exponnorm", - "params": { - "a": 2.5545662002746754, - "loc": 0.2836270950866221, - "max": 0.9799999952316284, - "min": 0.25, - "num_value": 65, - "scale": 0.08480139754424451 - }, - "sequential": null - } - }, - "trunk_diameters": { - "apical": {}, - "basal": { - "distribution": "exponnorm", - "params": { - "a": 4.0, - "loc": 0.7130976076221143, - "max": 3.432500028610228, - "min": 0.7835000157356262, - "num_value": 10, - "scale": 0.24388822746698835 - }, - "sequential": null - } - } - }, - "soma": { - "size": { - "norm": { - "mean": 6.8463239669799805, - "std": 1.1242210865020752 - } - } - } - }, - "L3_TPC:A": { - "apical": { - "filtration_metric": "path_distances", - "num_trees": { - "data": { - "bins": [ - 1 - ], - "weights": [ - 2 - ] - } - }, - "persistence_diagram": [ - [ - [ - 109.69773781299591, - 105.84351718425751, - 0.35893183946609497, - 1.0500389337539673, - -1.2730598449707031, - 0.08368444442749023 - ], - [ - 397.6659002304077, - 353.6781550645828, - -0.3453235626220703, - 0.3674764633178711, - 0.7171593904495239, - -0.5684151649475098 - ], - [ - 387.523503780365, - 315.595396399498, - -0.18420171737670898, - 0.6140093803405762, - 0.3818647861480713, - -0.6171480417251587 - ], - [ - 376.44524228572845, - 356.4452518224716, - 0.05703377723693848, - -0.05214214324951172, - 0.04322707653045654, - 0.13552099466323853 - ], - [ - 376.44526517391205, - 326.4452451467514, - -0.10551607608795166, - -0.06138032674789429, - -0.3862401247024536, - -0.04554927349090576 - ], - [ - 369.70683205127716, - 339.7068358659744, - 0.02450382709503174, - -0.06130841374397278, - -0.29559242725372314, - -0.02472272515296936 - ], - [ - 299.70684826374054, - 289.7068463563919, - -1.0158865451812744, - -0.00916224718093872, - -4.562684059143066, - 0.5681124329566956 - ], - [ - 291.56252896785736, - 289.3064259290695, - -0.08890795707702637, - -0.2529408931732178, - -3.887930154800415, - -0.7652496099472046 - ], - [ - 397.0879077911377, - 367.08790588378906, - 0.017078399658203125, - -0.002738356590270996, - 0.21483278274536133, - -0.09813660383224487 - ], - [ - 372.5858625173569, - 323.69258439540863, - 0.06862175464630127, - 0.3213644027709961, - 0.6824556589126587, - -0.42753028869628906 - ], - [ - 105.72084832191467, - 103.01951539516449, - -0.6732207536697388, - -0.09569168090820312, - -3.99937105178833, - 0.5294747352600098 - ], - [ - 122.535391330719, - 83.75930047035217, - 0.1472635269165039, - 0.39699625968933105, - 4.86012077331543, - -0.5160610675811768 - ], - [ - 80.1459676027298, - 33.87082636356354, - 2.8654139041900635, - 0.6077849268913269, - 2.5475969314575195, - -0.3491034209728241 - ], - [ - 376.0859581232071, - 273.903257727623, - 0.04709827899932861, - -0.4075509309768677, - 0.7092353701591492, - 0.3998638391494751 - ], - [ - 369.70684254169464, - 250.9039841890335, - 0.331329345703125, - 0.005659818649291992, - 0.8592648506164551, - -0.1830141544342041 - ], - [ - 376.4308784008026, - 316.06536173820496, - 0.3775200843811035, - -1.0812662839889526, - -0.8691344261169434, - 1.1530722379684448 - ], - [ - 386.4452508687973, - 240.98988020420074, - -0.02041339874267578, - -0.559205174446106, - -0.6154031157493591, - 0.9046450853347778 - ], - [ - 397.08791160583496, - 265.3080166578293, - -0.10634088516235352, - -0.1711130142211914, - 0.3891555070877075, - 0.8279526233673096 - ], - [ - 364.2152930498123, - 235.06765973567963, - 0.2370603084564209, - 0.014772891998291016, - -0.47945213317871094, - 0.30996251106262207 - ], - [ - 398.5050059556961, - 182.3675101995468, - -0.1353391408920288, - -0.45459067821502686, - 0.5847158432006836, - 0.35506510734558105 - ], - [ - 238.44787633419037, - 100.14066398143768, - -0.02804708480834961, - 0.2743295431137085, - 1.1200593709945679, - -0.5699241161346436 - ], - [ - 133.1070830821991, - 56.60226571559906, - -0.7532154321670532, - 0.3379720449447632, - -2.681727409362793, - -0.9721817970275879 - ], - [ - 186.36726033687592, - 43.29999303817749, - 0.7165430784225464, - -0.6293600797653198, - -5.033381462097168, - 1.1040304899215698 - ], - [ - 153.38708090782166, - 11.217400550842285, - 0.021857619285583496, - -0.10617756843566895, - -4.3105292320251465, - -1.5246721506118774 - ], - [ - 419.38870549201965, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 141.9892992824316, - 104.2619022578001, - -0.32691431045532227, - -0.2440202236175537, - -4.823974132537842, - -0.40711379051208496 - ], - [ - 161.27379678189754, - 53.86577667295933, - -0.03411436080932617, - 0.12199616432189941, - 0.6236710548400879, - 0.3026738166809082 - ], - [ - 169.68998586386442, - 101.54817747324705, - 5.253536224365234, - -0.9952888488769531, - 0.9528002738952637, - 1.0143115520477295 - ], - [ - 174.1102341338992, - 132.89022194594145, - 5.748910903930664, - -0.22517478466033936, - 0.20349693298339844, - 0.6408392190933228 - ], - [ - 596.0594476908445, - 472.4520082324743, - 0.09430587291717529, - -0.14840972423553467, - 0.16548633575439453, - 0.05655801296234131 - ], - [ - 531.3108677119017, - 431.27474592626095, - 0.017109036445617676, - 0.343428373336792, - -0.43335962295532227, - -0.9377040863037109 - ], - [ - 546.1151601672173, - 499.10419726371765, - -0.10761284828186035, - 0.3348112106323242, - -0.21776342391967773, - 0.01354837417602539 - ], - [ - 521.885817438364, - 491.35348376631737, - 0.08797740936279297, - 0.789778470993042, - -0.8848342895507812, - -0.6756605505943298 - ], - [ - 189.10875838249922, - 59.250320605933666, - -0.08237123489379883, - -0.23152518272399902, - -0.21730804443359375, - 1.2834991216659546 - ], - [ - 533.9792167544365, - 467.1930428445339, - -0.09165585041046143, - 0.5881975889205933, - 0.2650860548019409, - -0.9530400037765503 - ], - [ - 547.3421325087547, - 389.8166482895613, - 0.355399489402771, - -0.5106581449508667, - -0.7833064794540405, - 0.48953163623809814 - ], - [ - 265.5868006795645, - 189.52812607586384, - 0.01152336597442627, - -0.0029081106185913086, - -0.49273741245269775, - -0.034888505935668945 - ], - [ - 232.25666065514088, - 100.36052231490612, - 0.0353701114654541, - -0.001354813575744629, - -0.5916523933410645, - 0.06825339794158936 - ], - [ - 212.0061849206686, - 70.76226811110973, - 0.031258225440979004, - 0.32098257541656494, - 0.1346067190170288, - -0.6088486909866333 - ], - [ - 195.84333538264036, - 47.6777068823576, - -0.22231650352478027, - 0.476499080657959, - -4.251608848571777, - -0.4843301773071289 - ], - [ - 196.5892003029585, - 33.663908168673515, - -0.08870339393615723, - -0.046553850173950195, - 0.45634984970092773, - 0.7728453874588013 - ], - [ - 617.09835909307, + 210.67869347333908, 0, NaN, NaN, @@ -4631,36 +549,36 @@ "absolute_elevation_deviation": { "data": { "bins": [ - 1.312439203262329, - 1.3152077198028564, - 1.3179762363433838, - 1.3207447528839111, - 1.3235132694244385, - 1.3262817859649658, - 1.3290503025054932, - 1.3318188190460205, - 1.3345872163772583, - 1.3373557329177856, - 1.340124249458313, - 1.3428927659988403, - 1.3456612825393677, - 1.348429799079895, - 1.3511983156204224, - 1.3539668321609497, - 1.356735348701477, - 1.3595038652420044, - 1.3622723817825317, - 1.365040898323059, - 1.3678094148635864, - 1.3705779314041138, - 1.3733463287353516, - 1.376114845275879, - 1.3788833618164062, - 1.3816518783569336, - 1.384420394897461, - 1.3871889114379883, - 1.3899574279785156, - 1.392725944519043 + -1.2412249366257266, + -1.1823622985315625, + -1.123499660437398, + -1.0646370223432338, + -1.0057743842490694, + -0.946911746154905, + -0.8880491080607408, + -0.8291864699665764, + -0.770323831872412, + -0.7114611937782477, + -0.6525985556840834, + -0.5937359175899191, + -0.5348732794957547, + -0.4760106414015904, + -0.4171480033074261, + -0.3582853652132617, + -0.29942272711909734, + -0.24056008902493298, + -0.1816974509307686, + -0.12283481283660425, + -0.06397217474243999, + -0.0051095366482757365, + 0.05375310144588863, + 0.112615739540053, + 0.17147837763421736, + 0.23034101572838173, + 0.2892036538225461, + 0.34806629191671035, + 0.4069289300108746, + 0.46579156810503897 ], "weights": [ 1, @@ -4675,24 +593,24 @@ 0, 0, 0, + 1, 0, 0, 0, 0, 0, + 1, + 2, 0, 0, 0, + 1, + 1, + 1, 0, 0, 0, - 0, - 0, - 0, - 0, - 0, - 0, - 1 + 2 ] } }, @@ -4705,939 +623,303 @@ "orientation_deviation": { "data": { "bins": [ - -0.48333333333333334, - -0.45, - -0.4166666666666667, - -0.38333333333333336, - -0.35000000000000003, - -0.31666666666666665, - -0.2833333333333333, - -0.25, - -0.21666666666666667, - -0.18333333333333335, - -0.15000000000000002, - -0.11666666666666667, - -0.08333333333333331, - -0.04999999999999999, - -0.016666666666666663, - 0.016666666666666663, - 0.04999999999999999, - 0.08333333333333331, - 0.11666666666666664, - 0.14999999999999997, - 0.1833333333333333, - 0.21666666666666662, - 0.24999999999999994, - 0.2833333333333333, - 0.3166666666666667, - 0.35000000000000003, - 0.38333333333333336, - 0.4166666666666667, - 0.45, - 0.48333333333333334 + 0.3906444293680087, + 0.45964219960320146, + 0.5286399698383943, + 0.597637740073587, + 0.6666355103087799, + 0.7356332805439727, + 0.8046310507791654, + 0.8736288210143582, + 0.9426265912495511, + 1.0116243614847438, + 1.0806221317199367, + 1.1496199019551294, + 1.2186176721903221, + 1.287615442425515, + 1.3566132126607078, + 1.4256109828959005, + 1.4946087531310934, + 1.5636065233662861, + 1.6326042936014789, + 1.7016020638366718, + 1.7705998340718647, + 1.8395976043070572, + 1.9085953745422501, + 1.977593144777443, + 2.0465909150126356, + 2.115588685247829, + 2.1845864554830214, + 2.253584225718214, + 2.3225819959534073, + 2.3915797661886 ], "weights": [ + 1, + 1, 0, 0, 0, 0, + 1, 0, + 1, + 1, 0, 0, 0, + 1, 0, 0, + 1, 0, 0, 0, 0, - 0, - 2, - 0, - 0, - 0, - 0, - 0, - 0, - 0, + 1, 0, 0, + 1, 0, 0, 0, 0, - 0 + 1 ] } } } }, - "axon": { - "filtration_metric": "path_distances", - "num_trees": { - "data": { - "bins": [ - 1 - ], - "weights": [ - 2 - ] + "diameter": { + "diameter_power_relation": { + "apical": {}, + "basal": { + "distribution": "exponnorm", + "params": { + "a": 4.0, + "loc": 2.5908563288801734, + "max": 9.189130357830956, + "min": 2.5250375906714853, + "num_value": 51, + "scale": 0.5243368547854691 + }, + "sequential": null } }, - "persistence_diagram": [ - [ - [ - 240.37088459730148, - 121.13639110326767, - -0.9481592178344727, - 0.10728216171264648, - -3.993422508239746, - -0.7832211852073669 - ], - [ - 200.0916914343834, - 146.1905807852745, - 0.05858039855957031, - -1.1299968957901, - -5.586950302124023, - 0.3477208614349365 - ], - [ - 452.9000487923622, - 437.4966087937355, - 0.1818445324897766, - -0.13952398300170898, - 0.46104875206947327, - 0.2692596912384033 - ], - [ - 365.81649500131607, - 299.07576328516006, - 0.03663516044616699, - -0.1809391975402832, - 1.2949784994125366, - 0.32517218589782715 - ], - [ - 308.91885083913803, - 289.11834996938705, - -0.5319150686264038, - 0.336834192276001, - 1.5936737060546875, - -1.7446691989898682 - ], - [ - 244.90682643651962, - 126.3453716635704, - 0.5742647647857666, - -1.2131301164627075, - 1.2786340713500977, - 0.5421980619430542 - ], - [ - 303.30100470781326, - 120.4066898226738, - 0.6601635217666626, - -0.21145856380462646, - 1.867377519607544, - 0.010300278663635254 - ], - [ - 399.12028700113297, - 190.75894445180893, - 0.7077187299728394, - -0.02894008159637451, - -2.0518784523010254, - 0.8423409461975098 - ], - [ - 343.1328790783882, - 142.45730823278427, - -0.4350299835205078, - 0.34828102588653564, - 2.0810108184814453, - 0.35423266887664795 - ], - [ - 200.21358913183212, - 135.07028955221176, - 0.5623493194580078, - -0.3835430145263672, - 3.867237091064453, - 1.6287992000579834 - ], - [ - 373.3833882212639, - 116.06975358724594, - -0.641154408454895, - -0.9829444885253906, - 2.4374632835388184, - 1.1146478652954102 - ], - [ - 242.02043789625168, - 110.8842276930809, - 0.9704688787460327, - 1.283956527709961, - 3.8508152961730957, - -1.5521334409713745 - ], - [ - 376.8837220072746, - 105.6229493021965, - -0.5101491212844849, - -0.2567315101623535, - 2.3469531536102295, - 0.49477410316467285 - ], - [ - 455.8534100651741, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 693.2956436052918, - 582.1629847064614, - -0.06676673889160156, - 0.060852646827697754, - 1.0056411027908325, - -0.724223256111145 - ], - [ - 546.2076018676162, - 542.6792050823569, - 0.13229775428771973, - 0.0968242883682251, - -2.3360846042633057, - 0.0026183128356933594 - ], - [ - 774.5045281872153, - 772.027296744287, - -2.81783390045166, - 0.3903770446777344, - -0.278184175491333, - -0.8035371899604797 - ], - [ - 669.5799389258027, - 446.30874060839415, - 0.054990410804748535, - -0.36384856700897217, - 0.5785835981369019, - 0.2408742904663086 - ], - [ - 830.8037101998925, - 659.9235286787152, - -0.250080943107605, - -0.007918119430541992, - -0.604655921459198, - 0.7653335332870483 - ], - [ - 989.4400350376964, - 585.8035146966577, - 0.05003833770751953, - -0.044182419776916504, - -1.1609995365142822, - 0.4158130884170532 - ], - [ - 1178.353465743363, - 1129.5118404701352, - -0.1157083511352539, - -0.010590434074401855, - -0.1617419719696045, - 0.4887634515762329 - ], - [ - 1216.0548972561955, - 1023.7083174958825, - 0.2149667739868164, - 0.4188939332962036, - -5.915763854980469, - 0.2728828191757202 - ], - [ - 286.9680870398879, - 282.3301375731826, - 0.24825596809387207, - -0.16170716285705566, - 1.753455400466919, - 1.0442633628845215 - ], - [ - 783.5900832116604, - 778.7970456182957, - 0.8378596305847168, - -0.011311054229736328, - -2.4393255710601807, - -1.2320467233657837 - ], - [ - 824.2516462504864, - 821.2446957826614, - -0.219818115234375, - -0.18519341945648193, - 0.9252156019210815, - -0.5615888833999634 - ], - [ - 624.4977695345879, - 614.0386487692595, - -0.07965755462646484, - -0.03718709945678711, - 4.008501052856445, - 0.25725817680358887 - ], - [ - 762.3672753870487, - 752.0380352735519, - 0.24228212237358093, - -0.2419835329055786, - 0.23907232284545898, - 0.7925560474395752 - ], - [ - 602.3241576850414, - 599.7572419643402, - -1.4739395380020142, - 0.02080667018890381, - -3.2747185230255127, - 0.1502835750579834 - ], - [ - 668.7656317055225, - 656.0712141096592, - -0.014406479895114899, - -0.39035582542419434, - 2.3920061588287354, - 0.9942289590835571 - ], - [ - 771.9418592005968, - 748.4849425703287, - -0.5788612365722656, - -0.10929369926452637, - 1.302109956741333, - 0.3085007667541504 - ], - [ - 728.9690858125687, - 670.8134510815144, - -0.6833182573318481, - -0.5015501976013184, - 2.7938485145568848, - -0.022868871688842773 - ], - [ - 874.6854250431061, - 815.1586605012417, - -0.09661328792572021, - 0.5093525052070618, - -0.09995758533477783, - -1.0425111055374146 - ], - [ - 882.012137979269, - 778.4298721551895, - -0.2214193344116211, - -0.08870834112167358, - 0.45345616340637207, - 0.24386096000671387 - ], - [ - 702.2843584120274, - 699.7734062969685, - 0.1704409122467041, - -0.26286184787750244, - 0.4979550838470459, - 0.3485807180404663 - ], - [ - 888.9382729530334, - 886.0374568849802, - 0.15271830558776855, - -0.3707432746887207, - -4.100629806518555, - 0.028726696968078613 - ], - [ - 908.0336384177208, - 619.7192360013723, - -1.7398884296417236, - -0.44560766220092773, - -4.325351715087891, - 0.7946023941040039 - ], - [ - 906.5415843725204, - 647.344186425209, - -2.06358003616333, - 0.030972957611083984, - -2.023327350616455, - -1.2837400436401367 - ], - [ - 787.403838455677, - 785.1336852312088, - -0.021548718214035034, - 0.5285159349441528, - -2.5892183780670166, - -0.25592970848083496 - ], - [ - 935.046439498663, - 931.2854863703251, - -0.5939075350761414, - -0.27931785583496094, - 2.1804754734039307, - 0.9783922433853149 - ], - [ - 590.5266373455524, - 585.253583163023, - -0.31866008043289185, - -0.004419088363647461, - 1.4262633323669434, - 0.5049875974655151 - ], - [ - 877.5198203623295, - 776.86357447505, - 0.19522762298583984, - 0.4396095275878906, - -0.6921920776367188, - -1.2215157747268677 - ], - [ - 758.9722675085068, - 753.4483109116554, - -0.3673485517501831, - 0.057756662368774414, - 5.403219223022461, - 0.13386130332946777 - ], - [ - 695.7147368490696, - 692.8840683102608, - -0.2613348960876465, - 0.207200288772583, - 2.250312089920044, - -0.14171230792999268 - ], - [ - 673.7382985055447, - 670.2547269165516, - -0.12107300758361816, - 0.09517872333526611, - 1.532738447189331, - 0.2285599708557129 - ], - [ - 663.1826301813126, - 659.9606721997261, - 0.03516495227813721, - -0.32069408893585205, - 0.9811849594116211, - -0.19251251220703125 - ], - [ - 644.3979908823967, - 640.7315040081739, - -0.01939108967781067, - -0.00580286979675293, - 1.664764642715454, - -0.3881310224533081 - ], - [ - 643.8413933813572, - 639.1775194108486, - -0.24093306064605713, - -0.16318583488464355, - -0.6902909278869629, - 0.3740849494934082 - ], - [ - 771.7936328351498, - 748.0039113461971, - 0.2640816271305084, - 0.1714855432510376, - -0.8584207892417908, - -0.9144027233123779 - ], - [ - 714.3947398662567, - 654.151453524828, - -0.47152459621429443, - -0.7535151243209839, - 1.4752857685089111, - -0.7283550500869751 - ], - [ - 1035.1522533744574, - 713.2579710334539, - -0.15230512619018555, - -0.12422561645507812, - 0.6462752819061279, - -0.6062582731246948 - ], - [ - 998.1743398010731, - 684.4084361642599, - 0.1552412509918213, - -0.25331032276153564, - 4.307494163513184, - 0.938318133354187 - ], - [ - 631.9630630761385, - 623.003647044301, - 0.1585141122341156, - 0.3320509195327759, - -1.502419114112854, - -0.17170166969299316 - ], - [ - 663.7744689434767, - 656.2788918465376, - 0.353830486536026, - -0.3072478771209717, - -1.6387913227081299, - 1.7518658638000488 - ], - [ - 273.7783207446337, - 255.9904441088438, - -0.780676007270813, - 0.4180980920791626, - 2.9547033309936523, - -0.08389556407928467 - ], - [ - 677.2126061022282, - 625.3456887304783, - -0.39851921796798706, - -0.5020332336425781, - -0.8364763259887695, - -0.20840561389923096 - ], - [ - 696.8404068350792, - 635.5990340411663, - -0.014362215995788574, - 0.3149995803833008, - -0.7084431648254395, - -0.5660197734832764 - ], - [ - 1139.0644566714764, - 913.8716733157635, - -0.13741612434387207, - -0.22973573207855225, - -2.5406594276428223, - 0.18901729583740234 - ], - [ - 799.1147668063641, - 536.0693798959255, - -0.5047433376312256, - -0.12470555305480957, - -0.8041727542877197, - 0.29582643508911133 - ], - [ - 379.88965344429016, - 146.09066358208656, - 0.03279423713684082, - -0.10514986515045166, - -4.75140905380249, - -0.7811352014541626 - ], - [ - 335.4233263358474, - 331.298150382936, - 1.3923519849777222, - 1.5627113580703735, - 0.7997454404830933, - -0.612303614616394 - ], - [ - 856.3131907582283, - 577.1665659099817, - 1.1735010147094727, - -1.1183271408081055, - 0.3858516216278076, - 0.8235390186309814 - ], - [ - 671.6701237559319, - 609.051009953022, - -0.06678672134876251, - 0.3210911750793457, - -0.5296180248260498, - 0.2810779809951782 - ], - [ - 933.286318898201, - 679.0162887871265, - 0.05818188190460205, - -0.15972352027893066, - -1.2621227502822876, - 0.8096139430999756 - ], - [ - 795.7650966644287, - 544.1672978699207, - 0.5887634754180908, - 0.13713741302490234, - -2.07161283493042, - -1.4546045064926147 - ], - [ - 1150.2021892666817, - 659.439703464508, - -0.2174365222454071, - -0.12755215167999268, - -0.752092719078064, - -0.3099595308303833 - ], - [ - 621.8409988284111, - 618.1557657718658, - 0.5249611139297485, - -0.07094001770019531, - -1.5844594240188599, - -0.46037089824676514 - ], - [ - 986.9663816094398, - 574.0759018957615, - -0.07407328486442566, - -0.49598753452301025, - -0.036123812198638916, - 0.7621554136276245 - ], - [ - 542.3794503211975, - 536.7592020630836, - -0.050772495567798615, - -0.06464290618896484, - 1.2402034997940063, - 0.3238363265991211 - ], - [ - 890.022968351841, - 449.9677903354168, - -0.09003099799156189, - -0.1269209384918213, - -1.4378917217254639, - -0.5042673349380493 - ], - [ - 764.5853435695171, - 614.6661694347858, - 0.05313342809677124, - -0.006693601608276367, - -0.7878997325897217, - -0.4780144691467285 - ], - [ - 776.3854166865349, - 562.7274747490883, - 0.08991709351539612, - -0.04638814926147461, - 0.6758835911750793, - -0.12286722660064697 - ], - [ - 654.7619591653347, - 651.9274390637875, - 1.2327653169631958, - 0.6214115619659424, - 3.61550235748291, - 1.2910232543945312 - ], - [ - 777.0434999465942, - 580.6315727382898, - -0.146101713180542, - 0.33382081985473633, - -0.2735595703125, - -0.9326086044311523 - ], - [ - 652.696051761508, - 423.94468903541565, - -0.4327675700187683, - -0.3599706292152405, - 0.9191806316375732, - 0.28334343433380127 - ], - [ - 686.3980858772993, - 654.0852876156569, - 0.18759483098983765, - -0.25949954986572266, - -0.9007777571678162, - 0.0037664175033569336 - ], - [ - 429.5360727161169, - 425.54174552857876, - -0.034517765045166016, - -0.4578152894973755, - 1.1350466012954712, - -0.6985777616500854 - ], - [ - 685.5303767323494, - 449.108525454998, - 0.1533498764038086, - -0.14723610877990723, - -0.39873600006103516, - 0.3136749267578125 - ], - [ - 236.58438619971275, - 228.50051966309547, - 0.3502767086029053, - 0.01398324966430664, - -1.5890247821807861, - -1.1263041496276855 - ], - [ - 749.8820359408855, - 134.16781052947044, - 0.025074005126953125, - -0.04739677906036377, - -1.220162034034729, - 0.22754895687103271 - ], - [ - 1230.2466995194554, - 266.25675670057535, - -1.0494662523269653, - 1.4050612449645996, - -0.8987032175064087, - -1.407658338546753 - ], - [ - 745.1831213831902, - 594.1084425449371, - -0.21411731839179993, - -0.17826485633850098, - 1.6168488264083862, - -0.1377183198928833 - ], - [ - 1443.3102134913206, - 662.6148216426373, - 0.029779911041259766, - -0.7152389287948608, - -0.09906256198883057, - 0.5066136121749878 - ], - [ - 1036.0819641947746, - 539.0998658537865, - -0.044113993644714355, - -0.0015473365783691406, - 4.724297523498535, - 0.965087890625 - ], - [ - 920.8618301749229, - 433.1260893046856, - 0.17807328701019287, - -0.023955225944519043, - 3.128788948059082, - 1.3503453731536865 - ], - [ - 1164.2192679941654, - 374.0415062010288, - -0.27939677238464355, - 0.19942247867584229, - 1.7576332092285156, - 0.18185067176818848 - ], - [ - 672.7455983161926, - 441.8235781490803, - -0.3540385961532593, - -0.15720129013061523, - 2.058570623397827, - 0.10291171073913574 - ], - [ - 502.7334945499897, - 498.500708848238, - 0.10172152519226074, - -0.1994640827178955, - 4.855230331420898, - 1.3153998851776123 - ], - [ - 985.9907224327326, - 342.08337393403053, - -0.25650835037231445, - 0.0688779354095459, - 1.664003849029541, - -0.8102817535400391 - ], - [ - 346.52755858004093, - 340.2657393068075, - 0.22459274530410767, - -0.052823543548583984, - 1.289499044418335, - -1.5114572048187256 - ], - [ - 807.6563311517239, - 114.4550664126873, - 0.031212806701660156, - -0.3042435646057129, - -1.7042194604873657, - -0.26857447624206543 + "method": "external", + "sibling_ratios": { + "apical": {}, + "basal": { + "distribution": "expon_rev", + "params": { + "loc": -1.0, + "max": 1.0, + "min": 0.38914811611175537, + "num_value": 51.0, + "scale": 0.2681257128715515 + }, + "sequential": null + } + }, + "tapers": { + "apical": {}, + "basal": { + "distribution": "expon_rev", + "params": { + "loc": -4.1364226645387197e-16, + "max": 4.1364226645387197e-16, + "min": -0.006207112688571215, + "num_value": 81.0, + "scale": 0.0017335106385871768 + }, + "sequential": null + } + }, + "terminal_diameters": { + "apical": {}, + "basal": { + "distribution": "exponnorm", + "params": { + "a": 2.5545662002746754, + "loc": 0.2836270950866221, + "max": 0.9799999952316284, + "min": 0.25, + "num_value": 65, + "scale": 0.08480139754424451 + }, + "sequential": null + } + }, + "trunk_diameters": { + "apical": {}, + "basal": { + "distribution": "exponnorm", + "params": { + "a": 4.0, + "loc": 0.7130976076221143, + "max": 3.432500028610228, + "min": 0.7835000157356262, + "num_value": 10, + "scale": 0.24388822746698835 + }, + "sequential": null + } + } + }, + "soma": { + "size": { + "norm": { + "mean": 6.8463239669799805, + "std": 1.1242210865020752 + } + } + } + }, + "L3_TPC:A": { + "apical": { + "filtration_metric": "path_distances", + "num_trees": { + "data": { + "bins": [ + 1 ], + "weights": [ + 1 + ] + } + }, + "persistence_diagram": [ + [ [ - 1102.6198585554957, - 224.28225707262754, - 0.05747580528259277, - -0.11770974099636078, - -1.1371874809265137, - 1.5405482053756714 + 141.9892992824316, + 104.2619022578001, + -0.32691431045532227, + -0.2440204620361328, + -4.823974132537842, + -0.40711379051208496 ], [ - 805.1375606358051, - 516.5210703909397, - 0.20913182199001312, - -0.011237502098083496, - -3.1161980628967285, - 1.1886554956436157 + 161.27379678189754, + 53.86577667295933, + -0.03411436080932617, + 0.12199640274047852, + 0.6236710548400879, + 0.3026738166809082 ], [ - 454.056568980217, - 433.85469353199005, - 0.18713589012622833, - -0.18658411502838135, - 0.8860234618186951, - -0.015670299530029297 + 169.68998586386442, + 101.54817747324705, + 5.253536224365234, + -0.9952889680862427, + 0.9528002738952637, + 1.01431143283844 ], [ - 823.5938050895929, - 307.2670688331127, - 0.325355589389801, - 0.102530837059021, - -0.6600052118301392, - 0.8235489130020142 + 174.1102341338992, + 132.89022194594145, + 5.748910903930664, + -0.22517484426498413, + 0.20349693298339844, + 0.6408392786979675 ], [ - 861.698712900281, - 346.4688312113285, - -0.0677182674407959, - -0.21247875690460205, - 1.4186227321624756, - 0.7985072135925293 + 596.0594476908445, + 472.4520082324743, + 0.09430587291717529, + -0.14840972423553467, + 0.16548633575439453, + 0.05655801296234131 ], [ - 1677.5483415424824, - 332.62243631482124, - 0.3737889528274536, - 0.162453293800354, - -1.002897024154663, - -0.3161567449569702 + 531.3108677119017, + 431.27474592626095, + 0.017109036445617676, + 0.34342849254608154, + -0.43335962295532227, + -0.9377041459083557 ], [ - 268.7968203872442, - 259.9002790302038, - -0.28999650478363037, - -0.09070539474487305, - 1.1947028636932373, - -0.1532590389251709 + 546.1151601672173, + 499.10419726371765, + -0.10761284828186035, + 0.33481109142303467, + -0.21776342391967773, + 0.01354837417602539 ], [ - 743.819045253098, - 182.2380063161254, - 0.17232036590576172, - -0.8241897821426392, - -0.840149998664856, - 1.5787756443023682 + 521.885817438364, + 491.35348376631737, + 0.08797740936279297, + 0.789778470993042, + -0.8848342895507812, + -0.6756604909896851 ], [ - 626.8868456557393, - 166.5230278596282, - -0.9707677960395813, - 1.2685043811798096, - 4.005387306213379, - -0.3222212791442871 + 189.10875838249922, + 59.250320605933666, + -0.08237123489379883, + -0.23152518272399902, + -0.21730804443359375, + 1.2834993600845337 ], [ - 868.3833200931549, - 299.4239765703678, - -0.15244460105895996, - -0.013872385025024414, - 1.2557721138000488, - 0.3844485282897949 + 533.9792167544365, + 467.1930428445339, + -0.09165585041046143, + 0.5881977081298828, + 0.2650860548019409, + -0.9530401229858398 ], [ - 189.52398358285427, - 181.09129993617535, - -0.23631978034973145, - 0.3419067859649658, - 1.6321446895599365, - -0.44582951068878174 + 547.3421325087547, + 389.8166482895613, + 0.355399489402771, + -0.5106581449508667, + -0.7833064794540405, + 0.48953163623809814 ], [ - 408.50712798535824, - 169.58547501266003, - -0.09578758478164673, - -0.293381929397583, - -1.6255297660827637, - -0.8552508354187012 + 265.5868006795645, + 189.52812607586384, + 0.01152336597442627, + -0.0029081106185913086, + -0.49273741245269775, + -0.034888386726379395 ], [ - 1314.9724832847714, - 156.23844429850578, - -0.02969980239868164, - -0.22126567363739014, - 0.8039215207099915, - -1.315718173980713 + 232.25666065514088, + 100.36052231490612, + 0.0353701114654541, + -0.0013549327850341797, + -0.5916523933410645, + 0.06825339794158936 ], [ - 162.77128185331821, - 136.97572526335716, - 0.21744132041931152, - 0.2436208724975586, - -1.4933061599731445, - -1.6684391498565674 + 212.0061849206686, + 70.76226811110973, + 0.031258225440979004, + 0.3209826946258545, + 0.1346067190170288, + -0.6088488101959229 ], [ - 872.2433296591043, - 126.80256542563438, - -0.11874544620513916, - 0.01844620704650879, - 2.450878858566284, - 0.414068341255188 + 195.84333538264036, + 47.6777068823576, + -0.22231650352478027, + 0.476499080657959, + -4.251608848571777, + -0.48433029651641846 ], [ - 1219.1349280625582, - 101.07293078303337, - 0.10715901851654053, - 0.02522563934326172, - 4.082304954528809, - 0.7059136629104614 + 196.5892003029585, + 33.663908168673515, + -0.08870339393615723, + -0.046553850173950195, + 0.45634984970092773, + 0.7728452682495117 ], [ - 1931.3423718512058, + 617.09835909307, 0, NaN, NaN, @@ -5650,39 +932,38 @@ "absolute_elevation_deviation": { "data": { "bins": [ - -1.128167986869812, - -1.1276049613952637, - -1.1270418167114258, - -1.126478672027588, - -1.12591552734375, - -1.125352382659912, - -1.1247893571853638, - -1.1242262125015259, - -1.1236631870269775, - -1.1231000423431396, - -1.1225368976593018, - -1.1219737529754639, - -1.1214107275009155, - -1.1208475828170776, - -1.1202845573425293, - -1.1197214126586914, - -1.1191582679748535, - -1.1185951232910156, - -1.1180319786071777, - -1.1174689531326294, - -1.1169058084487915, - -1.1163427829742432, - -1.1157796382904053, - -1.1152164936065674, - -1.1146533489227295, - -1.1140902042388916, - -1.1135271787643433, - -1.1129640340805054, - -1.112401008605957, - -1.1118378639221191 + 0.8277215405773539, + 0.8610548739106874, + 0.8943882072440206, + 0.927721540577354, + 0.9610548739106872, + 0.9943882072440207, + 1.027721540577354, + 1.0610548739106873, + 1.0943882072440205, + 1.127721540577354, + 1.1610548739106874, + 1.1943882072440206, + 1.2277215405773538, + 1.2610548739106875, + 1.2943882072440207, + 1.327721540577354, + 1.3610548739106871, + 1.3943882072440208, + 1.427721540577354, + 1.4610548739106872, + 1.4943882072440204, + 1.527721540577354, + 1.5610548739106873, + 1.5943882072440205, + 1.6277215405773542, + 1.6610548739106874, + 1.6943882072440206, + 1.7277215405773538, + 1.7610548739106875, + 1.7943882072440207 ], "weights": [ - 1, 0, 0, 0, @@ -5698,6 +979,7 @@ 0, 0, 0, + 1, 0, 0, 0, @@ -5711,7 +993,7 @@ 0, 0, 0, - 1 + 0 ] } }, @@ -5771,7 +1053,7 @@ 0, 0, 0, - 2, + 1, 0, 0, 0, @@ -5796,192 +1078,14 @@ "num_trees": { "data": { "bins": [ - 3, - 4 + 3 ], "weights": [ - 1, 1 ] } }, "persistence_diagram": [ - [ - [ - 139.86553847789764, - 127.66342628002167, - 0.14974993467330933, - -0.29332607984542847, - -1.0830429792404175, - 1.4199836254119873 - ], - [ - 146.1609492301941, - 83.4933031797409, - 0.06223946809768677, - -1.3712399005889893, - -0.5036779046058655, - 0.8278759121894836 - ], - [ - 92.77127540111542, - 48.305373311042786, - 0.11318635940551758, - 1.0351157188415527, - -0.3758721351623535, - -1.2635045051574707 - ], - [ - 95.21088886260986, - 21.749937534332275, - -0.44544294476509094, - 0.2514001131057739, - 1.30238676071167, - -0.7274030447006226 - ], - [ - 158.72424161434174, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 149.2144205570221, - 135.00292468070984, - 0.5306221842765808, - -0.46240073442459106, - -1.574256181716919, - 0.875127375125885 - ], - [ - 74.12150204181671, - 50.79113805294037, - -0.1396866738796234, - 0.8529444336891174, - -0.49762141704559326, - 0.31866157054901123 - ], - [ - 142.69034147262573, - 34.696784257888794, - 0.16783545911312103, - -0.14487707614898682, - -0.4101612865924835, - -0.39537328481674194 - ], - [ - 159.1780618429184, - 23.569173336029053, - 0.02101808786392212, - -0.6281392574310303, - 0.5141335725784302, - -0.4529980421066284 - ], - [ - 191.89336395263672, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 49.94356179237366, - 41.361828088760376, - 0.42723512649536133, - -0.694365382194519, - 1.19692862033844, - 0.6116794347763062 - ], - [ - 59.580429553985596, - 27.09981071949005, - -0.30741560459136963, - -0.5864934921264648, - -0.20895624160766602, - 0.5212652683258057 - ], - [ - 91.87081813812256, - 6.105573296546936, - 0.8344888687133789, - 0.722583532333374, - -2.0563607215881348, - -0.14216184616088867 - ], - [ - 102.98714482784271, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], - [ - [ - 111.3294323682785, - 85.38660788536072, - 0.32865333557128906, - 0.454776406288147, - -1.270848274230957, - 0.15470337867736816 - ], - [ - 131.87277495861053, - 92.30185997486115, - 0.2054738998413086, - -0.23194384574890137, - 5.696390151977539, - -0.20328164100646973 - ], - [ - 112.64338058233261, - 59.922969937324524, - -0.6129698753356934, - 0.20901280641555786, - -5.494101524353027, - 0.18426144123077393 - ], - [ - 117.67971706390381, - 34.28444695472717, - 0.19789886474609375, - 0.3211359977722168, - 1.095170259475708, - -0.779013991355896 - ], - [ - 123.34376966953278, - 30.770858764648438, - 0.4361083507537842, - -0.9774636030197144, - -1.3248262405395508, - 0.35521066188812256 - ], - [ - 150.5048966407776, - 12.090131282806396, - 0.5465891361236572, - 1.7265498638153076, - 5.185709476470947, - -2.0522890090942383 - ], - [ - 172.09588181972504, - 0, - NaN, - NaN, - NaN, - NaN - ] - ], [ [ 125.50713980197906, @@ -5989,7 +1093,7 @@ 0.010989874601364136, -0.14378678798675537, -0.680117666721344, - -0.2543219327926636 + -0.2543220520019531 ], [ 162.59803120791912, @@ -6005,7 +1109,7 @@ 0.24418501555919647, 0.32875680923461914, -0.652210533618927, - -0.6986445188522339 + -0.6986446380615234 ], [ 145.75945636630058, @@ -6019,15 +1123,15 @@ 170.81609624624252, 40.14634037017822, -0.3505692183971405, - 0.3406410217285156, + 0.3406411409378052, 1.0624732971191406, - 0.06724309921264648 + 0.06724298000335693 ], [ 176.6381877362728, 16.14008802175522, 0.019208360463380814, - -0.838232159614563, + -0.8382322788238525, 0.1426069736480713, 0.9485580921173096 ], @@ -6043,9 +1147,9 @@ 157.66627165675163, 7.919246971607208, -0.0030654072761535645, - -0.8795281648635864, + -0.879528284072876, -0.011970896273851395, - 1.163081169128418 + 1.1630812883377075 ], [ 177.7325423359871, @@ -6061,7 +1165,7 @@ 163.04124587774277, 59.72201764583588, 0.0060443878173828125, - -0.29369235038757324, + -0.29369258880615234, -6.097765922546387, 0.7071933746337891 ], @@ -6079,7 +1183,7 @@ 4.875744342803955, -0.18515551090240479, 0.8259241580963135, - 0.49929356575012207 + 0.49929380416870117 ], [ 207.53501072525978, @@ -6095,7 +1199,7 @@ 136.07094660401344, 40.19579041004181, 0.20971989631652832, - 0.1469430923461914, + 0.1469428539276123, -0.5196757316589355, 0.2783629894256592 ], @@ -6103,17 +1207,17 @@ 130.3481251001358, 34.40322929620743, 0.060836195945739746, - -0.0008164644241333008, + -0.00081634521484375, -0.5054937601089478, - 0.3540968894958496 + 0.35409677028656006 ], [ 143.610936075449, 23.716740667819977, -0.8882325887680054, - -0.1321098804473877, + -0.1321096420288086, -3.780949115753174, - -0.12599658966064453 + -0.12599682807922363 ], [ 160.72333320975304, @@ -6137,43 +1241,43 @@ "absolute_elevation_deviation": { "data": { "bins": [ - -1.1221983432769775, - -1.075115442276001, - -1.0280324220657349, - -0.9809495210647583, - -0.9338666200637817, - -0.8867835998535156, - -0.8397006988525391, - -0.7926177978515625, - -0.7455348372459412, - -0.6984518766403198, - -0.6513689756393433, - -0.6042860746383667, - -0.5572030544281006, - -0.510120153427124, - -0.4630372226238251, - -0.4159542918205261, - -0.3688713312149048, - -0.3217884302139282, - -0.2747054696083069, - -0.22762253880500793, - -0.18053960800170898, - -0.13345667719841003, - -0.08637373894453049, - -0.03929080441594124, - 0.0077921319752931595, - 0.05487506836652756, - 0.1019580066204071, - 0.14904093742370605, - 0.196123868227005, - 0.24320681393146515 + -0.5546633450358789, + -0.5268188832212267, + -0.4989744214065745, + -0.47112995959192233, + -0.4432854977772701, + -0.41544103596261794, + -0.3875965741479657, + -0.3597521123333135, + -0.33190765051866133, + -0.3040631887040091, + -0.2762187268893569, + -0.2483742650747047, + -0.2205298032600525, + -0.1926853414454003, + -0.16484087963074812, + -0.13699641781609592, + -0.1091519560014437, + -0.08130749418679148, + -0.053463032372139285, + -0.02561857055748712, + 0.0022258912571651024, + 0.030070353071817324, + 0.05791481488646949, + 0.08575927670112171, + 0.11360373851577393, + 0.1414482003304261, + 0.16929266214507827, + 0.1971371239597305, + 0.2249815857743827, + 0.2528260475890349 ], "weights": [ 1, 0, 0, 0, - 1, + 0, 0, 0, 0, @@ -6184,13 +1288,13 @@ 1, 0, 0, - 1, 0, 0, 0, - 1, 0, - 1, + 0, + 0, + 0, 0, 0, 0, @@ -6245,17 +1349,14 @@ "weights": [ 1, 0, - 1, 0, 0, 0, - 1, 0, 0, 0, 0, 0, - 1, 0, 0, 0, @@ -6265,7 +1366,10 @@ 0, 0, 0, - 1, + 0, + 0, + 0, + 0, 0, 0, 0, @@ -6283,24 +1387,24 @@ "apical": { "distribution": "exponnorm", "params": { - "a": 4.0, - "loc": 1.749150507496415, - "max": 8.11589818645372, - "min": 1.799509794016765, - "num_value": 40, - "scale": 0.46550659780691905 + "a": 3.025473974134832, + "loc": 2.6792316283590853, + "max": 6.8283410071195405, + "min": 2.59282536057285, + "num_value": 16, + "scale": 0.4946756034963907 }, "sequential": null }, "basal": { "distribution": "exponnorm", "params": { - "a": 1.065007332761786, - "loc": 3.062202144268822, - "max": 7.633991912789879, - "min": 2.0, - "num_value": 32, - "scale": 1.4450035873171894 + "a": 0.3, + "loc": 4.7481553671990335, + "max": 6.954199059768282, + "min": 3.298277053636806, + "num_value": 15, + "scale": 1.2588979761680408 }, "sequential": null } @@ -6310,22 +1414,22 @@ "apical": { "distribution": "expon_rev", "params": { - "loc": -1.0, - "max": 1.0, - "min": 0.42720422297716143, - "num_value": 40.0, - "scale": 0.23270714282989502 + "loc": -0.9813085794448853, + "max": 0.9813085794448853, + "min": 0.42478740215301514, + "num_value": 16.0, + "scale": 0.2519545555114746 }, "sequential": null }, "basal": { "distribution": "expon_rev", "params": { - "loc": -1.0, - "max": 1.0, - "min": 0.4827579155564308, - "num_value": 32.0, - "scale": 0.18857097625732422 + "loc": -0.9940024614334106, + "max": 0.9940024614334106, + "min": 0.5938866108655929, + "num_value": 15.0, + "scale": 0.17557752132415771 }, "sequential": null } @@ -6334,22 +1438,22 @@ "apical": { "distribution": "expon_rev", "params": { - "loc": -9.841953085089043e-17, - "max": 9.841953085089043e-17, - "min": -0.0043574234703555705, - "num_value": 64.0, - "scale": 0.0011933960486203432 + "loc": -6.408057363246223e-18, + "max": 6.408057363246223e-18, + "min": -0.004344724677503109, + "num_value": 25.0, + "scale": 0.001989777898415923 }, "sequential": null }, "basal": { "distribution": "expon_rev", "params": { - "loc": -1.5910334685490776e-16, - "max": 1.5910334685490776e-16, - "min": -0.005049924016930163, - "num_value": 56.0, - "scale": 0.001477402518503368 + "loc": -1.595922966237103e-16, + "max": 1.595922966237103e-16, + "min": -0.0037232576403766872, + "num_value": 25.0, + "scale": 0.0019644065760076046 }, "sequential": null } @@ -6359,23 +1463,23 @@ "distribution": "exponnorm", "params": { "a": 0.3, - "loc": 0.4407677174531953, - "max": 0.6000000238418579, - "min": 0.30057699233293533, - "num_value": 42, - "scale": 0.11020694467576098 + "loc": 0.3712710851761293, + "max": 0.46310911774635316, + "min": 0.3127447128295898, + "num_value": 17, + "scale": 0.04979673193593169 }, "sequential": null }, "basal": { "distribution": "exponnorm", "params": { - "a": 0.735877200480221, - "loc": 0.3958188345943584, - "max": 0.6000000357627868, - "min": 0.30000001192092896, - "num_value": 39, - "scale": 0.09078264848451095 + "a": 1.0308705775946878, + "loc": 0.34120020826448, + "max": 0.4988087698817253, + "min": 0.3039841204881668, + "num_value": 18, + "scale": 0.04537444854582963 }, "sequential": null } @@ -6384,12 +1488,12 @@ "apical": { "distribution": "exponnorm", "params": { - "a": 0.3, - "loc": 1.750200780295405, - "max": 2.3495000898838043, - "min": 1.4404999911785126, - "num_value": 2, - "scale": 0.4862531982490122 + "a": 1.3007585163212707, + "loc": 1.3899999969093868, + "max": 1.3899999856948853, + "min": 1.3899999856948853, + "num_value": 1, + "scale": 1.2917495160173924e-27 }, "sequential": null }, @@ -6397,11 +1501,11 @@ "distribution": "exponnorm", "params": { "a": 4.0, - "loc": 1.1620941987531457, - "max": 1.8140000224113464, - "min": 1.2000000476837158, - "num_value": 7, - "scale": 0.06211353248078659 + "loc": 1.3742617033956122, + "max": 1.7910000443458556, + "min": 1.4039999842643738, + "num_value": 3, + "scale": 0.04733665039362104 }, "sequential": null } @@ -6410,8 +1514,8 @@ "soma": { "size": { "norm": { - "mean": 7.052670478820801, - "std": 0.4954349994659424 + "mean": 6.557235240936279, + "std": 0.0 } } } diff --git a/tests/data/in_vacuum/out/validation/morphometrics/morphometrics_apical_dendrite.pdf b/tests/data/in_vacuum/out/validation/morphometrics/morphometrics_apical_dendrite.pdf index 1a289e5..2df42d3 100644 Binary files a/tests/data/in_vacuum/out/validation/morphometrics/morphometrics_apical_dendrite.pdf and b/tests/data/in_vacuum/out/validation/morphometrics/morphometrics_apical_dendrite.pdf differ diff --git a/tests/data/in_vacuum/out/validation/morphometrics/morphometrics_basal_dendrite.pdf b/tests/data/in_vacuum/out/validation/morphometrics/morphometrics_basal_dendrite.pdf index 8e6c2ab..e6b342b 100644 Binary files a/tests/data/in_vacuum/out/validation/morphometrics/morphometrics_basal_dendrite.pdf and b/tests/data/in_vacuum/out/validation/morphometrics/morphometrics_basal_dendrite.pdf differ diff --git a/tests/data/in_vacuum/out/validation/score_matrix_reports.pdf b/tests/data/in_vacuum/out/validation/score_matrix_reports.pdf index 41e7f7c..ba7cec5 100644 Binary files a/tests/data/in_vacuum/out/validation/score_matrix_reports.pdf and b/tests/data/in_vacuum/out/validation/score_matrix_reports.pdf differ diff --git a/tests/data/synthesis_input/region_structure.yaml b/tests/data/synthesis_input/region_structure.yaml new file mode 100644 index 0000000..631cdb3 --- /dev/null +++ b/tests/data/synthesis_input/region_structure.yaml @@ -0,0 +1,28 @@ +layers: +- 1 +- 2 +- 3 +- 4 +- 5 +- 6 +names: + 1: layer 1 + 2: layer 2 + 3: layer 3 + 4: layer 4 + 5: layer 5 + 6: layer 6 +region_queries: + 1: '@.*1$' + 2: '@.*2[a|b]?$' + 3: '@.*3$' + 4: '@.*4$' + 5: '@.*5$' + 6: '@.*6[a|b]?$' +thicknesses: + 1: 200 + 2: 100 + 3: 100 + 4: 100 + 5: 100 + 6: 200