diff --git a/.github/workflows/run-integration-tests.yml b/.github/workflows/run-integration-tests.yml new file mode 100644 index 00000000..7ef06084 --- /dev/null +++ b/.github/workflows/run-integration-tests.yml @@ -0,0 +1,30 @@ +name: Run SpatialPy Integration Tests + +on: + push: + branches: [staging, develop] + +jobs: + run-tests: + runs-on: ${{ matrix.os }} + strategy: + matrix: + os: [ ubuntu-latest ] + + steps: + - name: Initialize environment + uses: actions/checkout@v2 + + - name: Install Python + uses: actions/setup-python@v2 + with: + python-version: '3.7' + + - name: Install Python dependencies + run: | + python3 -m pip install --upgrade pip + python3 -m pip install -r requirements.txt + python3 -m pip install coverage + + - name: Run tests + run: coverage run test/run_integration_tests.py diff --git a/.github/workflows/run-tests.yml b/.github/workflows/run-unit-tests.yml similarity index 92% rename from .github/workflows/run-tests.yml rename to .github/workflows/run-unit-tests.yml index 3ba08da0..cabdc656 100644 --- a/.github/workflows/run-tests.yml +++ b/.github/workflows/run-unit-tests.yml @@ -25,4 +25,4 @@ jobs: python3 -m pip install coverage - name: Run tests - run: coverage run test/run_tests.py + run: coverage run test/run_unit_tests.py diff --git a/docs/build/html/.doctrees/classes/spatialpy.core.doctree b/docs/build/html/.doctrees/classes/spatialpy.core.doctree index 372e3575..3c9dfe51 100644 Binary files a/docs/build/html/.doctrees/classes/spatialpy.core.doctree and b/docs/build/html/.doctrees/classes/spatialpy.core.doctree differ diff --git a/docs/build/html/.doctrees/classes/spatialpy.solvers.doctree b/docs/build/html/.doctrees/classes/spatialpy.solvers.doctree index a972d000..e0782b86 100644 Binary files a/docs/build/html/.doctrees/classes/spatialpy.solvers.doctree and b/docs/build/html/.doctrees/classes/spatialpy.solvers.doctree differ diff --git a/docs/build/html/.doctrees/classes/spatialpy.stochss.doctree b/docs/build/html/.doctrees/classes/spatialpy.stochss.doctree index f269045d..f901dc97 100644 Binary files a/docs/build/html/.doctrees/classes/spatialpy.stochss.doctree and b/docs/build/html/.doctrees/classes/spatialpy.stochss.doctree differ diff --git a/docs/build/html/.doctrees/environment.pickle b/docs/build/html/.doctrees/environment.pickle index ebf24ccd..e5b1ff22 100644 Binary files a/docs/build/html/.doctrees/environment.pickle and b/docs/build/html/.doctrees/environment.pickle differ diff --git a/docs/build/html/.doctrees/index.doctree b/docs/build/html/.doctrees/index.doctree index 62b27d8c..4ecb305d 100644 Binary files a/docs/build/html/.doctrees/index.doctree and b/docs/build/html/.doctrees/index.doctree differ diff --git a/docs/build/html/_modules/spatialpy/core/boundarycondition.html b/docs/build/html/_modules/spatialpy/core/boundarycondition.html index 514b800d..4a7889e4 100644 --- a/docs/build/html/_modules/spatialpy/core/boundarycondition.html +++ b/docs/build/html/_modules/spatialpy/core/boundarycondition.html @@ -124,7 +124,7 @@
:param name: Name of the Data Function.
:type name: str
+
+ :raises DataFunctionError: If a name is not provided.
"""
def __init__(self, name=None):
@@ -128,11 +130,11 @@ Source code for spatialpy.core.datafunction
"""
This method must be overridden by the DataFunction subclass.
- NOTE: The spatial location is evaulated at t=0 and is not
- reevaluated as the fluid domain moves over time.
+ NOTE: The spatial location is evaulated at t=0 and is not \
+ re-evaluated as the fluid domain moves over time.
- :param point: The x,y,z position
- :type point: vector of 3 doubles
+ :param point: The x, y, z position.
+ :type point: float[3]
:returns: Value of function at this spatial location.
:rtype: float
diff --git a/docs/build/html/_modules/spatialpy/core/domain.html b/docs/build/html/_modules/spatialpy/core/domain.html
index 1e734839..7b608992 100644
--- a/docs/build/html/_modules/spatialpy/core/domain.html
+++ b/docs/build/html/_modules/spatialpy/core/domain.html
@@ -130,13 +130,13 @@ Source code for spatialpy.core.domain
:type numpoints: int
:param xlim: Range of domain along x-axis
- :type xlim: tuple(float)
+ :type xlim: float(2)
:param ylim: Range of domain along y-axis
- :type ylim: tuple(float)
+ :type ylim: float(2)
:param zlim: Range of domain along z-axis
- :type zlim: tuple(float)
+ :type zlim: float(2)
:param rho: Background density for the system
:type rho: float
@@ -148,7 +148,7 @@ Source code for spatialpy.core.domain
:type P0: float
:param gravity: Acceleration of gravity for the system.
- :type species: float
+ :type gravity: float[3]
"""
def __init__(self, numpoints, xlim, ylim, zlim, rho0=1.0, c0=10, P0=None, gravity=None):
self.vertices = numpy.zeros((numpoints, 3), dtype=float)
@@ -225,10 +225,10 @@ Source code for spatialpy.core.domain
[docs] def compile_prep(self):
"""
- Generate the domain list of type ids and check for invalid type_ids and rho values
+ Generate the domains list of type ids and check for invalid type_ids and rho values
in preperation of compiling the simulation files.
- :raises DomainError: If a type_id is not set or rh for a particle is 0.
+ :raises DomainError: If a type_id is not set or rho=0 for a particle.
"""
if self.type_id.tolist().count(None) > 0:
raise DomainError(f"Particles must be assigned a type_id.")
@@ -243,7 +243,7 @@ Source code for spatialpy.core.domain
Add a single point particle to the domain space.
:param point: Spatial coordinate vertices of point to be added
- :type point: tuple(float, float, float) or tuple(float, float)
+ :type point: float(3)
:param vol: Default volume of particle to be added
:type vol: float
@@ -251,19 +251,19 @@ Source code for spatialpy.core.domain
:param mass: Default mass of particle to be added
:type mass: float
- :param type_id: Particle type ID of particle to be created
+ :param type_id: Particle type ID of particle to be craddedeated
:type type_id: str | int
- :param nu: Default viscosity of particle to be created
+ :param nu: Default viscosity of particle to be added
:type nu: float
:param fixed: True if particle is spatially fixed, else False
:type fixed: bool
- :param c: Default artificial speed of sound of particle to be created
+ :param c: Default artificial speed of sound of particle to be added
:type c: float
- :param rho: Default density of particle to be created
+ :param rho: Default density of particle to be added
:type rho: float
:raises DomainError: Type_id is 0 or type_id contains an invalid character.
@@ -297,9 +297,9 @@ Source code for spatialpy.core.domain
"""
Add a type definition to the domain. By default, all regions are set to type 0.
- :param geometry_ivar: an instance of a 'spatialpy.Geometry' subclass. The 'inside()' method
+ :param geometry_ivar: an instance of a :py:class:`spatialpy.core.geometry.Geometry` subclass. The 'inside()' method
of this object will be used to assign properties to points.
- :type geometry_ivar: spatialpy.Geometry.Geometry
+ :type geometry_ivar: spatialpy.core.geometry.Geometry
:param type_id: The identifier for this type.
:type type_id: str | int
@@ -363,9 +363,9 @@ Source code for spatialpy.core.domain
"""
Fill a geometric shape with particles.
- :param geometry_ivar: an instance of a 'spatialpy.Geometry' subclass. The 'inside()' method
+ :param geometry_ivar: an instance of a :py:class:`spatialpy.core.geometry.Geometry` subclass. The 'inside()' method
of this object will be used to create add the particles.
- :type geometry_ivar: spatialpy.geometry.Geometry
+ :type geometry_ivar: spatialpy.core.geometry.Geometry
:param deltax: Distance between particles on the x-axis.
:type deltax: float
@@ -394,8 +394,7 @@ Source code for spatialpy.core.domain
:param zmax: Maximum z value of the bounding box (defaults to Domain.zlim[1]).
:type zmax: float
- :param kwargs: Key word arguments for Domain.add_point.
- :type kwargs: dict
+ :param \**kwargs: Additional keyword arguments passed to :py:meth:`Domain.add_point`.
:returns: The number of particles that were created within this geometry.
:rtype: int
@@ -509,10 +508,10 @@ Source code for spatialpy.core.domain
Get distance between 2 domain vertices.
:param start: Starting point
- :type start: tuple(float, float, float) or tuple(float, float)
+ :type start: float(3)
:param end: Ending point
- :type end: tuple(float, float, float) or tuple(float, float)
+ :type end: float(2)
:returns: a distance measurement between start and end point
:rtype: float
@@ -524,10 +523,10 @@ Source code for spatialpy.core.domain
Find the nearest vertex of a given point in the domain.
:param point: Target source point
- :type point: tuple(float, float, float) or tuple(float, float)
+ :type point: float(3)
:returns: The coordinates of the nearest vertex to the source point.
- :rtype: tuple(float, float, float) or tuple(float, float)
+ :rtype: float(3)
"""
min_dist = None
min_vtx = None
@@ -745,7 +744,7 @@ Source code for spatialpy.core.domain
:type filename: str
:returns: SpatialPy Domain object created from xml mesh.
- :rtype: spatialpy.Domain.Domain
+ :rtype: spatialpy.core.domain.Domain
"""
root = ET.parse(filename).getroot()
if not root.tag == 'dolfin':
@@ -798,7 +797,7 @@ Source code for spatialpy.core.domain
:type mesh_obj: meshio.Mesh
:returns: SpatialPy Domain object created from the meshio object
- :rtype: spatialpy.Domain.Domain
+ :rtype: spatialpy.core.domain.Domain
"""
# create domain object
xlim = (min(mesh_obj.points[:, 0]), max(mesh_obj.points[:, 0]))
@@ -808,11 +807,13 @@ Source code for spatialpy.core.domain
#vertices
obj.vertices = mesh_obj.points
# triangles
- if 'triangle' in mesh_obj.cells:
- obj.triangles = mesh_obj.cells['triangle']
+ triangles = list(filter(lambda cell: cell.type == "triangle", mesh_obj.cells))
+ if triangles:
+ obj.triangles = triangles[0].data
#tetrahedrons
- if 'tetra' in mesh_obj.cells:
- obj.tetrahedrons = mesh_obj.cells['tetra']
+ tetras = list(filter(lambda cell: cell.type == "tetra", mesh_obj.cells))
+ if tetras:
+ obj.tetrahedrons = tetras[0].data
# volume
obj.calculate_vol()
if not numpy.count_nonzero(obj.vol):
@@ -833,18 +834,14 @@ Source code for spatialpy.core.domain
:type filename: str
:returns: SpatialPy Domain object created from the mesh file.
- :rtype: spatialpy.Domain.Domain
+ :rtype: spatialpy.core.domain.Domain
"""
- try:
- import pygmsh # pylint: disable=import-outside-toplevel
- except ImportError as err:
- raise DomainError("The python package 'pygmsh' is not installed.") from err
try:
import meshio # pylint: disable=import-outside-toplevel
except ImportError as err:
raise DomainError("The python package 'meshio' is not installed.") from err
- return cls.import_meshio_object(meshio.msh_io.read(filename))
+ return cls.import_meshio_object(meshio.read(filename))
[docs] def read_stochss_subdomain_file(self, filename, type_ids=None):
"""
@@ -884,7 +881,7 @@ Source code for spatialpy.core.domain
:type filename: str
:returns: SpatialPy Domain object created from StochSS domain.
- :rtype: spatialpy.Domain.Domain
+ :rtype: spatialpy.core.domain.Domain
"""
try:
with open(filename, "r", encoding="utf-8") as domain_file:
@@ -920,13 +917,13 @@ Source code for spatialpy.core.domain
Create a filled 3D domain
:param xlim: highest and lowest coordinate in the x dimension
- :type xlim: tuple(float, float)
+ :type xlim: float(2)
:param ylim: highest and lowest coordinate in the y dimension
- :type ylim: tuple(float, float)
+ :type ylim: float(2)
:param zlim: highest and lowest coordinate in the z dimension
- :type zlim: tuple(float, float)
+ :type zlim: float(2)
:param nx: number of particle spacing in the x dimension
:type nx: int
@@ -950,22 +947,15 @@ Source code for spatialpy.core.domain
:type c: float
:param rho: default density of particles to be created.
- :type rho:
+ :type rho: float
:param fixed: spatially fixed flag of particles to be created. Defaults to false.
:type fixed: bool
- :param rho0: background density for the system. Defaults to 1.0
- :type rho0: float
-
- :param c0: speed of sound for the system. Defaults to 10
- :type c0: float
-
- :param P0: background pressure for the system. Defaults to 10
- :type P0: float
-
+ :param \**kwargs: Additional keyword arguments passed to :py:class:`Domain`.
+
:returns: Uniform 3D SpatialPy Domain object.
- :rtype: spatialpy.Domain.Domain
+ :rtype: spatialpy.core.domain.Domain
"""
# Create domain object
numberparticles = nx * ny * nz
@@ -992,10 +982,10 @@ Source code for spatialpy.core.domain
Create a filled 2D domain
:param xlim: highest and lowest coordinate in the x dimension
- :type xlim: tuple(float, float)
+ :type xlim: float(2)
:param ylim: highest and lowest coordinate in the y dimension
- :type ylim: tuple(float, float)
+ :type ylim: float(2)
:param nx: number of particle spacing in the x dimension
:type nx: int
@@ -1016,22 +1006,15 @@ Source code for spatialpy.core.domain
:type c: float
:param rho: default density of particles to be created.
- :type rho:
+ :type rho: float
:param fixed: spatially fixed flag of particles to be created. Defaults to false.
:type fixed: bool
- :param rho0: background density for the system. Defaults to 1.0
- :type rho0: float
-
- :param c0: speed of sound for the system. Defaults to 10
- :type c0: float
-
- :param P0: background pressure for the system. Defaults to 10
- :type P0: float
+ :param \**kwargs: Additional keyword arguments passed to :py:class:`Domain`.
:returns: Uniform 2D SpatialPy Domain object.
- :rtype: spatialpy.Domain.Domain
+ :rtype: spatialpy.core.domain.Domain
"""
# Create domain object
numberparticles = nx * ny
diff --git a/docs/build/html/_modules/spatialpy/core/geometry.html b/docs/build/html/_modules/spatialpy/core/geometry.html
index bbdc26dc..8ca065ff 100644
--- a/docs/build/html/_modules/spatialpy/core/geometry.html
+++ b/docs/build/html/_modules/spatialpy/core/geometry.html
@@ -150,7 +150,7 @@ Source code for spatialpy.core.geometry
[docs]class GeometryExterior(Geometry):
"""
Mark particles that are on the edge of the domain.
- only works for meshes that define triangles and tetrahedrons.
+ only works for domains that define triangles and tetrahedrons.
"""
[docs] def inside(self, point, on_boundary):
"""
@@ -168,7 +168,7 @@ Source code for spatialpy.core.geometry
[docs]class GeometryInterior(Geometry):
"""
Mark particles that are not on the edge of the domain.
- Only works for meshes that define triangles and tetrahedrons.
+ Only works for domains that define triangles and tetrahedrons.
"""
[docs] def inside(self, point, on_boundary):
"""
diff --git a/docs/build/html/_modules/spatialpy/core/initialcondition.html b/docs/build/html/_modules/spatialpy/core/initialcondition.html
index 13d3e41e..9dc0c791 100644
--- a/docs/build/html/_modules/spatialpy/core/initialcondition.html
+++ b/docs/build/html/_modules/spatialpy/core/initialcondition.html
@@ -116,11 +116,14 @@ Source code for spatialpy.core.initialcondition
<
"""
Class used to defined initial conditions in SpatialPy.
SubClasses must implement the 'apply(model)' method, which
- direction modifies the model.u0[species,voxel] matrix.
+ direction modifies the model.u0[species, voxel] matrix.
"""
[docs] def apply(self, model):
"""
Set the initial condition of the species to the count.
+
+ :param model: Model contianing the target species.
+ :type model: spatialpy.core.model.Model
"""
raise InitialConditionError("spatialpy.InitialCondition subclasses must implement apply()")
@@ -129,7 +132,7 @@ Source code for spatialpy.core.initialcondition
<
Class used to defined the place initial condition in SpatialPy.
:param species: The species to set the initial condition.
- :type species: spayialpy.species.Species
+ :type species: spatialpy.core.species.Species
:param count: The initial condition for the target species.
:type count: int
@@ -151,7 +154,7 @@ Source code for spatialpy.core.initialcondition
<
Set the initial condition of the species to the count at the location.
:param model: Model contianing the target species.
- :type model: spatialpy.model.Model
+ :type model: spatialpy.core.model.Model
"""
spec_name = self.species.name
spec_ndx = None
@@ -167,7 +170,7 @@ Source code for spatialpy.core.initialcondition
<
Class used to defined the uniform initial condition in SpatialPy.
:param species: The species to set the initial condition.
- :type species: spayialpy.species.Species
+ :type species: spatialpy.core.species.Species
:param count: The initial condition for the target species.
:type count: int
@@ -194,7 +197,7 @@ Source code for spatialpy.core.initialcondition
<
Set 'count' of 'species' in over the list of types (all types if None).
:param model: Model contianing the target species.
- :type model: spatialpy.model.Model
+ :type model: spatialpy.core.model.Model
"""
spec_name = self.species.name
spec_ndx = None
@@ -219,7 +222,7 @@ Source code for spatialpy.core.initialcondition
<
Class used to defined the scatter initial condition in SpatialPy.
:param species: The species to set the initial condition.
- :type species: spayialpy.species.Species
+ :type species: spatialpy.core.species.Species
:param count: The initial condition for the target species.
:type count: int
@@ -246,7 +249,7 @@ Source code for spatialpy.core.initialcondition
<
Scatter 'count' of 'species' randomly over the list of types (all types if None).
:param model: Model contianing the target species.
- :type model: spatialpy.model.Model
+ :type model: spatialpy.core.model.Model
"""
spec_name = self.species.name
spec_ndx = None
diff --git a/docs/build/html/_modules/spatialpy/core/model.html b/docs/build/html/_modules/spatialpy/core/model.html
index 5f5db543..6e155948 100644
--- a/docs/build/html/_modules/spatialpy/core/model.html
+++ b/docs/build/html/_modules/spatialpy/core/model.html
@@ -125,8 +125,8 @@ Source code for spatialpy.core.model
"""
SpatialPy model to StochSS converter
- :param spatailpy_model: SpatialPy model to be converted to StochSS
- :type spatialpy_model: spatialpy.Model
+ :param spatialpy_model: SpatialPy model to be converted to StochSS
+ :type spatialpy_model: spatialpy.core.model.Model
:param filename: Path to the exported stochss model
:type filename: str
@@ -422,12 +422,12 @@ Source code for spatialpy.core.model
Adds a species, or list of species to the model. Will return the added object upon success.
:param obj: The species or list of species to be added to the model object.
- :type obj: spatialpy.Model.Species | list(spatialpy.Model.Species
+ :type obj: spatialpy.core.species.Species | list(spatialpy.core.species.Species
:returns: Species object which was added to the model.
- :rtype: spatialpy.Species | list(spatialpy.Species)
+ :rtype: spatialpy.core.species.Species | list(spatialpy.core.species.Species)
- :raises ModelError: If obj is not a spatialpy.Species
+ :raises ModelError: If obj is not a spatialpy.core.species.Species
"""
from spatialpy.core.species import Species # pylint: disable=import-outside-toplevel
if isinstance(obj, list):
@@ -452,7 +452,7 @@ Source code for spatialpy.core.model
Remove a Species from model.listOfSpecies.
:param obj: Species object to be removed
- :type obj: spatialpy.Model.Species
+ :type obj: spatialpy.core.species.Species
"""
self.listOfSpecies.pop(obj) # raises key error if param is missing
@@ -482,7 +482,7 @@ Source code for spatialpy.core.model
:type sname: str
:returns: The Species objected represented by given 'sname'
- :rtype: spatialpy.Model.Species
+ :rtype: spatialpy.core.species.Species
:raises ModelError: if the model does not contain the requested species
"""
@@ -510,12 +510,12 @@ Source code for spatialpy.core.model
Parameter object or a list of Parameter objects.
:param params: Parameter object or list of Parameters to be added.
- :type params: spatialpy.Model.Parameter | list(spatialpy.Model.Parameter)
+ :type params: spatialpy.core.parameter.Parameter | list(spatialpy.core.parameter.Parameter)
:returns: Parameter object which has been added to the model.
- :rtype: spatialpy.Parameter | list(spatialpy.Parameter)
+ :rtype: spatialpy.core.parameter.Parameter | list(spatialpy.core.parameter.Parameter)
- :raises ModelError: if obj is not a spatialpy.Parameter
+ :raises ModelError: if obj is not a spatialpy.core.parameter.Parameter
"""
from spatialpy.core.parameter import Parameter # pylint: disable=import-outside-toplevel
if isinstance(params,list):
@@ -542,7 +542,7 @@ Source code for spatialpy.core.model
Remove a Parameter from model.listOfParameters.
:param obj: Parameter object to be removed
- :type obj: spatialpy.Model.Parameter
+ :type obj: spatialpy.core.parameter.Parameter
"""
self.listOfParameters.pop(obj)
@@ -559,11 +559,11 @@ Source code for spatialpy.core.model
"""
Return the Parameter object from model associated with 'pname'
- :param pname: Name of parameter to be removed
- :type pname: spatialpy.Model.Parameter
+ :param pname: Name of parameter to be returned
+ :type pname: str
:returns: The Parameter object represented in the model by 'pname'
- :rtype: Spatialpy.Model.Parameter
+ :rtype: Spatialpy.core.parameter.Parameter
:raises ModelError: No parameter named {pname}
"""
@@ -592,12 +592,12 @@ Source code for spatialpy.core.model
or a dict with name, instance pairs.
:param reacs: Reaction or list of Reactions to be added.
- :type reacs: spatialpy.Model.Reaction | list(spatialpy.Model.Reaction)
+ :type reacs: spatialpy.core.reaction.Reaction | list(spatialpy.core.reaction.Reaction)
:returns: The Reaction object(s) added to the model
- :rtype: spatialpy.Model.Reaction
+ :rtype: spatialpy.core.reaction.Reaction | list(spatialpy.core.reaction.Reaction)
- :raises ModelError: Invalid input/reaction to add_reaction()
+ :raises ModelError: if obj is not a spatialpy.core.reaction.Reaction
"""
from spatialpy.core.reaction import Reaction # pylint: disable=import-outside-toplevel
if isinstance(reacs, list):
@@ -622,7 +622,7 @@ Source code for spatialpy.core.model
Remove reaction from model.listOfReactions
:param obj: Reaction to be removed.
- :type obj: spatialpy.Model.Reaction
+ :type obj: spatialpy.core.reaction.Reaction
"""
self.listOfReactions.pop(obj)
@@ -648,11 +648,11 @@ Source code for spatialpy.core.model
"""
Retrieve a reaction object from the model by name
- :param rname: name of Reaction to retrieve
+ :param rname: name of the reaction to be returned
:type rname: str
:returns: The Reaction Object in the model represented by 'rname'
- :rtype: spatialpy.Model.Reaction
+ :rtype: spatialpy.core.reaction.Reaction
:raises ModelError: Could not find reaction
"""
@@ -689,7 +689,7 @@ Source code for spatialpy.core.model
:type profile: bool
:returns: A SpatialPy Result object containing simulation data.
- :rtype: spatialpy.Result.Result
+ :rtype: spatialpy.core.result.Result
"""
from spatialpy.solvers.solver import Solver # pylint: disable=import-outside-toplevel
@@ -701,7 +701,7 @@ Source code for spatialpy.core.model
[docs] def set_timesteps(self, output_interval, num_steps, timestep_size=None):
- """"
+ """
Set the simlation time span parameters.
:param output_interval: size of each output timestep in seconds
@@ -761,7 +761,7 @@ Source code for spatialpy.core.model
Add a spatial domain to the model
:param domain: The Domain object to be added to the model
- :type domain: spatialpy.Domain.Domain
+ :type domain: spatialpy.core.domain.Domain
:raises ModelError: Invalid Domain object
"""
@@ -774,15 +774,15 @@ Source code for spatialpy.core.model
[docs] def add_data_function(self, data_function):
"""
Add a scalar spatial function to the simulation. This is useful if you have a
- spatially varying in put to your model. Argument is a instances of subclass of the
- spatialpy.DataFunction class. It must implement a function 'map(x)' which takes a
- the spatial positon 'x' as an array, and it returns a float value.
+ spatially varying input to your model. Argument is a instances of subclass of the
+ spatialpy.DataFunction class. It must implement a function 'map(point)' which takes a
+ the spatial positon 'point' as an array, and it returns a float value.
:param data_function: Data function to be added.
:type data_function: spatialpy.DataFunction
:returns: DataFunction object(s) added tothe model.
- :rtype: spatialpy.DataFunction | list(spatialpy.DataFunction)
+ :rtype: spatialpy.core.datafunction.DataFunction | list(spatialpy.core.datafunction.DataFunction)
:raises ModelError: Invalid DataFunction
"""
@@ -804,16 +804,16 @@ Source code for spatialpy.core.model
Add an initial condition object to the initialization of the model.
:param init_cond: Initial condition to be added
- :type init_cond: spatialpy.InitialCondition.InitialCondition
+ :type init_cond: spatialpy.core.initialcondition.InitialCondition
"""
self.listOfInitialConditions.append(init_cond)
[docs] def add_boundary_condition(self, bound_cond):
"""
- Add an BoundaryCondition object to the model.
+ Add an boundary condition object to the model.
:param bound_cond: Boundary condition to be added
- :type bound_cond: spatialpy.BoundaryCondition
+ :type bound_cond: spatialpy.core.boundarycondition.BoundaryCondition
"""
bound_cond.model = self
self.listOfBoundaryConditions.append(bound_cond)
diff --git a/docs/build/html/_modules/spatialpy/core/reaction.html b/docs/build/html/_modules/spatialpy/core/reaction.html
index 3525a238..3c4d5a34 100644
--- a/docs/build/html/_modules/spatialpy/core/reaction.html
+++ b/docs/build/html/_modules/spatialpy/core/reaction.html
@@ -135,7 +135,7 @@ Source code for spatialpy.core.reaction
:type propensity_function: str
:param rate: if mass action, rate is a reference to a parameter instance.
- :type rate: spatialpy.model.Parameter
+ :type rate: spatialpy.core.parameter.Parameter
:param annotation: Description of the reaction (meta)
:type annotation: str
@@ -270,8 +270,8 @@ Source code for spatialpy.core.reaction
"""
Add a product to this reaction
- :param S: Species object to be produced by the reaction
- :type S: spatialpy.Model.Species
+ :param species: Species object to be produced by the reaction
+ :type species: spatialpy.core.species.Species
:param stoichiometry: Stoichiometry of this product.
:type stoichiometry: int
@@ -288,7 +288,7 @@ Source code for spatialpy.core.reaction
Add a reactant to this reaction
:param species: reactant Species object
- :type species: spatialpy.Model.Species
+ :type species: spatialpy.core.species.Species
:param stoichiometry: Stoichiometry of this participant reactant
:type stoichiometry: int
@@ -316,7 +316,7 @@ Source code for spatialpy.core.reaction
Deferred object initialization, called by model.add_reaction().
:param model: Target SpatialPy Model for annotation.
- :type model: spatialpy.Model
+ :type model: spatialpy.core.model.Model
"""
self.ode_propensity_function = self.propensity_function
diff --git a/docs/build/html/_modules/spatialpy/core/result.html b/docs/build/html/_modules/spatialpy/core/result.html
index 4256e5b5..aa473c0b 100644
--- a/docs/build/html/_modules/spatialpy/core/result.html
+++ b/docs/build/html/_modules/spatialpy/core/result.html
@@ -405,25 +405,25 @@ Source code for spatialpy.core.result
one or all timepoints. Returns a numpy array containing the species population/concentration values.
:param species: A species in string or dictionary form to retreive information about
- :type species: str | dict
+ :type species: str | spatialpy.core.species.Species
:param timepoints: A time point where the information should be retreived from.
If 'timepoints' is None (default), a matrix of dimension:
(number of timepoints) x (number of voxels) is returned.
If an integer value is given, that value is used to index into the timespan, and that time point is returned
- as a 1D array with size (number of voxel).
- :type timepoints: int (default None)
+ as a 1D array with size (number of voxel). Defaults to None
+ :type timepoints: int
:param concentration: Whether or not the species is a concentration (True) or population (False)
If concentration is False (default), the integer, raw, trajectory data is returned.
- If set to True, the concentration (=copy_number/volume) is returned.
- :type concentration: bool (default False)
+ If set to True, the concentration (=copy_number/volume) is returned. Defaults to False
+ :type concentration: bool
- :param deterministic: Whether or not the species is deterministic (True) or stochastic (False)
- :type deterministic: bool (default False)
+ :param deterministic: Whether or not the species is deterministic (True) or stochastic (False). Defaults to False
+ :type deterministic: bool
- :param debug: Whether or not debug information should be printed
- :type debug: bool (default False)
+ :param debug: Whether or not debug information should be printed. Defaults to False
+ :type debug: bool
:returns: A numpy array containing population/concentration values for target species across specified
timepoints. Defaults to all timepoints.
@@ -433,7 +433,7 @@ Source code for spatialpy.core.result
"""
num_voxel = self.model.domain.get_num_voxels()
- if isinstance(species,str):
+ if isinstance(species, str):
spec_name = species
else:
spec_name = species.name
@@ -497,11 +497,13 @@ Source code for spatialpy.core.result
:param deterministic: Whether or not to plot the data as deterministic
:type deterministic: bool
- :param width: Width in pixels of output plot box
- :type width: int (default 500)
+ :param width: Width in pixels of output plot box or for matplotlib inches of output plot box. \
+ Defaults to 500 (Plotly) or 6.4 (MatPlotLib)
+ :type width: int
- :param height: Height in pixels of output plot box
- :type height: int (default 500)
+ :param height: Height in pixels of output plot box or for matplotlib inches of output plot box. \
+ Defaults to 500 (Plotly) or 4.8 (MatPlotLib)
+ :type height: int
:param colormap: colormap to use. Plotly specification, valid values: "Plotly3","Jet","Blues","YlOrRd",
"PuRd","BuGn","YlOrBr","PuBuGn","BuPu","YlGnBu", "PuBu","GnBu","YlGn","Greens","Reds",
@@ -543,7 +545,7 @@ Source code for spatialpy.core.result
:returns: A dictionary containing data for a plotly figure of species output trajectory
:rtype: dict
- :raises ResultsError: unable to plot species for given time
+ :raises ResultError: unable to plot species for given time
"""
time_index_list = self.get_timespan()
@@ -671,7 +673,14 @@ Source code for spatialpy.core.result
given, that value is used to index into the timespan, and that time point is returned \
as a 1D array with size (number of voxel).
- :param property_name: A string describing the property to be returned.
+ :param property_name: A string describing the property to be returned. Can be one of: {
+ 'v' : velocity,
+ 'rho': density,
+ 'mass': mass,
+ 'id': type_id,
+ 'type': type as str,
+ 'bvf_phi': boundary volume fraction,
+ 'nu': viscosity}
:type property_name: str
:param timepoints: timespan index to be returned. Default is None
@@ -680,7 +689,7 @@ Source code for spatialpy.core.result
:returns: a numpy array of target property values across timepoints, defaults to all timepoints.
:rtype: numpy.ndarray
- :raises ResultsError: Could not get data for given timepoints.
+ :raises ResultError: Could not get data for given timepoints.
"""
l_time = len(self.get_timespan()) - 1
@@ -732,11 +741,13 @@ Source code for spatialpy.core.result
:param p_ndx: The property index of the results to be plotted
:type p_ndx: int
- :param width: Width in pixels of output plot box or for matplotlib inches of output plot box
- :type width: int (default 500)
+ :param width: Width in pixels of output plot box or for matplotlib inches of output plot box. \
+ Defaults to 500 (Plotly) or 6.4 (MatPlotLib)
+ :type width: int
- :param height: Height in pixels of output plot box or for matplotlib inches of output plot box
- :type height: int (default 500)
+ :param height: Height in pixels of output plot box or for matplotlib inches of output plot box. \
+ Defaults to 500 (Plotly) or 4.8 (MatPlotLib)
+ :type height: int
:param colormap: colormap to use. Plotly specification, valid values: "Plotly3","Jet","Blues","YlOrRd",
"PuRd","BuGn","YlOrBr","PuBuGn","BuPu","YlGnBu", "PuBu","GnBu","YlGn","Greens","Reds",
@@ -928,9 +939,9 @@ Source code for spatialpy.core.result
The columns of modelname_mesh.csv are: 'Voxel ID', 'X', 'Y', 'Z', 'Type', 'Volume', 'Mass', 'Viscosity'
The columns of modelname_species_S.csv: 'Time', 'Voxel 0', Voxel 1', ... 'Voxel N'.
- :type folder_name: str (default current working directory)
- :param folder_name: A path where the vtk files will be written, created if non-existant.
- If no path is provided current working directory is used.
+ :type folder_name: str
+ :param folder_name: A path where the vtk files will be written, created if non-existant. \
+ Defaults current working directory
"""
if not folder_name:
folder_name = os.path.abspath(os.getcwd())
@@ -959,13 +970,13 @@ Source code for spatialpy.core.result
for voxel in range(num_vox):
writer.writerow([voxel] + data[:,voxel].tolist())
-[docs] def export_to_vtk(self, timespan, folder_name=None):
+ def __export_to_vtk(self, timespan, folder_name=None):
"""
Write the trajectory to a collection of vtk files.
The exported data is #molecules/volume, where the volume unit is implicit from the mesh dimension.
Not currently implemented.
"""
- raise ResultError("Not implemented.")
+ raise ResultError("Not implemented.")
diff --git a/docs/build/html/_modules/spatialpy/core/species.html b/docs/build/html/_modules/spatialpy/core/species.html
index 0de7a3d4..8429f830 100644
--- a/docs/build/html/_modules/spatialpy/core/species.html
+++ b/docs/build/html/_modules/spatialpy/core/species.html
@@ -121,7 +121,7 @@ Source code for spatialpy.core.species
:param diffusion_coefficient: Non-constant coefficient of diffusion for Species.
:type diffusion_coefficient: float
- :param restrict_to: Set the diffusion coefficient to zero for 'species' in all types not in 'listOfTypes'.
+ :param restrict_to: Set the diffusion coefficient to zero for 'species' in all types not in 'listOfTypes'. \
This effectively restricts the movement of 'species' to the types specified in 'listOfTypes'.
:type restrict_to: int, str, list of ints or list of strs
"""
@@ -164,7 +164,7 @@ Source code for spatialpy.core.species
:param diffusion_coefficient: Non-constant coefficient of diffusion for Species.
:type diffusion_coefficient: float
- :raises SpeciesError: If diffusion_coefficient is negative.
+ :raises SpeciesError: If diffusion_coefficient is negative or not a valid type.
"""
if not (isinstance(diffusion_coefficient, (Parameter, float, int)) or \
type(diffusion_coefficient).__name__ == 'Parameter'):
diff --git a/docs/build/html/_modules/spatialpy/solvers/solver.html b/docs/build/html/_modules/spatialpy/solvers/solver.html
index c4967386..5c84fcbc 100644
--- a/docs/build/html/_modules/spatialpy/solvers/solver.html
+++ b/docs/build/html/_modules/spatialpy/solvers/solver.html
@@ -142,7 +142,7 @@ Source code for spatialpy.solvers.solver
SpatialPy solver object.
:param model: Target model of solver simulation.
- :type model: spatialpy.Model.Model
+ :type model: spatialpy.core.model.Model
:param debug_level: Target level of debugging.
:type debug_level: int
diff --git a/docs/build/html/_modules/spatialpy/stochss/stochss_export.html b/docs/build/html/_modules/spatialpy/stochss/stochss_export.html
index bb8ca688..cead8e00 100644
--- a/docs/build/html/_modules/spatialpy/stochss/stochss_export.html
+++ b/docs/build/html/_modules/spatialpy/stochss/stochss_export.html
@@ -293,13 +293,17 @@ Source code for spatialpy.stochss.stochss_export
"""
SpatialPy model to StochSS converter
- Args:
- spatialpy_model : spatialpy.Model
- SpatialPy model to be converted to StochSS
- filename : str
- Path to the exported stochss model
- return_stochss_model : bool
- Whether or not to return the model
+ :param model: SpatialPy model to be converted to StochSS.
+ :type model: spatialpy.core.model.Model
+
+ :param filename: Path to the exported stochss model.
+ :type filename: str
+
+ :param return_stochss_model: Whether or not to return the model.
+ :type return_stochss_model: bool
+
+ :returns: StochSS model dict if return_stochss_model is True else path to StochSS model file.
+ :rtype: dict | str
"""
_ = model.compile_prep()
if path is None:
diff --git a/docs/build/html/_sources/index.rst.txt b/docs/build/html/_sources/index.rst.txt
index ef9b1b78..33060207 100644
--- a/docs/build/html/_sources/index.rst.txt
+++ b/docs/build/html/_sources/index.rst.txt
@@ -20,7 +20,7 @@ The latest version of SpatialPy can be found on `PyPI `_ for more information on how to build and simulate your models with SpatialPy. For an example of how to use SpatialPy to simulate a spatial stochastic reaction-diffusion system, see the `3D Cylinder Demo `_. We also provide examples of how to use SpatialPy to simulate physics (`Gravity Demo `_) and fluid flow (`Weir Model `_).
+See our `Example Notebook - Start Here `_ for more information on how to build and simulate your models with SpatialPy. For an example of how to use SpatialPy to simulate a spatial stochastic reaction-diffusion system, see the `3D Cylinder Demo `_. We also provide examples of how to use SpatialPy to simulate physics (`Gravity Demo `_) and fluid flow (`Weir Model `_).
Reporting Issues
diff --git a/docs/build/html/classes/spatialpy.core.html b/docs/build/html/classes/spatialpy.core.html
index a5249b96..0b5b39b2 100644
--- a/docs/build/html/classes/spatialpy.core.html
+++ b/docs/build/html/classes/spatialpy.core.html
@@ -128,7 +128,7 @@ Submodulesobject
Set spatial regions of the domain where a property of
particles are held constant (updated each simulation step)
-
+
- Conditions (one or more of the following must be set):
xmin, xmax: (float) min or max value in the x dimension
ymin, ymax: (float) min or max value in the y dimension
@@ -137,10 +137,7 @@ Submodules
@@ -154,17 +151,9 @@ Submodules
-- Parameters
-
+target (str) – Set target to properties, can be ‘nu’ ‘rho’ or ‘v’ or species name If species name, determinstic must also be set to True/False.
value (float or float[3]) – Value property will take in region defined by the conditions
-model (spatialpy.Model.Model) – Target model of boundary condition
+model (spatialpy.core.model.Model) – Target model of boundary condition
@@ -257,18 +246,18 @@ SubmodulesParameters
name (str) – Name of the Data Function.
+- Raises
+DataFunctionError – If a name is not provided.
+
-
map(point)[source]¶
This method must be overridden by the DataFunction subclass.
-
-- NOTE: The spatial location is evaulated at t=0 and is not
reevaluated as the fluid domain moves over time.
-
-
+NOTE: The spatial location is evaulated at t=0 and is not re-evaluated as the fluid domain moves over time.
- Parameters
-point (vector of 3 doubles) – The x,y,z position
+point (float[3]) – The x, y, z position.
- Returns
Value of function at this spatial location.
@@ -305,13 +294,13 @@ SubmodulesParameters
numpoints (int) – Total number of spatial domain points
-xlim (tuple(float)) – Range of domain along x-axis
-ylim (tuple(float)) – Range of domain along y-axis
-zlim (tuple(float)) – Range of domain along z-axis
+xlim (float(2)) – Range of domain along x-axis
+ylim (float(2)) – Range of domain along y-axis
+zlim (float(2)) – Range of domain along z-axis
rho (float) – Background density for the system
c0 (float) – Speed of sound for the system
P0 (float) – Background pressure for the system
-gravity – Acceleration of gravity for the system.
+gravity (float[3]) – Acceleration of gravity for the system.
@@ -322,14 +311,14 @@ Submodules
- Parameters
-point (tuple(float, float, float) or tuple(float, float)) – Spatial coordinate vertices of point to be added
+point (float(3)) – Spatial coordinate vertices of point to be added
vol (float) – Default volume of particle to be added
mass (float) – Default mass of particle to be added
-type_id (str | int) – Particle type ID of particle to be created
-nu (float) – Default viscosity of particle to be created
+type_id (str | int) – Particle type ID of particle to be craddedeated
+nu (float) – Default viscosity of particle to be added
fixed (bool) – True if particle is spatially fixed, else False
-c (float) – Default artificial speed of sound of particle to be created
-rho (float) – Default density of particle to be created
+c (float) – Default artificial speed of sound of particle to be added
+rho (float) – Default density of particle to be added
- Raises
@@ -350,13 +339,13 @@ Submodules
- Parameters
-point (tuple(float, float, float) or tuple(float, float)) – Target source point
+point (float(3)) – Target source point
- Returns
The coordinates of the nearest vertex to the source point.
- Return type
-tuple(float, float, float) or tuple(float, float)
+float(3)
@@ -364,11 +353,11 @@ Submodules
compile_prep()[source]¶
-Generate the domain list of type ids and check for invalid type_ids and rho values
+
Generate the domains list of type ids and check for invalid type_ids and rho values
in preperation of compiling the simulation files.
- Raises
-DomainError – If a type_id is not set or rh for a particle is 0.
+DomainError – If a type_id is not set or rho=0 for a particle.
@@ -394,26 +383,24 @@ Submodules
Parameters
-xlim (tuple(float, float)) – highest and lowest coordinate in the x dimension
-ylim (tuple(float, float)) – highest and lowest coordinate in the y dimension
+xlim (float(2)) – highest and lowest coordinate in the x dimension
+ylim (float(2)) – highest and lowest coordinate in the y dimension
nx (int) – number of particle spacing in the x dimension
ny (int) – number of particle spacing in the y dimension
type_id (int) – default type ID of particles to be created. Defaults to 1
mass (float) – default mass of particles to be created. Defaults to 1.0
nu (float) – default viscosity of particles to be created. Defaults to 1.0
c (float) – default artificial speed of sound of particles to be created. Defaults to 0.0.
-rho – default density of particles to be created.
+rho (float) – default density of particles to be created.
fixed (bool) – spatially fixed flag of particles to be created. Defaults to false.
-rho0 (float) – background density for the system. Defaults to 1.0
-c0 (float) – speed of sound for the system. Defaults to 10
-P0 (float) – background pressure for the system. Defaults to 10
+**kwargs – Additional keyword arguments passed to Domain.
Returns
Uniform 2D SpatialPy Domain object.
Return type
-spatialpy.Domain.Domain
+
@@ -425,9 +412,9 @@ Submodules
Parameters
-xlim (tuple(float, float)) – highest and lowest coordinate in the x dimension
-ylim (tuple(float, float)) – highest and lowest coordinate in the y dimension
-zlim (tuple(float, float)) – highest and lowest coordinate in the z dimension
+xlim (float(2)) – highest and lowest coordinate in the x dimension
+ylim (float(2)) – highest and lowest coordinate in the y dimension
+zlim (float(2)) – highest and lowest coordinate in the z dimension
nx (int) – number of particle spacing in the x dimension
ny (int) – number of particle spacing in the y dimension
nz (int) – number of particle spacing in the z dimension
@@ -435,18 +422,16 @@ SubmodulesDomain.
Returns
Uniform 3D SpatialPy Domain object.
Return type
-spatialpy.Domain.Domain
+
@@ -458,8 +443,8 @@ Submodules
Parameters
-start (tuple(float, float, float) or tuple(float, float)) – Starting point
-end (tuple(float, float, float) or tuple(float, float)) – Ending point
+start (float(3)) – Starting point
+end (float(2)) – Ending point
Returns
@@ -478,7 +463,7 @@ Submodules
Parameters
-geometry_ivar (spatialpy.geometry.Geometry) – an instance of a ‘spatialpy.Geometry’ subclass. The ‘inside()’ method
+
geometry_ivar (spatialpy.core.geometry.Geometry) – an instance of a spatialpy.core.geometry.Geometry subclass. The ‘inside()’ method
of this object will be used to create add the particles.
deltax (float) – Distance between particles on the x-axis.
deltay (float) – Distance between particles on the y-axis (defaults to deltax).
@@ -489,7 +474,7 @@ SubmodulesDomain.add_point().
Returns
@@ -619,7 +604,7 @@ SubmodulesSpatialPy Domain object created from the meshio object
Return type
-spatialpy.Domain.Domain
+
@@ -662,7 +647,7 @@ SubmodulesSpatialPy Domain object created from the mesh file.
Return type
-spatialpy.Domain.Domain
+
@@ -679,7 +664,7 @@ SubmodulesSpatialPy Domain object created from StochSS domain.
Return type
-spatialpy.Domain.Domain
+
@@ -713,7 +698,7 @@ SubmodulesSpatialPy Domain object created from xml mesh.
Return type
-spatialpy.Domain.Domain
+
@@ -725,7 +710,7 @@ Submodules
Parameters
-geometry_ivar (spatialpy.Geometry.Geometry) – an instance of a ‘spatialpy.Geometry’ subclass. The ‘inside()’ method
+
geometry_ivar (spatialpy.core.geometry.Geometry) – an instance of a spatialpy.core.geometry.Geometry subclass. The ‘inside()’ method
of this object will be used to assign properties to points.
type_id (str | int) – The identifier for this type.
vol (float) – The volume of each particle in the type.
@@ -822,7 +807,7 @@ Submodulesclass spatialpy.core.geometry.GeometryExterior[source]¶
Bases: spatialpy.core.geometry.Geometry
Mark particles that are on the edge of the domain.
-only works for meshes that define triangles and tetrahedrons.
+only works for domains that define triangles and tetrahedrons.
-
inside(point, on_boundary)[source]¶
@@ -849,7 +834,7 @@ Submodulesclass spatialpy.core.geometry.GeometryInterior[source]¶
Bases: spatialpy.core.geometry.Geometry
Mark particles that are not on the edge of the domain.
-Only works for meshes that define triangles and tetrahedrons.
+Only works for domains that define triangles and tetrahedrons.
-
inside(point, on_boundary)[source]¶
@@ -892,11 +877,16 @@ Submodulesobject
Class used to defined initial conditions in SpatialPy.
SubClasses must implement the ‘apply(model)’ method, which
-direction modifies the model.u0[species,voxel] matrix.
+direction modifies the model.u0[species, voxel] matrix.
-
apply(model)[source]¶
Set the initial condition of the species to the count.
+
+- Parameters
+model (spatialpy.core.model.Model) – Model contianing the target species.
+
+
@@ -909,7 +899,7 @@ Submodules
- Parameters
-species (spayialpy.species.Species) – The species to set the initial condition.
+species (spatialpy.core.species.Species) – The species to set the initial condition.
count (int) – The initial condition for the target species.
location (float[3]) – X, Y, Z coordinates to place the initial condition.
@@ -921,7 +911,7 @@ Submodules
- Parameters
-model (spatialpy.model.Model) – Model contianing the target species.
+model (spatialpy.core.model.Model) – Model contianing the target species.
@@ -936,7 +926,7 @@ Submodules
- Parameters
-species (spayialpy.species.Species) – The species to set the initial condition.
+species (spatialpy.core.species.Species) – The species to set the initial condition.
count (int) – The initial condition for the target species.
types (list) – Types of the particles to place the initial condition.
@@ -948,7 +938,7 @@ Submodules
- Parameters
-model (spatialpy.model.Model) – Model contianing the target species.
+model (spatialpy.core.model.Model) – Model contianing the target species.
@@ -963,7 +953,7 @@ Submodules
- Parameters
-species (spayialpy.species.Species) – The species to set the initial condition.
+species (spatialpy.core.species.Species) – The species to set the initial condition.
count (int) – The initial condition for the target species.
types (list) – Types of the particles to place the initial condition.
@@ -975,7 +965,7 @@ Submodules
- Parameters
-model (spatialpy.model.Model) – Model contianing the target species.
+model (spatialpy.core.model.Model) – Model contianing the target species.
@@ -1010,10 +1000,10 @@ Submodules
-
add_boundary_condition(bound_cond)[source]¶
-Add an BoundaryCondition object to the model.
+Add an boundary condition object to the model.
- Parameters
-bound_cond (spatialpy.BoundaryCondition) – Boundary condition to be added
+bound_cond (spatialpy.core.boundarycondition.BoundaryCondition) – Boundary condition to be added
@@ -1022,9 +1012,9 @@ Submodules
add_data_function(data_function)[source]¶
Add a scalar spatial function to the simulation. This is useful if you have a
-spatially varying in put to your model. Argument is a instances of subclass of the
-spatialpy.DataFunction class. It must implement a function ‘map(x)’ which takes a
-the spatial positon ‘x’ as an array, and it returns a float value.
+spatially varying input to your model. Argument is a instances of subclass of the
+spatialpy.DataFunction class. It must implement a function ‘map(point)’ which takes a
+the spatial positon ‘point’ as an array, and it returns a float value.
- Parameters
data_function (spatialpy.DataFunction) – Data function to be added.
@@ -1033,7 +1023,7 @@ SubmodulesDataFunction object(s) added tothe model.
- Return type
-spatialpy.DataFunction | list(spatialpy.DataFunction)
+spatialpy.core.datafunction.DataFunction | list(spatialpy.core.datafunction.DataFunction)
- Raises
ModelError – Invalid DataFunction
@@ -1047,7 +1037,7 @@ Submodules
- Parameters
-domain (spatialpy.Domain.Domain) – The Domain object to be added to the model
+domain (spatialpy.core.domain.Domain) – The Domain object to be added to the model
- Raises
ModelError – Invalid Domain object
@@ -1061,7 +1051,7 @@ Submodules
- Parameters
-init_cond (spatialpy.InitialCondition.InitialCondition) – Initial condition to be added
+init_cond (spatialpy.core.initialcondition.InitialCondition) – Initial condition to be added
@@ -1073,16 +1063,16 @@ Submodules
- Parameters
-params (spatialpy.Model.Parameter | list(spatialpy.Model.Parameter)) – Parameter object or list of Parameters to be added.
+params (spatialpy.core.parameter.Parameter | list(spatialpy.core.parameter.Parameter)) – Parameter object or list of Parameters to be added.
- Returns
Parameter object which has been added to the model.
- Return type
-spatialpy.Parameter | list(spatialpy.Parameter)
+spatialpy.core.parameter.Parameter | list(spatialpy.core.parameter.Parameter)
- Raises
-ModelError – if obj is not a spatialpy.Parameter
+ModelError – if obj is not a spatialpy.core.parameter.Parameter
@@ -1094,16 +1084,16 @@ Submodules
- Parameters
-reacs (spatialpy.Model.Reaction | list(spatialpy.Model.Reaction)) – Reaction or list of Reactions to be added.
+reacs (spatialpy.core.reaction.Reaction | list(spatialpy.core.reaction.Reaction)) – Reaction or list of Reactions to be added.
- Returns
The Reaction object(s) added to the model
- Return type
-spatialpy.Model.Reaction
+spatialpy.core.reaction.Reaction | list(spatialpy.core.reaction.Reaction)
- Raises
-ModelError – Invalid input/reaction to add_reaction()
+ModelError – if obj is not a spatialpy.core.reaction.Reaction
@@ -1114,16 +1104,16 @@ Submodules
- Parameters
-obj (spatialpy.Model.Species | list(spatialpy.Model.Species) – The species or list of species to be added to the model object.
+obj (spatialpy.core.species.Species | list(spatialpy.core.species.Species) – The species or list of species to be added to the model object.
- Returns
Species object which was added to the model.
- Return type
-spatialpy.Species | list(spatialpy.Species)
+spatialpy.core.species.Species | list(spatialpy.core.species.Species)
- Raises
-ModelError – If obj is not a spatialpy.Species
+ModelError – If obj is not a spatialpy.core.species.Species
@@ -1171,7 +1161,7 @@ Submodules
- Parameters
-obj (spatialpy.Model.Parameter) – Parameter object to be removed
+obj (spatialpy.core.parameter.Parameter) – Parameter object to be removed
@@ -1182,7 +1172,7 @@ Submodules
- Parameters
-obj (spatialpy.Model.Reaction) – Reaction to be removed.
+obj (spatialpy.core.reaction.Reaction) – Reaction to be removed.
@@ -1193,7 +1183,7 @@ Submodules
- Parameters
-obj (spatialpy.Model.Species) – Species object to be removed
+obj (spatialpy.core.species.Species) – Species object to be removed
@@ -1274,13 +1264,13 @@ Submodules
- Parameters
-pname (spatialpy.Model.Parameter) – Name of parameter to be removed
+pname (str) – Name of parameter to be returned
- Returns
The Parameter object represented in the model by ‘pname’
- Return type
-Spatialpy.Model.Parameter
+Spatialpy.core.parameter.Parameter
- Raises
ModelError – No parameter named {pname}
@@ -1294,13 +1284,13 @@ Submodules
- Parameters
-rname (str) – name of Reaction to retrieve
+rname (str) – name of the reaction to be returned
- Returns
The Reaction Object in the model represented by ‘rname’
- Return type
-spatialpy.Model.Reaction
+-
- Raises
ModelError – Could not find reaction
@@ -1320,7 +1310,7 @@ SubmodulesThe Species objected represented by given ‘sname’
- Return type
-spatialpy.Model.Species
+-
- Raises
ModelError – if the model does not contain the requested species
@@ -1354,7 +1344,7 @@ SubmodulesA SpatialPy Result object containing simulation data.
- Return type
-spatialpy.Result.Result
+-
@@ -1407,8 +1397,7 @@ Submodules
-
set_timesteps(output_interval, num_steps, timestep_size=None)[source]¶
-”
-Set the simlation time span parameters.
+Set the simlation time span parameters.
- Parameters
@@ -1461,7 +1450,7 @@ Submodules
- Parameters
-spatailpy_model – SpatialPy model to be converted to StochSS
+spatialpy_model (spatialpy.core.model.Model) – SpatialPy model to be converted to StochSS
filename (str) – Path to the exported stochss model
return_stochss_model (bool) – Whether or not to return the model
@@ -1535,7 +1524,7 @@ Submodulesspatialpy.core.parameter.Parameter) – if mass action, rate is a reference to a parameter instance.
annotation (str) – Description of the reaction (meta)
restrict_to (int, str, list of ints or list of strs) – Restrict reaction execution to a type or list of types within the domain.
@@ -1548,7 +1537,7 @@ Submodules
- Parameters
-S (spatialpy.Model.Species) – Species object to be produced by the reaction
+species (spatialpy.core.species.Species) – Species object to be produced by the reaction
stoichiometry (int) – Stoichiometry of this product.
@@ -1562,7 +1551,7 @@ Submodules
- Parameters
-species (spatialpy.Model.Species) – reactant Species object
+species (spatialpy.core.species.Species) – reactant Species object
stoichiometry (int) – Stoichiometry of this participant reactant
@@ -1586,7 +1575,7 @@ Submodules
- Parameters
-model (spatialpy.Model) – Target SpatialPy Model for annotation.
+model (spatialpy.core.model.Model) – Target SpatialPy Model for annotation.
@@ -1622,18 +1611,9 @@ Submodules
- Parameters
-folder_name (str (default current working directory)) – A path where the vtk files will be written, created if non-existant.
+folder_name (str) – A path where the vtk files will be written, created if non-existant. Defaults current working directory
-If no path is provided current working directory is used.
-
-
-
--
-export_to_vtk(timespan, folder_name=None)[source]¶
-Write the trajectory to a collection of vtk files.
-The exported data is #molecules/volume, where the volume unit is implicit from the mesh dimension.
-Not currently implemented.
@@ -1643,7 +1623,14 @@ Submodules
- Parameters
-property_name (str) – A string describing the property to be returned.
+property_name (str) – A string describing the property to be returned. Can be one of: {
+‘v’ : velocity,
+‘rho’: density,
+‘mass’: mass,
+‘id’: type_id,
+‘type’: type as str,
+‘bvf_phi’: boundary volume fraction,
+‘nu’: viscosity}
timepoints (int) – timespan index to be returned. Default is None
@@ -1654,7 +1641,7 @@ Submodulesnumpy.ndarray
- Raises
-ResultsError – Could not get data for given timepoints.
+ResultError – Could not get data for given timepoints.
@@ -1667,17 +1654,17 @@ Submodules
- Parameters
-species (str | dict) – A species in string or dictionary form to retreive information about
-timepoints (int (default None)) – A time point where the information should be retreived from.
+
species (str | spatialpy.core.species.Species) – A species in string or dictionary form to retreive information about
+timepoints (int) – A time point where the information should be retreived from.
If ‘timepoints’ is None (default), a matrix of dimension:
(number of timepoints) x (number of voxels) is returned.
If an integer value is given, that value is used to index into the timespan, and that time point is returned
-as a 1D array with size (number of voxel).
-concentration (bool (default False)) – Whether or not the species is a concentration (True) or population (False)
+as a 1D array with size (number of voxel). Defaults to None
+concentration (bool) – Whether or not the species is a concentration (True) or population (False)
If concentration is False (default), the integer, raw, trajectory data is returned.
-If set to True, the concentration (=copy_number/volume) is returned.
-deterministic (bool (default False)) – Whether or not the species is deterministic (True) or stochastic (False)
-debug (bool (default False)) – Whether or not debug information should be printed
+If set to True, the concentration (=copy_number/volume) is returned. Defaults to False
+deterministic (bool) – Whether or not the species is deterministic (True) or stochastic (False). Defaults to False
+debug (bool) – Whether or not debug information should be printed. Defaults to False
- Returns
@@ -1718,8 +1705,8 @@ Submodulesdict
- Raises
-ResultsError – unable to plot species for given time
+ResultError – unable to plot species for given time
@@ -1959,12 +1946,10 @@ Submodules
name (str) – Name of the Species
diffusion_coefficient (float) – Non-constant coefficient of diffusion for Species.
-restrict_to – Set the diffusion coefficient to zero for ‘species’ in all types not in ‘listOfTypes’.
+restrict_to (int, str, list of ints or list of strs) – Set the diffusion coefficient to zero for ‘species’ in all types not in ‘listOfTypes’. This effectively restricts the movement of ‘species’ to the types specified in ‘listOfTypes’.
-This effectively restricts the movement of ‘species’ to the types specified in ‘listOfTypes’.
-:type restrict_to: int, str, list of ints or list of strs
-
set_diffusion_coefficient(diffusion_coefficient)[source]¶
@@ -1974,7 +1959,7 @@ Submodulesdiffusion_coefficient (float) – Non-constant coefficient of diffusion for Species.
- Raises
-SpeciesError – If diffusion_coefficient is negative.
+SpeciesError – If diffusion_coefficient is negative or not a valid type.
@@ -2114,7 +2099,7 @@ Submodulesobject
Set spatial regions of the domain where a property of
particles are held constant (updated each simulation step)
-
+
- Conditions (one or more of the following must be set):
xmin, xmax: (float) min or max value in the x dimension
ymin, ymax: (float) min or max value in the y dimension
@@ -2123,10 +2108,7 @@ Submodules
@@ -2140,17 +2122,9 @@ Submodules
-- Parameters
-
+target (str) – Set target to properties, can be ‘nu’ ‘rho’ or ‘v’ or species name If species name, determinstic must also be set to True/False.
value (float or float[3]) – Value property will take in region defined by the conditions
-model (spatialpy.Model.Model) – Target model of boundary condition
+model (spatialpy.core.model.Model) – Target model of boundary condition
@@ -2186,18 +2160,18 @@ SubmodulesParameters
name (str) – Name of the Data Function.
+- Raises
+DataFunctionError – If a name is not provided.
+
-
map(point)[source]¶
This method must be overridden by the DataFunction subclass.
-
-- NOTE: The spatial location is evaulated at t=0 and is not
reevaluated as the fluid domain moves over time.
-
-
+NOTE: The spatial location is evaulated at t=0 and is not re-evaluated as the fluid domain moves over time.
- Parameters
-point (vector of 3 doubles) – The x,y,z position
+point (float[3]) – The x, y, z position.
- Returns
Value of function at this spatial location.
@@ -2226,13 +2200,13 @@ SubmodulesParameters
numpoints (int) – Total number of spatial domain points
-xlim (tuple(float)) – Range of domain along x-axis
-ylim (tuple(float)) – Range of domain along y-axis
-zlim (tuple(float)) – Range of domain along z-axis
+xlim (float(2)) – Range of domain along x-axis
+ylim (float(2)) – Range of domain along y-axis
+zlim (float(2)) – Range of domain along z-axis
rho (float) – Background density for the system
c0 (float) – Speed of sound for the system
P0 (float) – Background pressure for the system
-gravity – Acceleration of gravity for the system.
+gravity (float[3]) – Acceleration of gravity for the system.
@@ -2243,14 +2217,14 @@ Submodules
- Parameters
-point (tuple(float, float, float) or tuple(float, float)) – Spatial coordinate vertices of point to be added
+point (float(3)) – Spatial coordinate vertices of point to be added
vol (float) – Default volume of particle to be added
mass (float) – Default mass of particle to be added
-type_id (str | int) – Particle type ID of particle to be created
-nu (float) – Default viscosity of particle to be created
+type_id (str | int) – Particle type ID of particle to be craddedeated
+nu (float) – Default viscosity of particle to be added
fixed (bool) – True if particle is spatially fixed, else False
-c (float) – Default artificial speed of sound of particle to be created
-rho (float) – Default density of particle to be created
+c (float) – Default artificial speed of sound of particle to be added
+rho (float) – Default density of particle to be added
- Raises
@@ -2271,13 +2245,13 @@ Submodules
- Parameters
-point (tuple(float, float, float) or tuple(float, float)) – Target source point
+point (float(3)) – Target source point
- Returns
The coordinates of the nearest vertex to the source point.
- Return type
-tuple(float, float, float) or tuple(float, float)
+float(3)
@@ -2285,11 +2259,11 @@ Submodules
-
compile_prep()[source]¶
-Generate the domain list of type ids and check for invalid type_ids and rho values
+
Generate the domains list of type ids and check for invalid type_ids and rho values
in preperation of compiling the simulation files.
- Raises
-DomainError – If a type_id is not set or rh for a particle is 0.
+DomainError – If a type_id is not set or rho=0 for a particle.
@@ -2315,26 +2289,24 @@ Submodules
- Parameters
-xlim (tuple(float, float)) – highest and lowest coordinate in the x dimension
-ylim (tuple(float, float)) – highest and lowest coordinate in the y dimension
+xlim (float(2)) – highest and lowest coordinate in the x dimension
+ylim (float(2)) – highest and lowest coordinate in the y dimension
nx (int) – number of particle spacing in the x dimension
ny (int) – number of particle spacing in the y dimension
type_id (int) – default type ID of particles to be created. Defaults to 1
mass (float) – default mass of particles to be created. Defaults to 1.0
nu (float) – default viscosity of particles to be created. Defaults to 1.0
c (float) – default artificial speed of sound of particles to be created. Defaults to 0.0.
-rho – default density of particles to be created.
+rho (float) – default density of particles to be created.
fixed (bool) – spatially fixed flag of particles to be created. Defaults to false.
-rho0 (float) – background density for the system. Defaults to 1.0
-c0 (float) – speed of sound for the system. Defaults to 10
-P0 (float) – background pressure for the system. Defaults to 10
+**kwargs – Additional keyword arguments passed to Domain.
- Returns
Uniform 2D SpatialPy Domain object.
- Return type
-spatialpy.Domain.Domain
+-
@@ -2346,9 +2318,9 @@ Submodules
- Parameters
-xlim (tuple(float, float)) – highest and lowest coordinate in the x dimension
-ylim (tuple(float, float)) – highest and lowest coordinate in the y dimension
-zlim (tuple(float, float)) – highest and lowest coordinate in the z dimension
+xlim (float(2)) – highest and lowest coordinate in the x dimension
+ylim (float(2)) – highest and lowest coordinate in the y dimension
+zlim (float(2)) – highest and lowest coordinate in the z dimension
nx (int) – number of particle spacing in the x dimension
ny (int) – number of particle spacing in the y dimension
nz (int) – number of particle spacing in the z dimension
@@ -2356,18 +2328,16 @@ SubmodulesDomain.
- Returns
Uniform 3D SpatialPy Domain object.
- Return type
-spatialpy.Domain.Domain
+-
@@ -2379,8 +2349,8 @@ Submodules
- Parameters
-start (tuple(float, float, float) or tuple(float, float)) – Starting point
-end (tuple(float, float, float) or tuple(float, float)) – Ending point
+start (float(3)) – Starting point
+end (float(2)) – Ending point
- Returns
@@ -2399,7 +2369,7 @@ Submodules
- Parameters
-geometry_ivar (spatialpy.geometry.Geometry) – an instance of a ‘spatialpy.Geometry’ subclass. The ‘inside()’ method
+
geometry_ivar (spatialpy.core.geometry.Geometry) – an instance of a spatialpy.core.geometry.Geometry subclass. The ‘inside()’ method
of this object will be used to create add the particles.
deltax (float) – Distance between particles on the x-axis.
deltay (float) – Distance between particles on the y-axis (defaults to deltax).
@@ -2410,7 +2380,7 @@ SubmodulesDomain.add_point().
- Returns
@@ -2540,7 +2510,7 @@ SubmodulesSpatialPy Domain object created from the meshio object
- Return type
-spatialpy.Domain.Domain
+-
@@ -2583,7 +2553,7 @@ SubmodulesSpatialPy Domain object created from the mesh file.
- Return type
-spatialpy.Domain.Domain
+-
@@ -2600,7 +2570,7 @@ SubmodulesSpatialPy Domain object created from StochSS domain.
- Return type
-spatialpy.Domain.Domain
+-
@@ -2634,7 +2604,7 @@ SubmodulesSpatialPy Domain object created from xml mesh.
Return type
-spatialpy.Domain.Domain
+
@@ -2646,7 +2616,7 @@ Submodules
Parameters
-geometry_ivar (spatialpy.Geometry.Geometry) – an instance of a ‘spatialpy.Geometry’ subclass. The ‘inside()’ method
+
geometry_ivar (spatialpy.core.geometry.Geometry) – an instance of a spatialpy.core.geometry.Geometry subclass. The ‘inside()’ method
of this object will be used to assign properties to points.
type_id (str | int) – The identifier for this type.
vol (float) – The volume of each particle in the type.
@@ -2742,7 +2712,7 @@ Submodulesclass spatialpy.core.GeometryExterior[source]¶
Bases: spatialpy.core.geometry.Geometry
Mark particles that are on the edge of the domain.
-only works for meshes that define triangles and tetrahedrons.
+only works for domains that define triangles and tetrahedrons.
-
inside(point, on_boundary)[source]¶
@@ -2769,7 +2739,7 @@ Submodulesclass spatialpy.core.GeometryInterior[source]¶
Bases: spatialpy.core.geometry.Geometry
Mark particles that are not on the edge of the domain.
-Only works for meshes that define triangles and tetrahedrons.
+Only works for domains that define triangles and tetrahedrons.
-
inside(point, on_boundary)[source]¶
@@ -2797,11 +2767,16 @@ Submodulesobject
Class used to defined initial conditions in SpatialPy.
SubClasses must implement the ‘apply(model)’ method, which
-direction modifies the model.u0[species,voxel] matrix.
+direction modifies the model.u0[species, voxel] matrix.
-
apply(model)[source]¶
Set the initial condition of the species to the count.
+
+- Parameters
+model (spatialpy.core.model.Model) – Model contianing the target species.
+
+
@@ -3136,10 +3111,10 @@ Submodules
-
add_boundary_condition(bound_cond)[source]¶
-Add an BoundaryCondition object to the model.
+Add an boundary condition object to the model.
- Parameters
-bound_cond (spatialpy.BoundaryCondition) – Boundary condition to be added
+bound_cond (spatialpy.core.boundarycondition.BoundaryCondition) – Boundary condition to be added
@@ -3148,9 +3123,9 @@ Submodules
add_data_function(data_function)[source]¶
Add a scalar spatial function to the simulation. This is useful if you have a
-spatially varying in put to your model. Argument is a instances of subclass of the
-spatialpy.DataFunction class. It must implement a function ‘map(x)’ which takes a
-the spatial positon ‘x’ as an array, and it returns a float value.
+spatially varying input to your model. Argument is a instances of subclass of the
+spatialpy.DataFunction class. It must implement a function ‘map(point)’ which takes a
+the spatial positon ‘point’ as an array, and it returns a float value.
- Parameters
data_function (spatialpy.DataFunction) – Data function to be added.
@@ -3159,7 +3134,7 @@ SubmodulesDataFunction object(s) added tothe model.
- Return type
-spatialpy.DataFunction | list(spatialpy.DataFunction)
+spatialpy.core.datafunction.DataFunction | list(spatialpy.core.datafunction.DataFunction)
- Raises
ModelError – Invalid DataFunction
@@ -3173,7 +3148,7 @@ Submodules
- Parameters
-domain (spatialpy.Domain.Domain) – The Domain object to be added to the model
+domain (spatialpy.core.domain.Domain) – The Domain object to be added to the model
- Raises
ModelError – Invalid Domain object
@@ -3187,7 +3162,7 @@ Submodules
- Parameters
-init_cond (spatialpy.InitialCondition.InitialCondition) – Initial condition to be added
+init_cond (spatialpy.core.initialcondition.InitialCondition) – Initial condition to be added
@@ -3199,16 +3174,16 @@ Submodules
- Parameters
-params (spatialpy.Model.Parameter | list(spatialpy.Model.Parameter)) – Parameter object or list of Parameters to be added.
+params (spatialpy.core.parameter.Parameter | list(spatialpy.core.parameter.Parameter)) – Parameter object or list of Parameters to be added.
- Returns
Parameter object which has been added to the model.
- Return type
-spatialpy.Parameter | list(spatialpy.Parameter)
+spatialpy.core.parameter.Parameter | list(spatialpy.core.parameter.Parameter)
- Raises
-ModelError – if obj is not a spatialpy.Parameter
+ModelError – if obj is not a spatialpy.core.parameter.Parameter
@@ -3220,16 +3195,16 @@ Submodules
- Parameters
-reacs (spatialpy.Model.Reaction | list(spatialpy.Model.Reaction)) – Reaction or list of Reactions to be added.
+reacs (spatialpy.core.reaction.Reaction | list(spatialpy.core.reaction.Reaction)) – Reaction or list of Reactions to be added.
- Returns
The Reaction object(s) added to the model
- Return type
-spatialpy.Model.Reaction
+spatialpy.core.reaction.Reaction | list(spatialpy.core.reaction.Reaction)
- Raises
-ModelError – Invalid input/reaction to add_reaction()
+ModelError – if obj is not a spatialpy.core.reaction.Reaction
@@ -3240,16 +3215,16 @@ Submodules
- Parameters
-obj (spatialpy.Model.Species | list(spatialpy.Model.Species) – The species or list of species to be added to the model object.
+obj (spatialpy.core.species.Species | list(spatialpy.core.species.Species) – The species or list of species to be added to the model object.
- Returns
Species object which was added to the model.
- Return type
-spatialpy.Species | list(spatialpy.Species)
+spatialpy.core.species.Species | list(spatialpy.core.species.Species)
- Raises
-ModelError – If obj is not a spatialpy.Species
+ModelError – If obj is not a spatialpy.core.species.Species
@@ -3297,7 +3272,7 @@ Submodules
- Parameters
-obj (spatialpy.Model.Parameter) – Parameter object to be removed
+obj (spatialpy.core.parameter.Parameter) – Parameter object to be removed
@@ -3308,7 +3283,7 @@ Submodules
- Parameters
-obj (spatialpy.Model.Reaction) – Reaction to be removed.
+obj (spatialpy.core.reaction.Reaction) – Reaction to be removed.
@@ -3319,7 +3294,7 @@ Submodules
- Parameters
-obj (spatialpy.Model.Species) – Species object to be removed
+obj (spatialpy.core.species.Species) – Species object to be removed
@@ -3400,13 +3375,13 @@ Submodules
- Parameters
-pname (spatialpy.Model.Parameter) – Name of parameter to be removed
+pname (str) – Name of parameter to be returned
- Returns
The Parameter object represented in the model by ‘pname’
- Return type
-Spatialpy.Model.Parameter
+Spatialpy.core.parameter.Parameter
- Raises
ModelError – No parameter named {pname}
@@ -3420,13 +3395,13 @@ Submodules
- Parameters
-rname (str) – name of Reaction to retrieve
+rname (str) – name of the reaction to be returned
- Returns
The Reaction Object in the model represented by ‘rname’
- Return type
-spatialpy.Model.Reaction
+-
- Raises
ModelError – Could not find reaction
@@ -3446,7 +3421,7 @@ SubmodulesThe Species objected represented by given ‘sname’
- Return type
-spatialpy.Model.Species
+-
- Raises
ModelError – if the model does not contain the requested species
@@ -3480,7 +3455,7 @@ SubmodulesA SpatialPy Result object containing simulation data.
- Return type
-spatialpy.Result.Result
+-
@@ -3533,8 +3508,7 @@ Submodules
-
set_timesteps(output_interval, num_steps, timestep_size=None)[source]¶
-”
-Set the simlation time span parameters.
+Set the simlation time span parameters.
- Parameters
@@ -3694,7 +3668,7 @@ Submodules
- Parameters
-species (spayialpy.species.Species) – The species to set the initial condition.
+species (spatialpy.core.species.Species) – The species to set the initial condition.
count (int) – The initial condition for the target species.
location (float[3]) – X, Y, Z coordinates to place the initial condition.
@@ -3706,7 +3680,7 @@ Submodules
- Parameters
-model (spatialpy.model.Model) – Model contianing the target species.
+model (spatialpy.core.model.Model) – Model contianing the target species.
@@ -3725,7 +3699,7 @@ Submodulesspatialpy.core.parameter.Parameter) – if mass action, rate is a reference to a parameter instance.
annotation (str) – Description of the reaction (meta)
restrict_to (int, str, list of ints or list of strs) – Restrict reaction execution to a type or list of types within the domain.
@@ -3738,7 +3712,7 @@ Submodules
Parameters
-S (spatialpy.Model.Species) – Species object to be produced by the reaction
+species (spatialpy.core.species.Species) – Species object to be produced by the reaction
stoichiometry (int) – Stoichiometry of this product.
@@ -3752,7 +3726,7 @@ Submodules
Parameters
-species (spatialpy.Model.Species) – reactant Species object
+species (spatialpy.core.species.Species) – reactant Species object
stoichiometry (int) – Stoichiometry of this participant reactant
@@ -3776,7 +3750,7 @@ Submodules
Parameters
-model (spatialpy.Model) – Target SpatialPy Model for annotation.
+model (spatialpy.core.model.Model) – Target SpatialPy Model for annotation.
@@ -3804,18 +3778,9 @@ Submodules
Parameters
-folder_name (str (default current working directory)) – A path where the vtk files will be written, created if non-existant.
+folder_name (str) – A path where the vtk files will be written, created if non-existant. Defaults current working directory
-If no path is provided current working directory is used.
-
-
-
--
-export_to_vtk(timespan, folder_name=None)[source]¶
-Write the trajectory to a collection of vtk files.
-The exported data is #molecules/volume, where the volume unit is implicit from the mesh dimension.
-Not currently implemented.
@@ -3825,7 +3790,14 @@ Submodules
- Parameters
-property_name (str) – A string describing the property to be returned.
+property_name (str) – A string describing the property to be returned. Can be one of: {
+‘v’ : velocity,
+‘rho’: density,
+‘mass’: mass,
+‘id’: type_id,
+‘type’: type as str,
+‘bvf_phi’: boundary volume fraction,
+‘nu’: viscosity}
timepoints (int) – timespan index to be returned. Default is None
@@ -3836,7 +3808,7 @@ Submodulesnumpy.ndarray
Raises
-ResultsError – Could not get data for given timepoints.
+ResultError – Could not get data for given timepoints.
@@ -3849,17 +3821,17 @@ Submodules
Parameters
-species (str | dict) – A species in string or dictionary form to retreive information about
-timepoints (int (default None)) – A time point where the information should be retreived from.
+
species (str | spatialpy.core.species.Species) – A species in string or dictionary form to retreive information about
+timepoints (int) – A time point where the information should be retreived from.
If ‘timepoints’ is None (default), a matrix of dimension:
(number of timepoints) x (number of voxels) is returned.
If an integer value is given, that value is used to index into the timespan, and that time point is returned
-as a 1D array with size (number of voxel).
-concentration (bool (default False)) – Whether or not the species is a concentration (True) or population (False)
+as a 1D array with size (number of voxel). Defaults to None
+concentration (bool) – Whether or not the species is a concentration (True) or population (False)
If concentration is False (default), the integer, raw, trajectory data is returned.
-If set to True, the concentration (=copy_number/volume) is returned.
-deterministic (bool (default False)) – Whether or not the species is deterministic (True) or stochastic (False)
-debug (bool (default False)) – Whether or not debug information should be printed
+If set to True, the concentration (=copy_number/volume) is returned. Defaults to False
+deterministic (bool) – Whether or not the species is deterministic (True) or stochastic (False). Defaults to False
+debug (bool) – Whether or not debug information should be printed. Defaults to False
Returns
@@ -3900,8 +3872,8 @@ Submodulesdict
Raises
-ResultsError – unable to plot species for given time
+ResultError – unable to plot species for given time
@@ -4018,7 +3990,7 @@ Submodules
Parameters
-species (spayialpy.species.Species) – The species to set the initial condition.
+species (spatialpy.core.species.Species) – The species to set the initial condition.
count (int) – The initial condition for the target species.
types (list) – Types of the particles to place the initial condition.
@@ -4030,7 +4002,7 @@ Submodules
Parameters
-model (spatialpy.model.Model) – Model contianing the target species.
+model (spatialpy.core.model.Model) – Model contianing the target species.
@@ -4061,12 +4033,10 @@ Submodules
name (str) – Name of the Species
diffusion_coefficient (float) – Non-constant coefficient of diffusion for Species.
-restrict_to – Set the diffusion coefficient to zero for ‘species’ in all types not in ‘listOfTypes’.
+restrict_to (int, str, list of ints or list of strs) – Set the diffusion coefficient to zero for ‘species’ in all types not in ‘listOfTypes’. This effectively restricts the movement of ‘species’ to the types specified in ‘listOfTypes’.
-This effectively restricts the movement of ‘species’ to the types specified in ‘listOfTypes’.
-:type restrict_to: int, str, list of ints or list of strs
-
set_diffusion_coefficient(diffusion_coefficient)[source]¶
@@ -4076,7 +4046,7 @@ Submodulesdiffusion_coefficient (float) – Non-constant coefficient of diffusion for Species.
- Raises
-SpeciesError – If diffusion_coefficient is negative.
+SpeciesError – If diffusion_coefficient is negative or not a valid type.
@@ -4098,7 +4068,7 @@ Submodules
Parameters
-species (spayialpy.species.Species) – The species to set the initial condition.
+species (spatialpy.core.species.Species) – The species to set the initial condition.
count (int) – The initial condition for the target species.
types (list) – Types of the particles to place the initial condition.
@@ -4110,7 +4080,7 @@ Submodules
Parameters
-model (spatialpy.model.Model) – Model contianing the target species.
+model (spatialpy.core.model.Model) – Model contianing the target species.
diff --git a/docs/build/html/classes/spatialpy.solvers.html b/docs/build/html/classes/spatialpy.solvers.html
index 6399a06c..a0aecbb1 100644
--- a/docs/build/html/classes/spatialpy.solvers.html
+++ b/docs/build/html/classes/spatialpy.solvers.html
@@ -891,7 +891,7 @@ Submodules
Parameters
-model (spatialpy.Model.Model) – Target model of solver simulation.
+model (spatialpy.core.model.Model) – Target model of solver simulation.
debug_level (int) – Target level of debugging.
diff --git a/docs/build/html/classes/spatialpy.stochss.html b/docs/build/html/classes/spatialpy.stochss.html
index 2cb25e06..b422fed0 100644
--- a/docs/build/html/classes/spatialpy.stochss.html
+++ b/docs/build/html/classes/spatialpy.stochss.html
@@ -127,14 +127,17 @@ Submodules
Parameters
-spatialpy_model – spatialpy.Model
-SpatialPy model to be converted to StochSS
-filename – str
-Path to the exported stochss model
-return_stochss_model – bool
-Whether or not to return the model
+model (spatialpy.core.model.Model) – SpatialPy model to be converted to StochSS.
+filename (str) – Path to the exported stochss model.
+return_stochss_model (bool) – Whether or not to return the model.
+Returns
+StochSS model dict if return_stochss_model is True else path to StochSS model file.
+
+Return type
+dict | str
+
diff --git a/docs/build/html/genindex.html b/docs/build/html/genindex.html
index b01ffea2..f15d74f7 100644
--- a/docs/build/html/genindex.html
+++ b/docs/build/html/genindex.html
@@ -390,12 +390,6 @@ E
- export_to_vtk() (spatialpy.core.Result method)
-
-
diff --git a/docs/build/html/index.html b/docs/build/html/index.html
index e6a60f46..dfb90b68 100644
--- a/docs/build/html/index.html
+++ b/docs/build/html/index.html
@@ -100,7 +100,7 @@ Getting a copy of SpatialPyPlease register as a user! SpatialPy's development is funded by NIH grant 2R01EB014877, and to continue support, we need to prove SpatialPy has users. Please fill out our short registration form!
Examples¶
-See our Example Notebook - Getting Started for more information on how to build and simulate your models with SpatialPy. For an example of how to use SpatialPy to simulate a spatial stochastic reaction-diffusion system, see the 3D Cylinder Demo. We also provide examples of how to use SpatialPy to simulate physics (Gravity Demo) and fluid flow (Weir Model).
+See our Example Notebook - Start Here for more information on how to build and simulate your models with SpatialPy. For an example of how to use SpatialPy to simulate a spatial stochastic reaction-diffusion system, see the 3D Cylinder Demo. We also provide examples of how to use SpatialPy to simulate physics (Gravity Demo) and fluid flow (Weir Model).
Reporting Issues¶
diff --git a/docs/build/html/objects.inv b/docs/build/html/objects.inv
index 8e7baf8f..df1b09ba 100644
Binary files a/docs/build/html/objects.inv and b/docs/build/html/objects.inv differ
diff --git a/docs/build/html/searchindex.js b/docs/build/html/searchindex.js
index 4a0be063..70ef50ba 100644
--- a/docs/build/html/searchindex.js
+++ b/docs/build/html/searchindex.js
@@ -1 +1 @@
-Search.setIndex({docnames:["classes/spatialpy","classes/spatialpy.core","classes/spatialpy.solvers","classes/spatialpy.stochss","index"],envversion:{"sphinx.domains.c":2,"sphinx.domains.changeset":1,"sphinx.domains.citation":1,"sphinx.domains.cpp":4,"sphinx.domains.index":1,"sphinx.domains.javascript":2,"sphinx.domains.math":2,"sphinx.domains.python":3,"sphinx.domains.rst":2,"sphinx.domains.std":2,"sphinx.ext.todo":2,"sphinx.ext.viewcode":1,sphinx:56},filenames:["classes/spatialpy.rst","classes/spatialpy.core.rst","classes/spatialpy.solvers.rst","classes/spatialpy.stochss.rst","index.rst"],objects:{"":{spatialpy:[0,0,0,"-"]},"spatialpy.core":{BoundaryCondition:[1,1,1,""],BoundaryConditionError:[1,3,1,""],DataFunction:[1,1,1,""],DataFunctionError:[1,3,1,""],Domain:[1,1,1,""],DomainError:[1,3,1,""],Geometry:[1,1,1,""],GeometryAll:[1,1,1,""],GeometryError:[1,3,1,""],GeometryExterior:[1,1,1,""],GeometryInterior:[1,1,1,""],InitialCondition:[1,1,1,""],InitialConditionError:[1,3,1,""],KDTree:[1,1,1,""],Model:[1,1,1,""],ModelError:[1,3,1,""],OrderedDict:[1,1,1,""],Parameter:[1,1,1,""],ParameterError:[1,3,1,""],PlaceInitialCondition:[1,1,1,""],Reaction:[1,1,1,""],ReactionError:[1,3,1,""],Result:[1,1,1,""],ResultError:[1,3,1,""],ScatterInitialCondition:[1,1,1,""],SimulationError:[1,3,1,""],SimulationTimeout:[1,3,1,""],Species:[1,1,1,""],SpeciesError:[1,3,1,""],UniformInitialCondition:[1,1,1,""],VTKReader:[1,1,1,""],VTKReaderError:[1,3,1,""],VTKReaderIOError:[1,3,1,""],boundarycondition:[1,0,0,"-"],cleanup:[1,0,0,"-"],cleanup_build_files:[1,5,1,""],cleanup_core_files:[1,5,1,""],cleanup_result_files:[1,5,1,""],cleanup_tempfiles:[1,5,1,""],combinations:[1,1,1,""],datafunction:[1,0,0,"-"],domain:[1,0,0,"-"],geometry:[1,0,0,"-"],init_notebook_mode:[1,5,1,""],initialcondition:[1,0,0,"-"],iplot:[1,5,1,""],model:[1,0,0,"-"],parameter:[1,0,0,"-"],reaction:[1,0,0,"-"],result:[1,0,0,"-"],spatialpyerror:[1,0,0,"-"],species:[1,0,0,"-"],vtkreader:[1,0,0,"-"]},"spatialpy.core.BoundaryCondition":{expression:[1,2,1,""]},"spatialpy.core.DataFunction":{map:[1,2,1,""]},"spatialpy.core.Domain":{add_point:[1,2,1,""],calculate_vol:[1,2,1,""],closest_vertex:[1,2,1,""],compile_prep:[1,2,1,""],coordinates:[1,2,1,""],create_2D_domain:[1,2,1,""],create_3D_domain:[1,2,1,""],distance_between_2_vertices:[1,2,1,""],fill_with_particles:[1,2,1,""],find_boundary_points:[1,2,1,""],find_h:[1,2,1,""],get_bounding_box:[1,2,1,""],get_domain_size:[1,2,1,""],get_num_voxels:[1,2,1,""],get_type_def:[1,2,1,""],get_vol:[1,2,1,""],import_meshio_object:[1,2,1,""],plot_types:[1,2,1,""],read_msh_file:[1,2,1,""],read_stochss_domain:[1,2,1,""],read_stochss_subdomain_file:[1,2,1,""],read_xml_mesh:[1,2,1,""],set_properties:[1,2,1,""]},"spatialpy.core.Geometry":{inside:[1,2,1,""]},"spatialpy.core.GeometryAll":{inside:[1,2,1,""]},"spatialpy.core.GeometryExterior":{inside:[1,2,1,""]},"spatialpy.core.GeometryInterior":{inside:[1,2,1,""]},"spatialpy.core.InitialCondition":{apply:[1,2,1,""]},"spatialpy.core.KDTree":{count_neighbors:[1,2,1,""],innernode:[1,1,1,""],leafnode:[1,1,1,""],node:[1,1,1,""],query:[1,2,1,""],query_ball_point:[1,2,1,""],query_ball_tree:[1,2,1,""],query_pairs:[1,2,1,""],sparse_distance_matrix:[1,2,1,""]},"spatialpy.core.Model":{add_boundary_condition:[1,2,1,""],add_data_function:[1,2,1,""],add_domain:[1,2,1,""],add_initial_condition:[1,2,1,""],add_parameter:[1,2,1,""],add_reaction:[1,2,1,""],add_species:[1,2,1,""],compile_prep:[1,2,1,""],delete_all_parameters:[1,2,1,""],delete_all_reactions:[1,2,1,""],delete_all_species:[1,2,1,""],delete_parameter:[1,2,1,""],delete_reaction:[1,2,1,""],delete_species:[1,2,1,""],get_all_parameters:[1,2,1,""],get_all_reactions:[1,2,1,""],get_all_species:[1,2,1,""],get_num_reactions:[1,2,1,""],get_num_species:[1,2,1,""],get_parameter:[1,2,1,""],get_reaction:[1,2,1,""],get_species:[1,2,1,""],reserved_names:[1,4,1,""],run:[1,2,1,""],sanitized_data_function_names:[1,2,1,""],sanitized_parameter_names:[1,2,1,""],sanitized_species_names:[1,2,1,""],set_timesteps:[1,2,1,""],special_characters:[1,4,1,""],timespan:[1,2,1,""],update_namespace:[1,2,1,""]},"spatialpy.core.OrderedDict":{clear:[1,2,1,""],copy:[1,2,1,""],fromkeys:[1,2,1,""],items:[1,2,1,""],keys:[1,2,1,""],move_to_end:[1,2,1,""],pop:[1,2,1,""],popitem:[1,2,1,""],setdefault:[1,2,1,""],update:[1,2,1,""],values:[1,2,1,""]},"spatialpy.core.PlaceInitialCondition":{apply:[1,2,1,""]},"spatialpy.core.Reaction":{add_product:[1,2,1,""],add_reactant:[1,2,1,""],annotate:[1,2,1,""],initialize:[1,2,1,""]},"spatialpy.core.Result":{export_to_csv:[1,2,1,""],export_to_vtk:[1,2,1,""],get_property:[1,2,1,""],get_species:[1,2,1,""],get_timespan:[1,2,1,""],plot_property:[1,2,1,""],plot_species:[1,2,1,""],read_step:[1,2,1,""]},"spatialpy.core.ScatterInitialCondition":{apply:[1,2,1,""]},"spatialpy.core.Species":{set_diffusion_coefficient:[1,2,1,""]},"spatialpy.core.UniformInitialCondition":{apply:[1,2,1,""]},"spatialpy.core.VTKReader":{get_array_name:[1,2,1,""],get_arrays:[1,2,1,""],get_num_points:[1,2,1,""],get_points:[1,2,1,""],read_file:[1,2,1,""],set_filename:[1,2,1,""]},"spatialpy.core.boundarycondition":{BoundaryCondition:[1,1,1,""]},"spatialpy.core.boundarycondition.BoundaryCondition":{expression:[1,2,1,""]},"spatialpy.core.cleanup":{cleanup_build_files:[1,5,1,""],cleanup_core_files:[1,5,1,""],cleanup_result_files:[1,5,1,""],cleanup_tempfiles:[1,5,1,""]},"spatialpy.core.datafunction":{DataFunction:[1,1,1,""]},"spatialpy.core.datafunction.DataFunction":{map:[1,2,1,""]},"spatialpy.core.domain":{Domain:[1,1,1,""]},"spatialpy.core.domain.Domain":{add_point:[1,2,1,""],calculate_vol:[1,2,1,""],closest_vertex:[1,2,1,""],compile_prep:[1,2,1,""],coordinates:[1,2,1,""],create_2D_domain:[1,2,1,""],create_3D_domain:[1,2,1,""],distance_between_2_vertices:[1,2,1,""],fill_with_particles:[1,2,1,""],find_boundary_points:[1,2,1,""],find_h:[1,2,1,""],get_bounding_box:[1,2,1,""],get_domain_size:[1,2,1,""],get_num_voxels:[1,2,1,""],get_type_def:[1,2,1,""],get_vol:[1,2,1,""],import_meshio_object:[1,2,1,""],plot_types:[1,2,1,""],read_msh_file:[1,2,1,""],read_stochss_domain:[1,2,1,""],read_stochss_subdomain_file:[1,2,1,""],read_xml_mesh:[1,2,1,""],set_properties:[1,2,1,""]},"spatialpy.core.geometry":{Geometry:[1,1,1,""],GeometryAll:[1,1,1,""],GeometryExterior:[1,1,1,""],GeometryInterior:[1,1,1,""]},"spatialpy.core.geometry.Geometry":{inside:[1,2,1,""]},"spatialpy.core.geometry.GeometryAll":{inside:[1,2,1,""]},"spatialpy.core.geometry.GeometryExterior":{inside:[1,2,1,""]},"spatialpy.core.geometry.GeometryInterior":{inside:[1,2,1,""]},"spatialpy.core.initialcondition":{InitialCondition:[1,1,1,""],PlaceInitialCondition:[1,1,1,""],ScatterInitialCondition:[1,1,1,""],UniformInitialCondition:[1,1,1,""]},"spatialpy.core.initialcondition.InitialCondition":{apply:[1,2,1,""]},"spatialpy.core.initialcondition.PlaceInitialCondition":{apply:[1,2,1,""]},"spatialpy.core.initialcondition.ScatterInitialCondition":{apply:[1,2,1,""]},"spatialpy.core.initialcondition.UniformInitialCondition":{apply:[1,2,1,""]},"spatialpy.core.model":{Model:[1,1,1,""],export_StochSS:[1,5,1,""]},"spatialpy.core.model.Model":{add_boundary_condition:[1,2,1,""],add_data_function:[1,2,1,""],add_domain:[1,2,1,""],add_initial_condition:[1,2,1,""],add_parameter:[1,2,1,""],add_reaction:[1,2,1,""],add_species:[1,2,1,""],compile_prep:[1,2,1,""],delete_all_parameters:[1,2,1,""],delete_all_reactions:[1,2,1,""],delete_all_species:[1,2,1,""],delete_parameter:[1,2,1,""],delete_reaction:[1,2,1,""],delete_species:[1,2,1,""],get_all_parameters:[1,2,1,""],get_all_reactions:[1,2,1,""],get_all_species:[1,2,1,""],get_num_reactions:[1,2,1,""],get_num_species:[1,2,1,""],get_parameter:[1,2,1,""],get_reaction:[1,2,1,""],get_species:[1,2,1,""],reserved_names:[1,4,1,""],run:[1,2,1,""],sanitized_data_function_names:[1,2,1,""],sanitized_parameter_names:[1,2,1,""],sanitized_species_names:[1,2,1,""],set_timesteps:[1,2,1,""],special_characters:[1,4,1,""],timespan:[1,2,1,""],update_namespace:[1,2,1,""]},"spatialpy.core.parameter":{Parameter:[1,1,1,""]},"spatialpy.core.reaction":{Reaction:[1,1,1,""]},"spatialpy.core.reaction.Reaction":{add_product:[1,2,1,""],add_reactant:[1,2,1,""],annotate:[1,2,1,""],initialize:[1,2,1,""]},"spatialpy.core.result":{Result:[1,1,1,""]},"spatialpy.core.result.Result":{export_to_csv:[1,2,1,""],export_to_vtk:[1,2,1,""],get_property:[1,2,1,""],get_species:[1,2,1,""],get_timespan:[1,2,1,""],plot_property:[1,2,1,""],plot_species:[1,2,1,""],read_step:[1,2,1,""]},"spatialpy.core.spatialpyerror":{BoundaryConditionError:[1,3,1,""],DataFunctionError:[1,3,1,""],DomainError:[1,3,1,""],GeometryError:[1,3,1,""],InitialConditionError:[1,3,1,""],ModelError:[1,3,1,""],ParameterError:[1,3,1,""],ReactionError:[1,3,1,""],ResultError:[1,3,1,""],SimulationError:[1,3,1,""],SimulationTimeout:[1,3,1,""],SpeciesError:[1,3,1,""],VTKReaderError:[1,3,1,""],VTKReaderIOError:[1,3,1,""]},"spatialpy.core.species":{Species:[1,1,1,""]},"spatialpy.core.species.Species":{set_diffusion_coefficient:[1,2,1,""]},"spatialpy.core.vtkreader":{VTKReader:[1,1,1,""]},"spatialpy.core.vtkreader.VTKReader":{get_array_name:[1,2,1,""],get_arrays:[1,2,1,""],get_num_points:[1,2,1,""],get_points:[1,2,1,""],read_file:[1,2,1,""],set_filename:[1,2,1,""]},"spatialpy.solvers":{build_expression:[2,0,0,"-"],solver:[2,0,0,"-"]},"spatialpy.solvers.build_expression":{BuildExpression:[2,1,1,""],CppConverter:[2,1,1,""],ExpressionConverter:[2,1,1,""],ExpressionResults:[2,1,1,""],PythonConverter:[2,1,1,""]},"spatialpy.solvers.build_expression.BuildExpression":{ValidationVisitor:[2,1,1,""],getexpr_cpp:[2,2,1,""],getexpr_python:[2,2,1,""],map_operator:[2,2,1,""],operator_map:[2,4,1,""],validate:[2,2,1,""],with_blacklist:[2,2,1,""],with_namespace:[2,2,1,""]},"spatialpy.solvers.build_expression.BuildExpression.ValidationVisitor":{visit_Assign:[2,2,1,""],visit_BinOp:[2,2,1,""],visit_BoolOp:[2,2,1,""],visit_Call:[2,2,1,""],visit_Compare:[2,2,1,""],visit_Name:[2,2,1,""],visit_UnaryOp:[2,2,1,""]},"spatialpy.solvers.build_expression.CppConverter":{CppExpressionTransformer:[2,1,1,""],get_str:[2,2,1,""],visit_And:[2,2,1,""],visit_Or:[2,2,1,""]},"spatialpy.solvers.build_expression.CppConverter.CppExpressionTransformer":{visit_BinOp:[2,2,1,""]},"spatialpy.solvers.build_expression.ExpressionConverter":{convert_str:[2,2,1,""],get_str:[2,2,1,""],parse_comparison:[2,2,1,""],parse_logical:[2,2,1,""],parse_operator:[2,2,1,""],visit_Add:[2,2,1,""],visit_BinOp:[2,2,1,""],visit_BoolOp:[2,2,1,""],visit_Bytes:[2,2,1,""],visit_Call:[2,2,1,""],visit_Compare:[2,2,1,""],visit_Constant:[2,2,1,""],visit_Div:[2,2,1,""],visit_Ellipsis:[2,2,1,""],visit_Eq:[2,2,1,""],visit_Gt:[2,2,1,""],visit_GtE:[2,2,1,""],visit_Lt:[2,2,1,""],visit_LtE:[2,2,1,""],visit_Mult:[2,2,1,""],visit_Name:[2,2,1,""],visit_NameConstant:[2,2,1,""],visit_NotEq:[2,2,1,""],visit_Num:[2,2,1,""],visit_Pow:[2,2,1,""],visit_Str:[2,2,1,""],visit_Sub:[2,2,1,""],visit_USub:[2,2,1,""],visit_UnaryOp:[2,2,1,""]},"spatialpy.solvers.build_expression.PythonConverter":{visit_And:[2,2,1,""],visit_Or:[2,2,1,""]},"spatialpy.solvers.solver":{Solver:[2,1,1,""]},"spatialpy.solvers.solver.Solver":{compile:[2,2,1,""],run:[2,2,1,""]},"spatialpy.stochss":{stochss_export:[3,0,0,"-"]},"spatialpy.stochss.stochss_export":{"export":[3,5,1,""]},spatialpy:{core:[1,0,0,"-"],solvers:[2,0,0,"-"],stochss:[3,0,0,"-"]}},objnames:{"0":["py","module","Python module"],"1":["py","class","Python class"],"2":["py","method","Python method"],"3":["py","exception","Python exception"],"4":["py","attribute","Python attribute"],"5":["py","function","Python function"]},objtypes:{"0":"py:module","1":"py:class","2":"py:method","3":"py:exception","4":"py:attribute","5":"py:function"},terms:{"0":[1,2],"04":1,"1":[1,2],"10":1,"10000":1,"11":1,"13":1,"14142136":1,"15":1,"1999":1,"1d":1,"2":1,"20":1,"2000":1,"2015":1,"2019":[0,1,2,3],"2022":[0,1,2,3],"2d":1,"2e9":1,"2r01eb014877":4,"3":[0,1,2,3,4],"300":1,"3d":[1,4],"4":1,"5":1,"500":1,"6":1,"600":1,"7":1,"8":1,"800":1,"9":1,"abstract":[1,2],"byte":2,"case":1,"class":[1,2],"default":1,"do":1,"export":[1,3],"float":1,"function":[1,2],"import":1,"int":[1,2],"long":1,"new":[1,2],"public":[0,1,2,3,4],"return":[1,2,3],"short":4,"static":[1,4],"super":2,"switch":1,"true":[1,2],A:[0,1,2,3,4],And:2,By:[1,2],FOR:[0,1,2,3],For:[1,4],If:[0,1,2,3,4],In:1,It:1,No:1,Not:[1,2],Or:2,The:[1,2,4],These:1,Will:1,_ast:2,abl:1,about:1,absolut:1,acceler:1,accept:2,across:1,action:1,ad:[1,2],add:[1,2],add_boundary_condit:1,add_data_funct:1,add_domain:1,add_initial_condit:1,add_paramet:1,add_point:1,add_product:1,add_react:1,add_speci:1,addit:[1,2],addition:[1,2],addtion:[1,2],advect:[0,1,2,3,4],against:[1,2],algorithm:[1,4],align:1,all:[1,2],allow:2,along:[0,1,2,3],alreadi:1,also:[1,2,4],alwai:2,amount:1,an:[1,2,4],ani:[0,1,2,3,4],anim:1,animation_attribut:1,animation_opt:1,annot:1,append:2,appli:1,approxim:1,ar:[1,2],argument:1,arrai:1,arraid:1,array_lik:1,articl:4,artifici:1,asarrai:1,ascii:1,assign:[1,2],associ:1,assum:2,ast:2,attempt:1,attribut:1,author:4,auto_plai:1,automat:[1,2],autorang:1,avail:[1,2,4],averag:1,axi:1,background:1,bare:2,base:[1,2,4],bass:1,becaus:1,becom:1,been:1,begin:1,behavior:2,best:1,between:[1,2],binari:1,binboolopop:2,binop:2,biochem:1,bitand:2,bitor:2,bitxor:2,blacklist:2,blob:1,blue:1,bodi:1,bogu:1,bool:[1,2,3],boolop:2,both:[1,4],bottom:1,bound:1,bound_cond:1,boundari:1,boundarycondit:0,boundaryconditionerror:1,box:1,branch:1,brian:4,browser:1,brute:1,bugn:1,build:[1,2,4],build_dir:1,build_express:0,buildexpress:2,built:2,bulk:1,bupu:1,c0:1,c:[0,1,2,3],c_:1,calcul:1,calculate_vol:1,call:[1,2],can:[0,1,2,3,4],caus:2,cdn:1,cell:1,charact:1,chart:1,check:[1,2],chemic:1,choos:1,chosen:1,circumradiu:1,ckdtree:1,classmethod:[1,2],cleanup:0,cleanup_build_fil:1,cleanup_core_fil:1,cleanup_result_fil:1,cleanup_tempfil:1,clear:1,close:1,closest:1,closest_vertex:1,cloud:1,code:[1,4],coeffic:1,coeffici:1,collabor:1,collect:1,colormap:1,column:1,com:[1,4],combin:1,compar:[1,2],comparison:2,compil:[1,2],compile_prep:1,comput:1,conain:1,conatain:1,concentr:1,condit:[1,2],config:1,connect:1,consid:1,consol:2,constant:[1,2],construct:1,constructor:2,constuct:1,contact:4,contain:[1,2],content:4,context:2,contian:1,continu:4,convers:2,convert:[1,2,3],convert_str:2,convet:2,coodin:1,coordin:1,copi:[0,1,2,3],copy_numb:1,copyright:[0,1,2,3],core:[0,4],corner:1,correl:1,correspond:[1,2],could:[1,2],count:1,count_neighbor:1,coupl:1,cppconvert:2,cppexpressiontransform:2,creat:[1,2],create_2d_domain:1,create_3d_domain:1,csv:1,current:[1,2],custom:1,cylind:4,cython:1,d:1,data:[1,2],data_funct:1,datafunct:0,datafunctionerror:1,debug:[1,2],debug_level:[1,2],debugg:2,defer:1,defin:[1,2],definit:1,delete_all_paramet:1,delete_all_react:1,delete_all_speci:1,delete_paramet:1,delete_react:1,delete_speci:1,deltai:1,deltax:1,deltaz:1,demo:4,densiti:1,dependency_graph:1,describ:[1,4],descript:1,detail:[0,1,2,3],determinist:[0,1,2,3,4],determinst:1,develop:[0,1,2,3,4],diamet:1,dict:[1,2],dictionari:[1,2],differ:[1,2],diffus:[0,1,2,3,4],diffusion_coeffici:1,dimens:1,dimension:1,direct:1,directli:[1,4],directori:1,displai:1,dissip:4,distanc:1,distance_between_2_vertic:1,distance_upper_bound:1,distribut:[0,1,2,3],div:2,doe:1,doesn:1,dok_matrix:1,dolfin:1,dom:1,domain:[0,4],domainerror:1,domn:1,doubl:1,download:1,dr:4,draw:1,drawert:4,drawn:1,dtype:1,duplic:2,durat:1,dure:[1,2],dynam:4,e:1,each:1,edg:1,edit:1,effect:1,effici:1,either:1,element:1,ellipsi:2,els:1,embed:4,empti:2,end:1,engin:1,ensur:[1,2],enterpris:1,entir:1,entireti:1,ep:1,eq:2,equival:2,error:1,estim:1,euclidean:1,evalu:1,evaul:1,even:[0,1,2,3],evenli:1,exampl:1,exce:1,exceed:[1,2],except:1,execut:[1,2],exist:1,expect:[1,2],explor:1,export_stochss:1,export_to_csv:1,export_to_vtk:1,expres:2,express:[1,2],expressionconvert:2,expressionresult:2,extens:1,extra:1,f:1,f_durat:1,fail:2,fals:[1,2,3],far:2,faster:1,featur:4,fenic:1,fifo:1,figur:1,figure_or_data:1,file:1,filenam:[1,3],fill:[1,4],fill_with_particl:1,find:[1,4],find_boundary_point:1,find_h:1,first:[1,2],fit:[0,1,2,3],fix:1,flag:[1,2],flatten:1,flight:2,floordiv:2,flow:4,fluid:[1,4],folder_nam:1,follow:[1,2],forc:1,form:[1,4],format:1,forward:2,found:[1,2,4],foundat:[0,1,2,3],frame:[1,4],free:[0,1,2,3],frequenc:1,from:[1,2],fromkei:1,fund:4,further:1,furthest:1,g:1,gain:1,gdbgui:2,gener:[0,1,2,3,4],geometr:1,geometri:0,geometry_ivar:1,geometryal:1,geometryerror:1,geometryexterior:1,geometryinterior:1,get:[1,2],get_all_paramet:1,get_all_react:1,get_all_speci:1,get_arrai:1,get_array_nam:1,get_bounding_box:1,get_domain_s:1,get_num_point:1,get_num_react:1,get_num_speci:1,get_num_voxel:1,get_paramet:1,get_point:1,get_properti:1,get_react:1,get_speci:1,get_str:2,get_timespan:1,get_type_def:1,get_vol:1,getexpr_:2,getexpr_cpp:2,getexpr_python:2,github:[1,4],given:[1,2],gmsh:1,gnbu:1,gnu:[0,1,2,3,4],gprof:2,grai:1,grant:4,granular:2,graph:1,graph_obj:1,graph_refer:1,graviti:[1,4],greater:1,greatest:1,green:1,grei:1,gt:2,gte:2,guarante:1,h:1,ha:[1,4],hand:2,handl:2,happen:[1,2],hasn:[1,2],have:[0,1,2,3],height:1,held:1,help:1,here:1,high:1,higher:1,highest:1,hit:1,hope:[0,1,2,3],how:[1,2,4],http:[0,1,2,3,4],hybrid:4,hyperrectangl:1,i:1,id:1,idea:1,ideal:2,idempot:1,identifi:[1,2],idx:1,ignor:1,imag:1,image_height:1,image_width:1,immobil:1,implemenet:1,implement:[1,2],impli:[0,1,2,3],implicit:1,import_meshio_object:1,imposs:2,inch:1,incid:1,includ:1,included_types_list:1,incompat:1,increas:1,increment:2,indec:1,indeci:1,index:[1,4],indic:[1,2],inf:1,infer:2,infin:1,infinit:1,info:1,inform:[1,2,4],inherit:2,init_cond:1,init_notebook_mod:1,initailcondit:1,initi:1,initialcondit:0,initialconditionerror:1,inlin:1,innernod:1,input:1,insert:1,insid:1,instanc:[1,2],instead:1,integ:1,intend:4,intern:1,internet:1,interv:1,invalid:[1,2],invalid_:2,invalid_nam:2,invalid_oper:2,io:1,iplot:1,ipython:1,is_valid:2,item:[1,2],iter:1,its:1,j:1,jacob:4,jet:1,jpeg:1,js:1,json:1,jupyt:1,k:1,kd:1,kdtree:1,kei:[1,2],keyerror:1,keyword:1,kill:1,kth:1,kwarg:1,lack:1,lagrangian:4,larg:1,larger:1,last:[1,2],later:[1,2],latest:4,layout:1,leafnod:1,leafsiz:1,learn:1,leav:1,left:2,legaci:1,length:1,less:1,level:[1,2],li:4,librari:1,licens:[0,1,2,3,4],lifo:1,like:1,limit:1,link:1,link_text:1,list:[1,2],listofparamet:1,listofreact:1,listofspeci:1,listoftyp:1,load:1,local:1,locat:1,logic:2,look:1,lookup:1,lower:1,lowest:1,lshift:2,lt:2,lte:2,ly:1,m:1,mai:1,main:4,make:1,manag:2,maneewongvatana:1,manhattan:1,mani:[1,2],map:[1,2],map_oper:2,margin:1,mark:1,mass:1,master:1,mathemat:[1,2],matmult:2,matplotlib:1,matrix:1,max:1,max_dist:1,maximum:[1,2],mean:1,measur:1,meet:1,megabyt:1,merchant:[0,1,2,3],mesh:1,mesh_obj:1,meshio:1,messag:1,meta:1,method:[1,2],mgrid:1,midpoint:1,min:1,minim:1,minimum:1,minkowski:1,miss:1,mod:2,model:[0,2,3,4],modelerror:1,modelname_mesh:1,modelname_species_:1,modifi:[0,1,2,3],modul:4,molecul:1,moor:1,more:[0,1,2,3,4],most:[1,2],mount:1,move:1,move_to_end:1,movement:1,msh:1,much:1,mult:2,multipl:[1,2],must:1,n:1,name:[1,2],nameconst:2,namespac:[1,2],ndarrai:1,nearbi:1,nearby_point:1,nearer:1,nearest:1,necessarili:1,need:[1,4],neg:1,neighbor:1,nih:4,node:[1,2],nodetransform:2,nodevisitor:2,non:1,none:[1,2,3],nonneg:1,norm:1,notat:1,note:[1,2],notebook:[1,4],noteq:2,np:1,nsm:4,nu:1,num:2,num_step:1,number:[1,2],number_of_thread:[1,2],number_of_trajectori:[1,2],numpi:1,numpoint:1,nx:1,ny:1,nz:1,o:1,obj:1,object:[1,2],od:1,off:1,offlin:1,omit:1,on_boundari:1,one:[1,2],onli:[1,2],onlin:1,open:1,oper:2,operator_map:2,option:1,orang:1,order:1,ordereddict:1,org:[0,1,2,3],origin:2,orrd:1,other:[1,2],otherwis:[1,2],our:4,out:[1,4],outdat:1,output:[1,2],output_interv:1,over:1,overflow:1,overrid:2,overridden:1,p0:1,p:1,p_ndx:1,packag:4,page:[1,4],pair:1,param:1,param_nam:1,param_obj:1,paramet:[0,2,3],parametererror:1,paramt:1,parent:1,pars:2,parse_comparison:2,parse_log:2,parse_oper:2,part:1,partcil:1,particip:1,particl:[1,4],particular:[0,1,2,3],pass:[1,2],path:[1,3],pdf:1,perform:1,petzold:4,physic:4,pii:4,pixel:1,place:1,placeinitialcondit:1,platform:1,pleas:[1,4],plot:1,plot_imag:1,plot_properti:1,plot_speci:1,plot_typ:1,plotli:1,plotly3:1,plt:1,pname:1,png:1,point:1,pop:[1,2],popitem:1,popul:1,posit:1,positon:1,pow:2,pre:2,predict:1,preper:1,present:[1,2],pressur:1,print:[1,2],problem:[0,1,2,3,4],process:2,produc:1,product:1,profil:[1,2],program:[0,1,2,3],project:4,propens:1,propensity_funct:1,properti:[1,2],property_nam:1,proprti:1,prove:4,provid:[1,2,4],prune:1,pt:1,publish:[0,1,2,3],pubu:1,pubugn:1,pull:1,purd:1,purpl:1,purpos:[0,1,2,3],put:1,px:1,py:1,pypi:4,pyplot:1,python:[0,1,2,3,4],pythonconvert:2,pyurdm:4,queri:1,query_ball_point:1,query_ball_tre:1,query_pair:1,question:4,quick:1,r:1,radii:1,radiu:1,rais:[1,2],random:[1,2],randomli:1,rang:1,rapidli:1,rate:1,rather:1,ravel:1,raw:1,rdme:4,rdpu:1,reac:1,reach:1,react_nam:1,react_obj:1,reactant:1,reaction:[0,2,3,4],reactionerror:1,read:1,read_fil:1,read_msh_fil:1,read_step:1,read_stochss_domain:1,read_stochss_subdomain_fil:1,read_xml_mesh:1,reader:1,real:1,reason:1,receiv:[0,1,2,3],recent:[1,2],recurs:1,red:1,redistribut:[0,1,2,3],reevalu:1,refer:1,referenc:1,regardless:1,region:1,regist:4,registr:4,reject:2,rememb:1,remov:1,replac:4,repres:1,represent:[1,2],request:1,requir:1,reserved_nam:1,resolut:1,restrict:1,restrict_to:1,result:[0,2],result_dir:1,resulterror:1,resultserror:1,retreiv:1,retriev:1,return_plotly_figur:1,return_stochss_model:[1,3],rh:1,rho0:1,rho:1,right:[1,2],rname:1,rshift:2,rtype:2,rule:1,run:[1,2],runtimeerror:1,rvalu:2,s0021999118307101:4,s:[1,4],same:1,sampl:1,sanit:2,sanitized_data_function_nam:1,sanitized_parameter_nam:1,sanitized_species_nam:1,save:1,scalar:1,scatter:1,scatterinitialcondit:1,scienc:[1,4],sciencedirect:4,scipi:1,sdpd:[1,4],search:[1,4],second:[1,2],see:[0,1,2,3,4],seed:[1,2],self:[1,2],separ:1,sequenc:1,seri:[1,2],set:[1,2],set_diffusion_coeffici:1,set_filenam:1,set_properti:1,set_timestep:1,setdefault:1,setrecursionlimit:1,setter:1,shallow:1,shape:1,should:[0,1,2,3],show:1,show_link:1,significantli:1,simlat:1,simplifi:1,simul:[0,1,2,3,4],simulationerror:[1,2],simulationtimeout:[1,2],sinc:1,singl:[1,2],size:1,slide:1,smaller:1,smdl:1,smooth:4,sname:1,so:[1,2],softwar:[0,1,2,3,4],solver:[0,1,4],some:1,sort:1,sound:1,sourc:[1,2,3,4],space:1,spactialpi:2,span:1,spars:1,sparse_distance_matrix:1,spatailpy_model:1,spatial:[0,1,2,3,4],spatialpy_build:1,spatialpy_model:[1,3],spatialpy_result:1,spatialpyerror:0,spatialpysolv:1,spayialpi:1,speci:0,special_charact:1,species_nam:1,species_object:1,specieserror:1,specif:1,specifi:1,speed:1,split:1,split_dim:1,src:1,ssa:1,sssa:4,start:[1,2,4],statement:2,statist:1,step:1,step_num:1,stochast:[0,1,2,3,4],stochss:[0,1,4],stochss_export:0,stoichiometr:1,stoichiometri:1,store:1,str:[1,2,3],string:[1,2],struct:2,structur:1,style:1,sub:2,subclass:[1,2],subdomain:1,submodul:0,subpackag:4,substanti:1,substitut:2,success:1,suggest:4,sum:1,suppli:1,support:[1,4],sure:1,svg:1,sy:1,symbol:2,syntax:2,syntaxerror:2,system:[1,4],t:[1,2],t_durat:1,t_ndx:1,t_ndx_list:1,t_val:1,tag:1,take:1,target:[1,2],tempfil:1,term:[0,1,2,3],tetrahedron:1,text:1,than:1,them:1,thi:[0,1,2,3,4],thin:1,those:1,thread:[1,2],time:[1,2],time_span:1,timeout:[1,2],timepoint:1,timespan:1,timestep:1,timestep_s:1,titl:1,token:2,total:1,toth:1,trace:1,tracker:4,trajectori:[1,2],transit:1,travers:1,tree:[1,2],triangl:1,trigger:2,tspan:1,tupl:1,two:[1,2],txt:1,type:[1,2],type_id:1,u0:1,unabl:1,unaryop:2,under:[0,1,2,3,4],uniform:1,uniforminitialcondit:1,union:1,unit:1,univers:2,unnecessari:1,up:1,updat:1,update_namespac:1,upload:1,upon:1,upper:1,urdm:1,us:[0,1,2,3,4],use_matplotlib:1,user:[1,4],usual:1,usub:2,util:1,v1:1,v:1,valid:[1,2],validationvisitor:2,valu:[1,2],vari:1,vector:1,verbos:2,veri:1,version:[0,1,2,3,4],vertex:1,vertic:1,view:1,viewer:1,viscos:1,visit:2,visit_add:2,visit_and:2,visit_assign:2,visit_binop:2,visit_boolop:2,visit_byt:2,visit_cal:2,visit_compar:2,visit_const:2,visit_div:2,visit_ellipsi:2,visit_eq:2,visit_gt:2,visit_lt:2,visit_mult:2,visit_nam:2,visit_nameconst:2,visit_noteq:2,visit_num:2,visit_or:2,visit_pow:2,visit_str:2,visit_sub:2,visit_unaryop:2,visit_usub:2,visitor:2,vol:1,volum:1,voxel:1,vtk:1,vtkreader:0,vtkreadererror:1,vtkreaderioerror:1,wa:1,want:1,warranti:[0,1,2,3],we:[1,4],web:1,webp:1,weir:4,well:2,were:[1,2],what:2,when:[1,2],where:1,whether:[1,2,3],which:[1,2],whose:1,width:1,with_blacklist:2,with_namespac:2,within:1,without:[0,1,2,3],word:1,work:1,wp:1,write:1,write_imag:1,written:1,www:[0,1,2,3,4],x1:1,x2:1,x:1,xaxi:1,xlim:1,xmax:1,xmin:1,xml:1,y:1,yaxi:1,yet:1,yi:4,ylgn:1,ylgnbu:1,ylim:1,ylorbr:1,ylorrd:1,ymax:1,ymin:1,you:[0,1,2,3,4],your:[1,4],z:1,zero:1,zeroth:1,zip:1,zlim:1,zmax:1,zmin:1},titles:["spatialpy package","spatialpy.core package","spatialpy.solvers package","spatialpy.stochss package","Documentation for SpatialPy 1.0"],titleterms:{"0":4,"1":4,api:4,boundarycondit:1,build_express:2,cleanup:1,content:[0,1,2,3],copi:4,core:1,datafunct:1,document:4,domain:1,exampl:4,geometri:1,get:4,indic:4,initialcondit:1,issu:4,model:1,modul:[0,1,2,3],packag:[0,1,2,3],paramet:1,reaction:1,refer:4,report:4,result:1,solver:2,spatialpi:[0,1,2,3,4],spatialpyerror:1,speci:1,stochss:3,stochss_export:3,submodul:[1,2,3],subpackag:0,tabl:4,vtkreader:1}})
\ No newline at end of file
+Search.setIndex({docnames:["classes/spatialpy","classes/spatialpy.core","classes/spatialpy.solvers","classes/spatialpy.stochss","index"],envversion:{"sphinx.domains.c":2,"sphinx.domains.changeset":1,"sphinx.domains.citation":1,"sphinx.domains.cpp":4,"sphinx.domains.index":1,"sphinx.domains.javascript":2,"sphinx.domains.math":2,"sphinx.domains.python":3,"sphinx.domains.rst":2,"sphinx.domains.std":2,"sphinx.ext.todo":2,"sphinx.ext.viewcode":1,sphinx:56},filenames:["classes/spatialpy.rst","classes/spatialpy.core.rst","classes/spatialpy.solvers.rst","classes/spatialpy.stochss.rst","index.rst"],objects:{"":{spatialpy:[0,0,0,"-"]},"spatialpy.core":{BoundaryCondition:[1,1,1,""],BoundaryConditionError:[1,3,1,""],DataFunction:[1,1,1,""],DataFunctionError:[1,3,1,""],Domain:[1,1,1,""],DomainError:[1,3,1,""],Geometry:[1,1,1,""],GeometryAll:[1,1,1,""],GeometryError:[1,3,1,""],GeometryExterior:[1,1,1,""],GeometryInterior:[1,1,1,""],InitialCondition:[1,1,1,""],InitialConditionError:[1,3,1,""],KDTree:[1,1,1,""],Model:[1,1,1,""],ModelError:[1,3,1,""],OrderedDict:[1,1,1,""],Parameter:[1,1,1,""],ParameterError:[1,3,1,""],PlaceInitialCondition:[1,1,1,""],Reaction:[1,1,1,""],ReactionError:[1,3,1,""],Result:[1,1,1,""],ResultError:[1,3,1,""],ScatterInitialCondition:[1,1,1,""],SimulationError:[1,3,1,""],SimulationTimeout:[1,3,1,""],Species:[1,1,1,""],SpeciesError:[1,3,1,""],UniformInitialCondition:[1,1,1,""],VTKReader:[1,1,1,""],VTKReaderError:[1,3,1,""],VTKReaderIOError:[1,3,1,""],boundarycondition:[1,0,0,"-"],cleanup:[1,0,0,"-"],cleanup_build_files:[1,5,1,""],cleanup_core_files:[1,5,1,""],cleanup_result_files:[1,5,1,""],cleanup_tempfiles:[1,5,1,""],combinations:[1,1,1,""],datafunction:[1,0,0,"-"],domain:[1,0,0,"-"],geometry:[1,0,0,"-"],init_notebook_mode:[1,5,1,""],initialcondition:[1,0,0,"-"],iplot:[1,5,1,""],model:[1,0,0,"-"],parameter:[1,0,0,"-"],reaction:[1,0,0,"-"],result:[1,0,0,"-"],spatialpyerror:[1,0,0,"-"],species:[1,0,0,"-"],vtkreader:[1,0,0,"-"]},"spatialpy.core.BoundaryCondition":{expression:[1,2,1,""]},"spatialpy.core.DataFunction":{map:[1,2,1,""]},"spatialpy.core.Domain":{add_point:[1,2,1,""],calculate_vol:[1,2,1,""],closest_vertex:[1,2,1,""],compile_prep:[1,2,1,""],coordinates:[1,2,1,""],create_2D_domain:[1,2,1,""],create_3D_domain:[1,2,1,""],distance_between_2_vertices:[1,2,1,""],fill_with_particles:[1,2,1,""],find_boundary_points:[1,2,1,""],find_h:[1,2,1,""],get_bounding_box:[1,2,1,""],get_domain_size:[1,2,1,""],get_num_voxels:[1,2,1,""],get_type_def:[1,2,1,""],get_vol:[1,2,1,""],import_meshio_object:[1,2,1,""],plot_types:[1,2,1,""],read_msh_file:[1,2,1,""],read_stochss_domain:[1,2,1,""],read_stochss_subdomain_file:[1,2,1,""],read_xml_mesh:[1,2,1,""],set_properties:[1,2,1,""]},"spatialpy.core.Geometry":{inside:[1,2,1,""]},"spatialpy.core.GeometryAll":{inside:[1,2,1,""]},"spatialpy.core.GeometryExterior":{inside:[1,2,1,""]},"spatialpy.core.GeometryInterior":{inside:[1,2,1,""]},"spatialpy.core.InitialCondition":{apply:[1,2,1,""]},"spatialpy.core.KDTree":{count_neighbors:[1,2,1,""],innernode:[1,1,1,""],leafnode:[1,1,1,""],node:[1,1,1,""],query:[1,2,1,""],query_ball_point:[1,2,1,""],query_ball_tree:[1,2,1,""],query_pairs:[1,2,1,""],sparse_distance_matrix:[1,2,1,""]},"spatialpy.core.Model":{add_boundary_condition:[1,2,1,""],add_data_function:[1,2,1,""],add_domain:[1,2,1,""],add_initial_condition:[1,2,1,""],add_parameter:[1,2,1,""],add_reaction:[1,2,1,""],add_species:[1,2,1,""],compile_prep:[1,2,1,""],delete_all_parameters:[1,2,1,""],delete_all_reactions:[1,2,1,""],delete_all_species:[1,2,1,""],delete_parameter:[1,2,1,""],delete_reaction:[1,2,1,""],delete_species:[1,2,1,""],get_all_parameters:[1,2,1,""],get_all_reactions:[1,2,1,""],get_all_species:[1,2,1,""],get_num_reactions:[1,2,1,""],get_num_species:[1,2,1,""],get_parameter:[1,2,1,""],get_reaction:[1,2,1,""],get_species:[1,2,1,""],reserved_names:[1,4,1,""],run:[1,2,1,""],sanitized_data_function_names:[1,2,1,""],sanitized_parameter_names:[1,2,1,""],sanitized_species_names:[1,2,1,""],set_timesteps:[1,2,1,""],special_characters:[1,4,1,""],timespan:[1,2,1,""],update_namespace:[1,2,1,""]},"spatialpy.core.OrderedDict":{clear:[1,2,1,""],copy:[1,2,1,""],fromkeys:[1,2,1,""],items:[1,2,1,""],keys:[1,2,1,""],move_to_end:[1,2,1,""],pop:[1,2,1,""],popitem:[1,2,1,""],setdefault:[1,2,1,""],update:[1,2,1,""],values:[1,2,1,""]},"spatialpy.core.PlaceInitialCondition":{apply:[1,2,1,""]},"spatialpy.core.Reaction":{add_product:[1,2,1,""],add_reactant:[1,2,1,""],annotate:[1,2,1,""],initialize:[1,2,1,""]},"spatialpy.core.Result":{export_to_csv:[1,2,1,""],get_property:[1,2,1,""],get_species:[1,2,1,""],get_timespan:[1,2,1,""],plot_property:[1,2,1,""],plot_species:[1,2,1,""],read_step:[1,2,1,""]},"spatialpy.core.ScatterInitialCondition":{apply:[1,2,1,""]},"spatialpy.core.Species":{set_diffusion_coefficient:[1,2,1,""]},"spatialpy.core.UniformInitialCondition":{apply:[1,2,1,""]},"spatialpy.core.VTKReader":{get_array_name:[1,2,1,""],get_arrays:[1,2,1,""],get_num_points:[1,2,1,""],get_points:[1,2,1,""],read_file:[1,2,1,""],set_filename:[1,2,1,""]},"spatialpy.core.boundarycondition":{BoundaryCondition:[1,1,1,""]},"spatialpy.core.boundarycondition.BoundaryCondition":{expression:[1,2,1,""]},"spatialpy.core.cleanup":{cleanup_build_files:[1,5,1,""],cleanup_core_files:[1,5,1,""],cleanup_result_files:[1,5,1,""],cleanup_tempfiles:[1,5,1,""]},"spatialpy.core.datafunction":{DataFunction:[1,1,1,""]},"spatialpy.core.datafunction.DataFunction":{map:[1,2,1,""]},"spatialpy.core.domain":{Domain:[1,1,1,""]},"spatialpy.core.domain.Domain":{add_point:[1,2,1,""],calculate_vol:[1,2,1,""],closest_vertex:[1,2,1,""],compile_prep:[1,2,1,""],coordinates:[1,2,1,""],create_2D_domain:[1,2,1,""],create_3D_domain:[1,2,1,""],distance_between_2_vertices:[1,2,1,""],fill_with_particles:[1,2,1,""],find_boundary_points:[1,2,1,""],find_h:[1,2,1,""],get_bounding_box:[1,2,1,""],get_domain_size:[1,2,1,""],get_num_voxels:[1,2,1,""],get_type_def:[1,2,1,""],get_vol:[1,2,1,""],import_meshio_object:[1,2,1,""],plot_types:[1,2,1,""],read_msh_file:[1,2,1,""],read_stochss_domain:[1,2,1,""],read_stochss_subdomain_file:[1,2,1,""],read_xml_mesh:[1,2,1,""],set_properties:[1,2,1,""]},"spatialpy.core.geometry":{Geometry:[1,1,1,""],GeometryAll:[1,1,1,""],GeometryExterior:[1,1,1,""],GeometryInterior:[1,1,1,""]},"spatialpy.core.geometry.Geometry":{inside:[1,2,1,""]},"spatialpy.core.geometry.GeometryAll":{inside:[1,2,1,""]},"spatialpy.core.geometry.GeometryExterior":{inside:[1,2,1,""]},"spatialpy.core.geometry.GeometryInterior":{inside:[1,2,1,""]},"spatialpy.core.initialcondition":{InitialCondition:[1,1,1,""],PlaceInitialCondition:[1,1,1,""],ScatterInitialCondition:[1,1,1,""],UniformInitialCondition:[1,1,1,""]},"spatialpy.core.initialcondition.InitialCondition":{apply:[1,2,1,""]},"spatialpy.core.initialcondition.PlaceInitialCondition":{apply:[1,2,1,""]},"spatialpy.core.initialcondition.ScatterInitialCondition":{apply:[1,2,1,""]},"spatialpy.core.initialcondition.UniformInitialCondition":{apply:[1,2,1,""]},"spatialpy.core.model":{Model:[1,1,1,""],export_StochSS:[1,5,1,""]},"spatialpy.core.model.Model":{add_boundary_condition:[1,2,1,""],add_data_function:[1,2,1,""],add_domain:[1,2,1,""],add_initial_condition:[1,2,1,""],add_parameter:[1,2,1,""],add_reaction:[1,2,1,""],add_species:[1,2,1,""],compile_prep:[1,2,1,""],delete_all_parameters:[1,2,1,""],delete_all_reactions:[1,2,1,""],delete_all_species:[1,2,1,""],delete_parameter:[1,2,1,""],delete_reaction:[1,2,1,""],delete_species:[1,2,1,""],get_all_parameters:[1,2,1,""],get_all_reactions:[1,2,1,""],get_all_species:[1,2,1,""],get_num_reactions:[1,2,1,""],get_num_species:[1,2,1,""],get_parameter:[1,2,1,""],get_reaction:[1,2,1,""],get_species:[1,2,1,""],reserved_names:[1,4,1,""],run:[1,2,1,""],sanitized_data_function_names:[1,2,1,""],sanitized_parameter_names:[1,2,1,""],sanitized_species_names:[1,2,1,""],set_timesteps:[1,2,1,""],special_characters:[1,4,1,""],timespan:[1,2,1,""],update_namespace:[1,2,1,""]},"spatialpy.core.parameter":{Parameter:[1,1,1,""]},"spatialpy.core.reaction":{Reaction:[1,1,1,""]},"spatialpy.core.reaction.Reaction":{add_product:[1,2,1,""],add_reactant:[1,2,1,""],annotate:[1,2,1,""],initialize:[1,2,1,""]},"spatialpy.core.result":{Result:[1,1,1,""]},"spatialpy.core.result.Result":{export_to_csv:[1,2,1,""],get_property:[1,2,1,""],get_species:[1,2,1,""],get_timespan:[1,2,1,""],plot_property:[1,2,1,""],plot_species:[1,2,1,""],read_step:[1,2,1,""]},"spatialpy.core.spatialpyerror":{BoundaryConditionError:[1,3,1,""],DataFunctionError:[1,3,1,""],DomainError:[1,3,1,""],GeometryError:[1,3,1,""],InitialConditionError:[1,3,1,""],ModelError:[1,3,1,""],ParameterError:[1,3,1,""],ReactionError:[1,3,1,""],ResultError:[1,3,1,""],SimulationError:[1,3,1,""],SimulationTimeout:[1,3,1,""],SpeciesError:[1,3,1,""],VTKReaderError:[1,3,1,""],VTKReaderIOError:[1,3,1,""]},"spatialpy.core.species":{Species:[1,1,1,""]},"spatialpy.core.species.Species":{set_diffusion_coefficient:[1,2,1,""]},"spatialpy.core.vtkreader":{VTKReader:[1,1,1,""]},"spatialpy.core.vtkreader.VTKReader":{get_array_name:[1,2,1,""],get_arrays:[1,2,1,""],get_num_points:[1,2,1,""],get_points:[1,2,1,""],read_file:[1,2,1,""],set_filename:[1,2,1,""]},"spatialpy.solvers":{build_expression:[2,0,0,"-"],solver:[2,0,0,"-"]},"spatialpy.solvers.build_expression":{BuildExpression:[2,1,1,""],CppConverter:[2,1,1,""],ExpressionConverter:[2,1,1,""],ExpressionResults:[2,1,1,""],PythonConverter:[2,1,1,""]},"spatialpy.solvers.build_expression.BuildExpression":{ValidationVisitor:[2,1,1,""],getexpr_cpp:[2,2,1,""],getexpr_python:[2,2,1,""],map_operator:[2,2,1,""],operator_map:[2,4,1,""],validate:[2,2,1,""],with_blacklist:[2,2,1,""],with_namespace:[2,2,1,""]},"spatialpy.solvers.build_expression.BuildExpression.ValidationVisitor":{visit_Assign:[2,2,1,""],visit_BinOp:[2,2,1,""],visit_BoolOp:[2,2,1,""],visit_Call:[2,2,1,""],visit_Compare:[2,2,1,""],visit_Name:[2,2,1,""],visit_UnaryOp:[2,2,1,""]},"spatialpy.solvers.build_expression.CppConverter":{CppExpressionTransformer:[2,1,1,""],get_str:[2,2,1,""],visit_And:[2,2,1,""],visit_Or:[2,2,1,""]},"spatialpy.solvers.build_expression.CppConverter.CppExpressionTransformer":{visit_BinOp:[2,2,1,""]},"spatialpy.solvers.build_expression.ExpressionConverter":{convert_str:[2,2,1,""],get_str:[2,2,1,""],parse_comparison:[2,2,1,""],parse_logical:[2,2,1,""],parse_operator:[2,2,1,""],visit_Add:[2,2,1,""],visit_BinOp:[2,2,1,""],visit_BoolOp:[2,2,1,""],visit_Bytes:[2,2,1,""],visit_Call:[2,2,1,""],visit_Compare:[2,2,1,""],visit_Constant:[2,2,1,""],visit_Div:[2,2,1,""],visit_Ellipsis:[2,2,1,""],visit_Eq:[2,2,1,""],visit_Gt:[2,2,1,""],visit_GtE:[2,2,1,""],visit_Lt:[2,2,1,""],visit_LtE:[2,2,1,""],visit_Mult:[2,2,1,""],visit_Name:[2,2,1,""],visit_NameConstant:[2,2,1,""],visit_NotEq:[2,2,1,""],visit_Num:[2,2,1,""],visit_Pow:[2,2,1,""],visit_Str:[2,2,1,""],visit_Sub:[2,2,1,""],visit_USub:[2,2,1,""],visit_UnaryOp:[2,2,1,""]},"spatialpy.solvers.build_expression.PythonConverter":{visit_And:[2,2,1,""],visit_Or:[2,2,1,""]},"spatialpy.solvers.solver":{Solver:[2,1,1,""]},"spatialpy.solvers.solver.Solver":{compile:[2,2,1,""],run:[2,2,1,""]},"spatialpy.stochss":{stochss_export:[3,0,0,"-"]},"spatialpy.stochss.stochss_export":{"export":[3,5,1,""]},spatialpy:{core:[1,0,0,"-"],solvers:[2,0,0,"-"],stochss:[3,0,0,"-"]}},objnames:{"0":["py","module","Python module"],"1":["py","class","Python class"],"2":["py","method","Python method"],"3":["py","exception","Python exception"],"4":["py","attribute","Python attribute"],"5":["py","function","Python function"]},objtypes:{"0":"py:module","1":"py:class","2":"py:method","3":"py:exception","4":"py:attribute","5":"py:function"},terms:{"0":[1,2],"04":1,"1":[1,2],"10":1,"10000":1,"11":1,"13":1,"14142136":1,"15":1,"1999":1,"1d":1,"2":1,"20":1,"2000":1,"2015":1,"2019":[0,1,2,3],"2022":[0,1,2,3],"2d":1,"2e9":1,"2r01eb014877":4,"3":[0,1,2,3,4],"300":1,"3d":[1,4],"4":1,"5":1,"500":1,"6":1,"600":1,"7":1,"8":1,"800":1,"9":1,"abstract":[1,2],"byte":2,"case":1,"class":[1,2],"default":1,"do":1,"export":[1,3],"float":1,"function":[1,2],"import":1,"int":[1,2],"long":1,"new":[1,2],"public":[0,1,2,3,4],"return":[1,2,3],"short":4,"static":[1,4],"super":2,"switch":1,"true":[1,2,3],A:[0,1,2,3,4],And:2,By:[1,2],FOR:[0,1,2,3],For:[1,4],If:[0,1,2,3,4],In:1,It:1,No:1,Not:2,Or:2,The:[1,2,4],These:1,Will:1,_ast:2,abl:1,about:1,absolut:1,acceler:1,accept:2,across:1,action:1,ad:[1,2],add:[1,2],add_boundary_condit:1,add_data_funct:1,add_domain:1,add_initial_condit:1,add_paramet:1,add_point:1,add_product:1,add_react:1,add_speci:1,addit:[1,2],addition:[1,2],addtion:[1,2],advect:[0,1,2,3,4],against:[1,2],algorithm:[1,4],align:1,all:[1,2],allow:2,along:[0,1,2,3],alreadi:1,also:[1,2,4],alwai:2,amount:1,an:[1,2,4],ani:[0,1,2,3,4],anim:1,animation_attribut:1,animation_opt:1,annot:1,append:2,appli:1,approxim:1,ar:[1,2],argument:1,arrai:1,arraid:1,array_lik:1,articl:4,artifici:1,asarrai:1,ascii:1,assign:[1,2],associ:1,assum:2,ast:2,attempt:1,attribut:1,author:4,auto_plai:1,automat:[1,2],autorang:1,avail:[1,2,4],averag:1,axi:1,background:1,bare:2,base:[1,2,4],bass:1,becaus:1,becom:1,been:1,begin:1,behavior:2,best:1,between:[1,2],binari:1,binboolopop:2,binop:2,biochem:1,bitand:2,bitor:2,bitxor:2,blacklist:2,blob:1,blue:1,bodi:1,bogu:1,bool:[1,2,3],boolop:2,both:[1,4],bottom:1,bound:1,bound_cond:1,boundari:1,boundarycondit:0,boundaryconditionerror:1,box:1,branch:1,brian:4,browser:1,brute:1,bugn:1,build:[1,2,4],build_dir:1,build_express:0,buildexpress:2,built:2,bulk:1,bupu:1,bvf_phi:1,c0:1,c:[0,1,2,3],c_:1,calcul:1,calculate_vol:1,call:[1,2],can:[0,1,2,3,4],caus:2,cdn:1,cell:1,charact:1,chart:1,check:[1,2],chemic:1,choos:1,chosen:1,circumradiu:1,ckdtree:1,classmethod:[1,2],cleanup:0,cleanup_build_fil:1,cleanup_core_fil:1,cleanup_result_fil:1,cleanup_tempfil:1,clear:1,close:1,closest:1,closest_vertex:1,cloud:1,code:[1,4],coeffic:1,coeffici:1,collabor:1,colormap:1,column:1,com:[1,4],combin:1,compar:[1,2],comparison:2,compil:[1,2],compile_prep:1,comput:1,conain:1,conatain:1,concentr:1,condit:[1,2],config:1,connect:1,consid:1,consol:2,constant:[1,2],construct:1,constructor:2,constuct:1,contact:4,contain:[1,2],content:4,context:2,contian:1,continu:4,convers:2,convert:[1,2,3],convert_str:2,convet:2,coodin:1,coordin:1,copi:[0,1,2,3],copy_numb:1,copyright:[0,1,2,3],core:[0,2,3,4],corner:1,correl:1,correspond:[1,2],could:[1,2],count:1,count_neighbor:1,coupl:1,cppconvert:2,cppexpressiontransform:2,cradded:1,creat:[1,2],create_2d_domain:1,create_3d_domain:1,csv:1,current:[1,2],custom:1,cylind:4,cython:1,d:1,data:[1,2],data_funct:1,datafunct:0,datafunctionerror:1,debug:[1,2],debug_level:[1,2],debugg:2,defer:1,defin:[1,2],definit:1,delete_all_paramet:1,delete_all_react:1,delete_all_speci:1,delete_paramet:1,delete_react:1,delete_speci:1,deltai:1,deltax:1,deltaz:1,demo:4,densiti:1,dependency_graph:1,describ:[1,4],descript:1,detail:[0,1,2,3],determinist:[0,1,2,3,4],determinst:1,develop:[0,1,2,3,4],diamet:1,dict:[1,2,3],dictionari:[1,2],differ:[1,2],diffus:[0,1,2,3,4],diffusion_coeffici:1,dimens:1,dimension:1,direct:1,directli:[1,4],directori:1,displai:1,dissip:4,distanc:1,distance_between_2_vertic:1,distance_upper_bound:1,distribut:[0,1,2,3],div:2,doe:1,doesn:1,dok_matrix:1,dolfin:1,dom:1,domain:[0,4],domainerror:1,domn:1,download:1,dr:4,draw:1,drawert:4,drawn:1,dtype:1,duplic:2,durat:1,dure:[1,2],dynam:4,e:1,each:1,edg:1,edit:1,effect:1,effici:1,either:1,element:1,ellipsi:2,els:[1,3],embed:4,empti:2,end:1,engin:1,ensur:[1,2],enterpris:1,entir:1,entireti:1,ep:1,eq:2,equival:2,error:1,estim:1,euclidean:1,evalu:1,evaul:1,even:[0,1,2,3],evenli:1,exampl:1,exce:1,exceed:[1,2],except:1,execut:[1,2],exist:1,expect:[1,2],explor:1,export_stochss:1,export_to_csv:1,expres:2,express:[1,2],expressionconvert:2,expressionresult:2,extens:1,extra:1,f:1,f_durat:1,fail:2,fals:[1,2,3],far:2,faster:1,featur:4,fenic:1,fifo:1,figur:1,figure_or_data:1,file:[1,3],filenam:[1,3],fill:[1,4],fill_with_particl:1,find:[1,4],find_boundary_point:1,find_h:1,first:[1,2],fit:[0,1,2,3],fix:1,flag:[1,2],flatten:1,flight:2,floordiv:2,flow:4,fluid:[1,4],folder_nam:1,follow:[1,2],forc:1,form:[1,4],format:1,forward:2,found:[1,2,4],foundat:[0,1,2,3],fraction:1,frame:[1,4],free:[0,1,2,3],frequenc:1,from:[1,2],fromkei:1,fund:4,further:1,furthest:1,g:1,gain:1,gdbgui:2,gener:[0,1,2,3,4],geometr:1,geometri:0,geometry_ivar:1,geometryal:1,geometryerror:1,geometryexterior:1,geometryinterior:1,get:[1,2],get_all_paramet:1,get_all_react:1,get_all_speci:1,get_arrai:1,get_array_nam:1,get_bounding_box:1,get_domain_s:1,get_num_point:1,get_num_react:1,get_num_speci:1,get_num_voxel:1,get_paramet:1,get_point:1,get_properti:1,get_react:1,get_speci:1,get_str:2,get_timespan:1,get_type_def:1,get_vol:1,getexpr_:2,getexpr_cpp:2,getexpr_python:2,github:[1,4],given:[1,2],gmsh:1,gnbu:1,gnu:[0,1,2,3,4],gprof:2,grai:1,grant:4,granular:2,graph:1,graph_obj:1,graph_refer:1,graviti:[1,4],greater:1,greatest:1,green:1,grei:1,gt:2,gte:2,guarante:1,h:1,ha:[1,4],hand:2,handl:2,happen:[1,2],hasn:[1,2],have:[0,1,2,3],height:1,held:1,help:1,here:[1,4],high:1,higher:1,highest:1,hit:1,hope:[0,1,2,3],how:[1,2,4],http:[0,1,2,3,4],hybrid:4,hyperrectangl:1,i:1,id:1,idea:1,ideal:2,idempot:1,identifi:[1,2],idx:1,ignor:1,imag:1,image_height:1,image_width:1,immobil:1,implemenet:1,implement:[1,2],impli:[0,1,2,3],import_meshio_object:1,imposs:2,inch:1,incid:1,includ:1,included_types_list:1,incompat:1,increas:1,increment:2,indec:1,indeci:1,index:[1,4],indic:[1,2],inf:1,infer:2,infin:1,infinit:1,info:1,inform:[1,2,4],inherit:2,init_cond:1,init_notebook_mod:1,initailcondit:1,initi:1,initialcondit:0,initialconditionerror:1,inlin:1,innernod:1,input:1,insert:1,insid:1,instanc:[1,2],instead:1,integ:1,intend:4,intern:1,internet:1,interv:1,invalid:[1,2],invalid_:2,invalid_nam:2,invalid_oper:2,io:1,iplot:1,ipython:1,is_valid:2,item:[1,2],iter:1,its:1,j:1,jacob:4,jet:1,jpeg:1,js:1,json:1,jupyt:1,k:1,kd:1,kdtree:1,kei:[1,2],keyerror:1,keyword:1,kill:1,kth:1,kwarg:1,lack:1,lagrangian:4,larg:1,larger:1,last:[1,2],later:[1,2],latest:4,layout:1,leafnod:1,leafsiz:1,learn:1,leav:1,left:2,legaci:1,length:1,less:1,level:[1,2],li:4,librari:1,licens:[0,1,2,3,4],lifo:1,like:1,limit:1,link:1,link_text:1,list:[1,2],listofparamet:1,listofreact:1,listofspeci:1,listoftyp:1,load:1,local:1,locat:1,logic:2,look:1,lookup:1,lower:1,lowest:1,lshift:2,lt:2,lte:2,ly:1,m:1,mai:1,main:4,make:1,manag:2,maneewongvatana:1,manhattan:1,mani:[1,2],map:[1,2],map_oper:2,margin:1,mark:1,mass:1,master:1,mathemat:[1,2],matmult:2,matplotlib:1,matrix:1,max:1,max_dist:1,maximum:[1,2],mean:1,measur:1,meet:1,megabyt:1,merchant:[0,1,2,3],mesh:1,mesh_obj:1,meshio:1,messag:1,meta:1,method:[1,2],mgrid:1,midpoint:1,min:1,minim:1,minimum:1,minkowski:1,miss:1,mod:2,model:[0,2,3,4],modelerror:1,modelname_mesh:1,modelname_species_:1,modifi:[0,1,2,3],modul:4,moor:1,more:[0,1,2,3,4],most:[1,2],mount:1,move:1,move_to_end:1,movement:1,msh:1,much:1,mult:2,multipl:[1,2],must:1,n:1,name:[1,2],nameconst:2,namespac:[1,2],ndarrai:1,nearbi:1,nearby_point:1,nearer:1,nearest:1,necessarili:1,need:[1,4],neg:1,neighbor:1,nih:4,node:[1,2],nodetransform:2,nodevisitor:2,non:1,none:[1,2,3],nonneg:1,norm:1,notat:1,note:[1,2],notebook:[1,4],noteq:2,np:1,nsm:4,nu:1,num:2,num_step:1,number:[1,2],number_of_thread:[1,2],number_of_trajectori:[1,2],numpi:1,numpoint:1,nx:1,ny:1,nz:1,o:1,obj:1,object:[1,2],od:1,off:1,offlin:1,omit:1,on_boundari:1,one:[1,2],onli:[1,2],onlin:1,open:1,oper:2,operator_map:2,option:1,orang:1,order:1,ordereddict:1,org:[0,1,2,3],origin:2,orrd:1,other:[1,2],otherwis:[1,2],our:4,out:[1,4],outdat:1,output:[1,2],output_interv:1,over:1,overflow:1,overrid:2,overridden:1,p0:1,p:1,p_ndx:1,packag:4,page:[1,4],pair:1,param:1,param_nam:1,param_obj:1,paramet:[0,2,3],parametererror:1,paramt:1,parent:1,pars:2,parse_comparison:2,parse_log:2,parse_oper:2,part:1,partcil:1,particip:1,particl:[1,4],particular:[0,1,2,3],pass:[1,2],path:[1,3],pdf:1,perform:1,petzold:4,physic:4,pii:4,pixel:1,place:1,placeinitialcondit:1,platform:1,pleas:[1,4],plot:1,plot_imag:1,plot_properti:1,plot_speci:1,plot_typ:1,plotli:1,plotly3:1,plt:1,pname:1,png:1,point:1,pop:[1,2],popitem:1,popul:1,posit:1,positon:1,pow:2,pre:2,predict:1,preper:1,present:[1,2],pressur:1,print:[1,2],problem:[0,1,2,3,4],process:2,produc:1,product:1,profil:[1,2],program:[0,1,2,3],project:4,propens:1,propensity_funct:1,properti:[1,2],property_nam:1,proprti:1,prove:4,provid:[1,2,4],prune:1,pt:1,publish:[0,1,2,3],pubu:1,pubugn:1,pull:1,purd:1,purpl:1,purpos:[0,1,2,3],put:1,px:1,py:1,pypi:4,pyplot:1,python:[0,1,2,3,4],pythonconvert:2,pyurdm:4,queri:1,query_ball_point:1,query_ball_tre:1,query_pair:1,question:4,quick:1,r:1,radii:1,radiu:1,rais:[1,2],random:[1,2],randomli:1,rang:1,rapidli:1,rate:1,rather:1,ravel:1,raw:1,rdme:4,rdpu:1,re:1,reac:1,reach:1,react_nam:1,react_obj:1,reactant:1,reaction:[0,2,3,4],reactionerror:1,read:1,read_fil:1,read_msh_fil:1,read_step:1,read_stochss_domain:1,read_stochss_subdomain_fil:1,read_xml_mesh:1,reader:1,real:1,reason:1,receiv:[0,1,2,3],recent:[1,2],recurs:1,red:1,redistribut:[0,1,2,3],refer:1,referenc:1,regardless:1,region:1,regist:4,registr:4,reject:2,rememb:1,remov:1,replac:4,repres:1,represent:[1,2],request:1,requir:1,reserved_nam:1,resolut:1,restrict:1,restrict_to:1,result:[0,2],result_dir:1,resulterror:1,retreiv:1,retriev:1,return_plotly_figur:1,return_stochss_model:[1,3],rho0:1,rho:1,right:[1,2],rname:1,rshift:2,rtype:2,rule:1,run:[1,2],runtimeerror:1,rvalu:2,s0021999118307101:4,s:[1,4],same:1,sampl:1,sanit:2,sanitized_data_function_nam:1,sanitized_parameter_nam:1,sanitized_species_nam:1,save:1,scalar:1,scatter:1,scatterinitialcondit:1,scienc:[1,4],sciencedirect:4,scipi:1,sdpd:[1,4],search:[1,4],second:[1,2],see:[0,1,2,3,4],seed:[1,2],self:[1,2],separ:1,sequenc:1,seri:[1,2],set:[1,2],set_diffusion_coeffici:1,set_filenam:1,set_properti:1,set_timestep:1,setdefault:1,setrecursionlimit:1,setter:1,shallow:1,shape:1,should:[0,1,2,3],show:1,show_link:1,significantli:1,simlat:1,simplifi:1,simul:[0,1,2,3,4],simulationerror:[1,2],simulationtimeout:[1,2],sinc:1,singl:[1,2],size:1,slide:1,smaller:1,smdl:1,smooth:4,sname:1,so:[1,2],softwar:[0,1,2,3,4],solver:[0,1,4],some:1,sort:1,sound:1,sourc:[1,2,3,4],space:1,spactialpi:2,span:1,spars:1,sparse_distance_matrix:1,spatial:[0,1,2,3,4],spatialpy_build:1,spatialpy_model:1,spatialpy_result:1,spatialpyerror:0,spatialpysolv:1,speci:0,special_charact:1,species_nam:1,species_object:1,specieserror:1,specif:1,specifi:1,speed:1,split:1,split_dim:1,src:1,ssa:1,sssa:4,start:[1,2,4],statement:2,statist:1,step:1,step_num:1,stochast:[0,1,2,3,4],stochss:[0,1,4],stochss_export:0,stoichiometr:1,stoichiometri:1,store:1,str:[1,2,3],string:[1,2],struct:2,structur:1,style:1,sub:2,subclass:[1,2],subdomain:1,submodul:0,subpackag:4,substanti:1,substitut:2,success:1,suggest:4,sum:1,suppli:1,support:[1,4],sure:1,svg:1,sy:1,symbol:2,syntax:2,syntaxerror:2,system:[1,4],t:[1,2],t_durat:1,t_ndx:1,t_ndx_list:1,t_val:1,tag:1,take:1,target:[1,2],tempfil:1,term:[0,1,2,3],tetrahedron:1,text:1,than:1,them:1,thi:[0,1,2,3,4],thin:1,those:1,thread:[1,2],time:[1,2],time_span:1,timeout:[1,2],timepoint:1,timespan:1,timestep:1,timestep_s:1,titl:1,token:2,total:1,toth:1,trace:1,tracker:4,trajectori:[1,2],transit:1,travers:1,tree:[1,2],triangl:1,trigger:2,tspan:1,tupl:1,two:[1,2],txt:1,type:[1,2,3],type_id:1,u0:1,unabl:1,unaryop:2,under:[0,1,2,3,4],uniform:1,uniforminitialcondit:1,union:1,univers:2,unnecessari:1,up:1,updat:1,update_namespac:1,upload:1,upon:1,upper:1,urdm:1,us:[0,1,2,3,4],use_matplotlib:1,user:[1,4],usual:1,usub:2,util:1,v1:1,v:1,valid:[1,2],validationvisitor:2,valu:[1,2],vari:1,veloc:1,verbos:2,veri:1,version:[0,1,2,3,4],vertex:1,vertic:1,view:1,viewer:1,viscos:1,visit:2,visit_add:2,visit_and:2,visit_assign:2,visit_binop:2,visit_boolop:2,visit_byt:2,visit_cal:2,visit_compar:2,visit_const:2,visit_div:2,visit_ellipsi:2,visit_eq:2,visit_gt:2,visit_lt:2,visit_mult:2,visit_nam:2,visit_nameconst:2,visit_noteq:2,visit_num:2,visit_or:2,visit_pow:2,visit_str:2,visit_sub:2,visit_unaryop:2,visit_usub:2,visitor:2,vol:1,volum:1,voxel:1,vtk:1,vtkreader:0,vtkreadererror:1,vtkreaderioerror:1,wa:1,want:1,warranti:[0,1,2,3],we:[1,4],web:1,webp:1,weir:4,well:2,were:[1,2],what:2,when:[1,2],where:1,whether:[1,2,3],which:[1,2],whose:1,width:1,with_blacklist:2,with_namespac:2,within:1,without:[0,1,2,3],work:1,wp:1,write:1,write_imag:1,written:1,www:[0,1,2,3,4],x1:1,x2:1,x:1,xaxi:1,xlim:1,xmax:1,xmin:1,xml:1,y:1,yaxi:1,yet:1,yi:4,ylgn:1,ylgnbu:1,ylim:1,ylorbr:1,ylorrd:1,ymax:1,ymin:1,you:[0,1,2,3,4],your:[1,4],z:1,zero:1,zeroth:1,zip:1,zlim:1,zmax:1,zmin:1},titles:["spatialpy package","spatialpy.core package","spatialpy.solvers package","spatialpy.stochss package","Documentation for SpatialPy 1.0"],titleterms:{"0":4,"1":4,api:4,boundarycondit:1,build_express:2,cleanup:1,content:[0,1,2,3],copi:4,core:1,datafunct:1,document:4,domain:1,exampl:4,geometri:1,get:4,indic:4,initialcondit:1,issu:4,model:1,modul:[0,1,2,3],packag:[0,1,2,3],paramet:1,reaction:1,refer:4,report:4,result:1,solver:2,spatialpi:[0,1,2,3,4],spatialpyerror:1,speci:1,stochss:3,stochss_export:3,submodul:[1,2,3],subpackag:0,tabl:4,vtkreader:1}})
\ No newline at end of file
diff --git a/docs/index.rst b/docs/index.rst
index ef9b1b78..33060207 100644
--- a/docs/index.rst
+++ b/docs/index.rst
@@ -20,7 +20,7 @@ The latest version of SpatialPy can be found on `PyPI `_ for more information on how to build and simulate your models with SpatialPy. For an example of how to use SpatialPy to simulate a spatial stochastic reaction-diffusion system, see the `3D Cylinder Demo `_. We also provide examples of how to use SpatialPy to simulate physics (`Gravity Demo `_) and fluid flow (`Weir Model `_).
+See our `Example Notebook - Start Here `_ for more information on how to build and simulate your models with SpatialPy. For an example of how to use SpatialPy to simulate a spatial stochastic reaction-diffusion system, see the `3D Cylinder Demo `_. We also provide examples of how to use SpatialPy to simulate physics (`Gravity Demo `_) and fluid flow (`Weir Model `_).
Reporting Issues
diff --git a/examples/3D_Cylinder_Demo.ipynb b/examples/3D_Cylinder_Demo.ipynb
index 8e8c8ec4..2d98d2dd 100644
--- a/examples/3D_Cylinder_Demo.ipynb
+++ b/examples/3D_Cylinder_Demo.ipynb
@@ -4465,7 +4465,7 @@
"## Visualization\n",
"Plot the results of the simulation.\n",
"\n",
- "TODO: Plot of the time-average spatial concentration."
+ "These plots tell us the accuracy of the simulation. On the left is a plot of the population of both species over time. You can see they are approaching steady-state levels as time goes on. The plot on the left shows the time-averaged population over the space (i.e. the length of the cylinder along the x-axis). You can see that \"B\" is created on the left and \"A\" is created on the right, and the populations fall as you move towards the center of the cylinder. At the center, the population is (almost) zero for both species, as they annihilate each other on contact. "
]
},
{
@@ -15019,7 +15019,7 @@
"lastKernelId": null
},
"kernelspec": {
- "display_name": "Python 3 (ipykernel)",
+ "display_name": "Python 3",
"language": "python",
"name": "python3"
},
@@ -15033,7 +15033,7 @@
"name": "python",
"nbconvert_exporter": "python",
"pygments_lexer": "ipython3",
- "version": "3.9.9"
+ "version": "3.8.10"
}
},
"nbformat": 4,
diff --git a/examples/tests/3D_Cylinder_Demo_Results_Check.ipynb b/examples/tests/3D_Cylinder_Demo_Results_Check.ipynb
index e77b8e0a..e6fbb31d 100644
--- a/examples/tests/3D_Cylinder_Demo_Results_Check.ipynb
+++ b/examples/tests/3D_Cylinder_Demo_Results_Check.ipynb
@@ -8,7 +8,7 @@
"source": [
"import os\n",
"import sys\n",
- "from collections import OrderedDict"
+ "sys.path.insert(1, os.path.abspath(os.path.join(os.getcwd(), '../../')))"
]
},
{
@@ -17,28 +17,16 @@
"metadata": {},
"outputs": [],
"source": [
- "sys.path.append(\"../..\")"
+ "import numpy"
]
},
{
"cell_type": "code",
"execution_count": 3,
"metadata": {},
- "outputs": [
- {
- "data": {
- "text/plain": [
- "'/Users/bryanrumsey/Documents/SpatialPy/examples/tests/../../spatialpy/__init__.py'"
- ]
- },
- "execution_count": 3,
- "metadata": {},
- "output_type": "execute_result"
- }
- ],
+ "outputs": [],
"source": [
- "import spatialpy\n",
- "spatialpy.__file__"
+ "import matplotlib.pyplot as plt"
]
},
{
@@ -47,13 +35,14 @@
"metadata": {},
"outputs": [],
"source": [
- "import matplotlib.pyplot as plt\n",
- "import numpy\n",
- "\n",
- "# Global Constants\n",
- "MAX_X_DIM = 5.0\n",
- "MIN_X_DIM = -5.0\n",
- "TOL = 1e-9"
+ "from spatialpy import (\n",
+ " Model,\n",
+ " Domain,\n",
+ " Species,\n",
+ " Parameter,\n",
+ " Reaction,\n",
+ " Geometry\n",
+ ")"
]
},
{
@@ -74,9 +63,12 @@
"metadata": {},
"outputs": [],
"source": [
- "class Edge1(spatialpy.Geometry):\n",
+ "class Edge1(Geometry):\n",
+ " def __init__(self, xmax):\n",
+ " self.xmax = xmax\n",
+ "\n",
" def inside(self, point, on_boundary):\n",
- " return abs(point[0] - MAX_X_DIM) < 0.05"
+ " return abs(point[0] - self.xmax) < 0.05"
]
},
{
@@ -85,9 +77,12 @@
"metadata": {},
"outputs": [],
"source": [
- "class Edge2(spatialpy.Geometry):\n",
+ "class Edge2(Geometry):\n",
+ " def __init__(self, xmin):\n",
+ " self.xmin = xmin\n",
+ "\n",
" def inside(self, point, on_boundary):\n",
- " return abs(point[0] - MIN_X_DIM) < 0.05"
+ " return abs(point[0] - self.xmin) < 0.05"
]
},
{
@@ -96,9 +91,12 @@
"metadata": {},
"outputs": [],
"source": [
- "class Middle(spatialpy.Geometry):\n",
+ "class Middle(Geometry):\n",
+ " def __init__(self, xmin):\n",
+ " self.xmin = xmin\n",
+ "\n",
" def inside(self, point, on_boundary):\n",
- " return abs(point[0] - MIN_X_DIM) >= 0.05"
+ " return abs(point[0] - self.xmin) >= 0.05"
]
},
{
@@ -107,45 +105,97 @@
"metadata": {},
"outputs": [],
"source": [
- "class cylinderDemo3D(spatialpy.Model):\n",
+ "class cylinderDemo3D(Model):\n",
+ " # Define type IDs as constants of the Model\n",
+ " MIDDLE = Middle.__name__\n",
+ " EDGE1 = Edge1.__name__\n",
+ " EDGE2 = Edge2.__name__\n",
+ " \n",
" def __init__(self, model_name=\"3D Cylinder Demo\"):\n",
- " spatialpy.Model.__init__(self, model_name)\n",
+ " Model.__init__(self, model_name)\n",
"\n",
+ " # Set domain bounds\n",
+ " xmin = -5\n",
+ " xmax = 5\n",
+ " \n",
" # System constants\n",
" D_const = 0.1\n",
"\n",
- " # Define Species\n",
- " A = spatialpy.Species(name=\"A\", diffusion_coefficient=D_const, restrict_to=[1,2])\n",
- " B = spatialpy.Species(name=\"B\", diffusion_coefficient=D_const, restrict_to=[1,3])\n",
- " self.add_species([A, B])\n",
+ " \"\"\"\n",
+ " Create a domain from a FEniCS/dolfin style XML mesh file\n",
+ " \n",
+ " - filename: Name of the mesh file.\n",
+ " \"\"\"\n",
+ " domain = Domain.read_xml_mesh(filename='../Domain_Files/cylinder.xml')\n",
+ " # Add type IDs to the particles\n",
+ " \"\"\"\n",
+ " Update the prpoerties of particles within a geometric shape.\n",
"\n",
- " # Define Domain\n",
- " domain = spatialpy.Domain.read_xml_mesh('../Domain_Files/cylinder.xml')\n",
- " domain.set_properties(Middle(), 1)\n",
- " domain.set_properties(Edge1(), 2)\n",
- " domain.set_properties(Edge2(), 3)\n",
+ " - geometry_ivar: an instance of a 'spatialpy.Geometry' subclass. The 'inside()' method\n",
+ " of this object will be used to add a single point particles.\n",
+ " - type_id: Particle type ID of particle to be created.\n",
+ " - vol: Default volume of particle to be added.\n",
+ " - mass: Default mass of particle to be added.\n",
+ " - nu: Default viscosity of particle to be created.\n",
+ " - c: Default artificial speed of sound of particle to be created.\n",
+ " - rho: Default density of particle to be created\n",
+ " - fixed: True if particle is spatially fixed, else False.\n",
+ " \"\"\"\n",
+ " domain.set_properties(Middle(xmin=xmin), self.MIDDLE)\n",
+ " domain.set_properties(Edge1(xmax=xmax), self.EDGE1)\n",
+ " domain.set_properties(Edge2(xmin=xmin), self.EDGE2)\n",
+ " # Add the Domain to the Model\n",
" self.add_domain(domain)\n",
"\n",
- " vol = self.domain.get_vol()\n",
- " print(f\"vol {vol}\")\n",
- " type_id = self.domain.type\n",
- " left = numpy.sum(vol[type_id == 2])\n",
- " right = numpy.sum(vol[type_id == 3])\n",
- " print(f\"left {left} right {right}\")\n",
+ " # Define Species\n",
+ " A = Species(name=\"A\", diffusion_coefficient=D_const, restrict_to=[self.MIDDLE, self.EDGE1])\n",
+ " B = Species(name=\"B\", diffusion_coefficient=D_const, restrict_to=[self.MIDDLE, self.EDGE2])\n",
" \n",
- " k_react = spatialpy.Parameter(name=\"k_react\", expression=1.0)\n",
- " k_creat1 = spatialpy.Parameter(name=\"k_creat1\", expression=100 / left)\n",
- " k_creat2 = spatialpy.Parameter(name=\"k_creat2\", expression=100 / right)\n",
- " self.add_parameter([k_react, k_creat1,k_creat2])\n",
- "\n",
+ " # Add the Species to the Model.\n",
+ " self.add_species([A, B])\n",
"\n",
+ " # Define Parameters\n",
+ " vol = self.domain.get_vol()\n",
+ " type_id = self.domain.type_id\n",
+ " left = numpy.sum(vol[type_id == self.domain.get_type_def(self.EDGE1)])\n",
+ " right = numpy.sum(vol[type_id == self.domain.get_type_def(self.EDGE2)])\n",
+ " \n",
+ " k_react = Parameter(name=\"k_react\", expression=1.0)\n",
+ " k_creat1 = Parameter(name=\"k_creat1\", expression=100 / left)\n",
+ " k_creat2 = Parameter(name=\"k_creat2\", expression=100 / right)\n",
+ " \n",
+ " # Add the Parameters to the Model.\n",
+ " self.add_parameter([k_react, k_creat1, k_creat2])\n",
+ " \n",
" # Define Reactions\n",
- " R1 = spatialpy.Reaction(reactants={}, products={A:1}, rate=k_creat1, restrict_to=2)\n",
- " R2 = spatialpy.Reaction(reactants={}, products={B:1}, rate=k_creat2, restrict_to=3)\n",
- " R3 = spatialpy.Reaction(reactants={A:1, B:1}, products={}, rate=k_react)\n",
+ " R1 = Reaction(\n",
+ " reactants={},\n",
+ " products={\"A\":1},\n",
+ " rate=\"k_creat1\",\n",
+ " restrict_to=self.EDGE1\n",
+ " )\n",
+ " \n",
+ " R2 = Reaction(\n",
+ " reactants={},\n",
+ " products={\"B\":1},\n",
+ " rate=\"k_creat2\",\n",
+ " restrict_to=self.EDGE2\n",
+ " )\n",
+ " \n",
+ " R3 = Reaction(\n",
+ " reactants={\"A\":1, \"B\":1},\n",
+ " products={},\n",
+ " rate=\"k_react\"\n",
+ " )\n",
+ " \n",
+ " # Add the Reactions to the Model.\n",
" self.add_reaction([R1, R2, R3])\n",
" \n",
- " self.timespan(range(500), timestep_size=1e-3)"
+ " \"\"\"\n",
+ " Use NumPy to set the timespan of the Model. Reaction diffusion examples may require a small\n",
+ " timespan_size (around 1e-3) to generate accurate deterministic results.\n",
+ " \"\"\"\n",
+ " self.timespan(numpy.linspace(0, 500, 501), timestep_size=1e-5)"
]
},
{
@@ -155,34 +205,23 @@
"scrolled": true,
"tags": []
},
- "outputs": [
- {
- "name": "stdout",
- "output_type": "stream",
- "text": [
- "vol [0.01513526 0.07034112 0.02382667 ... 0.01674217 0.02120607 0.01969156]\n",
- "left 0.5092013833059308 right 0.505804729089437\n"
- ]
- }
- ],
+ "outputs": [],
"source": [
"model = cylinderDemo3D()"
]
},
{
"cell_type": "code",
- "execution_count": 11,
+ "execution_count": null,
"metadata": {},
"outputs": [
{
"name": "stdout",
"output_type": "stream",
"text": [
- "Number of Timesteps: 499000\n",
- "Output Frequency: 1000.0\n",
- "Timestep Size: 0.001\n",
- "CPU times: user 9.91 ms, sys: 7.13 ms, total: 17 ms\n",
- "Wall time: 3min 15s\n"
+ "Number of Timesteps: 50000000\n",
+ "Output Frequency: 99999.99999999999\n",
+ "Timestep Size: 1e-05\n"
]
}
],
@@ -195,21 +234,9 @@
},
{
"cell_type": "code",
- "execution_count": 12,
+ "execution_count": null,
"metadata": {},
- "outputs": [
- {
- "name": "stdout",
- "output_type": "stream",
- "text": [
- "Number of Timesteps: 499\n",
- "Output Frequency: 1.0\n",
- "Timestep Size: 1\n",
- "CPU times: user 8.52 ms, sys: 6 ms, total: 14.5 ms\n",
- "Wall time: 4.71 s\n"
- ]
- }
- ],
+ "outputs": [],
"source": [
"model.timestep_size = 1\n",
"model.timespan(range(500))\n",
@@ -231,7 +258,39 @@
},
{
"cell_type": "code",
- "execution_count": 13,
+ "execution_count": null,
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "def check_accuracy(results, deterministic=False):\n",
+ " fig, (ax1, ax2) = plt.subplots(1, 2, figsize=(15, 4.5))\n",
+ "\n",
+ " tspan = results.get_timespan()\n",
+ " A_sum = numpy.sum(results.get_species(\"A\", deterministic=deterministic), axis=1)\n",
+ " B_sum = numpy.sum(results.get_species(\"B\", deterministic=deterministic), axis=1)\n",
+ "\n",
+ " ax1.plot(tspan, A_sum, '-r', label=\"A\")\n",
+ " ax1.plot(tspan, B_sum, '-b', label=\"B\")\n",
+ " ax1.set_xlabel(\"Time\", fontsize=14)\n",
+ " ax1.tick_params(axis=\"x\", labelsize=12)\n",
+ " ax1.tick_params(axis=\"y\", labelsize=12)\n",
+ " _ = ax1.legend(loc='best')\n",
+ "\n",
+ " x_vals = results.model.domain.coordinates()[:, 0]\n",
+ " A_vals = numpy.sum(results.get_species(\"A\", deterministic=deterministic), axis=0)\n",
+ " B_vals = numpy.sum(results.get_species(\"B\", deterministic=deterministic), axis=0)\n",
+ "\n",
+ " ax2.plot(x_vals, A_vals, '.r')\n",
+ " ax2.plot(x_vals, B_vals, '.b')\n",
+ " ax2.set_xlabel(\"X-Coordinate\", fontsize=14)\n",
+ " ax2.tick_params(axis=\"x\", labelsize=12)\n",
+ " ax2.tick_params(axis=\"y\", labelsize=12)\n",
+ " _ = ax2.legend(['A', 'B'], loc='best')"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
"metadata": {},
"outputs": [],
"source": [
@@ -265,19813 +324,36 @@
},
{
"cell_type": "code",
- "execution_count": 14,
+ "execution_count": null,
"metadata": {},
- "outputs": [
- {
- "data": {
- "text/html": [
- " \n",
- " "
- ]
- },
- "metadata": {},
- "output_type": "display_data"
- },
- {
- "data": {
- "application/vnd.plotly.v1+json": {
- "config": {
- "plotlyServerURL": "https://plot.ly"
- },
- "data": [
- {
- "type": "histogram",
- "x": [
- 1565.224247,
- 1818.911328,
- 1922.47678,
- 1794.591662,
- 11221.832806,
- 10794.41376,
- 12893.225008,
- 12187.049807,
- 1345.121457,
- 1395.235998,
- 1407.277092,
- 1576.922575,
- 1635.088976,
- 1842.884785,
- 2022.056003,
- 1954.357444,
- 22269.938468,
- 19490.78128,
- 18656.609971,
- 21215.78276,
- 3423.891452,
- 2841.518872,
- 3216.957591,
- 3630.277363,
- 4195.806906,
- 4873.44433,
- 4170.196427,
- 4831.775357,
- 30275.682043,
- 31249.051993,
- 29245.695302,
- 32047.639268,
- 20658.792651,
- 20956.914957,
- 19645.764327,
- 22020.389133,
- 22959.236333,
- 24428.624824,
- 25101.203399,
- 25551.452841,
- 471.239802,
- 429.843113,
- 508.623088,
- 560.942909,
- 13086.620537,
- 13144.088836,
- 11830.03781,
- 13005.561052,
- 1719.676337,
- 1697.870045,
- 1950.988248,
- 1595.186823,
- 24149.579047,
- 20634.725206,
- 23264.45391,
- 22061.580822,
- 985.683333,
- 932.740161,
- 979.803708,
- 1181.024752,
- 354.999306,
- 526.395841,
- 353.345939,
- 416.28719,
- 348.085864,
- 24060.170595,
- 22642.92807,
- 23451.830795,
- 1328.561265,
- 1173.773788,
- 1164.887821,
- 1026.933212,
- 25113.389199,
- 24245.538865,
- 22292.560699,
- 27308.690851,
- 813.704888,
- 806.212751,
- 899.798717,
- 974.743232,
- 30378.504905,
- 32364.791354,
- 33649.664743,
- 32514.40482,
- 660.893186,
- 822.616904,
- 803.08697,
- 710.384566,
- 1307.833854,
- 1382.955037,
- 1493.398978,
- 2454.970968,
- 2992.704245,
- 3081.39456,
- 31755.523752,
- 39080.706873,
- 33044.209835,
- 32006.979231,
- 15810.050163,
- 14426.00843,
- 15129.602588,
- 15115.1645,
- 13520.192653,
- 14376.115281,
- 12018.989155,
- 17097.367949,
- 19109.717634,
- 17615.960033,
- 17922.40358,
- 16745.201696,
- 19730.373842,
- 3046.469553,
- 2648.347339,
- 2551.515518,
- 2850.611329,
- 3093.245676,
- 2791.222085,
- 2678.953483,
- 2942.052861,
- 10093.426983,
- 9723.119499,
- 11188.92264,
- 319.202405,
- 311.289874,
- 241.745461,
- 361.374258,
- 2151.636378,
- 2881.357799,
- 2310.112744,
- 2490.225368,
- 1469.670615,
- 1647.931206,
- 1552.261565,
- 204.363427,
- 383.978411,
- 14797.713488,
- 15681.448726,
- 14180.828657,
- 16632.519956,
- 23687.616108,
- 25033.543907,
- 25820.795168,
- 23192.849931,
- 23368.13313,
- 24448.632052,
- 27554.866417,
- 1451.230062,
- 1630.821948,
- 1707.085133,
- 5455.987831,
- 5124.987042,
- 4751.273205,
- 5648.034717,
- 4609.774732,
- 4656.983898,
- 3589.753185,
- 4273.545331,
- 29204.340751,
- 29253.469376,
- 31652.691289,
- 26898.313179,
- 14986.415883,
- 17172.253749,
- 15782.678685,
- 10030.252862,
- 10222.075778,
- 10246.035128,
- 9223.19773,
- 39080.706873,
- 9214.018308,
- 8490.991445,
- 8415.221431,
- 7729.472556,
- 7521.496596,
- 7711.710858,
- 8534.351226,
- 6814.03615,
- 1190.719602,
- 3079.887878,
- 3499.104935,
- 3089.427177,
- 2729.124187,
- 505.414467,
- 515.242785,
- 520.26973,
- 522.002968,
- 2336.843037,
- 2270.489158,
- 11740.140058,
- 13430.467631,
- 11739.81457,
- 33112.669057,
- 39080.706873,
- 39080.706873,
- 39080.706873,
- 4374.73274,
- 4016.770071,
- 3395.227348,
- 14421.037748,
- 12685.904001,
- 15262.129542,
- 13175.877825,
- 16320.259313,
- 5102.235025,
- 5657.804578,
- 5252.841223,
- 6093.533022,
- 12422.171919,
- 13824.078274,
- 11543.238822,
- 11205.69758,
- 10048.541308,
- 1787.401232,
- 1901.41049,
- 1576.381168,
- 330.838884,
- 170.989284,
- 187.613529,
- 173.414623,
- 257.960397,
- 3967.113363,
- 592.493716,
- 584.792098,
- 744.075369,
- 1171.294494,
- 965.203075,
- 1249.433578,
- 1003.243012,
- 20084.285918,
- 19701.484494,
- 20898.636235,
- 2020.125587,
- 2172.890137,
- 21259.714819,
- 32114.210204,
- 31777.861652,
- 33225.530183,
- 3513.27016,
- 2902.741593,
- 4174.668888,
- 4163.496761,
- 3678.027401,
- 4055.084026,
- 2338.316477,
- 1903.632424,
- 2344.791772,
- 546.744255,
- 625.641964,
- 437.391528,
- 427.039563,
- 16220.101864,
- 17853.137943,
- 15141.889195,
- 17666.23541,
- 1302.944496,
- 9653.031217,
- 8685.145823,
- 4917.592293,
- 5424.914879,
- 5523.998366,
- 982.865076,
- 854.719011,
- 961.711469,
- 12045.88419,
- 10536.333774,
- 12115.227079,
- 11657.757414,
- 6765.393138,
- 7104.891234,
- 7923.045378,
- 7959.853089,
- 744.755037,
- 644.966091,
- 770.590133,
- 9711.929454,
- 1196.355464,
- 1038.795101,
- 1380.530997,
- 1912.795858,
- 1640.567119,
- 1851.02117,
- 5231.371516,
- 5070.064929,
- 4464.203642,
- 4719.564727,
- 18184.519149,
- 20294.218332,
- 21524.483777,
- 20828.819892,
- 675.943475,
- 728.960502,
- 864.644525,
- 952.109281,
- 603.823006,
- 1047.524637,
- 1185.37806,
- 7744.644239,
- 8835.595945,
- 7892.716433,
- 8017.532669,
- 3358.960635,
- 3509.378573,
- 3893.301069,
- 5684.016347,
- 5233.971389,
- 6149.266561,
- 31889.203488,
- 29000.772641,
- 32798.918494,
- 30757.312671,
- 6225.612789,
- 6810.796216,
- 7189.617471,
- 6699.273703,
- 11509.966048,
- 1295.722486,
- 1419.110363,
- 297.31435,
- 1081.143565,
- 1270.408445,
- 1276.514874,
- 18071.17748,
- 8993.092569,
- 24171.730052,
- 1996.326597,
- 1811.885413,
- 2252.817487,
- 1994.730239,
- 29086.414505,
- 26696.020551,
- 30612.064917,
- 4842.472307,
- 5789.434164,
- 5601.393606,
- 33268.514195,
- 39080.706873,
- 39080.706873,
- 561.543428,
- 624.690877,
- 780.062687,
- 596.296057,
- 0,
- 184.556662,
- 0,
- 0,
- 24521.167108,
- 27195.377752,
- 27670.88771,
- 27833.128212,
- 8807.603137,
- 9628.133732,
- 10299.298556,
- 10350.135049,
- 9734.912044,
- 11459.248234,
- 256.617594,
- 212.474208,
- 164.727301,
- 0,
- 170.206612,
- 169.345003,
- 212.989704,
- 39080.706873,
- 39080.706873,
- 39080.706873,
- 12700.058712,
- 11329.764573,
- 13068.371509,
- 13176.216653,
- 16207.613159,
- 913.336749,
- 1054.937054,
- 1036.342525,
- 1136.522317,
- 7355.246252,
- 3574.37007,
- 3549.183835,
- 3660.559549,
- 1236.472665,
- 250.974209,
- 313.802964,
- 322.041613,
- 426.540352,
- 296.501711,
- 300.991035,
- 16360.377139,
- 15929.880937,
- 39080.706873,
- 32890.475301,
- 39080.706873,
- 39080.706873,
- 214.964371,
- 267.567414,
- 163.406497,
- 4852.811438,
- 4555.602776,
- 5539.93795,
- 30674.760816,
- 28392.072514,
- 13194.946064,
- 13585.330388,
- 7866.918048,
- 6510.334391,
- 10728.009775,
- 10157.679151,
- 11549.873796,
- 12045.269402,
- 3478.204493,
- 3904.105983,
- 534.577619,
- 732.401615,
- 2734.885683,
- 3489.985535,
- 971.299729,
- 739.779548,
- 807.871865,
- 8456.197878,
- 585.612337,
- 844.683207,
- 709.734657,
- 587.453854,
- 645.048726,
- 475.309249,
- 484.206617,
- 6058.103793,
- 6234.821247,
- 4636.958551,
- 13916.13966,
- 15019.616594,
- 15722.531258,
- 13612.431691,
- 21118.935458,
- 14034.7119,
- 12948.357657,
- 15194.404222,
- 170.72239,
- 0,
- 214.41869,
- 4093.870116,
- 3572.107346,
- 3718.666571,
- 2555.942911,
- 2692.216658,
- 3025.490217,
- 3215.729169,
- 25645.668086,
- 25827.272159,
- 27950.338337,
- 12813.937646,
- 16055.99292,
- 19042.152853,
- 17911.484167,
- 18773.149219,
- 1642.417848,
- 1991.69974,
- 1063.743219,
- 1222.018228,
- 17812.534432,
- 19584.476628,
- 20023.783934,
- 19162.93295,
- 31225.71776,
- 24131.212369,
- 26629.513708,
- 22698.989541,
- 16624.132278,
- 17834.678953,
- 14910.965963,
- 17331.611386,
- 6641.550988,
- 6891.014537,
- 6996.393223,
- 4207.05468,
- 4428.56328,
- 1001.112644,
- 3960.716737,
- 2086.089407,
- 29369.047956,
- 27699.717043,
- 7622.351589,
- 6458.757,
- 6483.817811,
- 276.746212,
- 24697.671603,
- 25266.286353,
- 11733.970611,
- 11220.877593,
- 8882.19471,
- 7905.528054,
- 1920.555225,
- 2409.404716,
- 2445.407049,
- 2501.508816,
- 1479.908811,
- 1487.111928,
- 846.715614,
- 1836.477364,
- 1528.933084,
- 2090.421473,
- 2030.997275,
- 32178.137996,
- 33128.611268,
- 12795.990351,
- 11419.205109,
- 13335.344786,
- 12067.769108,
- 23191.112273,
- 24468.72048,
- 182.318781,
- 223.45704,
- 5773.585825,
- 4247.307556,
- 5124.183093,
- 5043.610536,
- 3169.165626,
- 3590.898654,
- 3288.909174,
- 4764.949606,
- 5349.042627,
- 4284.128962,
- 4505.576537,
- 4198.113201,
- 4319.771079,
- 4653.302575,
- 3367.387496,
- 11566.89429,
- 1243.155154,
- 1110.788273,
- 970.878153,
- 1239.645458,
- 17462.526858,
- 18070.699387,
- 13500.874663,
- 21823.570878,
- 19635.208952,
- 545.74738,
- 1056.646068,
- 874.522853,
- 953.377038,
- 1073.897008,
- 3349.112609,
- 3816.599071,
- 3687.975363,
- 9756.397987,
- 39080.706873,
- 39080.706873,
- 2101.20511,
- 5288.152428,
- 357.632976,
- 359.579561,
- 484.849849,
- 503.538786,
- 2518.517481,
- 11162.405683,
- 9662.952957,
- 9617.231197,
- 1893.671283,
- 2130.770952,
- 8283.613701,
- 9162.115122,
- 9134.320009,
- 9577.346691,
- 6630.623063,
- 14594.167704,
- 14690.813304,
- 3217.502248,
- 0,
- 0,
- 158.489371,
- 163.964977,
- 8866.332292,
- 8159.115947,
- 8807.404638,
- 9114.429165,
- 6190.539148,
- 171.771889,
- 0,
- 0,
- 164.859897,
- 11388.309148,
- 10463.968435,
- 10341.500199,
- 39080.706873,
- 627.077586,
- 5671.433868,
- 1685.45896,
- 18752.923121,
- 8589.104078,
- 6680.980066,
- 6488.865235,
- 7521.679664,
- 7046.014356,
- 191.113765,
- 319.687317,
- 156.950438,
- 2225.00435,
- 18297.507351,
- 225.541288,
- 2724.342608,
- 33153.569317,
- 29994.376791,
- 33061.554283,
- 335.6551,
- 520.165386,
- 258.105873,
- 212.625559,
- 27107.823646,
- 29052.207417,
- 30390.73185,
- 1255.991305,
- 11263.136572,
- 32395.182165,
- 32015.770211,
- 30664.745409,
- 39080.706873,
- 671.464938,
- 2694.17022,
- 3243.515866,
- 218.548089,
- 280.603993,
- 855.368673,
- 1088.569772,
- 6702.956042,
- 6066.355985,
- 6854.313271,
- 7288.013403,
- 2135.97204,
- 1553.657021,
- 1399.553014,
- 285.127222,
- 1376.094607,
- 551.749519,
- 10734.312264,
- 29600.381323,
- 33009.904924,
- 667.446167,
- 737.667025,
- 2404.589037,
- 2745.568997,
- 2292.232326,
- 5436.636823,
- 4754.890887,
- 5510.5987,
- 5223.183046,
- 9295.784305,
- 2556.885272,
- 2367.488453,
- 33189.47066,
- 853.726387,
- 0,
- 175.063817,
- 31543.112279,
- 32302.508299,
- 317.105956,
- 572.290092,
- 411.744382,
- 468.481131,
- 3469.712998,
- 3852.910448,
- 4062.329859,
- 4446.789064,
- 3888.317798,
- 3239.341261,
- 1450.111955,
- 1584.444976,
- 1739.029901,
- 31092.865151,
- 29447.237645,
- 28048.726038,
- 27412.588566,
- 4844.124006,
- 27075.170801,
- 3033.713518,
- 3080.134247,
- 30763.59859,
- 33047.549635,
- 3084.518261,
- 5672.728089,
- 6717.658333,
- 4627.358531,
- 4620.645169,
- 10488.136334,
- 583.562571,
- 706.343421,
- 867.811417,
- 960.19698,
- 1106.74379,
- 7385.512032,
- 7580.071122,
- 1155.013263,
- 1123.939735,
- 1306.053745,
- 19394.102548,
- 21708.69301,
- 23866.669683,
- 20659.771125,
- 10435.400548,
- 8506.953367,
- 8990.806531,
- 7894.600863,
- 7898.462834,
- 3196.98732,
- 207.511194,
- 1342.747955,
- 1277.779061,
- 1375.087613,
- 12375.356285,
- 11366.013515,
- 32201.00245,
- 206.428619,
- 18913.06314,
- 19473.77271,
- 20495.135862,
- 469.09133,
- 7377.800729,
- 4295.661846,
- 15767.981083,
- 17684.895453,
- 17231.167077,
- 17881.141502,
- 8275.478852,
- 3808.911623,
- 39080.706873,
- 32283.164533,
- 39080.706873,
- 842.906748,
- 1455.81625,
- 1583.458021,
- 1829.958154,
- 1574.891247,
- 15641.999558,
- 147.857046,
- 197.435176,
- 16652.56973,
- 786.423169,
- 352.29945,
- 330.329431,
- 531.360636,
- 726.916554,
- 6138.75971,
- 6324.451098,
- 6484.107881,
- 31459.992889,
- 39080.706873,
- 39080.706873,
- 1288.277242,
- 5200.216467,
- 5283.919962,
- 5804.284562,
- 0,
- 4279.030552,
- 0,
- 0,
- 25775.721028,
- 1170.90326,
- 6230.502429,
- 7872.681922,
- 2537.615391,
- 2212.923845,
- 13576.50164,
- 7724.313425,
- 21485.985823,
- 21298.068074,
- 428.140567,
- 400.826556,
- 331.793111,
- 388.551813,
- 12751.239999,
- 14869.714628,
- 0,
- 21458.883778,
- 19346.328032,
- 9317.618602,
- 5350.620293,
- 376.486666,
- 311.654681,
- 336.398843,
- 209.097003,
- 293.663675,
- 345.724696,
- 32037.811091,
- 31507.712292,
- 31295.393304,
- 372.135623,
- 470.184264,
- 558.100119,
- 22324.195336,
- 373.018863,
- 513.858548,
- 1721.157195,
- 666.218709,
- 39080.706873,
- 1839.438688,
- 199.857679,
- 174.504831,
- 272.405423,
- 15749.024885,
- 17496.487442,
- 16585.601395,
- 16636.201562,
- 0,
- 2100.28447,
- 11474.79039,
- 24838.952192,
- 463.096737,
- 2339.860957,
- 6173.532592,
- 611.32216,
- 16530.591089,
- 27916.788724,
- 0,
- 0,
- 207.197393,
- 1639.426936,
- 27355.806261,
- 26995.905245,
- 28511.366391,
- 983.926357,
- 14210.273267,
- 1935.540684,
- 3648.399359,
- 0,
- 0,
- 17671.52007,
- 24623.169573,
- 22036.222446,
- 24038.294338,
- 24021.202888,
- 1169.706839,
- 148.849584,
- 14269.153068,
- 26596.673947,
- 7622.540277,
- 39080.706873,
- 177.904916,
- 3199.862074,
- 8407.733198,
- 8561.556374,
- 8732.143125,
- 27622.358303,
- 26389.145904,
- 39080.706873,
- 6562.297667,
- 7379.129256,
- 2967.481252,
- 2107.468043,
- 19785.413828,
- 20953.039168,
- 2795.859236,
- 3562.699614,
- 15362.201212,
- 15464.898729,
- 39080.706873,
- 23511.759808,
- 7478.038735,
- 7150.276802,
- 23879.590146,
- 3347.579024,
- 12076.652231,
- 13698.164555,
- 8931.549878,
- 21053.092984,
- 10403.570025,
- 10616.884473,
- 0,
- 0,
- 0,
- 2361.808041,
- 1103.476378,
- 0,
- 5818.275757,
- 24214.125171,
- 6635.359748,
- 2606.015232,
- 171.936137,
- 16055.532701,
- 17612.035622,
- 23597.578067,
- 1757.991872,
- 17903.405195,
- 4681.278603,
- 4850.246942,
- 2357.36547,
- 2789.861152,
- 3516.757381,
- 10236.888837,
- 9559.775237,
- 13985.164003,
- 730.404527,
- 1345.734571,
- 3729.021544,
- 1569.157205,
- 779.73235,
- 1839.590158,
- 22168.619126,
- 20408.375319,
- 646.668956,
- 21562.278811,
- 2589.058683,
- 480.26355,
- 592.415366,
- 0,
- 188.067256,
- 3836.512775,
- 1725.625842,
- 1380.923337,
- 1399.917938,
- 6237.498796,
- 5721.453022,
- 39080.706873,
- 212.038529,
- 16382.201402,
- 5495.676534,
- 4285.908728,
- 39080.706873,
- 39080.706873,
- 39080.706873,
- 0,
- 13148.787414,
- 28118.729286,
- 3184.030732,
- 4604.699547,
- 2393.127138,
- 2675.640798,
- 2111.080138,
- 6334.316729,
- 14071.493772,
- 1203.071752,
- 282.193167,
- 39080.706873,
- 39080.706873,
- 5947.88827,
- 6583.632284,
- 21354.595532,
- 29360.713789,
- 883.99247,
- 2509.596645,
- 31465.557157,
- 39080.706873,
- 31010.773178,
- 0,
- 0,
- 0,
- 39080.706873,
- 27856.543698,
- 26377.713237,
- 279.287783,
- 2369.900188,
- 2780.982856,
- 7913.050323,
- 1956.467938,
- 17783.746012,
- 10738.206206,
- 2685.079153,
- 10790.608227,
- 5864.677666,
- 574.166931,
- 4259.243598,
- 26652.014956,
- 0,
- 0,
- 9442.740819,
- 10381.612021,
- 39080.706873,
- 476.111071,
- 0,
- 0,
- 0,
- 26608.236251,
- 174.1379,
- 0,
- 27194.642483,
- 719.662943,
- 627.427205,
- 19515.502501,
- 2875.612689,
- 2116.238956,
- 1675.281244,
- 22641.700777,
- 1469.397928,
- 3965.357246,
- 701.323369,
- 835.296288,
- 3837.824301,
- 3987.036853,
- 0,
- 0,
- 2583.086252,
- 2739.381655,
- 1531.857327,
- 1436.245221,
- 18099.296,
- 14900.854602,
- 39080.706873,
- 0,
- 1367.990745,
- 22442.848462,
- 22901.148449,
- 5078.553507,
- 5347.805452,
- 8838.30172,
- 5735.091989,
- 5471.475196,
- 1279.419824,
- 12538.31871,
- 32477.818001,
- 39080.706873,
- 2804.435878,
- 6266.276308,
- 6439.80459,
- 39080.706873,
- 2845.602368,
- 4151.775997,
- 19644.495154,
- 10682.799177,
- 7282.096179,
- 537.109338,
- 429.757827,
- 2428.465389,
- 26278.066235,
- 623.282083,
- 0,
- 447.252327,
- 8163.969048,
- 6658.188944,
- 21648.187016,
- 762.003388,
- 0,
- 754.610925,
- 5057.885795,
- 3187.533237,
- 7408.761237,
- 8708.944777,
- 1586.82541,
- 725.614148,
- 2362.431269,
- 178.793746,
- 1632.767548,
- 0,
- 6704.965994,
- 2100.184942,
- 2094.940904,
- 170.819651,
- 1913.453666,
- 857.738935,
- 2119.99269,
- 11678.045403,
- 984.866496,
- 8241.466013,
- 11419.897505,
- 2670.023256,
- 4414.899186,
- 2306.774209,
- 5879.33931,
- 12490.313327,
- 6143.441017,
- 13407.595289,
- 905.529349,
- 19513.576088
- ]
- },
- {
- "type": "histogram",
- "x": [
- 0,
- 0,
- 0,
- 0,
- 23,
- 10,
- 23,
- 24,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 29,
- 49,
- 27,
- 36,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1,
- 0,
- 0,
- 63,
- 46,
- 53,
- 63,
- 30,
- 33,
- 44,
- 46,
- 47,
- 44,
- 46,
- 44,
- 0,
- 0,
- 0,
- 0,
- 20,
- 21,
- 20,
- 16,
- 0,
- 0,
- 0,
- 0,
- 51,
- 38,
- 36,
- 51,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 33,
- 40,
- 45,
- 0,
- 0,
- 0,
- 0,
- 45,
- 33,
- 39,
- 38,
- 0,
- 0,
- 0,
- 0,
- 51,
- 58,
- 54,
- 63,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 50,
- 69,
- 46,
- 52,
- 28,
- 19,
- 24,
- 23,
- 26,
- 27,
- 17,
- 35,
- 43,
- 26,
- 37,
- 25,
- 29,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 20,
- 13,
- 20,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 28,
- 30,
- 29,
- 21,
- 38,
- 52,
- 51,
- 40,
- 46,
- 44,
- 53,
- 0,
- 0,
- 0,
- 2,
- 4,
- 1,
- 4,
- 0,
- 0,
- 0,
- 0,
- 44,
- 38,
- 61,
- 46,
- 25,
- 26,
- 29,
- 10,
- 9,
- 10,
- 18,
- 80,
- 19,
- 11,
- 9,
- 10,
- 4,
- 7,
- 15,
- 8,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 18,
- 24,
- 24,
- 82,
- 62,
- 65,
- 66,
- 0,
- 0,
- 0,
- 26,
- 17,
- 33,
- 18,
- 28,
- 2,
- 8,
- 1,
- 8,
- 16,
- 31,
- 24,
- 20,
- 24,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 49,
- 32,
- 40,
- 0,
- 0,
- 26,
- 53,
- 59,
- 55,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 21,
- 37,
- 26,
- 27,
- 0,
- 16,
- 13,
- 1,
- 0,
- 2,
- 0,
- 0,
- 0,
- 15,
- 16,
- 24,
- 19,
- 4,
- 6,
- 7,
- 13,
- 0,
- 0,
- 0,
- 16,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1,
- 2,
- 0,
- 1,
- 32,
- 26,
- 44,
- 43,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 11,
- 11,
- 16,
- 12,
- 0,
- 0,
- 0,
- 5,
- 3,
- 2,
- 51,
- 47,
- 43,
- 45,
- 10,
- 7,
- 6,
- 5,
- 19,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 33,
- 15,
- 50,
- 0,
- 0,
- 0,
- 0,
- 40,
- 42,
- 50,
- 0,
- 5,
- 2,
- 58,
- 56,
- 63,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 33,
- 51,
- 45,
- 52,
- 12,
- 20,
- 15,
- 18,
- 17,
- 12,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 69,
- 59,
- 57,
- 19,
- 21,
- 23,
- 18,
- 19,
- 0,
- 0,
- 0,
- 0,
- 10,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 16,
- 32,
- 63,
- 68,
- 59,
- 51,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1,
- 37,
- 69,
- 21,
- 22,
- 12,
- 8,
- 12,
- 16,
- 17,
- 15,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 16,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 6,
- 4,
- 0,
- 25,
- 19,
- 27,
- 23,
- 33,
- 27,
- 22,
- 25,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 36,
- 48,
- 54,
- 23,
- 32,
- 28,
- 25,
- 34,
- 0,
- 0,
- 0,
- 0,
- 34,
- 31,
- 31,
- 31,
- 60,
- 45,
- 43,
- 42,
- 33,
- 32,
- 24,
- 40,
- 8,
- 9,
- 6,
- 0,
- 0,
- 0,
- 0,
- 0,
- 49,
- 40,
- 9,
- 6,
- 8,
- 0,
- 51,
- 51,
- 18,
- 15,
- 13,
- 10,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 54,
- 57,
- 21,
- 23,
- 25,
- 24,
- 36,
- 44,
- 0,
- 0,
- 5,
- 0,
- 1,
- 3,
- 0,
- 0,
- 0,
- 0,
- 1,
- 1,
- 0,
- 0,
- 0,
- 0,
- 0,
- 15,
- 0,
- 0,
- 0,
- 0,
- 26,
- 31,
- 22,
- 36,
- 36,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 15,
- 55,
- 73,
- 0,
- 3,
- 0,
- 0,
- 0,
- 0,
- 0,
- 16,
- 13,
- 14,
- 0,
- 0,
- 10,
- 16,
- 13,
- 18,
- 6,
- 18,
- 26,
- 0,
- 0,
- 0,
- 0,
- 0,
- 8,
- 10,
- 10,
- 8,
- 1,
- 0,
- 0,
- 0,
- 0,
- 17,
- 16,
- 13,
- 58,
- 0,
- 3,
- 0,
- 23,
- 13,
- 12,
- 9,
- 9,
- 7,
- 0,
- 0,
- 0,
- 0,
- 30,
- 0,
- 0,
- 61,
- 44,
- 69,
- 0,
- 0,
- 0,
- 0,
- 51,
- 61,
- 78,
- 0,
- 18,
- 47,
- 56,
- 49,
- 70,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 5,
- 5,
- 7,
- 11,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 19,
- 54,
- 72,
- 0,
- 0,
- 0,
- 0,
- 0,
- 2,
- 1,
- 4,
- 3,
- 6,
- 0,
- 0,
- 50,
- 0,
- 0,
- 0,
- 41,
- 54,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 61,
- 51,
- 45,
- 39,
- 2,
- 35,
- 0,
- 0,
- 56,
- 54,
- 0,
- 7,
- 6,
- 0,
- 0,
- 16,
- 0,
- 0,
- 0,
- 0,
- 0,
- 9,
- 9,
- 0,
- 0,
- 0,
- 41,
- 38,
- 26,
- 35,
- 17,
- 9,
- 17,
- 10,
- 21,
- 0,
- 0,
- 0,
- 0,
- 0,
- 28,
- 12,
- 62,
- 0,
- 30,
- 26,
- 37,
- 0,
- 13,
- 0,
- 25,
- 27,
- 23,
- 25,
- 7,
- 0,
- 65,
- 51,
- 61,
- 0,
- 0,
- 0,
- 0,
- 0,
- 21,
- 0,
- 0,
- 29,
- 0,
- 0,
- 0,
- 0,
- 0,
- 6,
- 2,
- 12,
- 44,
- 84,
- 57,
- 0,
- 2,
- 4,
- 4,
- 0,
- 1,
- 0,
- 0,
- 45,
- 0,
- 6,
- 12,
- 0,
- 0,
- 33,
- 14,
- 36,
- 47,
- 0,
- 0,
- 0,
- 0,
- 21,
- 21,
- 0,
- 37,
- 39,
- 10,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 47,
- 50,
- 60,
- 0,
- 0,
- 0,
- 33,
- 0,
- 0,
- 0,
- 0,
- 59,
- 0,
- 0,
- 0,
- 0,
- 26,
- 30,
- 14,
- 19,
- 0,
- 0,
- 21,
- 49,
- 0,
- 0,
- 6,
- 0,
- 39,
- 56,
- 0,
- 0,
- 0,
- 0,
- 43,
- 52,
- 52,
- 0,
- 23,
- 0,
- 0,
- 0,
- 0,
- 25,
- 58,
- 46,
- 47,
- 45,
- 0,
- 0,
- 26,
- 35,
- 9,
- 54,
- 0,
- 0,
- 13,
- 14,
- 11,
- 58,
- 33,
- 57,
- 6,
- 6,
- 0,
- 0,
- 30,
- 34,
- 0,
- 0,
- 34,
- 24,
- 63,
- 45,
- 8,
- 14,
- 46,
- 0,
- 15,
- 31,
- 14,
- 47,
- 16,
- 23,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 4,
- 36,
- 2,
- 0,
- 0,
- 32,
- 40,
- 31,
- 0,
- 36,
- 1,
- 1,
- 0,
- 0,
- 0,
- 19,
- 15,
- 25,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 36,
- 35,
- 0,
- 37,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 7,
- 6,
- 62,
- 0,
- 22,
- 3,
- 0,
- 55,
- 61,
- 66,
- 0,
- 19,
- 45,
- 0,
- 0,
- 0,
- 0,
- 0,
- 5,
- 30,
- 0,
- 0,
- 54,
- 62,
- 7,
- 8,
- 38,
- 46,
- 0,
- 0,
- 51,
- 68,
- 67,
- 0,
- 0,
- 0,
- 58,
- 45,
- 46,
- 0,
- 0,
- 0,
- 15,
- 0,
- 41,
- 17,
- 0,
- 21,
- 4,
- 0,
- 0,
- 50,
- 0,
- 0,
- 12,
- 13,
- 79,
- 0,
- 0,
- 0,
- 0,
- 37,
- 0,
- 0,
- 41,
- 0,
- 0,
- 31,
- 0,
- 0,
- 0,
- 35,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 30,
- 23,
- 72,
- 0,
- 0,
- 35,
- 29,
- 1,
- 2,
- 18,
- 2,
- 5,
- 0,
- 16,
- 48,
- 64,
- 0,
- 3,
- 7,
- 49,
- 0,
- 0,
- 24,
- 20,
- 11,
- 0,
- 0,
- 0,
- 50,
- 0,
- 0,
- 0,
- 15,
- 7,
- 46,
- 0,
- 0,
- 0,
- 0,
- 0,
- 6,
- 11,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 6,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 21,
- 0,
- 12,
- 20,
- 0,
- 0,
- 0,
- 1,
- 21,
- 8,
- 32,
- 0,
- 44
- ]
- },
- {
- "type": "histogram",
- "x": [
- 0,
- 0,
- 0,
- 0,
- 472.8715639712987,
- 158.18279603910278,
- 413.2008695183515,
- 471.08703332940763,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 453.82701366175803,
- 1256.1525840853158,
- 375.4432315928526,
- 925.6164348340319,
- 0,
- 0,
- 0,
- 0,
- 0,
- 50.74081591231987,
- 0,
- 0,
- 1841.5667933352822,
- 860.6335010945013,
- 979.4138300624606,
- 1140.6431054461182,
- 921.8572350428663,
- 2217.592903702708,
- 2768.6886483765416,
- 2667.9039554576034,
- 2713.782550955598,
- 1115.9015977681968,
- 4336.758744225512,
- 2324.352879027998,
- 0,
- 0,
- 0,
- 0,
- 557.2117125901987,
- 518.6593889698437,
- 476.3719512195122,
- 347.6749239461104,
- 0,
- 0,
- 0,
- 0,
- 822.567377945517,
- 565.5519340387849,
- 907.3266628021272,
- 1735.4022049816251,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 3376.649953954773,
- 5040.957781978576,
- 734.8138471587198,
- 0,
- 0,
- 0,
- 0,
- 2962.670353545329,
- 695.9235749383158,
- 703.6281956447219,
- 530.3929094842626,
- 0,
- 0,
- 0,
- 0,
- 2509.2250922509224,
- 885.1178122329386,
- 1865.6716417910447,
- 7000.777864207134,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 4111.1659266568,
- 6678.2810685249715,
- 934.5414651984885,
- 4047.9526700918573,
- 673.4978592389474,
- 428.44901456726654,
- 716.3965254768514,
- 477.1982239926968,
- 1662.8293681248401,
- 635.9674949947002,
- 824.9223602484471,
- 821.1721646098259,
- 1603.7595106668657,
- 1410.8964619057956,
- 684.7793899911164,
- 913.3087348847404,
- 1668.4885794833438,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 336.07797008906067,
- 250.64589519145488,
- 411.7683391324041,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 393.13695206537307,
- 689.2748828232699,
- 826.65830506542,
- 465.86951216806796,
- 1855.5593534840568,
- 1060.4453870625662,
- 4486.671945104249,
- 2822.068576266403,
- 1874.2615002240966,
- 1010.5417881996278,
- 872.1265077092693,
- 0,
- 0,
- 0,
- 48.944032498837586,
- 136.75681219870765,
- 31.376486461046095,
- 113.10298026352994,
- 0,
- 0,
- 0,
- 0,
- 721.7492577465019,
- 2063.8713882250704,
- 4773.830020347473,
- 2388.6177173122855,
- 1443.6680718369234,
- 512.5879778404275,
- 2575.4884547069273,
- 497.88399302962415,
- 1046.146693014065,
- 226.2750599628909,
- 983.1767533318767,
- 7190.364911019234,
- 290.1339197092553,
- 339.1189074205383,
- 195.69471624266143,
- 222.22222222222223,
- 132.3845771967566,
- 169.68462899667904,
- 638.8959877331971,
- 419.99160016799664,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 299.4609702535436,
- 460.7941018354965,
- 655.3079947575361,
- 2160.68087797423,
- 4933.163590070019,
- 4170.676932948348,
- 9243.697478991597,
- 0,
- 0,
- 0,
- 970.6925518013813,
- 922.9098805646038,
- 613.5197441808582,
- 341.99076624931126,
- 621.7524537016477,
- 135.21736190926916,
- 160.61676839062,
- 46.68534080298786,
- 478.9272030651341,
- 742.080608506099,
- 1233.7817400302476,
- 3955.174686882004,
- 1582.1533106558027,
- 3234.065489826169,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 3247.183565275017,
- 719.7480881691408,
- 2728.1407720638385,
- 0,
- 0,
- 2121.4099216710183,
- 3831.417624521073,
- 1527.7454102902716,
- 2073.12476441764,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 770.7270525195435,
- 3446.669771774569,
- 1569.9535052231147,
- 1624.2555495397944,
- 0,
- 421.5962688730205,
- 409.8102263413404,
- 56.12617163383286,
- 0,
- 128.73326467559218,
- 0,
- 0,
- 0,
- 345.1449608835711,
- 316.3493287462681,
- 457.48270143535194,
- 610.5790860595154,
- 72.1071512267229,
- 149.4880035877121,
- 152.97537096527458,
- 304.32136335970785,
- 0,
- 0,
- 0,
- 226.10047339786618,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 56.637970095151786,
- 65.75702778234424,
- 0,
- 42.66393617475148,
- 1008.3504017646133,
- 665.4381654381654,
- 1055.2824079625855,
- 807.7392692777308,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 258.38579347928214,
- 296.0251890524503,
- 431.7206767221608,
- 625.912789484665,
- 0,
- 0,
- 0,
- 143.52144210345025,
- 72.19521586369544,
- 51.09992590510744,
- 1268.4989429175475,
- 1348.4435518576963,
- 1060.497694034084,
- 1094.9704357982334,
- 262.88117770767616,
- 141.24008797239765,
- 180.10986701888152,
- 130.7462998797134,
- 428.58431832536314,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 632.5353165551743,
- 325.8602711157456,
- 3312.3550844650545,
- 0,
- 0,
- 0,
- 0,
- 818.3640901837227,
- 961.6925789389326,
- 785.8669684395826,
- 0,
- 135.40228017439813,
- 31.31998058161204,
- 1579.9509670389539,
- 5437.421108845519,
- 6688.6081324981415,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1155.0981833455844,
- 887.5585179513062,
- 745.4156934850669,
- 2259.396046056919,
- 266.6311158512199,
- 837.3456144023446,
- 1296.9047207331835,
- 929.6080152868874,
- 425.89437819420783,
- 313.22596643261727,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 2717.284290946324,
- 2759.846571241463,
- 1830.501942901185,
- 1230.809095031418,
- 734.5225603357817,
- 1259.0321874315744,
- 298.70560902754727,
- 296.92139396780743,
- 0,
- 0,
- 0,
- 0,
- 232.35820340637127,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 262.2821828434667,
- 1900.801900801901,
- 3784.693019343986,
- 1880.9991424856848,
- 2957.9865637220496,
- 5067.5675675675675,
- 0,
- 0,
- 0,
- 0,
- 0,
- 17.903179604697794,
- 939.5632300660234,
- 3053.2324439134472,
- 352.89372857430936,
- 535.6968929580208,
- 190.51852792684087,
- 149.58024045023652,
- 302.1071977039853,
- 701.7236086136573,
- 1055.114200595829,
- 426.64542920530175,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 400.5607850991388,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 588.3506569915669,
- 283.7281883955171,
- 0,
- 2019.712392955243,
- 444.5276309016892,
- 1867.9950186799501,
- 1184.6510430079834,
- 810.4921898025345,
- 605.5169320475443,
- 1430.615164520744,
- 1163.819189050789,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 2007.0245860511789,
- 1478.2421237411845,
- 893.9805310906563,
- 1599.2212487832012,
- 1801.9032603187115,
- 933.8313767342582,
- 839.348665435622,
- 1214.4592084583512,
- 0,
- 0,
- 0,
- 0,
- 857.8926120306822,
- 741.6445369506447,
- 1358.5765623630466,
- 3014.0982012639765,
- 1143.7503574219868,
- 1395.3488372093022,
- 777.070984530866,
- 1202.9558343357965,
- 1950.4698859270643,
- 486.64760630208656,
- 1615.1827175449223,
- 2882.6751225136927,
- 129.5756397797214,
- 181.4845435663729,
- 138.78287419332455,
- 0,
- 0,
- 0,
- 0,
- 0,
- 3201.358944204887,
- 2305.2097740894424,
- 182.29324907334265,
- 282.03440819780013,
- 171.0717646052519,
- 0,
- 2402.2609514837495,
- 2251.8544683857294,
- 1737.1163867979155,
- 1088.139281828074,
- 246.8338807982228,
- 250.84031505543572,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 5748.350010645093,
- 2352.9411764705883,
- 1718.0724862963266,
- 1989.9636615331372,
- 1127.4974067559644,
- 604.2600332343018,
- 2625.4375729288213,
- 2090.0627018810565,
- 0,
- 0,
- 155.53067064825183,
- 0,
- 44.08393581378946,
- 48.07076015895398,
- 0,
- 0,
- 0,
- 0,
- 21.15014487849242,
- 24.85089463220676,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1107.6650420912715,
- 0,
- 0,
- 0,
- 0,
- 660.6362435206829,
- 804.5469881394201,
- 430.4609845816702,
- 813.8719960210702,
- 716.574772587034,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 792.8956549318109,
- 3224.104578228501,
- 4803.579653879055,
- 0,
- 101.02370689655173,
- 0,
- 0,
- 0,
- 0,
- 0,
- 332.64724838354226,
- 244.91333835719666,
- 268.06058169146223,
- 0,
- 0,
- 648.5925541574783,
- 951.7011658339281,
- 289.2810253899731,
- 1036.2694300518135,
- 440.43162299053074,
- 836.0039013515395,
- 1336.8296570517764,
- 0,
- 0,
- 0,
- 0,
- 0,
- 199.61075901991117,
- 514.7740142077628,
- 740.7956144899622,
- 218.43003412969284,
- 80.37293039704228,
- 0,
- 0,
- 0,
- 0,
- 465.3454505638892,
- 1160.4293588627793,
- 451.52999201139244,
- 6638.434245164244,
- 0,
- 111.85682326621924,
- 0,
- 636.3083052066619,
- 465.33271288971616,
- 283.145749274439,
- 1106.6027296200664,
- 446.7609828741623,
- 393.2805213776055,
- 0,
- 0,
- 0,
- 0,
- 1815.5410312273057,
- 0,
- 0,
- 1469.9503590534484,
- 1156.9813305285302,
- 2289.012738853503,
- 0,
- 0,
- 0,
- 0,
- 4851.598173515981,
- 4198.788546255507,
- 3423.1545685947513,
- 0,
- 413.13778145011366,
- 4808.1841432225065,
- 4045.0736781277087,
- 3361.6904500548844,
- 3622.8133733567956,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 119.52857928330664,
- 105.54980895484579,
- 315.5711838427554,
- 237.68366464995677,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1610.3059581320451,
- 1089.940255126756,
- 1834.4883815735834,
- 0,
- 0,
- 0,
- 0,
- 0,
- 60.66672733339399,
- 26.32895395065954,
- 83.22929671244279,
- 218.7067142961289,
- 96.95402763189787,
- 0,
- 0,
- 1816.7944478761672,
- 0,
- 0,
- 0,
- 2064.867042707494,
- 4733.52033660589,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 3345.0318052204434,
- 4237.28813559322,
- 2872.6460261729976,
- 718.311415626036,
- 118.7507421921387,
- 1534.8184529029993,
- 0,
- 0,
- 2025.5362245451586,
- 1265.6447756996201,
- 0,
- 119.5886151638364,
- 90.21064184871675,
- 0,
- 0,
- 299.7601918465228,
- 0,
- 0,
- 0,
- 0,
- 0,
- 163.71971185330713,
- 426.884219513352,
- 0,
- 0,
- 0,
- 920.8930416423342,
- 616.2728466940205,
- 615.2244386076998,
- 2315.2741946153337,
- 599.5415270675365,
- 204.6989787795392,
- 847.3309076409311,
- 461.68051708217916,
- 744.5752375549567,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1294.618087664139,
- 891.5967010922059,
- 7099.507614794458,
- 0,
- 683.6671908115129,
- 1358.6246538119872,
- 2272.8668837152163,
- 0,
- 663.1976328946025,
- 0,
- 1653.7672818680956,
- 3468.208092485549,
- 580.3391199031086,
- 1210.4778966736067,
- 266.859822347604,
- 0,
- 7182.32044198895,
- 4994.613651943982,
- 7202.739402526862,
- 0,
- 0,
- 0,
- 0,
- 0,
- 922.3876663592041,
- 0,
- 0,
- 906.2216805724821,
- 0,
- 0,
- 0,
- 0,
- 0,
- 330.9431880860452,
- 30.384054448225573,
- 723.8508867173363,
- 1846.7995802728228,
- 13513.513513513513,
- 3273.980470993682,
- 0,
- 282.60562385191463,
- 170.77231780728346,
- 343.878954607978,
- 0,
- 50.69194504993156,
- 0,
- 0,
- 978.4097580066532,
- 0,
- 150.31189718666232,
- 239.48271733056598,
- 0,
- 0,
- 852.6691127073536,
- 473.7412019491067,
- 1738.7104564114948,
- 2886.977886977887,
- 0,
- 0,
- 0,
- 0,
- 868.7378480122451,
- 427.72470823064543,
- 0,
- 703.6227060948939,
- 2330.445174783388,
- 719.2174913693901,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 4927.65778989306,
- 5041.33897963299,
- 1892.9236205319114,
- 0,
- 0,
- 0,
- 733.5615524829948,
- 0,
- 0,
- 0,
- 0,
- 3056.519711961871,
- 0,
- 0,
- 0,
- 0,
- 1331.4897321657193,
- 1983.0777366472764,
- 896.2294347352922,
- 622.8282960729038,
- 0,
- 0,
- 1500.7503751875938,
- 2432.1238894128155,
- 0,
- 0,
- 488.20179007323026,
- 0,
- 1833.1374853113984,
- 1673.2901066722445,
- 0,
- 0,
- 0,
- 0,
- 1163.8292689528243,
- 6983.615363953801,
- 3943.5765205521006,
- 0,
- 1648.1547832318165,
- 0,
- 0,
- 0,
- 0,
- 1452.3062623446033,
- 2581.4491721559552,
- 4482.120237747247,
- 6346.205779098028,
- 762.3500711526733,
- 0,
- 0,
- 1546.5143944801332,
- 816.5169718884871,
- 317.1917953055614,
- 3405.436085009775,
- 0,
- 0,
- 641.1521010061157,
- 497.47708052021886,
- 1449.2753623188405,
- 2713.577243379807,
- 2493.7655860349128,
- 4417.577307602884,
- 486.1054848902212,
- 387.5468285751195,
- 0,
- 0,
- 1444.5996051427746,
- 3037.884203002144,
- 0,
- 0,
- 904.1591320072333,
- 603.2121044562293,
- 5928.295850192905,
- 3281.5576460293155,
- 338.8681802778719,
- 718.4276697285369,
- 3604.1682989892656,
- 0,
- 825.9457078354716,
- 618.7007284702125,
- 601.7623038899634,
- 3242.0500793267574,
- 1289.3867354339593,
- 664.8936170212767,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 215.2620815843289,
- 543.5274934323761,
- 102.10332856851133,
- 0,
- 0,
- 2523.659305993691,
- 5553.2417048452035,
- 2212.231499322058,
- 0,
- 869.376222560313,
- 46.74644727000748,
- 66.73785371062466,
- 0,
- 0,
- 0,
- 1846.0940536338903,
- 716.8116219057631,
- 1997.4432726110579,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1885.6065367693272,
- 574.4296733957,
- 0,
- 2077.951252386836,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 396.4657906660625,
- 334.4854498829301,
- 3628.064837029668,
- 0,
- 425.0386398763524,
- 151.56873642196734,
- 0,
- 7294.429708222812,
- 3511.3976513930465,
- 4962.779156327543,
- 0,
- 686.639442015106,
- 4131.093362709998,
- 0,
- 0,
- 0,
- 0,
- 0,
- 285.66531451751126,
- 1566.8250900924427,
- 0,
- 0,
- 3018.446059250978,
- 5281.090289608177,
- 409.3327875562832,
- 468.11000585137504,
- 988.888021443256,
- 3195.110092380357,
- 0,
- 0,
- 3206.337231233497,
- 3571.241006249672,
- 3326.7130089374377,
- 0,
- 0,
- 0,
- 5264.591086502677,
- 4085.3381752156147,
- 3115.0538362565176,
- 0,
- 0,
- 0,
- 912.4642618164122,
- 0,
- 1630.672552996858,
- 1144.2417715554957,
- 0,
- 947.5251545368408,
- 265.26958021088933,
- 0,
- 0,
- 4495.99856128046,
- 0,
- 0,
- 500.12503125781444,
- 456.04434154213146,
- 6297.831632653061,
- 0,
- 0,
- 0,
- 0,
- 3172.153635116598,
- 0,
- 0,
- 2859.3346816374924,
- 0,
- 0,
- 1212.690216328287,
- 0,
- 0,
- 0,
- 3780.5141499243896,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1403.5744362309347,
- 1281.69406519922,
- 10904.134484325306,
- 0,
- 0,
- 2409.9703917923293,
- 1063.9078435688605,
- 53.888020692999945,
- 38.96660561898453,
- 999.3337774816789,
- 134.86176668914362,
- 386.99690402476784,
- 0,
- 845.0853007975493,
- 8059.100067159166,
- 7178.106774338268,
- 0,
- 163.79122079056563,
- 376.87089479918166,
- 9867.09625453081,
- 0,
- 0,
- 1948.5264268896647,
- 699.471898716469,
- 1340.3192396734494,
- 0,
- 0,
- 0,
- 6658.676255160474,
- 0,
- 0,
- 0,
- 1448.1560146746476,
- 716.4790174002047,
- 3290.179529361276,
- 0,
- 0,
- 0,
- 0,
- 0,
- 446.09665427509293,
- 1096.3819395993223,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 428.2043962318013,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1142.5462459194778,
- 0,
- 1374.098248024734,
- 1061.8529333687284,
- 0,
- 0,
- 0,
- 87.30574471800244,
- 1766.6358206444015,
- 584.6671051669955,
- 1911.360649862621,
- 0,
- 2234.409912654885
- ]
- }
- ],
- "layout": {
- "bargap": 0.2,
- "bargroupgap": 0.1,
- "template": {
- "data": {
- "bar": [
- {
- "error_x": {
- "color": "#2a3f5f"
- },
- "error_y": {
- "color": "#2a3f5f"
- },
- "marker": {
- "line": {
- "color": "#E5ECF6",
- "width": 0.5
- },
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "bar"
- }
- ],
- "barpolar": [
- {
- "marker": {
- "line": {
- "color": "#E5ECF6",
- "width": 0.5
- },
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "barpolar"
- }
- ],
- "carpet": [
- {
- "aaxis": {
- "endlinecolor": "#2a3f5f",
- "gridcolor": "white",
- "linecolor": "white",
- "minorgridcolor": "white",
- "startlinecolor": "#2a3f5f"
- },
- "baxis": {
- "endlinecolor": "#2a3f5f",
- "gridcolor": "white",
- "linecolor": "white",
- "minorgridcolor": "white",
- "startlinecolor": "#2a3f5f"
- },
- "type": "carpet"
- }
- ],
- "choropleth": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "choropleth"
- }
- ],
- "contour": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "contour"
- }
- ],
- "contourcarpet": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "contourcarpet"
- }
- ],
- "heatmap": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "heatmap"
- }
- ],
- "heatmapgl": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "heatmapgl"
- }
- ],
- "histogram": [
- {
- "marker": {
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "histogram"
- }
- ],
- "histogram2d": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "histogram2d"
- }
- ],
- "histogram2dcontour": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "histogram2dcontour"
- }
- ],
- "mesh3d": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "mesh3d"
- }
- ],
- "parcoords": [
- {
- "line": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "parcoords"
- }
- ],
- "pie": [
- {
- "automargin": true,
- "type": "pie"
- }
- ],
- "scatter": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatter"
- }
- ],
- "scatter3d": [
- {
- "line": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatter3d"
- }
- ],
- "scattercarpet": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattercarpet"
- }
- ],
- "scattergeo": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattergeo"
- }
- ],
- "scattergl": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattergl"
- }
- ],
- "scattermapbox": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattermapbox"
- }
- ],
- "scatterpolar": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterpolar"
- }
- ],
- "scatterpolargl": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterpolargl"
- }
- ],
- "scatterternary": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterternary"
- }
- ],
- "surface": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "surface"
- }
- ],
- "table": [
- {
- "cells": {
- "fill": {
- "color": "#EBF0F8"
- },
- "line": {
- "color": "white"
- }
- },
- "header": {
- "fill": {
- "color": "#C8D4E3"
- },
- "line": {
- "color": "white"
- }
- },
- "type": "table"
- }
- ]
- },
- "layout": {
- "annotationdefaults": {
- "arrowcolor": "#2a3f5f",
- "arrowhead": 0,
- "arrowwidth": 1
- },
- "autotypenumbers": "strict",
- "coloraxis": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "colorscale": {
- "diverging": [
- [
- 0,
- "#8e0152"
- ],
- [
- 0.1,
- "#c51b7d"
- ],
- [
- 0.2,
- "#de77ae"
- ],
- [
- 0.3,
- "#f1b6da"
- ],
- [
- 0.4,
- "#fde0ef"
- ],
- [
- 0.5,
- "#f7f7f7"
- ],
- [
- 0.6,
- "#e6f5d0"
- ],
- [
- 0.7,
- "#b8e186"
- ],
- [
- 0.8,
- "#7fbc41"
- ],
- [
- 0.9,
- "#4d9221"
- ],
- [
- 1,
- "#276419"
- ]
- ],
- "sequential": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "sequentialminus": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ]
- },
- "colorway": [
- "#636efa",
- "#EF553B",
- "#00cc96",
- "#ab63fa",
- "#FFA15A",
- "#19d3f3",
- "#FF6692",
- "#B6E880",
- "#FF97FF",
- "#FECB52"
- ],
- "font": {
- "color": "#2a3f5f"
- },
- "geo": {
- "bgcolor": "white",
- "lakecolor": "white",
- "landcolor": "#E5ECF6",
- "showlakes": true,
- "showland": true,
- "subunitcolor": "white"
- },
- "hoverlabel": {
- "align": "left"
- },
- "hovermode": "closest",
- "mapbox": {
- "style": "light"
- },
- "paper_bgcolor": "white",
- "plot_bgcolor": "#E5ECF6",
- "polar": {
- "angularaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "bgcolor": "#E5ECF6",
- "radialaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- }
- },
- "scene": {
- "xaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- },
- "yaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- },
- "zaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- }
- },
- "shapedefaults": {
- "line": {
- "color": "#2a3f5f"
- }
- },
- "ternary": {
- "aaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "baxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "bgcolor": "#E5ECF6",
- "caxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- }
- },
- "title": {
- "x": 0.05
- },
- "xaxis": {
- "automargin": true,
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": "",
- "title": {
- "standoff": 15
- },
- "zerolinecolor": "white",
- "zerolinewidth": 2
- },
- "yaxis": {
- "automargin": true,
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": "",
- "title": {
- "standoff": 15
- },
- "zerolinecolor": "white",
- "zerolinewidth": 2
- }
- }
- },
- "xaxis": {
- "title": {
- "text": "Value"
- }
- },
- "yaxis": {
- "title": {
- "text": "Count"
- }
- }
- }
- },
- "text/html": [
- " "
- ]
- },
- "metadata": {},
- "output_type": "display_data"
- }
- ],
+ "outputs": [],
+ "source": [
+ "check_accuracy(results)"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "check_accuracy(results, deterministic=True)"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "metadata": {},
+ "outputs": [],
"source": [
"analyze_data(results=results, t_ndx=200)"
]
},
{
"cell_type": "code",
- "execution_count": 15,
+ "execution_count": null,
"metadata": {},
- "outputs": [
- {
- "data": {
- "text/html": [
- " \n",
- " "
- ]
- },
- "metadata": {},
- "output_type": "display_data"
- },
- {
- "data": {
- "application/vnd.plotly.v1+json": {
- "config": {
- "linkText": "Export to plot.ly",
- "plotlyServerURL": "https://plot.ly",
- "showLink": false
- },
- "data": [
- {
- "marker": {
- "color": [
- 0,
- 0,
- 0,
- 0,
- 23,
- 10,
- 23,
- 24,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 29,
- 49,
- 27,
- 36,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1,
- 0,
- 0,
- 63,
- 46,
- 53,
- 63,
- 30,
- 33,
- 44,
- 46,
- 47,
- 44,
- 46,
- 44,
- 0,
- 0,
- 0,
- 0,
- 20,
- 21,
- 20,
- 16,
- 0,
- 0,
- 0,
- 0,
- 51,
- 38,
- 36,
- 51,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 33,
- 40,
- 45,
- 0,
- 0,
- 0,
- 0,
- 45,
- 33,
- 39,
- 38,
- 0,
- 0,
- 0,
- 0,
- 51,
- 58,
- 54,
- 63,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 50,
- 69,
- 46,
- 52,
- 28,
- 19,
- 24,
- 23,
- 26,
- 27,
- 17,
- 35,
- 43,
- 26,
- 37,
- 25,
- 29,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 20,
- 13,
- 20,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 28,
- 30,
- 29,
- 21,
- 38,
- 52,
- 51,
- 40,
- 46,
- 44,
- 53,
- 0,
- 0,
- 0,
- 2,
- 4,
- 1,
- 4,
- 0,
- 0,
- 0,
- 0,
- 44,
- 38,
- 61,
- 46,
- 25,
- 26,
- 29,
- 10,
- 9,
- 10,
- 18,
- 80,
- 19,
- 11,
- 9,
- 10,
- 4,
- 7,
- 15,
- 8,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 18,
- 24,
- 24,
- 82,
- 62,
- 65,
- 66,
- 0,
- 0,
- 0,
- 26,
- 17,
- 33,
- 18,
- 28,
- 2,
- 8,
- 1,
- 8,
- 16,
- 31,
- 24,
- 20,
- 24,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 49,
- 32,
- 40,
- 0,
- 0,
- 26,
- 53,
- 59,
- 55,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 21,
- 37,
- 26,
- 27,
- 0,
- 16,
- 13,
- 1,
- 0,
- 2,
- 0,
- 0,
- 0,
- 15,
- 16,
- 24,
- 19,
- 4,
- 6,
- 7,
- 13,
- 0,
- 0,
- 0,
- 16,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1,
- 2,
- 0,
- 1,
- 32,
- 26,
- 44,
- 43,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 11,
- 11,
- 16,
- 12,
- 0,
- 0,
- 0,
- 5,
- 3,
- 2,
- 51,
- 47,
- 43,
- 45,
- 10,
- 7,
- 6,
- 5,
- 19,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 33,
- 15,
- 50,
- 0,
- 0,
- 0,
- 0,
- 40,
- 42,
- 50,
- 0,
- 5,
- 2,
- 58,
- 56,
- 63,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 33,
- 51,
- 45,
- 52,
- 12,
- 20,
- 15,
- 18,
- 17,
- 12,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 69,
- 59,
- 57,
- 19,
- 21,
- 23,
- 18,
- 19,
- 0,
- 0,
- 0,
- 0,
- 10,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 16,
- 32,
- 63,
- 68,
- 59,
- 51,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1,
- 37,
- 69,
- 21,
- 22,
- 12,
- 8,
- 12,
- 16,
- 17,
- 15,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 16,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 6,
- 4,
- 0,
- 25,
- 19,
- 27,
- 23,
- 33,
- 27,
- 22,
- 25,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 36,
- 48,
- 54,
- 23,
- 32,
- 28,
- 25,
- 34,
- 0,
- 0,
- 0,
- 0,
- 34,
- 31,
- 31,
- 31,
- 60,
- 45,
- 43,
- 42,
- 33,
- 32,
- 24,
- 40,
- 8,
- 9,
- 6,
- 0,
- 0,
- 0,
- 0,
- 0,
- 49,
- 40,
- 9,
- 6,
- 8,
- 0,
- 51,
- 51,
- 18,
- 15,
- 13,
- 10,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 54,
- 57,
- 21,
- 23,
- 25,
- 24,
- 36,
- 44,
- 0,
- 0,
- 5,
- 0,
- 1,
- 3,
- 0,
- 0,
- 0,
- 0,
- 1,
- 1,
- 0,
- 0,
- 0,
- 0,
- 0,
- 15,
- 0,
- 0,
- 0,
- 0,
- 26,
- 31,
- 22,
- 36,
- 36,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 15,
- 55,
- 73,
- 0,
- 3,
- 0,
- 0,
- 0,
- 0,
- 0,
- 16,
- 13,
- 14,
- 0,
- 0,
- 10,
- 16,
- 13,
- 18,
- 6,
- 18,
- 26,
- 0,
- 0,
- 0,
- 0,
- 0,
- 8,
- 10,
- 10,
- 8,
- 1,
- 0,
- 0,
- 0,
- 0,
- 17,
- 16,
- 13,
- 58,
- 0,
- 3,
- 0,
- 23,
- 13,
- 12,
- 9,
- 9,
- 7,
- 0,
- 0,
- 0,
- 0,
- 30,
- 0,
- 0,
- 61,
- 44,
- 69,
- 0,
- 0,
- 0,
- 0,
- 51,
- 61,
- 78,
- 0,
- 18,
- 47,
- 56,
- 49,
- 70,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 5,
- 5,
- 7,
- 11,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 19,
- 54,
- 72,
- 0,
- 0,
- 0,
- 0,
- 0,
- 2,
- 1,
- 4,
- 3,
- 6,
- 0,
- 0,
- 50,
- 0,
- 0,
- 0,
- 41,
- 54,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 61,
- 51,
- 45,
- 39,
- 2,
- 35,
- 0,
- 0,
- 56,
- 54,
- 0,
- 7,
- 6,
- 0,
- 0,
- 16,
- 0,
- 0,
- 0,
- 0,
- 0,
- 9,
- 9,
- 0,
- 0,
- 0,
- 41,
- 38,
- 26,
- 35,
- 17,
- 9,
- 17,
- 10,
- 21,
- 0,
- 0,
- 0,
- 0,
- 0,
- 28,
- 12,
- 62,
- 0,
- 30,
- 26,
- 37,
- 0,
- 13,
- 0,
- 25,
- 27,
- 23,
- 25,
- 7,
- 0,
- 65,
- 51,
- 61,
- 0,
- 0,
- 0,
- 0,
- 0,
- 21,
- 0,
- 0,
- 29,
- 0,
- 0,
- 0,
- 0,
- 0,
- 6,
- 2,
- 12,
- 44,
- 84,
- 57,
- 0,
- 2,
- 4,
- 4,
- 0,
- 1,
- 0,
- 0,
- 45,
- 0,
- 6,
- 12,
- 0,
- 0,
- 33,
- 14,
- 36,
- 47,
- 0,
- 0,
- 0,
- 0,
- 21,
- 21,
- 0,
- 37,
- 39,
- 10,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 47,
- 50,
- 60,
- 0,
- 0,
- 0,
- 33,
- 0,
- 0,
- 0,
- 0,
- 59,
- 0,
- 0,
- 0,
- 0,
- 26,
- 30,
- 14,
- 19,
- 0,
- 0,
- 21,
- 49,
- 0,
- 0,
- 6,
- 0,
- 39,
- 56,
- 0,
- 0,
- 0,
- 0,
- 43,
- 52,
- 52,
- 0,
- 23,
- 0,
- 0,
- 0,
- 0,
- 25,
- 58,
- 46,
- 47,
- 45,
- 0,
- 0,
- 26,
- 35,
- 9,
- 54,
- 0,
- 0,
- 13,
- 14,
- 11,
- 58,
- 33,
- 57,
- 6,
- 6,
- 0,
- 0,
- 30,
- 34,
- 0,
- 0,
- 34,
- 24,
- 63,
- 45,
- 8,
- 14,
- 46,
- 0,
- 15,
- 31,
- 14,
- 47,
- 16,
- 23,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 4,
- 36,
- 2,
- 0,
- 0,
- 32,
- 40,
- 31,
- 0,
- 36,
- 1,
- 1,
- 0,
- 0,
- 0,
- 19,
- 15,
- 25,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 36,
- 35,
- 0,
- 37,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 7,
- 6,
- 62,
- 0,
- 22,
- 3,
- 0,
- 55,
- 61,
- 66,
- 0,
- 19,
- 45,
- 0,
- 0,
- 0,
- 0,
- 0,
- 5,
- 30,
- 0,
- 0,
- 54,
- 62,
- 7,
- 8,
- 38,
- 46,
- 0,
- 0,
- 51,
- 68,
- 67,
- 0,
- 0,
- 0,
- 58,
- 45,
- 46,
- 0,
- 0,
- 0,
- 15,
- 0,
- 41,
- 17,
- 0,
- 21,
- 4,
- 0,
- 0,
- 50,
- 0,
- 0,
- 12,
- 13,
- 79,
- 0,
- 0,
- 0,
- 0,
- 37,
- 0,
- 0,
- 41,
- 0,
- 0,
- 31,
- 0,
- 0,
- 0,
- 35,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 30,
- 23,
- 72,
- 0,
- 0,
- 35,
- 29,
- 1,
- 2,
- 18,
- 2,
- 5,
- 0,
- 16,
- 48,
- 64,
- 0,
- 3,
- 7,
- 49,
- 0,
- 0,
- 24,
- 20,
- 11,
- 0,
- 0,
- 0,
- 50,
- 0,
- 0,
- 0,
- 15,
- 7,
- 46,
- 0,
- 0,
- 0,
- 0,
- 0,
- 6,
- 11,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 6,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 21,
- 0,
- 12,
- 20,
- 0,
- 0,
- 0,
- 1,
- 21,
- 8,
- 32,
- 0,
- 44
- ],
- "colorbar": {
- "thickness": 20,
- "title": {
- "text": "A"
- }
- },
- "colorscale": [
- [
- 0,
- "#0508b8"
- ],
- [
- 0.08333333333333333,
- "#1910d8"
- ],
- [
- 0.16666666666666666,
- "#3c19f0"
- ],
- [
- 0.25,
- "#6b1cfb"
- ],
- [
- 0.3333333333333333,
- "#981cfd"
- ],
- [
- 0.4166666666666667,
- "#bf1cfd"
- ],
- [
- 0.5,
- "#dd2bfd"
- ],
- [
- 0.5833333333333334,
- "#f246fe"
- ],
- [
- 0.6666666666666666,
- "#fc67fd"
- ],
- [
- 0.75,
- "#fe88fc"
- ],
- [
- 0.8333333333333334,
- "#fea5fd"
- ],
- [
- 0.9166666666666666,
- "#febefe"
- ],
- [
- 1,
- "#fec3fe"
- ]
- ],
- "size": 5
- },
- "mode": "markers",
- "name": "A",
- "type": "scatter3d",
- "x": [
- -2.101682662963867,
- -1.887513518333435,
- -1.7570427656173706,
- -1.8541388511657715,
- 1.8749754428863525,
- 1.80832040309906,
- 2.1825294494628906,
- 2.062222480773926,
- -2.38004469871521,
- -2.3056769371032715,
- -2.2629430294036865,
- -2.0936312675476074,
- -1.9997928142547607,
- -1.7547287940979004,
- -1.6898266077041626,
- -1.6704288721084595,
- 3.5905017852783203,
- 3.2578799724578857,
- 3.160881519317627,
- 3.4964303970336914,
- -0.6913178563117981,
- -1.0443613529205322,
- -0.8108569979667664,
- -0.5850074887275696,
- -0.293684720993042,
- 0.0675533190369606,
- -0.271133154630661,
- 0.018742907792329788,
- 4.4305853843688965,
- 4.508673667907715,
- 4.325611114501953,
- 4.611989498138428,
- 3.4338648319244385,
- 3.488844871520996,
- 3.289395570755005,
- 3.6204428672790527,
- 3.71138858795166,
- 3.857684850692749,
- 3.974630117416382,
- 4.003854274749756,
- -3.9132473468780518,
- -4.0064496994018555,
- -3.8273096084594727,
- -3.709832191467285,
- 2.3001842498779297,
- 2.2914557456970215,
- 2.0052285194396973,
- 2.2628118991851807,
- -1.980513334274292,
- -2.0251479148864746,
- -1.7515032291412354,
- -2.1317431926727295,
- 3.794757843017578,
- 3.3874454498291016,
- 3.7147281169891357,
- 3.586693048477173,
- -2.8868887424468994,
- -3.001088857650757,
- -2.9482247829437256,
- -2.6325371265411377,
- -4.134808540344238,
- -3.772261619567871,
- -4.165527820587158,
- -3.994203805923462,
- -4.163450241088867,
- 3.875136137008667,
- 3.7112133502960205,
- 3.765407085418701,
- -2.4520857334136963,
- -2.657001495361328,
- -2.6662352085113525,
- -2.8774945735931396,
- 3.942436933517456,
- 3.8352348804473877,
- 3.6082088947296143,
- 4.133811950683594,
- -3.171978712081909,
- -3.221795082092285,
- -3.0311388969421387,
- -2.9480156898498535,
- 4.4702277183532715,
- 4.6418352127075195,
- 4.766424655914307,
- 4.669127941131592,
- -3.4734950065612793,
- -3.1584713459014893,
- -3.2440361976623535,
- -3.3585245609283447,
- -2.429314613342285,
- -2.2996301651000977,
- -2.1834332942962646,
- -1.2482850551605225,
- -0.8828672766685486,
- -0.8636268973350525,
- 4.625131607055664,
- 5,
- 4.731442928314209,
- 4.639413356781006,
- 2.726271152496338,
- 2.482100486755371,
- 2.630417823791504,
- 2.613208293914795,
- 2.359410285949707,
- 2.4850215911865234,
- 2.0713677406311035,
- 2.9034955501556396,
- 3.2096197605133057,
- 3.0044784545898438,
- 3.031195640563965,
- 2.8652327060699463,
- 3.303494453430176,
- -0.9179192781448364,
- -1.1669803857803345,
- -1.2644528150558472,
- -1.0285327434539795,
- -0.8682996034622192,
- -1.0111645460128784,
- -1.1425732374191284,
- -0.9068978428840637,
- 1.6444306373596191,
- 1.5535091161727905,
- 1.877994418144226,
- -4.233823299407959,
- -4.286869049072266,
- -4.4695281982421875,
- -4.121842384338379,
- -1.4972978830337524,
- -0.9989351034164429,
- -1.422027349472046,
- -1.2346546649932861,
- -2.2228097915649414,
- -2.000976085662842,
- -2.127882480621338,
- -4.581174373626709,
- -4.083948135375977,
- 2.5844061374664307,
- 2.6696746349334717,
- 2.439190149307251,
- 2.836972236633301,
- 3.768427848815918,
- 3.901214361190796,
- 4.03761625289917,
- 3.712953805923462,
- 3.7559714317321777,
- 3.856983184814453,
- 4.166917324066162,
- -2.2912299633026123,
- -2.089019775390625,
- -1.982771635055542,
- 0.2804890275001526,
- 0.14649292826652527,
- -0.02719704993069172,
- 0.35809698700904846,
- -0.09706947952508926,
- -0.06142881140112877,
- -0.6113005876541138,
- -0.263994425535202,
- 4.316342830657959,
- 4.358631610870361,
- 4.577394962310791,
- 4.1251115798950195,
- 2.637986421585083,
- 2.9547457695007324,
- 2.78865909576416,
- 1.622883915901184,
- 1.6951839923858643,
- 1.6690202951431274,
- 1.4459738731384277,
- 5,
- 1.4305493831634521,
- 1.2514207363128662,
- 1.230926275253296,
- 1.0252352952957153,
- 1.0430431365966797,
- 1.0417221784591675,
- 1.277311086654663,
- 0.8228275179862976,
- -2.6111531257629395,
- -0.8876737952232361,
- -0.6530675888061523,
- -0.8721553087234497,
- -1.1404987573623657,
- -3.7799670696258545,
- -3.7419769763946533,
- -3.7747626304626465,
- -3.765298843383789,
- -1.3552204370498657,
- -1.448533058166504,
- 1.976080060005188,
- 2.3143045902252197,
- 2.006865978240967,
- 4.718459129333496,
- 5,
- 5,
- 5,
- -0.21346406638622284,
- -0.3900603652000427,
- -0.7078602910041809,
- 2.546725273132324,
- 2.2419445514678955,
- 2.62286114692688,
- 2.31475830078125,
- 2.815099000930786,
- 0.17036111652851105,
- 0.35399267077445984,
- 0.22068481147289276,
- 0.5616357326507568,
- 2.168175220489502,
- 2.396758794784546,
- 2.032904624938965,
- 1.9458956718444824,
- 1.672920823097229,
- -1.9237370491027832,
- -1.7913600206375122,
- -2.1189286708831787,
- -4.244471549987793,
- -4.725438117980957,
- -4.62848424911499,
- -4.6635870933532715,
- -4.4014410972595215,
- -0.39015352725982666,
- -3.62326979637146,
- -3.6562275886535645,
- -3.3212900161743164,
- -2.650617837905884,
- -2.9336674213409424,
- -2.5238282680511475,
- -2.854623556137085,
- 3.359579563140869,
- 3.281346321105957,
- 3.4625306129455566,
- -1.6233601570129395,
- -1.4790972471237183,
- 3.500380516052246,
- 4.63165283203125,
- 4.554935932159424,
- 4.720632076263428,
- -0.6211792826652527,
- -0.9868704080581665,
- -0.2744942903518677,
- -0.23266896605491638,
- -0.4965898394584656,
- -0.32649561762809753,
- -1.423138976097107,
- -1.7905021905899048,
- -1.4218405485153198,
- -3.732257604598999,
- -3.5719547271728516,
- -3.941251754760742,
- -3.9911673069000244,
- 2.76228666305542,
- 3.034092664718628,
- 2.5956602096557617,
- 3.0007383823394775,
- -2.4493157863616943,
- 1.5511066913604736,
- 1.313583254814148,
- 0.09208802133798599,
- 0.2716134786605835,
- 0.33897581696510315,
- -2.9448187351226807,
- -3.1763267517089844,
- -2.965965747833252,
- 2.055418014526367,
- 1.7646766901016235,
- 2.0915160179138184,
- 1.9841140508651733,
- 0.7309734225273132,
- 0.8535610437393188,
- 1.1015901565551758,
- 1.1043431758880615,
- -3.231236696243286,
- -3.466428518295288,
- -3.2163987159729004,
- 1.5548237562179565,
- -2.620222806930542,
- -2.8454513549804688,
- -2.381518602371216,
- -1.7730915546417236,
- -2.034778118133545,
- -1.792545199394226,
- 0.23506808280944824,
- 0.15298357605934143,
- -0.12086783349514008,
- -0.0009967255173251033,
- 3.0469939708709717,
- 3.3803346157073975,
- 3.5396389961242676,
- 3.4276304244995117,
- -3.4141626358032227,
- -3.28906512260437,
- -3.1413207054138184,
- -2.9626805782318115,
- -3.5331058502197266,
- -2.7990610599517822,
- -2.5825302600860596,
- 1.0379852056503296,
- 1.3705062866210938,
- 1.090142846107483,
- 1.1630381345748901,
- -0.7285075783729553,
- -0.5913762450218201,
- -0.41392114758491516,
- 0.37851566076278687,
- 0.2083987444639206,
- 0.536102294921875,
- 4.585145950317383,
- 4.314233303070068,
- 4.690446853637695,
- 4.508464336395264,
- 0.5570757389068604,
- 0.7471429109573364,
- 0.8703640103340149,
- 0.735404372215271,
- 1.950286626815796,
- -2.459625482559204,
- -2.3318281173706055,
- -4.318643569946289,
- -2.7759718894958496,
- -2.491568088531494,
- -2.487426280975342,
- 3.034865140914917,
- 1.392642855644226,
- 3.841580390930176,
- -1.7278932332992554,
- -1.9114822149276733,
- -1.5143166780471802,
- -1.7121433019638062,
- 4.3564581871032715,
- 4.085196018218994,
- 4.489546298980713,
- 0.03738686069846153,
- 0.4072064459323883,
- 0.3515777885913849,
- 4.740171909332275,
- 5,
- 5,
- -3.7102108001708984,
- -3.5805227756500244,
- -3.250467300415039,
- -3.6381490230560303,
- -5,
- -4.672852039337158,
- -5,
- -5,
- 3.9007976055145264,
- 4.133395671844482,
- 4.175212860107422,
- 4.236222267150879,
- 1.3414992094039917,
- 1.545016884803772,
- 1.7293202877044678,
- 1.7089415788650513,
- 1.5792618989944458,
- 1.938088297843933,
- -4.447057247161865,
- -4.589023590087891,
- -4.721797943115234,
- -5,
- -4.662319183349609,
- -4.697544574737549,
- -4.536230564117432,
- 5,
- 5,
- 5,
- 2.2066378593444824,
- 1.9319493770599365,
- 2.258507013320923,
- 2.2539353370666504,
- 2.732060194015503,
- -2.9786436557769775,
- -2.8140065670013428,
- -2.7915046215057373,
- -2.627666711807251,
- 0.9115676283836365,
- -0.532065212726593,
- -0.5675407648086548,
- -0.5571060180664062,
- -2.564318895339966,
- -4.4288010597229,
- -4.226881980895996,
- -4.208695411682129,
- -4.0041913986206055,
- -4.3078436851501465,
- -4.320655345916748,
- 2.809098720550537,
- 2.785369634628296,
- 5,
- 4.710524559020996,
- 5,
- 5,
- -4.560494422912598,
- -4.414031982421875,
- -4.710155963897705,
- 0.027450760826468468,
- -0.09511373937129974,
- 0.3111163377761841,
- 4.47791862487793,
- 4.311753749847412,
- 2.278442859649658,
- 2.3220880031585693,
- 1.0773473978042603,
- 0.6730288863182068,
- 1.7689932584762573,
- 1.6555397510528564,
- 1.9800528287887573,
- 2.0714244842529297,
- -0.6446894407272339,
- -0.43192827701568604,
- -3.7548670768737793,
- -3.300417423248291,
- -1.1125221252441406,
- -0.6115882396697998,
- -2.978154420852661,
- -3.3732173442840576,
- -3.242103338241577,
- 1.2596628665924072,
- -3.6130688190460205,
- -3.133923292160034,
- -3.3986732959747314,
- -3.5859854221343994,
- -3.520331621170044,
- -3.851719617843628,
- -3.865055561065674,
- 0.5590431690216064,
- 0.6265019774436951,
- -0.03324676677584648,
- 2.4285573959350586,
- 2.5746889114379883,
- 2.7181601524353027,
- 2.378453016281128,
- 3.447817087173462,
- 2.445730209350586,
- 2.310244083404541,
- 2.6667962074279785,
- -4.695241928100586,
- -5,
- -4.548861980438232,
- -0.33884161710739136,
- -0.5452479720115662,
- -0.44265344738960266,
- -1.2199991941452026,
- -1.154729962348938,
- -0.9447287917137146,
- -0.8053910136222839,
- 3.9948537349700928,
- 3.997985601425171,
- 4.207438945770264,
- 2.2636070251464844,
- 2.816199541091919,
- 3.2298614978790283,
- 3.0754427909851074,
- 3.1898257732391357,
- -2.0362820625305176,
- -1.695935845375061,
- -2.8119935989379883,
- -2.5727436542510986,
- 3.0221409797668457,
- 3.255614995956421,
- 3.368884563446045,
- 3.2635715007781982,
- 4.541206359863281,
- 3.801682472229004,
- 4.062766075134277,
- 3.6565608978271484,
- 2.893397092819214,
- 3.020784378051758,
- 2.637270450592041,
- 2.978060007095337,
- 0.706810474395752,
- 0.7772684097290039,
- 0.8003952503204346,
- -0.22241777181625366,
- -0.1280590295791626,
- -2.9058010578155518,
- -0.3929927349090576,
- -1.6517680883407593,
- 4.374144554138184,
- 4.208742141723633,
- 1.0169200897216797,
- 0.6947392225265503,
- 0.6771532297134399,
- -4.339812278747559,
- 3.8944802284240723,
- 3.9562127590179443,
- 2.033257246017456,
- 1.9155778884887695,
- 1.3438067436218262,
- 1.0825568437576294,
- -1.7339566946029663,
- -1.3611284494400024,
- -1.3337901830673218,
- -1.2508692741394043,
- -2.2653911113739014,
- -2.2419567108154297,
- -3.1367833614349365,
- -1.81843900680542,
- -2.1527793407440186,
- -1.6042685508728027,
- -1.647326946258545,
- 4.628890037536621,
- 4.72548246383667,
- 2.286425828933716,
- 1.9910200834274292,
- 2.3555381298065186,
- 2.0931544303894043,
- 3.7614736557006836,
- 3.912747859954834,
- -4.636204242706299,
- -4.488008499145508,
- 0.4070380926132202,
- -0.13350971043109894,
- 0.19662299752235413,
- 0.13111887872219086,
- -0.7308740019798279,
- -0.5450983643531799,
- -0.6622709035873413,
- 0.003929497674107552,
- 0.24031925201416016,
- -0.22965681552886963,
- -0.0660269558429718,
- -0.17119362950325012,
- -0.18464888632297516,
- -0.0036181053146719933,
- -0.7095974087715149,
- 1.9864104986190796,
- -2.5475826263427734,
- -2.7074756622314453,
- -2.891202926635742,
- -2.509110927581787,
- 2.9578778743743896,
- 3.029849052429199,
- 2.3168818950653076,
- 3.536309242248535,
- 3.2530806064605713,
- -3.741461992263794,
- -2.821955680847168,
- -3.082059383392334,
- -2.9099485874176025,
- -2.7286927700042725,
- -0.6247063279151917,
- -0.3622240722179413,
- -0.4216044247150421,
- 1.6000310182571411,
- 5,
- 5,
- -1.6445059776306152,
- 0.2146318256855011,
- -4.1633453369140625,
- -4.1257829666137695,
- -3.817925214767456,
- -3.784167766571045,
- -1.2936067581176758,
- 1.8930131196975708,
- 1.5624295473098755,
- 1.5452696084976196,
- -1.8079805374145508,
- -1.6008325815200806,
- 1.2422401905059814,
- 1.4802297353744507,
- 1.4433354139328003,
- 1.5805444717407227,
- 0.7913298010826111,
- 2.578340768814087,
- 2.6075079441070557,
- -0.813774585723877,
- -5,
- -5,
- -4.7412261962890625,
- -4.72172212600708,
- 1.3737642765045166,
- 1.2108287811279297,
- 1.3925875425338745,
- 1.4203695058822632,
- 0.5987880825996399,
- -4.71983003616333,
- -5,
- -5,
- -4.692821025848389,
- 1.909011960029602,
- 1.7303102016448975,
- 1.6846473217010498,
- 5,
- -3.5527470111846924,
- 0.37845441699028015,
- -1.9841102361679077,
- 3.145871162414551,
- 1.289706826210022,
- 0.7273845076560974,
- 0.720970630645752,
- 1.0219862461090088,
- 0.8861194849014282,
- -4.596095085144043,
- -4.253779888153076,
- -4.743481159210205,
- -1.5359901189804077,
- 3.121032953262329,
- -4.488008499145508,
- -1.1460216045379639,
- 4.6934332847595215,
- 4.375402450561523,
- 4.680056095123291,
- -4.230134010314941,
- -3.7863848209381104,
- -4.4221673011779785,
- -4.591073989868164,
- 4.1638264656066895,
- 4.340243339538574,
- 4.488320350646973,
- -2.5075998306274414,
- 1.917682409286499,
- 4.661116600036621,
- 4.636397361755371,
- 4.488320350646973,
- 5,
- -3.489121437072754,
- -1.138638973236084,
- -0.7274905443191528,
- -4.574654579162598,
- -4.382515907287598,
- -3.1639509201049805,
- -2.7766637802124023,
- 0.7139411568641663,
- 0.4993683397769928,
- 0.7703021764755249,
- 0.901824951171875,
- -1.5355284214019775,
- -2.1874425411224365,
- -2.3504247665405273,
- -4.327395915985107,
- -2.3662376403808594,
- -3.6765761375427246,
- 1.808962345123291,
- 4.351280689239502,
- 4.706614017486572,
- -3.448230266571045,
- -3.3269059658050537,
- -1.3753197193145752,
- -1.1046783924102783,
- -1.4444420337677002,
- 0.29257264733314514,
- 0.009619895368814468,
- 0.32545214891433716,
- 0.23237977921962738,
- 1.4445356130599976,
- -1.2714718580245972,
- -1.4109042882919312,
- 4.735227108001709,
- -3.157381772994995,
- -5,
- -4.624974727630615,
- 4.58084774017334,
- 4.646906852722168,
- -4.253415107727051,
- -3.6714272499084473,
- -4.048503875732422,
- -3.91367769241333,
- -0.662963330745697,
- -0.45707225799560547,
- -0.3023490607738495,
- -0.10872425138950348,
- -0.40253975987434387,
- -0.7720760107040405,
- -2.228641986846924,
- -2.0955162048339844,
- -1.9311330318450928,
- 4.527668476104736,
- 4.4020185470581055,
- 4.253148078918457,
- 4.159819602966309,
- 0.06420236825942993,
- 4.135446548461914,
- -0.9258043766021729,
- -0.8058002591133118,
- 4.537054061889648,
- 4.744240760803223,
- -0.8789688944816589,
- 0.3651331961154938,
- 0.7293714880943298,
- -0.06956324726343155,
- -0.08140537887811661,
- 1.721306324005127,
- -3.6552634239196777,
- -3.3976213932037354,
- -3.114668607711792,
- -2.9648706912994385,
- -2.7460291385650635,
- 0.9609786868095398,
- 1.0764851570129395,
- -2.625852346420288,
- -2.673210859298706,
- -2.3928139209747314,
- 3.227536678314209,
- 3.531540632247925,
- 3.7912299633026123,
- 3.446416139602661,
- 1.760624647140503,
- 1.2702659368515015,
- 1.4204895496368408,
- 1.1356712579727173,
- 1.1212012767791748,
- -0.7966426014900208,
- -4.596960067749023,
- -2.358410358428955,
- -2.481785297393799,
- -2.317129611968994,
- 2.1517908573150635,
- 1.9424786567687988,
- 4.65165901184082,
- -4.577237129211426,
- 3.162456750869751,
- 3.290433168411255,
- 3.418100118637085,
- -3.9114646911621094,
- 0.9896045327186584,
- -0.19112993776798248,
- 2.6939661502838135,
- 3.0167806148529053,
- 2.893794298171997,
- 3.0206243991851807,
- 1.2407162189483643,
- -0.46050986647605896,
- 5,
- 4.663840293884277,
- 5,
- -3.103480339050293,
- -2.277939558029175,
- -2.125932216644287,
- -1.824216604232788,
- -2.0925588607788086,
- 2.68068528175354,
- -4.7859697341918945,
- -4.575015544891357,
- 2.8520922660827637,
- -3.2595419883728027,
- -4.203586101531982,
- -4.2565202713012695,
- -3.767660140991211,
- -3.32572078704834,
- 0.5733931660652161,
- 0.5859797596931458,
- 0.6658535599708557,
- 4.556863307952881,
- 5,
- 5,
- -2.477255344390869,
- 0.25908347964286804,
- 0.25868678092956543,
- 0.49322885274887085,
- -5,
- -0.1877877414226532,
- -5,
- -5,
- 3.983049154281616,
- -2.6407032012939453,
- 0.5915303230285645,
- 1.0867373943328857,
- -1.214605450630188,
- -1.4895960092544556,
- 2.3244974613189697,
- 1.0752484798431396,
- 3.5134105682373047,
- 3.492990732192993,
- -4.003303050994873,
- -4.055683612823486,
- -4.244694709777832,
- -4.091361999511719,
- 2.220043897628784,
- 2.544774293899536,
- -5,
- 3.5021090507507324,
- 3.226494312286377,
- 1.4538578987121582,
- 0.25620901584625244,
- -4.075596809387207,
- -4.281928539276123,
- -4.1883087158203125,
- -4.555990695953369,
- -4.334146976470947,
- -4.165266990661621,
- 4.628626346588135,
- 4.596282482147217,
- 4.575169086456299,
- -4.123189449310303,
- -3.8626294136047363,
- -3.69762921333313,
- 3.6556200981140137,
- -4.1212477684021,
- -3.785296678543091,
- -1.9285658597946167,
- -3.4919838905334473,
- 5,
- -1.8179099559783936,
- -4.580845355987549,
- -4.697874546051025,
- -4.374136447906494,
- 2.7386975288391113,
- 3.034958839416504,
- 2.8929836750030518,
- 2.8669273853302,
- -5,
- -1.5589079856872559,
- 1.9696201086044312,
- 3.9466171264648438,
- -3.894467353820801,
- -1.4353413581848145,
- 0.6438999772071838,
- -3.559412717819214,
- 2.898449182510376,
- 4.226627349853516,
- -5,
- -5,
- -4.580845355987549,
- -2.0328192710876465,
- 4.1754069328308105,
- 4.199225902557373,
- 4.34015417098999,
- -2.9041290283203125,
- 2.497323513031006,
- -1.7650561332702637,
- -0.5644856095314026,
- -5,
- -5,
- 3.0372588634490967,
- 3.8829185962677,
- 3.6070923805236816,
- 3.8541207313537598,
- 3.8192059993743896,
- -2.6382784843444824,
- -4.700376033782959,
- 2.501884937286377,
- 4.065597057342529,
- 1.0171412229537964,
- 5,
- -4.651655673980713,
- -0.8031032681465149,
- 1.2622673511505127,
- 1.2936519384384155,
- 1.369748592376709,
- 4.189074516296387,
- 4.076688766479492,
- 5,
- 0.7270625233650208,
- 0.995764970779419,
- -0.8975422382354736,
- -1.5903971195220947,
- 3.329392194747925,
- 3.4523019790649414,
- -1.0810967683792114,
- -0.5812257528305054,
- 2.644548177719116,
- 2.6585214138031006,
- 5,
- 3.7732388973236084,
- 0.9950934052467346,
- 0.8841180801391602,
- 3.8183670043945312,
- -0.6460126042366028,
- 2.1103804111480713,
- 2.3608930110931396,
- 1.3835891485214233,
- 3.4795989990234375,
- 1.769286036491394,
- 1.7716087102890015,
- -5,
- -5,
- -5,
- -1.426405906677246,
- -2.7312746047973633,
- -5,
- 0.47139957547187805,
- 3.8471028804779053,
- 0.7896639108657837,
- -1.2268297672271729,
- -4.720064640045166,
- 2.7558088302612305,
- 3.023494243621826,
- 3.7829294204711914,
- -1.891106128692627,
- 3.048088550567627,
- 0.008336871862411499,
- 0.07599930465221405,
- -1.3721232414245605,
- -1.032981276512146,
- -0.6021665930747986,
- 1.735460877418518,
- 1.5383501052856445,
- 2.478435516357422,
- -3.304556131362915,
- -2.378432035446167,
- -0.4857358932495117,
- -2.097623586654663,
- -3.2147445678710938,
- -1.8128300905227661,
- 3.589271306991577,
- 3.373690366744995,
- -3.5193681716918945,
- 3.53788161277771,
- -1.1633410453796387,
- -3.841488838195801,
- -3.562544822692871,
- -5,
- -4.628747463226318,
- -0.3776344060897827,
- -1.9576623439788818,
- -2.3299407958984375,
- -2.3134829998016357,
- 0.5879091620445251,
- 0.39716675877571106,
- 5,
- -4.527527809143066,
- 2.8390586376190186,
- 0.3319953382015228,
- -0.2031165361404419,
- 5,
- 5,
- 5,
- -5,
- 2.2759742736816406,
- 4.30157470703125,
- -0.7995855808258057,
- -0.05464247241616249,
- -1.3260889053344727,
- -1.0919172763824463,
- -1.5666868686676025,
- 0.6270329356193542,
- 2.468057155609131,
- -2.5841712951660156,
- -4.339723110198975,
- 5,
- 5,
- 0.5067524909973145,
- 0.7723978161811829,
- 3.510948657989502,
- 4.363494873046875,
- -3.0252578258514404,
- -1.2719022035598755,
- 4.58084774017334,
- 5,
- 4.526966571807861,
- -5,
- -5,
- -5,
- 5,
- 4.227243900299072,
- 4.085610389709473,
- -4.363025188446045,
- -1.356877088546753,
- -1.0370725393295288,
- 1.1098798513412476,
- -1.7669402360916138,
- 3.0309200286865234,
- 1.8378273248672485,
- -1.0789508819580078,
- 1.8391550779342651,
- 0.4916764497756958,
- -3.601686716079712,
- -0.24966329336166382,
- 4.12544059753418,
- -5,
- -5,
- 1.536503791809082,
- 1.7359037399291992,
- 5,
- -3.840538263320923,
- -5,
- -5,
- -5,
- 4.124938011169434,
- -4.646697998046875,
- -5,
- 4.167131423950195,
- -3.3831329345703125,
- -3.5020036697387695,
- 3.266669988632202,
- -0.9436191916465759,
- -1.5299025774002075,
- -1.982384204864502,
- 3.6774818897247314,
- -2.2120511531829834,
- -0.3448413610458374,
- -3.386986017227173,
- -3.1074790954589844,
- -0.4411892294883728,
- -0.3736647963523865,
- -5,
- -5,
- -1.2011436223983765,
- -1.1121392250061035,
- -2.1613833904266357,
- -2.2924811840057373,
- 3.104656934738159,
- 2.610442638397217,
- 5,
- -5,
- -2.3681676387786865,
- 3.672323226928711,
- 3.7326676845550537,
- 0.1613098382949829,
- 0.2413194328546524,
- 1.3728821277618408,
- 0.4339759051799774,
- 0.35695144534111023,
- -2.493479013442993,
- 2.1896910667419434,
- 4.700502395629883,
- 5,
- -1.016597032546997,
- 0.6210448145866394,
- 0.6637445688247681,
- 5,
- -1.0216628313064575,
- -0.23358485102653503,
- 3.3018922805786133,
- 1.8105369806289673,
- 0.955568790435791,
- -3.7231528759002686,
- -3.9804978370666504,
- -1.2900493144989014,
- 4.1124267578125,
- -3.540820360183716,
- -5,
- -3.8975656032562256,
- 1.2156816720962524,
- 0.7590240836143494,
- 3.5594608783721924,
- -3.283069372177124,
- -5,
- -3.2769768238067627,
- 0.1670776754617691,
- -0.7176233530044556,
- 0.9799598455429077,
- 1.3872452974319458,
- -2.0572428703308105,
- -3.3091535568237305,
- -1.3487980365753174,
- -4.625357627868652,
- -2.012728691101074,
- -5,
- 0.8194661736488342,
- -1.579920768737793,
- -1.5731505155563354,
- -4.639402389526367,
- -1.7494895458221436,
- -3.0217342376708984,
- -1.5556175708770752,
- 2.022423028945923,
- -2.8629543781280518,
- 1.2468470335006714,
- 1.9912384748458862,
- -1.0789836645126343,
- -0.08867280930280685,
- -1.3601857423782349,
- 0.519882321357727,
- 2.222944498062134,
- 0.5680000185966492,
- 2.373995542526245,
- -2.9980807304382324,
- 3.2855708599090576
- ],
- "y": [
- -0.9644528031349182,
- -0.5014916062355042,
- -0.9228641390800476,
- -0.9955595135688782,
- 0.2492223083972931,
- 0.057115908712148666,
- -0.16631139814853668,
- -0.06584170460700989,
- 0.10396039485931396,
- -0.31133314967155457,
- -0.041115161031484604,
- -0.04820563644170761,
- -0.949433445930481,
- -0.8801339268684387,
- -0.5981799364089966,
- -0.9736314415931702,
- -0.43101099133491516,
- -0.4243756830692291,
- -0.4731490910053253,
- -0.6577183604240417,
- 0.2146396040916443,
- 0.5974391102790833,
- 0.2125028818845749,
- 0.43337777256965637,
- 0.4884589910507202,
- 0.6967326402664185,
- 0.6029126048088074,
- 0.23680882155895233,
- 0.6917465329170227,
- 0.4850515127182007,
- 0.18376414477825165,
- 0.48162636160850525,
- -0.6320042610168457,
- -0.7730603814125061,
- -0.9154437184333801,
- -0.9334678649902344,
- -0.937618613243103,
- -0.6324880123138428,
- -0.9645949602127075,
- -0.8584909439086914,
- -0.021662965416908264,
- -0.19917190074920654,
- -0.40617337822914124,
- 0.01375947892665863,
- 0.6443992257118225,
- 0.2646108865737915,
- 0.3110242187976837,
- 0.4987179636955261,
- 0.2822154462337494,
- 0.22283178567886353,
- 0.3027957081794739,
- 0.48568424582481384,
- -0.004136862698942423,
- 0.24444110691547394,
- 0.3975219428539276,
- 0.06679671257734299,
- 0.3392251133918762,
- 0.4178438186645508,
- 0.0005444167763926089,
- 0.26371410489082336,
- 0.6860716342926025,
- 0.5389652252197266,
- 0.2810700237751007,
- 0.29595068097114563,
- -0.0028515858575701714,
- -0.914943516254425,
- -0.8317362070083618,
- -0.5160342454910278,
- 0.1723458170890808,
- -0.24010129272937775,
- 0.11037452518939972,
- -0.04924260079860687,
- 0.9950059056282043,
- 0.5880264043807983,
- 0.590488612651825,
- 0.6281570792198181,
- -0.1020033061504364,
- 0.12514355778694153,
- 0.26880502700805664,
- -0.06841706484556198,
- 0.07446050643920898,
- -0.19104579091072083,
- 0.17392556369304657,
- -0.010952293872833252,
- 0.8551027774810791,
- 0.8424614071846008,
- 0.4966377019882202,
- 0.9818977117538452,
- -0.7847625613212585,
- -0.3964613676071167,
- -0.7274291515350342,
- 0.9931104183197021,
- 0.990178644657135,
- 0.9477092027664185,
- -0.7309668660163879,
- -0.8255475759506226,
- -0.5082603693008423,
- -0.8930004835128784,
- 0.4194926917552948,
- 0.20234280824661255,
- 0.382354199886322,
- 0.04821555316448212,
- -0.22185000777244568,
- -0.2684493958950043,
- -0.2542339563369751,
- -0.6113150715827942,
- -0.749304473400116,
- 0.9967495203018188,
- 0.6226924657821655,
- 0.9509856700897217,
- 0.9614278674125671,
- -0.5285993218421936,
- -0.26093634963035583,
- -0.44633013010025024,
- -0.7162333726882935,
- 0.37243372201919556,
- 0.7037805914878845,
- 0.5981281399726868,
- 0.8595001101493835,
- -0.2422453761100769,
- -0.2717275023460388,
- -0.342314749956131,
- -0.36787569522857666,
- -0.0067490083165466785,
- -0.12062981724739075,
- -0.10932574421167374,
- 0.7730425596237183,
- 0.7197641730308533,
- 0.5498804450035095,
- 0.8838788866996765,
- -0.4682152271270752,
- -0.8429638743400574,
- -0.7152993083000183,
- 0.16587448120117188,
- 0.17635276913642883,
- 0.4282841980457306,
- -0.06333015114068985,
- 0.0034832851961255074,
- 0.09057462960481644,
- -0.7059872150421143,
- -0.3774401545524597,
- -0.6989597082138062,
- -0.5003755688667297,
- 0.7566817402839661,
- 0.44234010577201843,
- 0.45263102650642395,
- 0.5166338682174683,
- 0.16024252772331238,
- 0.5950716137886047,
- -0.18073487281799316,
- 0.0018878098344430327,
- -0.2708609104156494,
- -0.25196877121925354,
- -0.11142797023057938,
- -0.43370550870895386,
- -0.15656259655952454,
- -0.039399806410074234,
- 0.46687936782836914,
- 0.32242169976234436,
- 0.6205798983573914,
- 0.6568413972854614,
- 0.2932124137878418,
- 0.286562442779541,
- 0.5216072797775269,
- -0.9623097777366638,
- -0.9981469511985779,
- -0.6364484429359436,
- -0.9993236660957336,
- -0.07432012259960175,
- 0.42001017928123474,
- 0.34383609890937805,
- -0.08206897974014282,
- 0.17495545744895935,
- -0.6187282204627991,
- -0.17506438493728638,
- -0.16744637489318848,
- -0.3097870349884033,
- -0.4293544590473175,
- -0.34442025423049927,
- -0.08278083801269531,
- 0.040901072323322296,
- -0.20948979258537292,
- -0.8171733617782593,
- -0.6349214315414429,
- -0.63686603307724,
- -0.34542766213417053,
- 0.9818851351737976,
- 0.7231388688087463,
- -0.4980590343475342,
- -0.5276463031768799,
- -0.6645891070365906,
- 0.6138550639152527,
- 0.7307949662208557,
- 0.565581202507019,
- 0.8974766731262207,
- 0.2210589051246643,
- -0.04366305470466614,
- 0.2200208306312561,
- 0.9976720213890076,
- 0.9910743236541748,
- 0.04993176832795143,
- 0.2965986132621765,
- 0.3659362196922302,
- -0.6525683999061584,
- -0.4112653136253357,
- -0.9211462140083313,
- -0.8424838185310364,
- -0.9637735486030579,
- -0.9835269451141357,
- -0.9970294237136841,
- -0.9710226655006409,
- -0.9704429507255554,
- -0.000344896805472672,
- 0.21921929717063904,
- -0.13210053741931915,
- 0.1057116687297821,
- -0.5773980617523193,
- -0.8491992354393005,
- -0.9644528031349182,
- -0.9644528031349182,
- 0.18421055376529694,
- -0.34306600689888,
- -0.6099089980125427,
- -0.522908627986908,
- 0.5520397424697876,
- 0.6777611374855042,
- 0.7900189757347107,
- 0.8836524486541748,
- 0.998988151550293,
- 0.6972864270210266,
- 0.9325829744338989,
- -0.7420949339866638,
- -0.8717162013053894,
- 0.3239639103412628,
- 0.3646659553050995,
- 0.18762114644050598,
- 0.4323038160800934,
- 0.49042609333992004,
- 0.4172574579715729,
- -0.4056946337223053,
- -0.7565715909004211,
- -0.8770694732666016,
- -0.6713137626647949,
- 0.3914759159088135,
- 0.5560338497161865,
- 0.401335746049881,
- 0.6967827081680298,
- 0.5735718011856079,
- 0.9659417867660522,
- 0.4600377678871155,
- -0.7376769781112671,
- -0.7612969279289246,
- -0.8649499416351318,
- -0.9680713415145874,
- -0.07136695086956024,
- 0.08702337741851807,
- -0.0012019457062706351,
- -0.40912172198295593,
- -0.006982382852584124,
- -0.2469279021024704,
- 0.2634161114692688,
- 0.19823867082595825,
- 0.6264614462852478,
- -0.0895332545042038,
- 0.15487948060035706,
- 0.010749834589660168,
- 0.21317049860954285,
- 0.3579390347003937,
- 0.6785242557525635,
- 0.4390743672847748,
- 0.2672802209854126,
- -0.8758218884468079,
- -0.963442862033844,
- -0.9812936782836914,
- 0.47073882818222046,
- 0.4233376085758209,
- 0.6527111530303955,
- 0.6982703804969788,
- 0.6721965670585632,
- 0.9104544520378113,
- 0.8594658970832825,
- 0.9712696671485901,
- 0.7178391218185425,
- 0.9804772734642029,
- 0.9899379014968872,
- -0.272844135761261,
- -0.23376643657684326,
- -0.262163907289505,
- 0.03704443946480751,
- -0.4075758457183838,
- -0.7010478377342224,
- -0.20673303306102753,
- -0.5571584105491638,
- -0.8706849217414856,
- -0.48726165294647217,
- -0.2910931706428528,
- -0.002765015931800008,
- 0.05970108136534691,
- 0.3084672689437866,
- 0.15337669849395752,
- -0.6174674034118652,
- -0.6328142881393433,
- -0.5624826550483704,
- 0.1400715708732605,
- 0.3191937208175659,
- 0.02131892368197441,
- -0.09887219220399857,
- -0.13459566235542297,
- 0.031372569501399994,
- -0.23347316682338715,
- -0.1083475649356842,
- 0.10015857964754105,
- -0.15261906385421753,
- -0.3190996050834656,
- 0.5962103009223938,
- 0.944227933883667,
- 0.6263585686683655,
- -0.03721585124731064,
- -0.14064188301563263,
- -0.12287423759698868,
- 0.1620333045721054,
- 0.051118478178977966,
- 0.025942236185073853,
- 0.9509856700897217,
- 0.07660112529993057,
- -0.2148650735616684,
- -0.2792571783065796,
- -0.3916383981704712,
- -0.5475131869316101,
- -0.3573049306869507,
- -0.5381907820701599,
- 0.5642790794372559,
- 0.39763057231903076,
- 0.4926196038722992,
- 0.6876794695854187,
- 0.9853602051734924,
- 0.9853602051734924,
- 0.2784459888935089,
- 0.33439427614212036,
- 0.3757942020893097,
- 0.5680580735206604,
- -0.202531099319458,
- 0.04602264240384102,
- 0.1253708153963089,
- -0.053822703659534454,
- -0.09523261338472366,
- -0.3647562861442566,
- 0.055967457592487335,
- -0.18043585121631622,
- -0.36183372139930725,
- -0.26616132259368896,
- 0.5843426585197449,
- 0.7874525785446167,
- 0.3204408586025238,
- 0.46942922472953796,
- -0.3549381494522095,
- -0.15470989048480988,
- -0.28662583231925964,
- -0.45677778124809265,
- -0.14482297003269196,
- -0.3699699342250824,
- -0.31996339559555054,
- 0,
- 0.03902474418282509,
- -0.4207833707332611,
- 0.5997176170349121,
- 0.34521904587745667,
- 0.260562002658844,
- 0.301216721534729,
- -0.39678168296813965,
- -0.9933051466941833,
- -0.48806899785995483,
- -0.9801273941993713,
- -0.9932265877723694,
- -0.00268577691167593,
- -0.4860992431640625,
- -0.718903660774231,
- -0.22610677778720856,
- 0.40737977623939514,
- 0.7242735624313354,
- 0.9194390773773193,
- 0.992190957069397,
- 0.5167772769927979,
- -0.8444285988807678,
- -0.6822850704193115,
- 0.6697694063186646,
- 0.9455884695053101,
- -0.563209056854248,
- -0.6827536821365356,
- -0.6466551423072815,
- -1,
- 0.00808846578001976,
- -0.21341004967689514,
- -0.08499597012996674,
- -0.22998903691768646,
- -0.6067743301391602,
- -0.49108201265335083,
- -0.5265984535217285,
- -0.9826362729072571,
- -0.23542766273021698,
- -0.2631172835826874,
- -0.38973894715309143,
- -0.510794460773468,
- 0.614811897277832,
- 0.9284683465957642,
- 0.980880856513977,
- 0.6759928464889526,
- 0.7887943387031555,
- 0.334210067987442,
- 0.8685921430587769,
- 0.9433988928794861,
- 0.3017013370990753,
- 0.322925865650177,
- 0.0030513221863657236,
- -0.08400421589612961,
- 0.1492752730846405,
- 0.15100379288196564,
- 0.2531687021255493,
- 0.22673995792865753,
- 0.08318476378917694,
- -0.09412675350904465,
- -0.10312476009130478,
- 0.00051957240793854,
- 0.1938382387161255,
- -0.429431289434433,
- -0.6668448448181152,
- 0.27889484167099,
- -0.9699349999427795,
- -0.6830593347549438,
- -0.9178845286369324,
- -0.8040575385093689,
- -0.03522491827607155,
- 0.586391270160675,
- 0.9315357804298401,
- 0.7273709177970886,
- 0.23738005757331848,
- 0.16160446405410767,
- 0.196137934923172,
- 0.6648127436637878,
- 0.9904631972312927,
- 0.9321214556694031,
- -0.9826473593711853,
- -0.5793296098709106,
- -0.5139965415000916,
- -0.9829296469688416,
- 0.10490112006664276,
- 0.26333707571029663,
- 0.015549364499747753,
- 0.7950919270515442,
- -0.22844749689102173,
- 0.08410408347845078,
- -0.014554033055901527,
- -0.40973183512687683,
- -0.6088537573814392,
- -0.7200993895530701,
- -0.25975117087364197,
- -0.05376914516091347,
- 0.25696367025375366,
- -0.02727169543504715,
- -0.9200538992881775,
- -0.9851748943328857,
- 0.2039009928703308,
- -0.18674251437187195,
- -0.0373150035738945,
- 0.0003531149122864008,
- 0.7743528485298157,
- 0.49138516187667847,
- 0.8453116416931152,
- 0.8113861680030823,
- -0.2243531048297882,
- 0.17102263867855072,
- 0.13133029639720917,
- -0.8719936609268188,
- -0.7000458240509033,
- -0.5028141736984253,
- 0.5621294975280762,
- -0.48999398946762085,
- 1,
- 0.9576523303985596,
- -0.41538330912590027,
- -0.5296134352684021,
- -0.5272583365440369,
- 0.26668936014175415,
- 0.9760602116584778,
- 0.874788224697113,
- -0.8827227354049683,
- -0.9637153744697571,
- -0.5040878057479858,
- -0.27172648906707764,
- 0.274967223405838,
- -0.01066218875348568,
- 0.29421308636665344,
- 0.1539771407842636,
- 0.15297439694404602,
- 0.35023635625839233,
- -0.21796944737434387,
- 0.8537461161613464,
- 0.9835426211357117,
- 0.9496530294418335,
- 0.9985606074333191,
- -0.2221001833677292,
- 0.4310095012187958,
- 0.6029019355773926,
- 0.7001603841781616,
- 0.8360967636108398,
- 0.519031286239624,
- -0.9936496019363403,
- -0.9828091859817505,
- 0.26668936014175415,
- 0.5236851572990417,
- 0.49962037801742554,
- 0.5692272782325745,
- 0.22008033096790314,
- 0.2918113172054291,
- -0.005608721170574427,
- 0.03870052844285965,
- 0.26892536878585815,
- -0.1814487725496292,
- 0.06543553620576859,
- 0.08210965245962143,
- -0.09493392705917358,
- 0.23452402651309967,
- 0.04021294042468071,
- -0.09652941673994064,
- 0.6716895699501038,
- 0.8282829523086548,
- -0.5790790915489197,
- -0.7159784436225891,
- -0.874889612197876,
- -0.9411375522613525,
- -0.25209754705429077,
- -0.6056337356567383,
- -0.4996890425682068,
- 0.268974632024765,
- 0.4170511066913605,
- 0.2456361949443817,
- 0.17661170661449432,
- -0.6461558938026428,
- -0.8366621732711792,
- -0.9373155832290649,
- 0.6573933362960815,
- 0.764940083026886,
- 0.4581672251224518,
- 0.012059792876243591,
- -0.36481741070747375,
- 0.047285694628953934,
- -0.19150404632091522,
- -0.06492480635643005,
- 0.2849947214126587,
- 0.49767422676086426,
- 0.28277072310447693,
- 0.54390949010849,
- 0.1638433039188385,
- -0.31062552332878113,
- -0.08801092207431793,
- -0.47230759263038635,
- -0.2938145399093628,
- -0.0704847201704979,
- 0.6260424852371216,
- 0.39466437697410583,
- 0.31425905227661133,
- 0.7220942974090576,
- -0.7903173565864563,
- 0.2835279703140259,
- 0.6021785140037537,
- 0.5951641798019409,
- 0.3522506654262543,
- 0.5202761888504028,
- 0.6336329579353333,
- 0.44877156615257263,
- 0.5989428758621216,
- 0.9741127490997314,
- 0.9952908158302307,
- 0.6856418251991272,
- -0.18962796032428741,
- 0.14198823273181915,
- 0.027870045974850655,
- -0.2665543556213379,
- -0.12062981724739075,
- -0.35000452399253845,
- -0.6031556725502014,
- -0.7968862652778625,
- -0.9509775042533875,
- 0.2576938569545746,
- -0.17726917564868927,
- 0.9844260215759277,
- -0.4435259699821472,
- -0.1699523627758026,
- 0.6966899037361145,
- 0.9935153722763062,
- 0.994518518447876,
- 0.9067777991294861,
- -0.9979760646820068,
- -0.9827584624290466,
- -0.01198972761631012,
- 0.004887382499873638,
- 0.9262871146202087,
- -0.011220625601708889,
- 0.20926238596439362,
- 0.08175507932901382,
- 0.13949643075466156,
- 0.24324852228164673,
- 0.2432398945093155,
- -0.03161051869392395,
- 0.41032442450523376,
- 0.5218767523765564,
- -0.1977277398109436,
- 0.07446050643920898,
- -0.20594902336597443,
- -0.3251917064189911,
- -0.6149249076843262,
- 0.4732542634010315,
- 0.07446050643920898,
- 0.3481038212776184,
- 0.22188933193683624,
- 0.2149362415075302,
- -0.24006293714046478,
- -0.2876802384853363,
- 0.41702282428741455,
- 0.19047819077968597,
- -0.2501949965953827,
- -0.15160758793354034,
- 0.43379339575767517,
- 0.0909355953335762,
- 0.451621413230896,
- 0.5065004825592041,
- -0.9908729195594788,
- -0.08206022530794144,
- -0.027877792716026306,
- 0.5542229413986206,
- -0.38842886686325073,
- 0.9741654992103577,
- -0.3724351227283478,
- -0.1986246407032013,
- -0.3232215344905853,
- 0.7665350437164307,
- 0.5796975493431091,
- -0.6754114627838135,
- -0.8743530511856079,
- -0.8580234050750732,
- 0.7657902240753174,
- 0.6770547032356262,
- 0.5566800236701965,
- 0.935212254524231,
- -0.584112286567688,
- 0.017612561583518982,
- -0.36803585290908813,
- -0.5247402191162109,
- 0.4970661997795105,
- -0.6998907327651978,
- -0.5846438407897949,
- 0.9509856700897217,
- 0.8254937529563904,
- 0.6614059805870056,
- 0.5184406042098999,
- -0.5043556690216064,
- -0.8817981481552124,
- -0.6980621218681335,
- -0.3875381350517273,
- -0.9762217998504639,
- -0.9982428550720215,
- 0.2067089080810547,
- 0.11346746981143951,
- 0.01595616154372692,
- -0.2828061878681183,
- 0.014170551672577858,
- 0.6205798983573914,
- -0.8973569869995117,
- -0.7388009428977966,
- -0.5494065880775452,
- -0.8166348338127136,
- 0.5313565731048584,
- -0.004518178757280111,
- 0.48383238911628723,
- -0.4977671205997467,
- -0.11393170058727264,
- -0.1845625638961792,
- -0.3601009249687195,
- -0.314405232667923,
- 0.48286524415016174,
- 0.20714795589447021,
- 0.040663253515958786,
- -0.9531037211418152,
- -0.26953038573265076,
- -0.4040994942188263,
- -0.26528051495552063,
- 0.23274151980876923,
- -0.6318374872207642,
- -0.9665676951408386,
- 0.005913611501455307,
- 0.49386274814605713,
- 0.23279796540737152,
- 0.24144552648067474,
- 0.3414899408817291,
- 0.30328240990638733,
- -0.9941494464874268,
- -0.3179697096347809,
- -0.25289952754974365,
- -0.4826950430870056,
- -0.992070198059082,
- -0.9115789532661438,
- -0.5940829515457153,
- -0.5463100671768188,
- -0.9485341310501099,
- -0.6519872546195984,
- -0.9987034797668457,
- -0.5913269519805908,
- -0.7342608571052551,
- 1,
- 0.45685240626335144,
- -0.0836566612124443,
- -0.5427722334861755,
- -0.2221001833677292,
- -0.9979760646820068,
- -0.7426897883415222,
- 0.4536954462528229,
- -0.5354653596878052,
- -0.5605345368385315,
- -0.24477224051952362,
- -0.31265220046043396,
- -0.8582495450973511,
- -0.2184845358133316,
- -0.8255475759506226,
- -0.8973569869995117,
- -0.9509775042533875,
- 0.7109987735748291,
- -0.3486618995666504,
- -0.5666218400001526,
- 0.0820944681763649,
- 0.28015971183776855,
- -0.9690587520599365,
- -0.6733459830284119,
- -0.929873526096344,
- 0.05627104640007019,
- -0.5349896550178528,
- -0.49556639790534973,
- -0.2316868156194687,
- -0.2666398584842682,
- -0.5846438407897949,
- 0.9041470885276794,
- 0.34881946444511414,
- 0.73880535364151,
- -0.4977671205997467,
- -0.620514452457428,
- 0.3705782890319824,
- -0.3981460928916931,
- -0.7447241544723511,
- -0.5671089291572571,
- -0.7126420140266418,
- 0.3201524019241333,
- -0.9361801147460938,
- -0.021949056535959244,
- 0.26071488857269287,
- 0.11704500019550323,
- -0.09812191873788834,
- -0.6564890742301941,
- 0.5860076546669006,
- 0.23305492103099823,
- 0.1070864275097847,
- 0.02329915389418602,
- -0.2407625913619995,
- 0.3414646089076996,
- 0.6114945411682129,
- 0.0007608749438077211,
- -0.18877489864826202,
- -0.06473154574632645,
- -0.5393319725990295,
- -0.37636464834213257,
- -0.2776724100112915,
- 0.407381534576416,
- 0.5711175799369812,
- 0.10242214798927307,
- -0.5774988532066345,
- 0.5009621977806091,
- 0.7229906320571899,
- 0.5307389497756958,
- 0.8771102428436279,
- -0.6564419269561768,
- -0.41044551134109497,
- -0.6564419269561768,
- -0.7309668660163879,
- -0.9828091859817505,
- -0.9828091859817505,
- -0.31996339559555054,
- 0.02778959460556507,
- -0.18145851790905,
- -0.4760945737361908,
- -0.6159340143203735,
- -0.5961918830871582,
- -0.6848282217979431,
- -0.251895934343338,
- 0.29486724734306335,
- 0.40002304315567017,
- 0.9899379014968872,
- 0.7229412794113159,
- 0.9807852506637573,
- -0.7337335348129272,
- -0.8108888864517212,
- -0.5162743926048279,
- -0.6094732284545898,
- -0.9194790720939636,
- 0.5308945178985596,
- 0.01500244252383709,
- -0.7993972897529602,
- 0.9984241127967834,
- -0.012843931093811989,
- -0.8668404221534729,
- 0.990543007850647,
- 0.0920555591583252,
- -0.31916898488998413,
- 0.9374285340309143,
- 0.7959373593330383,
- 0.8754876255989075,
- -0.8362293243408203,
- -0.6582773923873901,
- -0.9916395545005798,
- -0.8973569869995117,
- 0.061656251549720764,
- 0.5361354351043701,
- 0.36971715092658997,
- -0.4583832919597626,
- -0.46862149238586426,
- -0.9807852506637573,
- -0.9511585831642151,
- -0.27999889850616455,
- 0.038460005074739456,
- 0.1938815712928772,
- 0.19310392439365387,
- 0.5270761847496033,
- 0.5389652252197266,
- -0.5263717770576477,
- 0.31121960282325745,
- 0.13053779304027557,
- 0.2712872624397278,
- 0.9807852506637573,
- -0.97075355052948,
- 0.9580817818641663,
- 0.7310782670974731,
- 0.5388161540031433,
- 0.9519411325454712,
- 0.8434329628944397,
- -0.4833066761493683,
- -0.20707954466342926,
- -0.5099445581436157,
- -0.6608012318611145,
- -0.018839603289961815,
- -0.7309668660163879,
- -0.5254232883453369,
- 0.3551715314388275,
- -0.21630725264549255,
- -0.39276570081710815,
- -0.07621423900127411,
- 0.02646898478269577,
- 0.3646659553050995,
- 0.8563774824142456,
- 0.5865227580070496,
- 0.46233615279197693,
- 0.8343841433525085,
- -0.8973569869995117,
- -0.5947028398513794,
- -0.8064454793930054,
- 0.570570170879364,
- 0.5161767601966858,
- 0.48175233602523804,
- 0.4885003864765167,
- -0.38643592596054077,
- -0.4773034155368805,
- -0.38785600662231445,
- 0.8576608896255493,
- -0.9899351596832275,
- 0.9875081777572632,
- -0.1636705994606018,
- -0.9172571897506714,
- -0.16427050530910492,
- -0.4349454939365387,
- -0.9953550100326538,
- -0.9971668124198914,
- 0.6962160468101501,
- 0.5453452467918396,
- -0.05568347126245499,
- -0.6601232290267944,
- -0.842789351940155,
- -0.2496166080236435,
- -0.8420789837837219,
- -0.8744059801101685,
- -0.834104597568512,
- -0.9026780724525452,
- 0.9523860216140747,
- 0.9934259653091431,
- -0.7173683643341064,
- -0.9974165558815002,
- 0.3086850345134735,
- -0.8398857116699219,
- -0.2520681619644165,
- -0.2881055772304535,
- -0.17640793323516846,
- -0.8340798020362854,
- 0.803859293460846,
- -0.5375675559043884,
- -0.35286054015159607,
- -0.40147092938423157,
- -0.5391048192977905,
- -0.4075758457183838,
- -0.06929513067007065,
- 0.4999752938747406,
- 0.5083998441696167,
- 0.7683452367782593,
- 0.44873738288879395,
- 0.1870150864124298,
- 0.44929590821266174,
- 0.7604588270187378,
- -0.253332257270813,
- 0.7990961074829102,
- -0.4588089883327484,
- -0.36481741070747375,
- -0.2928994297981262,
- -0.620514452457428,
- -0.8754743337631226,
- -0.6474624276161194,
- -0.7147241830825806,
- -0.8206048011779785,
- 0.8667620420455933,
- 0.8917268514633179,
- 0.9518074989318848,
- -0.5455569624900818,
- 0.06518997251987457,
- -0.1746850311756134,
- 0.711083710193634,
- -0.7957763075828552,
- -0.23037903010845184,
- 0.4979412853717804,
- -0.9531556367874146,
- -0.9841888546943665,
- 0.04183444380760193,
- 0.8254937529563904,
- 0.9814017415046692,
- -0.5506122708320618,
- 0.9509856700897217,
- 0.8974766731262207,
- 0.8271036744117737,
- 0.6565945744514465,
- 0.5882179737091064,
- 0.4074084758758545,
- 0.1779918372631073,
- 0.8254937529563904,
- 0.3646659553050995,
- 0.6998251676559448,
- -0.25461456179618835,
- -0.16163697838783264,
- 0.5031144618988037,
- 0.056570108979940414,
- 0.4599801003932953,
- 0.22676178812980652,
- -0.27921000123023987,
- -0.5993555784225464,
- 0.9872598648071289,
- -0.1492013782262802,
- -0.11010982096195221,
- 0.08578278124332428,
- -0.176510289311409,
- 0.12077020108699799,
- -0.08411595970392227,
- 0.9915391802787781,
- 0.7307949662208557,
- 0.8754876255989075,
- -0.2441762387752533,
- -0.14552778005599976,
- -0.2168065309524536,
- -0.4977671205997467,
- 0.6998251676559448,
- 0.5844343304634094,
- -0.4977671205997467,
- -0.5964337587356567,
- 0.16315852105617523,
- 0.7636315226554871,
- 0.265627384185791,
- 0.9430791139602661,
- 0.6161730289459229,
- 0.9977315664291382,
- 0.9039280414581299,
- -0.06703191250562668,
- 0.4994438886642456,
- 0.4858933091163635,
- 0.9834839701652527,
- 0.880670964717865,
- 0.8490715026855469,
- 0.9645264744758606,
- -0.9836878776550293,
- 0.020235415548086166,
- 0.6966110467910767,
- 0.9339800477027893,
- 0.5601944327354431,
- -0.00601609330624342,
- 0.22188933193683624,
- 0.06982731819152832,
- 0.42058631777763367,
- -0.20701900124549866,
- -0.5002540349960327,
- -0.9948720335960388,
- -0.6225435733795166,
- 0.29936158657073975,
- -0.9993430376052856,
- -0.8705465197563171,
- 0.9978688955307007,
- 0.9816693663597107,
- -0.2221001833677292,
- -0.07432012259960175,
- 0.005510379560291767,
- 0.93561190366745,
- 0.769040584564209,
- 0.4979412853717804,
- 0.09552592039108276,
- -0.4952143132686615,
- 0.8628236055374146,
- 0.891992449760437,
- 0.3251786231994629,
- -0.9622695446014404,
- -0.9051315188407898,
- 0.6972473859786987,
- -0.9227719902992249,
- -0.9991018772125244,
- 0.9954250454902649,
- -0.2867448031902313,
- 0.40268635749816895,
- 0.14126500487327576,
- 0.9529435634613037,
- 0.6507450938224792,
- 0.27342158555984497,
- -0.9639715552330017,
- -0.971455454826355,
- 0.9434934258460999,
- 0.7417119145393372,
- 0.922407329082489,
- 0.7960216403007507,
- 0.39301806688308716,
- 0.44151046872138977,
- 0.9164034128189087,
- -0.45337846875190735,
- -0.7604051232337952,
- -0.9881238341331482,
- 0.3329641819000244,
- 0.5564926266670227,
- -0.7899213433265686,
- 0.7021987438201904,
- -0.9409090876579285,
- 0.8222968578338623,
- -0.1262354850769043,
- 0.9899379014968872,
- 0.8101232051849365,
- 0.4139884412288666,
- 0.4850161373615265,
- 0.8455127477645874,
- -0.7117887139320374,
- -0.9599732160568237,
- 0.32545220851898193,
- -0.017274606972932816,
- 0.0917535200715065,
- 0.9274268746376038,
- 0.7069732546806335
- ],
- "z": [
- 0.24893133342266083,
- 0.06961314380168915,
- 0.38458311557769775,
- 0.045085154473781586,
- -0.2524856626987457,
- -0.6164182424545288,
- -0.4557993710041046,
- -0.09390309453010559,
- -0.6660021543502808,
- -0.5890951156616211,
- -0.9959505200386047,
- -0.6060599088668823,
- -0.298443466424942,
- -0.4645257592201233,
- -0.23048292100429535,
- -0.21867342293262482,
- -0.31317806243896484,
- 0.07732536643743515,
- -0.3414348065853119,
- -0.05248579755425453,
- -0.10382933914661407,
- -0.019813725724816322,
- 0.2175561636686325,
- 0.13014905154705048,
- 0.40530869364738464,
- 0.7156205773353577,
- 0.7926167249679565,
- 0.4570474326610565,
- -0.13187628984451294,
- 0.12653519213199615,
- -0.22819986939430237,
- -0.3281902074813843,
- 0.28013405203819275,
- 0.6267420649528503,
- 0.39846572279930115,
- 0.3510749340057373,
- -0.33739176392555237,
- -0.18817365169525146,
- -0.24846261739730835,
- -0.5050169229507446,
- -0.5259588956832886,
- -0.26771974563598633,
- -0.446445107460022,
- -0.248659148812294,
- 0.24804984033107758,
- 0.18279309570789337,
- 0.03786000609397888,
- -0.07831154018640518,
- -0.20537401735782623,
- 0.22865191102027893,
- 0.03590712696313858,
- 0.0510106198489666,
- -0.5112490653991699,
- -0.4819660484790802,
- -0.5647855401039124,
- -0.9934210777282715,
- -0.9370624423027039,
- -0.3811916410923004,
- -0.5316653251647949,
- -0.5263366103172302,
- -0.7243698835372925,
- -0.8403451442718506,
- -0.5899010300636292,
- -0.9501896500587463,
- -0.9997191429138184,
- 0.3994015157222748,
- 0.5550714731216431,
- 0.1366790235042572,
- 0.33598801493644714,
- 0.49225300550460815,
- 0.6483957171440125,
- 0.3165377676486969,
- 0.05070596933364868,
- 0.3658945858478546,
- 0.07349245995283127,
- 0.02135220356285572,
- 0.9899535775184631,
- 0.6588714122772217,
- 0.9584241509437561,
- 0.7039474248886108,
- 0.9926663041114807,
- 0.5769069790840149,
- 0.6764622330665588,
- 0.998921275138855,
- 0.5113556385040283,
- 0.5350059866905212,
- 0.4005412459373474,
- 0.18379539251327515,
- -0.6124829649925232,
- -0.916515052318573,
- -0.6823439002037048,
- 0.06995134800672531,
- -0.09971776604652405,
- 0.30412760376930237,
- -0.678033173084259,
- -0.5627862811088562,
- -0.42405495047569275,
- -0.4404540956020355,
- -0.22640195488929749,
- -0.2587750554084778,
- -0.5708564519882202,
- -0.5173807144165039,
- -0.9726678133010864,
- -0.6065524220466614,
- -0.9628442525863647,
- -0.060457516461610794,
- 0.07383366674184799,
- 0.033002905547618866,
- -0.26771634817123413,
- -0.29332637786865234,
- -0.2589031755924225,
- 0.4012563228607178,
- 0.6697467565536499,
- 0.37911468744277954,
- 0.6959860324859619,
- -0.3439806401729584,
- -0.709836483001709,
- -0.36161622405052185,
- -0.5031288266181946,
- -0.37700721621513367,
- -0.027168434113264084,
- 0.1186046227812767,
- 0.9283714294433594,
- 0.6873116493225098,
- 0.9881190061569214,
- 0.9892323613166809,
- 0.6267638206481934,
- 0.6916837096214294,
- 0.3116864562034607,
- 0.45751941204071045,
- -0.30098357796669006,
- -0.5340659618377686,
- -0.070583276450634,
- 0.9836627840995789,
- 0.9826307892799377,
- 0.2885918915271759,
- 0.23875781893730164,
- -0.0010253038490191102,
- -0.01305148471146822,
- -0.7080255746841431,
- -0.5416524410247803,
- -0.7137928605079651,
- -0.8609718084335327,
- -0.6466995477676392,
- -0.22543102502822876,
- -0.46304792165756226,
- 0.40055951476097107,
- 0.5511629581451416,
- 0.4643996059894562,
- -0.24696844816207886,
- 0.0023746946826577187,
- -0.121971994638443,
- 0.09900698065757751,
- 0.24953289330005646,
- 0.22445939481258392,
- 0.10599268972873688,
- -0.02011456899344921,
- 0.4988115429878235,
- 0.9421597123146057,
- 0.7781175374984741,
- 0.7483584880828857,
- -0.9510202407836914,
- -0.5498870611190796,
- -0.8496232032775879,
- -0.25599583983421326,
- -0.018814457580447197,
- 0.0450722798705101,
- 0.006867034826427698,
- 0.9926801323890686,
- -0.33451950550079346,
- -0.6014363765716553,
- -0.3249167501926422,
- -0.42981573939323425,
- -0.7796371579170227,
- -0.6329610347747803,
- -0.9835079908370972,
- -0.9459924101829529,
- -0.5039926767349243,
- -0.4338308274745941,
- -0.25865885615348816,
- -0.6047350168228149,
- -0.20979124307632446,
- 0.5729902386665344,
- 0.7663477659225464,
- 0.29461243748664856,
- 0.5809187293052673,
- -0.18392319977283478,
- 0.020668039098381996,
- -0.27200955152511597,
- 0.03924412652850151,
- 0.0195060633122921,
- 0.3324436545372009,
- 0.6782426834106445,
- 0.17382746934890747,
- 0.4320796728134155,
- 0.20146599411964417,
- 0.37333109974861145,
- 0.5286331176757812,
- -0.02363656461238861,
- -0.0906238928437233,
- 0.5550857782363892,
- 0.5451454520225525,
- 0.5945549011230469,
- -0.7518652677536011,
- -0.5248426795005798,
- -0.387797087430954,
- -0.5349641442298889,
- -0.25117042660713196,
- 0.1672535389661789,
- -0.030160700902342796,
- 0.2272733896970749,
- 0.22918443381786346,
- 0.0007958645583130419,
- -0.47246626019477844,
- -0.26326435804367065,
- -0.2667330503463745,
- 0.2950707972049713,
- 0.5224003791809082,
- 0.24893133342266083,
- 0.24893133342266083,
- -0.3438313901424408,
- 0.2669813930988312,
- -0.05906572937965393,
- 0.3875717222690582,
- 0.2657814919948578,
- 0.7311900854110718,
- 0.6060779690742493,
- 0.45794302225112915,
- -0.010273333638906479,
- 0.1575591117143631,
- 0.3539920449256897,
- -0.6644736528396606,
- -0.48027414083480835,
- -0.9416919350624084,
- 0.9293450713157654,
- 0.4946977198123932,
- 0.5810832977294922,
- 0.8662898540496826,
- 0.9053993225097656,
- 0.5155513882637024,
- 0.6468337774276733,
- 0.4702588617801666,
- 0.11277738958597183,
- -0.048379454761743546,
- -0.2031347006559372,
- -0.4603961706161499,
- -0.1806602030992508,
- 0.10649269074201584,
- 0.24402277171611786,
- 0.22087182104587555,
- 0.6698569059371948,
- 0.6410759091377258,
- 0.4929329752922058,
- 0.23700262606143951,
- -0.37436285614967346,
- -0.2582411468029022,
- 0.000663433806039393,
- -0.9097479581832886,
- -0.6664299368858337,
- -0.9650605320930481,
- 0.4332942068576813,
- 0.19210495054721832,
- 0.2930695116519928,
- 0.23533089458942413,
- 0.6286520957946777,
- 0.6442918181419373,
- 0.34618571400642395,
- -0.006241363473236561,
- 0.1833106428384781,
- 0.29168185591697693,
- -0.002174111781641841,
- 0.47259294986724854,
- 0.25226056575775146,
- 0.1899283230304718,
- 0.1295872926712036,
- -0.14776815474033356,
- -0.007787336595356464,
- 0.1263086497783661,
- 0.15495635569095612,
- 0.40780001878738403,
- 0.5031928420066833,
- 0.22645917534828186,
- 0.04210563376545906,
- 0.1961057186126709,
- -0.10216209292411804,
- 0.28054866194725037,
- 0.4921416640281677,
- 0.18888798356056213,
- 0.29682838916778564,
- 0.9105742573738098,
- 0.7120792269706726,
- 0.46320977807044983,
- 0.830166220664978,
- 0.48220357298851013,
- -0.8679813146591187,
- -0.9516631364822388,
- 0.47452154755592346,
- 0.7259277701377869,
- 0.6084266901016235,
- 0.9848937392234802,
- -0.23830050230026245,
- -0.76807701587677,
- -0.44848307967185974,
- -0.24442195892333984,
- 0.0057609472423791885,
- 0.04943608120083809,
- -0.038206059485673904,
- -0.20376498997211456,
- -0.33428671956062317,
- -0.4373824894428253,
- -0.42244595289230347,
- -0.6520264744758606,
- -0.36086952686309814,
- -0.6188114285469055,
- 0.1818607598543167,
- -0.31560376286506653,
- -0.2107848972082138,
- -0.6734336614608765,
- 0.9861479997634888,
- 0.9878979325294495,
- 0.9840410947799683,
- 0.34084373712539673,
- -0.6104958653450012,
- 0.29332637786865234,
- 0.6329606175422668,
- 0.4734562635421753,
- 0.6387461423873901,
- 0.9190930128097534,
- -0.34333351254463196,
- -0.19907696545124054,
- -0.007516813464462757,
- 0.35606294870376587,
- 0.5664986968040466,
- 0.2380324900150299,
- 0.02087165042757988,
- 0.1486402451992035,
- -0.1486402451992035,
- -0.5884139537811279,
- -0.24894261360168457,
- -0.5900663137435913,
- -0.4645562767982483,
- 0.22966508567333221,
- 0.30052053928375244,
- 0.25223761796951294,
- 0.4725068509578705,
- 0.9906204342842102,
- 0.53376704454422,
- 0.5839667320251465,
- 0.9822286367416382,
- -0.5414755940437317,
- -0.959226131439209,
- -0.8078566789627075,
- -0.6092051267623901,
- -0.634707510471344,
- -0.5340558290481567,
- 0.20579388737678528,
- 0.5619252324104309,
- 0.020743170753121376,
- -0.8842752575874329,
- -0.9857361912727356,
- -0.5279218554496765,
- -0.9429054260253906,
- 0,
- -0.4684806168079376,
- -0.21044278144836426,
- -0.7952387928962708,
- -0.9352442026138306,
- -0.9609246850013733,
- -0.4732184112071991,
- 0.23765499889850616,
- -0.0679740384221077,
- -0.14824911952018738,
- 0.19725912809371948,
- -0.06877187639474869,
- -0.07851611077785492,
- 0.8686026334762573,
- 0.6927322745323181,
- 0.6234987378120422,
- 0.5488587021827698,
- -0.19145558774471283,
- -0.3909909725189209,
- -0.07928632199764252,
- -0.3109854459762573,
- 0.5313256978988647,
- 0.03555777668952942,
- 0.0490003265440464,
- 0.31111860275268555,
- 0.10442136228084564,
- 0.17511685192584991,
- -0.11836609244346619,
- 0,
- -0.01821127161383629,
- -0.3708040714263916,
- -0.2981916069984436,
- -0.46162664890289307,
- -0.1726837307214737,
- -0.123359814286232,
- 0.4126456081867218,
- 0.17629684507846832,
- 0.43020865321159363,
- -0.16406390070915222,
- -0.29134809970855713,
- -0.3465260863304138,
- -0.1638673096895218,
- -0.36755621433258057,
- -0.19412018358707428,
- -0.2797713577747345,
- 0.6075701713562012,
- 0.654580295085907,
- -0.4861188530921936,
- -0.31833672523498535,
- -0.5780981779098511,
- -0.6000235080718994,
- -0.004480898380279541,
- 0.06860040128231049,
- -0.24482126533985138,
- 0.28688132762908936,
- -0.9631673693656921,
- -0.971184492111206,
- -0.5911328792572021,
- -0.9907293319702148,
- 0.5847785472869873,
- 0.9999487996101379,
- 0.5352766513824463,
- -0.8988922834396362,
- -0.7401489019393921,
- 0.9553634524345398,
- -0.23085886240005493,
- -0.11746350675821304,
- -0.3938993215560913,
- -0.5889719724655151,
- -0.2792058289051056,
- -0.3732108473777771,
- -0.3574441075325012,
- -0.6824148297309875,
- -0.22026440501213074,
- -0.5700737833976746,
- -0.5176344513893127,
- 0.12050525844097137,
- -0.09682867676019669,
- -0.35551348328590393,
- -0.17618408799171448,
- -0.2755252420902252,
- 0.04571164771914482,
- -0.17331843078136444,
- -0.9896681308746338,
- -0.6911693215370178,
- -0.5965977907180786,
- -0.5998966097831726,
- -0.9706664681434631,
- -0.9917164444923401,
- -0.6897068619728088,
- -0.9094218611717224,
- 0.78774094581604,
- 0.6912752389907837,
- 0.0785423144698143,
- 0.016106540337204933,
- -0.22879524528980255,
- 0.013991397805511951,
- -0.38984066247940063,
- -0.15052154660224915,
- -0.5829851031303406,
- -0.23330901563167572,
- 0.059916771948337555,
- 0.0003111835103482008,
- 0.6251672506332397,
- 0.31113284826278687,
- 0.5296736359596252,
- -0.5800420045852661,
- 0.5752048492431641,
- 0.6355389952659607,
- 0.25313037633895874,
- -0.47975510358810425,
- -0.7129015326499939,
- 0.2674548923969269,
- -0.20113208889961243,
- 0.3797936737537384,
- 1.1691379777549558e-15,
- -0.2713494598865509,
- 0.40313920378685,
- 0.845343828201294,
- 0.39367449283599854,
- -0.9590659737586975,
- -0.2106667459011078,
- -0.47452685236930847,
- -0.4596824049949646,
- -0.25136223435401917,
- 0.15601640939712524,
- 0.08271649479866028,
- 0.9565548896789551,
- 0.7303852438926697,
- 0.6288405656814575,
- 0.9848345518112183,
- -0.09036430716514587,
- -0.42064154148101807,
- -0.9738449454307556,
- -0.5138938426971436,
- -0.16709473729133606,
- -0.2977195680141449,
- 0.014614290557801723,
- 0.9725919365882874,
- -0.593136191368103,
- 0.7926254868507385,
- 0.7128075361251831,
- 0.5469134449958801,
- 0.4639262855052948,
- -0.06447644531726837,
- 0.17454104125499725,
- -0.9590659737586975,
- -0.8485125303268433,
- -0.8613754510879517,
- -0.8202615976333618,
- -0.9732046723365784,
- -0.44705015420913696,
- -0.9994475841522217,
- -0.7387363910675049,
- -0.9583876729011536,
- 0.5713192224502563,
- 0.6820598244667053,
- 0.6784961819648743,
- 0.9906498193740845,
- -0.9688231945037842,
- -0.6363033056259155,
- -0.9904927015304565,
- -0.09575266391038895,
- -0.5594531893730164,
- 0.3919374942779541,
- 0.6962965726852417,
- 0.4743371605873108,
- 0.32579144835472107,
- -0.036251384764909744,
- 0.30545035004615784,
- -0.3993871510028839,
- -0.16404372453689575,
- -0.05687348172068596,
- 0.06529530882835388,
- -0.2403002232313156,
- -0.21965867280960083,
- -0.5458555817604065,
- -0.33839061856269836,
- -0.7479055523872375,
- -0.6366367340087891,
- -0.8835325837135315,
- -0.998812198638916,
- 0.9292991161346436,
- 0.5906811952590942,
- 0.1568344235420227,
- 0.329791784286499,
- 0.6214436292648315,
- 0.8624156713485718,
- 0.9541876912117004,
- 0.8377023935317993,
- 0.16098438203334808,
- 0.5198801755905151,
- 0.4614923894405365,
- 0.4828778803348541,
- -0.4090541899204254,
- -0.6571433544158936,
- 0.7736345529556274,
- 0.9174755811691284,
- 0.5050711035728455,
- 0.6888444423675537,
- -0.6057143807411194,
- 0.9539580345153809,
- 0.7932191491127014,
- 0.3558451235294342,
- -0.294318825006485,
- -0.43747037649154663,
- -0.2859049141407013,
- -0.5471164584159851,
- 0.3661544919013977,
- 0.21708662807941437,
- 0.047813039273023605,
- -0.10936380922794342,
- -0.9813233017921448,
- 0.6716124415397644,
- 0.9972550272941589,
- 0.9591069221496582,
- 0.9881190061569214,
- -0.5873571634292603,
- -0.7924172282218933,
- -0.597710132598877,
- -0.2933533787727356,
- 0.6591892242431641,
- 0.982540488243103,
- 0.15812546014785767,
- 0.5574328303337097,
- 0.3088320791721344,
- -0.15484392642974854,
- 0.06583964824676514,
- 0.0556543804705143,
- -0.41467854380607605,
- -0.020549282431602478,
- -0.17505614459514618,
- -0.6844256520271301,
- -0.14388316869735718,
- 0.37474673986434937,
- -0.9988948702812195,
- -0.18562301993370056,
- 0.21414516866207123,
- 0.1545124351978302,
- -0.0718170553445816,
- 0.09742579609155655,
- 0.2770216763019562,
- -0.1361367404460907,
- 0.23760713636875153,
- -0.979985237121582,
- -0.9926663041114807,
- -0.9774913191795349,
- -0.16620796918869019,
- 0.3408176600933075,
- -0.8754684329032898,
- -0.9926663041114807,
- -0.9343691468238831,
- -0.9726558923721313,
- 0.3258844017982483,
- -0.6285980939865112,
- -0.9526984095573425,
- 0.5530601739883423,
- 0.4029441475868225,
- -0.15432234108448029,
- -0.25908252596855164,
- 0.4096115529537201,
- 0.43439316749572754,
- -0.8870314359664917,
- -0.41186952590942383,
- 0.09266889840364456,
- 0.2557157576084137,
- 0.6775721907615662,
- -0.4413914978504181,
- 0.13172948360443115,
- 0.21691279113292694,
- -0.9269883036613464,
- 0.30631664395332336,
- 0.21891158819198608,
- -0.6346932053565979,
- -0.3447767496109009,
- 0.130438894033432,
- 0.47534096240997314,
- 0.5058916211128235,
- -0.6356008052825928,
- -0.24553059041500092,
- -0.17978045344352722,
- -0.34532439708709717,
- -0.2420850694179535,
- -0.4619636535644531,
- -0.4826432168483734,
- 0.5221319198608398,
- 0.029748890548944473,
- -0.7130288481712341,
- -0.8076095581054688,
- 0.29332637786865234,
- 0.5628518462181091,
- 0.06730208545923233,
- 0.4723880887031555,
- -0.12552547454833984,
- -0.4614121615886688,
- 0.08412102609872818,
- -0.13070812821388245,
- -0.2101341336965561,
- 0.01784065179526806,
- 0.9772608280181885,
- 0.9888244271278381,
- 0.998428463935852,
- 0.9541769623756409,
- 0.9986042976379395,
- -0.7781175374984741,
- 0.43230360746383667,
- 0.6684873104095459,
- 0.2304299771785736,
- -0.5736464858055115,
- -0.844412088394165,
- 0.00047851071576587856,
- -0.8698142766952515,
- -0.8623660206794739,
- -0.6524214744567871,
- 0.4876599907875061,
- 0.41059526801109314,
- 0.11519432067871094,
- 0.027569491416215897,
- -0.18464042246341705,
- 0.07333831489086151,
- -0.28634411096572876,
- -0.628840982913971,
- -0.4625285863876343,
- -0.7084884643554688,
- 0.13881811499595642,
- 0.013083233498036861,
- -0.2419593632221222,
- -0.9994175434112549,
- -0.8644529581069946,
- -0.969346821308136,
- 0.6237660050392151,
- 0.3980129659175873,
- 0.07845746725797653,
- 0.059401463717222214,
- 0.9435102343559265,
- 0.6205036044120789,
- 0.8704222440719604,
- 0.0805128887295723,
- 0.40569618344306946,
- 0.7998630404472351,
- -0.15637905895709991,
- -0.30140817165374756,
- -0.10545636713504791,
- 0.013164041563868523,
- -0.8021248579025269,
- -0.674019455909729,
- 1.1381953347961641e-15,
- 0.8842353820800781,
- 0.70960932970047,
- 0.8383103013038635,
- 0.9725919365882874,
- -0.020549282431602478,
- 0.6637487411499023,
- -0.4817539155483246,
- 0.842215895652771,
- 0.827395498752594,
- 0.5711965560913086,
- 0.9451232552528381,
- -0.505468487739563,
- -0.5622516870498657,
- 0.5627862811088562,
- 0.43230360746383667,
- 0.2933533787727356,
- -0.7023643851280212,
- 0.5701262354850769,
- 0.32938721776008606,
- -0.9919143915176392,
- -0.9549797773361206,
- 0.23374751210212708,
- 0.026159776374697685,
- -0.36292386054992676,
- 0.9944577813148499,
- 0.021349981427192688,
- -0.4515495300292969,
- -0.0596543550491333,
- -0.054855652153491974,
- -0.8076095581054688,
- -0.4196002781391144,
- -0.4410720765590668,
- -0.6684819459915161,
- 0.8623660206794739,
- 0.7781712412834167,
- -0.4617902934551239,
- 0.9156145453453064,
- 0.6612699031829834,
- 0.8220000267028809,
- 0.7003620862960815,
- 0.9428480863571167,
- 0.3421337604522705,
- 0.009491427801549435,
- -0.024708475917577744,
- -0.243136465549469,
- -0.6658512353897095,
- 0.05885906517505646,
- -0.12039002776145935,
- -0.9692688584327698,
- -0.9894528985023499,
- -0.712857186794281,
- 0.9669307470321655,
- 0.9363831281661987,
- 0.7855737209320068,
- 0.0020480032544583082,
- 0.48156502842903137,
- 0.23229436576366425,
- 0.2777603268623352,
- 0.9257963299751282,
- 0.6556273102760315,
- -0.9106780886650085,
- -0.3095446527004242,
- 0.9899122714996338,
- -0.8134732842445374,
- 0.8606582283973694,
- 0.6877522468566895,
- 0.4117426872253418,
- 0.4701825976371765,
- 0.7486863732337952,
- 0.544661283493042,
- 0.7486863732337952,
- 0.678033173084259,
- 0.17454104125499725,
- -0.17454104125499725,
- -0.9429054260253906,
- -0.9972629547119141,
- -0.7024728059768677,
- 0.484409362077713,
- -0.7819303274154663,
- -0.7981323003768921,
- -0.7253903150558472,
- -0.28735053539276123,
- 0.36599305272102356,
- -0.9146113395690918,
- -0.10216209292411804,
- 0.01893974095582962,
- 0.19509032368659973,
- -0.6746619939804077,
- -0.580647885799408,
- -0.8524736762046814,
- -0.38539648056030273,
- 0.3909161388874054,
- 0.8446590304374695,
- -0.9985224008560181,
- 0.5946504473686218,
- -0.01600003056228161,
- 0.40821167826652527,
- 0.48939603567123413,
- -0.09601835906505585,
- -0.9909332990646362,
- -0.5974749326705933,
- 0.33801841735839844,
- 0.5988664031028748,
- 0.47321829199790955,
- 0.5466654896736145,
- -0.08516772836446762,
- -0.08488517999649048,
- -0.43230360746383667,
- -0.9939273595809937,
- -0.8418577313423157,
- 0.37960660457611084,
- 0.3056824207305908,
- -0.3595028221607208,
- -0.19509032368659973,
- -0.29275640845298767,
- -0.9550285339355469,
- 0.9962120056152344,
- 0.9809043407440186,
- 0.6006340980529785,
- 0.8467000126838684,
- -0.8403451442718506,
- -0.8470764756202698,
- 0.2801212966442108,
- -0.9871431589126587,
- 0.08321216702461243,
- 0.19509032368659973,
- 0.22816050052642822,
- -0.2699337899684906,
- -0.6778974533081055,
- -0.8404248356819153,
- 0.2901766896247864,
- 0.5331884622573853,
- 0.44227609038352966,
- 0.9771484136581421,
- 0.8558570742607117,
- -0.7451087236404419,
- 0.9981444478034973,
- -0.678033173084259,
- -0.8475834727287292,
- 0.3360883593559265,
- 0.9743492007255554,
- -0.282871812582016,
- -0.22345055639743805,
- 0.3189956545829773,
- -0.9293450713157654,
- 0.5089709162712097,
- 0.8060675263404846,
- 0.8813042640686035,
- -0.5501174926757812,
- 0.43230360746383667,
- 0.399971067905426,
- 0.5860621929168701,
- -0.8191595077514648,
- 0.8525258898735046,
- 0.4839176535606384,
- 0.43716105818748474,
- 0.44707098603248596,
- -0.004523725248873234,
- -0.0728132501244545,
- -0.5065698027610779,
- 0.10219016671180725,
- 0.12683188915252686,
- 0.46737194061279297,
- -0.39507293701171875,
- 0.14336158335208893,
- 0.5697399377822876,
- -0.04716167598962784,
- -0.02876582369208336,
- 0.716044545173645,
- 0.8369349837303162,
- -0.3292773365974426,
- 0.7456651926040649,
- 0.5343924760818481,
- -0.9642449021339417,
- -0.535721480846405,
- -0.4752419590950012,
- 0.5506404638290405,
- 0.42234858870506287,
- 0.2887100875377655,
- -0.06674723327159882,
- 0.6946030259132385,
- 0.02623007260262966,
- 0.946326732635498,
- -0.5398248434066772,
- -0.9635012149810791,
- -0.9525694251060486,
- -0.5915231704711914,
- -0.5506868362426758,
- 0.5892135500907898,
- -0.8410922288894653,
- -0.9329262375831604,
- -0.9138374328613281,
- 0.8402705788612366,
- 0.9105742573738098,
- -0.9931750297546387,
- -0.4777680039405823,
- -0.8566827178001404,
- -0.6324874758720398,
- 0.8885729312896729,
- 0.9815806150436401,
- -0.13777193427085876,
- -0.6420971155166626,
- -0.5806383490562439,
- 0.5950174927711487,
- -0.8831895589828491,
- -0.9292991161346436,
- -0.515745222568512,
- -0.7781712412834167,
- -0.47324317693710327,
- 0.7560555934906006,
- -0.6978248953819275,
- 0.5688090324401855,
- 0.48954278230667114,
- -0.4428369104862213,
- -0.2906172573566437,
- -0.8368217945098877,
- -0.9935793280601501,
- 0.982795000076294,
- -0.7022608518600464,
- -0.5990626811981201,
- 0.4099653661251068,
- 0.8622729182243347,
- -0.286173015832901,
- 0.16053339838981628,
- 0.6610923409461975,
- 0.5628518462181091,
- 0.18883104622364044,
- 0.8341196775436401,
- -0.29332637786865234,
- -0.4320796728134155,
- -0.5608901381492615,
- -0.7485610842704773,
- -0.06010530889034271,
- 0.21931923925876617,
- -0.22103886306285858,
- -0.5628518462181091,
- 0.9293450713157654,
- 0.7130826711654663,
- 0.9627287983894348,
- 0.9840801358222961,
- -0.8595077991485596,
- 0.31655168533325195,
- 0.882563591003418,
- 0.971177875995636,
- -0.9552678465843201,
- 0.7955359220504761,
- -0.12935291230678558,
- 0.9853049516677856,
- -0.33821555972099304,
- 0.9915511608123779,
- -0.9826152324676514,
- -0.9881051778793335,
- 0.9917153120040894,
- 0.08590389788150787,
- -0.6782426834106445,
- 0.47321829199790955,
- -0.17458701133728027,
- -0.445766419172287,
- -0.648909866809845,
- -0.8623660206794739,
- 0.7130826711654663,
- 0.807781457901001,
- 0.8623660206794739,
- -0.31360378861427307,
- 0.9839302897453308,
- 0.6382311582565308,
- -0.9593880772590637,
- 0.3193909227848053,
- -0.7817341685295105,
- 0.023031573742628098,
- -0.4200100302696228,
- 0.9933979511260986,
- -0.8614697456359863,
- -0.8687127232551575,
- 0.16769032180309296,
- 0.46352097392082214,
- -0.5226393938064575,
- -0.24868835508823395,
- 0.16562004387378693,
- 0.3897646963596344,
- 0.7157204151153564,
- 0.3493865430355072,
- -0.8276746273040771,
- -0.9994074702262878,
- 0.9726558923721313,
- -0.2598225772380829,
- 0.9036200046539307,
- 0.9771667718887329,
- 0.8610367178916931,
- -0.05206523463129997,
- 0.20172397792339325,
- -0.9491549134254456,
- 0.006670048926025629,
- 0.48246243596076965,
- 0.02163754589855671,
- 0.1861138790845871,
- -0.9725919365882874,
- -0.9926801323890686,
- -0.9994572997093201,
- 0.34400707483291626,
- 0.6316402554512024,
- -0.8622729182243347,
- 0.6931447386741638,
- 0.8637305498123169,
- -0.49691101908683777,
- 0.4423399865627289,
- 0.9413233995437622,
- 0.2561284601688385,
- 0.4177584648132324,
- -0.7151981592178345,
- 0.3847554624080658,
- 0.00911870226264,
- 0.04645007848739624,
- 0.9529821872711182,
- 0.9131877422332764,
- 0.9860866069793701,
- -0.28687211871147156,
- 0.7533616423606873,
- 0.525320291519165,
- -0.2505177855491638,
- 0.22584663331508636,
- -0.31802502274513245,
- -0.664940357208252,
- 0.3854376971721649,
- -0.5987637042999268,
- 0.9183555841445923,
- -0.8924358487129211,
- -0.39667022228240967,
- -0.8860922455787659,
- 0.642162561416626,
- -0.12058087438344955,
- -0.9389616847038269,
- -0.830712616443634,
- -0.606196939945221,
- -0.7111347317695618,
- -0.3265444338321686,
- -0.56674724817276,
- 0.9875668883323669,
- -0.10216209292411804,
- 0.5815808773040771,
- 0.9071466326713562,
- -0.8691815733909607,
- -0.5292973518371582,
- -0.7014018893241882,
- 0.2636984586715698,
- 0.9412404298782349,
- 0.9982985854148865,
- 0.9909630417823792,
- -0.3709893822669983,
- -0.7072163224220276
- ]
- }
- ],
- "layout": {
- "height": 500,
- "scene": {
- "aspectmode": "data"
- },
- "template": {
- "data": {
- "bar": [
- {
- "error_x": {
- "color": "#2a3f5f"
- },
- "error_y": {
- "color": "#2a3f5f"
- },
- "marker": {
- "line": {
- "color": "#E5ECF6",
- "width": 0.5
- },
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "bar"
- }
- ],
- "barpolar": [
- {
- "marker": {
- "line": {
- "color": "#E5ECF6",
- "width": 0.5
- },
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "barpolar"
- }
- ],
- "carpet": [
- {
- "aaxis": {
- "endlinecolor": "#2a3f5f",
- "gridcolor": "white",
- "linecolor": "white",
- "minorgridcolor": "white",
- "startlinecolor": "#2a3f5f"
- },
- "baxis": {
- "endlinecolor": "#2a3f5f",
- "gridcolor": "white",
- "linecolor": "white",
- "minorgridcolor": "white",
- "startlinecolor": "#2a3f5f"
- },
- "type": "carpet"
- }
- ],
- "choropleth": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "choropleth"
- }
- ],
- "contour": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "contour"
- }
- ],
- "contourcarpet": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "contourcarpet"
- }
- ],
- "heatmap": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "heatmap"
- }
- ],
- "heatmapgl": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "heatmapgl"
- }
- ],
- "histogram": [
- {
- "marker": {
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "histogram"
- }
- ],
- "histogram2d": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "histogram2d"
- }
- ],
- "histogram2dcontour": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "histogram2dcontour"
- }
- ],
- "mesh3d": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "mesh3d"
- }
- ],
- "parcoords": [
- {
- "line": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "parcoords"
- }
- ],
- "pie": [
- {
- "automargin": true,
- "type": "pie"
- }
- ],
- "scatter": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatter"
- }
- ],
- "scatter3d": [
- {
- "line": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatter3d"
- }
- ],
- "scattercarpet": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattercarpet"
- }
- ],
- "scattergeo": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattergeo"
- }
- ],
- "scattergl": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattergl"
- }
- ],
- "scattermapbox": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattermapbox"
- }
- ],
- "scatterpolar": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterpolar"
- }
- ],
- "scatterpolargl": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterpolargl"
- }
- ],
- "scatterternary": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterternary"
- }
- ],
- "surface": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "surface"
- }
- ],
- "table": [
- {
- "cells": {
- "fill": {
- "color": "#EBF0F8"
- },
- "line": {
- "color": "white"
- }
- },
- "header": {
- "fill": {
- "color": "#C8D4E3"
- },
- "line": {
- "color": "white"
- }
- },
- "type": "table"
- }
- ]
- },
- "layout": {
- "annotationdefaults": {
- "arrowcolor": "#2a3f5f",
- "arrowhead": 0,
- "arrowwidth": 1
- },
- "autotypenumbers": "strict",
- "coloraxis": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "colorscale": {
- "diverging": [
- [
- 0,
- "#8e0152"
- ],
- [
- 0.1,
- "#c51b7d"
- ],
- [
- 0.2,
- "#de77ae"
- ],
- [
- 0.3,
- "#f1b6da"
- ],
- [
- 0.4,
- "#fde0ef"
- ],
- [
- 0.5,
- "#f7f7f7"
- ],
- [
- 0.6,
- "#e6f5d0"
- ],
- [
- 0.7,
- "#b8e186"
- ],
- [
- 0.8,
- "#7fbc41"
- ],
- [
- 0.9,
- "#4d9221"
- ],
- [
- 1,
- "#276419"
- ]
- ],
- "sequential": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "sequentialminus": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ]
- },
- "colorway": [
- "#636efa",
- "#EF553B",
- "#00cc96",
- "#ab63fa",
- "#FFA15A",
- "#19d3f3",
- "#FF6692",
- "#B6E880",
- "#FF97FF",
- "#FECB52"
- ],
- "font": {
- "color": "#2a3f5f"
- },
- "geo": {
- "bgcolor": "white",
- "lakecolor": "white",
- "landcolor": "#E5ECF6",
- "showlakes": true,
- "showland": true,
- "subunitcolor": "white"
- },
- "hoverlabel": {
- "align": "left"
- },
- "hovermode": "closest",
- "mapbox": {
- "style": "light"
- },
- "paper_bgcolor": "white",
- "plot_bgcolor": "#E5ECF6",
- "polar": {
- "angularaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "bgcolor": "#E5ECF6",
- "radialaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- }
- },
- "scene": {
- "xaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- },
- "yaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- },
- "zaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- }
- },
- "shapedefaults": {
- "line": {
- "color": "#2a3f5f"
- }
- },
- "ternary": {
- "aaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "baxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "bgcolor": "#E5ECF6",
- "caxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- }
- },
- "title": {
- "x": 0.05
- },
- "xaxis": {
- "automargin": true,
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": "",
- "title": {
- "standoff": 15
- },
- "zerolinecolor": "white",
- "zerolinewidth": 2
- },
- "yaxis": {
- "automargin": true,
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": "",
- "title": {
- "standoff": 15
- },
- "zerolinecolor": "white",
- "zerolinewidth": 2
- }
- }
- },
- "title": {
- "text": "Raw Stochastic Results"
- },
- "width": 500,
- "xaxis": {
- "range": [
- -5,
- 5
- ]
- },
- "yaxis": {
- "range": [
- -1,
- 0.9999999999999999
- ]
- }
- }
- },
- "text/html": [
- " "
- ]
- },
- "metadata": {},
- "output_type": "display_data"
- },
- {
- "data": {
- "text/html": [
- " \n",
- " "
- ]
- },
- "metadata": {},
- "output_type": "display_data"
- },
- {
- "data": {
- "application/vnd.plotly.v1+json": {
- "config": {
- "linkText": "Export to plot.ly",
- "plotlyServerURL": "https://plot.ly",
- "showLink": false
- },
- "data": [
- {
- "marker": {
- "color": [
- 0,
- 0,
- 0,
- 0,
- 472.8715639712987,
- 158.18279603910278,
- 413.2008695183515,
- 471.08703332940763,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 453.82701366175803,
- 1256.1525840853158,
- 375.4432315928526,
- 925.6164348340319,
- 0,
- 0,
- 0,
- 0,
- 0,
- 50.74081591231987,
- 0,
- 0,
- 1841.5667933352822,
- 860.6335010945013,
- 979.4138300624606,
- 1140.6431054461182,
- 921.8572350428663,
- 2217.592903702708,
- 2768.6886483765416,
- 2667.9039554576034,
- 2713.782550955598,
- 1115.9015977681968,
- 4336.758744225512,
- 2324.352879027998,
- 0,
- 0,
- 0,
- 0,
- 557.2117125901987,
- 518.6593889698437,
- 476.3719512195122,
- 347.6749239461104,
- 0,
- 0,
- 0,
- 0,
- 822.567377945517,
- 565.5519340387849,
- 907.3266628021272,
- 1735.4022049816251,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 3376.649953954773,
- 5040.957781978576,
- 734.8138471587198,
- 0,
- 0,
- 0,
- 0,
- 2962.670353545329,
- 695.9235749383158,
- 703.6281956447219,
- 530.3929094842626,
- 0,
- 0,
- 0,
- 0,
- 2509.2250922509224,
- 885.1178122329386,
- 1865.6716417910447,
- 7000.777864207134,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 4111.1659266568,
- 6678.2810685249715,
- 934.5414651984885,
- 4047.9526700918573,
- 673.4978592389474,
- 428.44901456726654,
- 716.3965254768514,
- 477.1982239926968,
- 1662.8293681248401,
- 635.9674949947002,
- 824.9223602484471,
- 821.1721646098259,
- 1603.7595106668657,
- 1410.8964619057956,
- 684.7793899911164,
- 913.3087348847404,
- 1668.4885794833438,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 336.07797008906067,
- 250.64589519145488,
- 411.7683391324041,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 393.13695206537307,
- 689.2748828232699,
- 826.65830506542,
- 465.86951216806796,
- 1855.5593534840568,
- 1060.4453870625662,
- 4486.671945104249,
- 2822.068576266403,
- 1874.2615002240966,
- 1010.5417881996278,
- 872.1265077092693,
- 0,
- 0,
- 0,
- 48.944032498837586,
- 136.75681219870765,
- 31.376486461046095,
- 113.10298026352994,
- 0,
- 0,
- 0,
- 0,
- 721.7492577465019,
- 2063.8713882250704,
- 4773.830020347473,
- 2388.6177173122855,
- 1443.6680718369234,
- 512.5879778404275,
- 2575.4884547069273,
- 497.88399302962415,
- 1046.146693014065,
- 226.2750599628909,
- 983.1767533318767,
- 7190.364911019234,
- 290.1339197092553,
- 339.1189074205383,
- 195.69471624266143,
- 222.22222222222223,
- 132.3845771967566,
- 169.68462899667904,
- 638.8959877331971,
- 419.99160016799664,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 299.4609702535436,
- 460.7941018354965,
- 655.3079947575361,
- 2160.68087797423,
- 4933.163590070019,
- 4170.676932948348,
- 9243.697478991597,
- 0,
- 0,
- 0,
- 970.6925518013813,
- 922.9098805646038,
- 613.5197441808582,
- 341.99076624931126,
- 621.7524537016477,
- 135.21736190926916,
- 160.61676839062,
- 46.68534080298786,
- 478.9272030651341,
- 742.080608506099,
- 1233.7817400302476,
- 3955.174686882004,
- 1582.1533106558027,
- 3234.065489826169,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 3247.183565275017,
- 719.7480881691408,
- 2728.1407720638385,
- 0,
- 0,
- 2121.4099216710183,
- 3831.417624521073,
- 1527.7454102902716,
- 2073.12476441764,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 770.7270525195435,
- 3446.669771774569,
- 1569.9535052231147,
- 1624.2555495397944,
- 0,
- 421.5962688730205,
- 409.8102263413404,
- 56.12617163383286,
- 0,
- 128.73326467559218,
- 0,
- 0,
- 0,
- 345.1449608835711,
- 316.3493287462681,
- 457.48270143535194,
- 610.5790860595154,
- 72.1071512267229,
- 149.4880035877121,
- 152.97537096527458,
- 304.32136335970785,
- 0,
- 0,
- 0,
- 226.10047339786618,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 56.637970095151786,
- 65.75702778234424,
- 0,
- 42.66393617475148,
- 1008.3504017646133,
- 665.4381654381654,
- 1055.2824079625855,
- 807.7392692777308,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 258.38579347928214,
- 296.0251890524503,
- 431.7206767221608,
- 625.912789484665,
- 0,
- 0,
- 0,
- 143.52144210345025,
- 72.19521586369544,
- 51.09992590510744,
- 1268.4989429175475,
- 1348.4435518576963,
- 1060.497694034084,
- 1094.9704357982334,
- 262.88117770767616,
- 141.24008797239765,
- 180.10986701888152,
- 130.7462998797134,
- 428.58431832536314,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 632.5353165551743,
- 325.8602711157456,
- 3312.3550844650545,
- 0,
- 0,
- 0,
- 0,
- 818.3640901837227,
- 961.6925789389326,
- 785.8669684395826,
- 0,
- 135.40228017439813,
- 31.31998058161204,
- 1579.9509670389539,
- 5437.421108845519,
- 6688.6081324981415,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1155.0981833455844,
- 887.5585179513062,
- 745.4156934850669,
- 2259.396046056919,
- 266.6311158512199,
- 837.3456144023446,
- 1296.9047207331835,
- 929.6080152868874,
- 425.89437819420783,
- 313.22596643261727,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 2717.284290946324,
- 2759.846571241463,
- 1830.501942901185,
- 1230.809095031418,
- 734.5225603357817,
- 1259.0321874315744,
- 298.70560902754727,
- 296.92139396780743,
- 0,
- 0,
- 0,
- 0,
- 232.35820340637127,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 262.2821828434667,
- 1900.801900801901,
- 3784.693019343986,
- 1880.9991424856848,
- 2957.9865637220496,
- 5067.5675675675675,
- 0,
- 0,
- 0,
- 0,
- 0,
- 17.903179604697794,
- 939.5632300660234,
- 3053.2324439134472,
- 352.89372857430936,
- 535.6968929580208,
- 190.51852792684087,
- 149.58024045023652,
- 302.1071977039853,
- 701.7236086136573,
- 1055.114200595829,
- 426.64542920530175,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 400.5607850991388,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 588.3506569915669,
- 283.7281883955171,
- 0,
- 2019.712392955243,
- 444.5276309016892,
- 1867.9950186799501,
- 1184.6510430079834,
- 810.4921898025345,
- 605.5169320475443,
- 1430.615164520744,
- 1163.819189050789,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 2007.0245860511789,
- 1478.2421237411845,
- 893.9805310906563,
- 1599.2212487832012,
- 1801.9032603187115,
- 933.8313767342582,
- 839.348665435622,
- 1214.4592084583512,
- 0,
- 0,
- 0,
- 0,
- 857.8926120306822,
- 741.6445369506447,
- 1358.5765623630466,
- 3014.0982012639765,
- 1143.7503574219868,
- 1395.3488372093022,
- 777.070984530866,
- 1202.9558343357965,
- 1950.4698859270643,
- 486.64760630208656,
- 1615.1827175449223,
- 2882.6751225136927,
- 129.5756397797214,
- 181.4845435663729,
- 138.78287419332455,
- 0,
- 0,
- 0,
- 0,
- 0,
- 3201.358944204887,
- 2305.2097740894424,
- 182.29324907334265,
- 282.03440819780013,
- 171.0717646052519,
- 0,
- 2402.2609514837495,
- 2251.8544683857294,
- 1737.1163867979155,
- 1088.139281828074,
- 246.8338807982228,
- 250.84031505543572,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 5748.350010645093,
- 2352.9411764705883,
- 1718.0724862963266,
- 1989.9636615331372,
- 1127.4974067559644,
- 604.2600332343018,
- 2625.4375729288213,
- 2090.0627018810565,
- 0,
- 0,
- 155.53067064825183,
- 0,
- 44.08393581378946,
- 48.07076015895398,
- 0,
- 0,
- 0,
- 0,
- 21.15014487849242,
- 24.85089463220676,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1107.6650420912715,
- 0,
- 0,
- 0,
- 0,
- 660.6362435206829,
- 804.5469881394201,
- 430.4609845816702,
- 813.8719960210702,
- 716.574772587034,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 792.8956549318109,
- 3224.104578228501,
- 4803.579653879055,
- 0,
- 101.02370689655173,
- 0,
- 0,
- 0,
- 0,
- 0,
- 332.64724838354226,
- 244.91333835719666,
- 268.06058169146223,
- 0,
- 0,
- 648.5925541574783,
- 951.7011658339281,
- 289.2810253899731,
- 1036.2694300518135,
- 440.43162299053074,
- 836.0039013515395,
- 1336.8296570517764,
- 0,
- 0,
- 0,
- 0,
- 0,
- 199.61075901991117,
- 514.7740142077628,
- 740.7956144899622,
- 218.43003412969284,
- 80.37293039704228,
- 0,
- 0,
- 0,
- 0,
- 465.3454505638892,
- 1160.4293588627793,
- 451.52999201139244,
- 6638.434245164244,
- 0,
- 111.85682326621924,
- 0,
- 636.3083052066619,
- 465.33271288971616,
- 283.145749274439,
- 1106.6027296200664,
- 446.7609828741623,
- 393.2805213776055,
- 0,
- 0,
- 0,
- 0,
- 1815.5410312273057,
- 0,
- 0,
- 1469.9503590534484,
- 1156.9813305285302,
- 2289.012738853503,
- 0,
- 0,
- 0,
- 0,
- 4851.598173515981,
- 4198.788546255507,
- 3423.1545685947513,
- 0,
- 413.13778145011366,
- 4808.1841432225065,
- 4045.0736781277087,
- 3361.6904500548844,
- 3622.8133733567956,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 119.52857928330664,
- 105.54980895484579,
- 315.5711838427554,
- 237.68366464995677,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1610.3059581320451,
- 1089.940255126756,
- 1834.4883815735834,
- 0,
- 0,
- 0,
- 0,
- 0,
- 60.66672733339399,
- 26.32895395065954,
- 83.22929671244279,
- 218.7067142961289,
- 96.95402763189787,
- 0,
- 0,
- 1816.7944478761672,
- 0,
- 0,
- 0,
- 2064.867042707494,
- 4733.52033660589,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 3345.0318052204434,
- 4237.28813559322,
- 2872.6460261729976,
- 718.311415626036,
- 118.7507421921387,
- 1534.8184529029993,
- 0,
- 0,
- 2025.5362245451586,
- 1265.6447756996201,
- 0,
- 119.5886151638364,
- 90.21064184871675,
- 0,
- 0,
- 299.7601918465228,
- 0,
- 0,
- 0,
- 0,
- 0,
- 163.71971185330713,
- 426.884219513352,
- 0,
- 0,
- 0,
- 920.8930416423342,
- 616.2728466940205,
- 615.2244386076998,
- 2315.2741946153337,
- 599.5415270675365,
- 204.6989787795392,
- 847.3309076409311,
- 461.68051708217916,
- 744.5752375549567,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1294.618087664139,
- 891.5967010922059,
- 7099.507614794458,
- 0,
- 683.6671908115129,
- 1358.6246538119872,
- 2272.8668837152163,
- 0,
- 663.1976328946025,
- 0,
- 1653.7672818680956,
- 3468.208092485549,
- 580.3391199031086,
- 1210.4778966736067,
- 266.859822347604,
- 0,
- 7182.32044198895,
- 4994.613651943982,
- 7202.739402526862,
- 0,
- 0,
- 0,
- 0,
- 0,
- 922.3876663592041,
- 0,
- 0,
- 906.2216805724821,
- 0,
- 0,
- 0,
- 0,
- 0,
- 330.9431880860452,
- 30.384054448225573,
- 723.8508867173363,
- 1846.7995802728228,
- 13513.513513513513,
- 3273.980470993682,
- 0,
- 282.60562385191463,
- 170.77231780728346,
- 343.878954607978,
- 0,
- 50.69194504993156,
- 0,
- 0,
- 978.4097580066532,
- 0,
- 150.31189718666232,
- 239.48271733056598,
- 0,
- 0,
- 852.6691127073536,
- 473.7412019491067,
- 1738.7104564114948,
- 2886.977886977887,
- 0,
- 0,
- 0,
- 0,
- 868.7378480122451,
- 427.72470823064543,
- 0,
- 703.6227060948939,
- 2330.445174783388,
- 719.2174913693901,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 4927.65778989306,
- 5041.33897963299,
- 1892.9236205319114,
- 0,
- 0,
- 0,
- 733.5615524829948,
- 0,
- 0,
- 0,
- 0,
- 3056.519711961871,
- 0,
- 0,
- 0,
- 0,
- 1331.4897321657193,
- 1983.0777366472764,
- 896.2294347352922,
- 622.8282960729038,
- 0,
- 0,
- 1500.7503751875938,
- 2432.1238894128155,
- 0,
- 0,
- 488.20179007323026,
- 0,
- 1833.1374853113984,
- 1673.2901066722445,
- 0,
- 0,
- 0,
- 0,
- 1163.8292689528243,
- 6983.615363953801,
- 3943.5765205521006,
- 0,
- 1648.1547832318165,
- 0,
- 0,
- 0,
- 0,
- 1452.3062623446033,
- 2581.4491721559552,
- 4482.120237747247,
- 6346.205779098028,
- 762.3500711526733,
- 0,
- 0,
- 1546.5143944801332,
- 816.5169718884871,
- 317.1917953055614,
- 3405.436085009775,
- 0,
- 0,
- 641.1521010061157,
- 497.47708052021886,
- 1449.2753623188405,
- 2713.577243379807,
- 2493.7655860349128,
- 4417.577307602884,
- 486.1054848902212,
- 387.5468285751195,
- 0,
- 0,
- 1444.5996051427746,
- 3037.884203002144,
- 0,
- 0,
- 904.1591320072333,
- 603.2121044562293,
- 5928.295850192905,
- 3281.5576460293155,
- 338.8681802778719,
- 718.4276697285369,
- 3604.1682989892656,
- 0,
- 825.9457078354716,
- 618.7007284702125,
- 601.7623038899634,
- 3242.0500793267574,
- 1289.3867354339593,
- 664.8936170212767,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 215.2620815843289,
- 543.5274934323761,
- 102.10332856851133,
- 0,
- 0,
- 2523.659305993691,
- 5553.2417048452035,
- 2212.231499322058,
- 0,
- 869.376222560313,
- 46.74644727000748,
- 66.73785371062466,
- 0,
- 0,
- 0,
- 1846.0940536338903,
- 716.8116219057631,
- 1997.4432726110579,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1885.6065367693272,
- 574.4296733957,
- 0,
- 2077.951252386836,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 396.4657906660625,
- 334.4854498829301,
- 3628.064837029668,
- 0,
- 425.0386398763524,
- 151.56873642196734,
- 0,
- 7294.429708222812,
- 3511.3976513930465,
- 4962.779156327543,
- 0,
- 686.639442015106,
- 4131.093362709998,
- 0,
- 0,
- 0,
- 0,
- 0,
- 285.66531451751126,
- 1566.8250900924427,
- 0,
- 0,
- 3018.446059250978,
- 5281.090289608177,
- 409.3327875562832,
- 468.11000585137504,
- 988.888021443256,
- 3195.110092380357,
- 0,
- 0,
- 3206.337231233497,
- 3571.241006249672,
- 3326.7130089374377,
- 0,
- 0,
- 0,
- 5264.591086502677,
- 4085.3381752156147,
- 3115.0538362565176,
- 0,
- 0,
- 0,
- 912.4642618164122,
- 0,
- 1630.672552996858,
- 1144.2417715554957,
- 0,
- 947.5251545368408,
- 265.26958021088933,
- 0,
- 0,
- 4495.99856128046,
- 0,
- 0,
- 500.12503125781444,
- 456.04434154213146,
- 6297.831632653061,
- 0,
- 0,
- 0,
- 0,
- 3172.153635116598,
- 0,
- 0,
- 2859.3346816374924,
- 0,
- 0,
- 1212.690216328287,
- 0,
- 0,
- 0,
- 3780.5141499243896,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1403.5744362309347,
- 1281.69406519922,
- 10904.134484325306,
- 0,
- 0,
- 2409.9703917923293,
- 1063.9078435688605,
- 53.888020692999945,
- 38.96660561898453,
- 999.3337774816789,
- 134.86176668914362,
- 386.99690402476784,
- 0,
- 845.0853007975493,
- 8059.100067159166,
- 7178.106774338268,
- 0,
- 163.79122079056563,
- 376.87089479918166,
- 9867.09625453081,
- 0,
- 0,
- 1948.5264268896647,
- 699.471898716469,
- 1340.3192396734494,
- 0,
- 0,
- 0,
- 6658.676255160474,
- 0,
- 0,
- 0,
- 1448.1560146746476,
- 716.4790174002047,
- 3290.179529361276,
- 0,
- 0,
- 0,
- 0,
- 0,
- 446.09665427509293,
- 1096.3819395993223,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 428.2043962318013,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1142.5462459194778,
- 0,
- 1374.098248024734,
- 1061.8529333687284,
- 0,
- 0,
- 0,
- 87.30574471800244,
- 1766.6358206444015,
- 584.6671051669955,
- 1911.360649862621,
- 0,
- 2234.409912654885
- ],
- "colorbar": {
- "thickness": 20,
- "title": {
- "text": "A"
- }
- },
- "colorscale": [
- [
- 0,
- "#0508b8"
- ],
- [
- 0.08333333333333333,
- "#1910d8"
- ],
- [
- 0.16666666666666666,
- "#3c19f0"
- ],
- [
- 0.25,
- "#6b1cfb"
- ],
- [
- 0.3333333333333333,
- "#981cfd"
- ],
- [
- 0.4166666666666667,
- "#bf1cfd"
- ],
- [
- 0.5,
- "#dd2bfd"
- ],
- [
- 0.5833333333333334,
- "#f246fe"
- ],
- [
- 0.6666666666666666,
- "#fc67fd"
- ],
- [
- 0.75,
- "#fe88fc"
- ],
- [
- 0.8333333333333334,
- "#fea5fd"
- ],
- [
- 0.9166666666666666,
- "#febefe"
- ],
- [
- 1,
- "#fec3fe"
- ]
- ],
- "size": 5
- },
- "mode": "markers",
- "name": "A",
- "type": "scatter3d",
- "x": [
- -2.101682662963867,
- -1.887513518333435,
- -1.7570427656173706,
- -1.8541388511657715,
- 1.8749754428863525,
- 1.80832040309906,
- 2.1825294494628906,
- 2.062222480773926,
- -2.38004469871521,
- -2.3056769371032715,
- -2.2629430294036865,
- -2.0936312675476074,
- -1.9997928142547607,
- -1.7547287940979004,
- -1.6898266077041626,
- -1.6704288721084595,
- 3.5905017852783203,
- 3.2578799724578857,
- 3.160881519317627,
- 3.4964303970336914,
- -0.6913178563117981,
- -1.0443613529205322,
- -0.8108569979667664,
- -0.5850074887275696,
- -0.293684720993042,
- 0.0675533190369606,
- -0.271133154630661,
- 0.018742907792329788,
- 4.4305853843688965,
- 4.508673667907715,
- 4.325611114501953,
- 4.611989498138428,
- 3.4338648319244385,
- 3.488844871520996,
- 3.289395570755005,
- 3.6204428672790527,
- 3.71138858795166,
- 3.857684850692749,
- 3.974630117416382,
- 4.003854274749756,
- -3.9132473468780518,
- -4.0064496994018555,
- -3.8273096084594727,
- -3.709832191467285,
- 2.3001842498779297,
- 2.2914557456970215,
- 2.0052285194396973,
- 2.2628118991851807,
- -1.980513334274292,
- -2.0251479148864746,
- -1.7515032291412354,
- -2.1317431926727295,
- 3.794757843017578,
- 3.3874454498291016,
- 3.7147281169891357,
- 3.586693048477173,
- -2.8868887424468994,
- -3.001088857650757,
- -2.9482247829437256,
- -2.6325371265411377,
- -4.134808540344238,
- -3.772261619567871,
- -4.165527820587158,
- -3.994203805923462,
- -4.163450241088867,
- 3.875136137008667,
- 3.7112133502960205,
- 3.765407085418701,
- -2.4520857334136963,
- -2.657001495361328,
- -2.6662352085113525,
- -2.8774945735931396,
- 3.942436933517456,
- 3.8352348804473877,
- 3.6082088947296143,
- 4.133811950683594,
- -3.171978712081909,
- -3.221795082092285,
- -3.0311388969421387,
- -2.9480156898498535,
- 4.4702277183532715,
- 4.6418352127075195,
- 4.766424655914307,
- 4.669127941131592,
- -3.4734950065612793,
- -3.1584713459014893,
- -3.2440361976623535,
- -3.3585245609283447,
- -2.429314613342285,
- -2.2996301651000977,
- -2.1834332942962646,
- -1.2482850551605225,
- -0.8828672766685486,
- -0.8636268973350525,
- 4.625131607055664,
- 5,
- 4.731442928314209,
- 4.639413356781006,
- 2.726271152496338,
- 2.482100486755371,
- 2.630417823791504,
- 2.613208293914795,
- 2.359410285949707,
- 2.4850215911865234,
- 2.0713677406311035,
- 2.9034955501556396,
- 3.2096197605133057,
- 3.0044784545898438,
- 3.031195640563965,
- 2.8652327060699463,
- 3.303494453430176,
- -0.9179192781448364,
- -1.1669803857803345,
- -1.2644528150558472,
- -1.0285327434539795,
- -0.8682996034622192,
- -1.0111645460128784,
- -1.1425732374191284,
- -0.9068978428840637,
- 1.6444306373596191,
- 1.5535091161727905,
- 1.877994418144226,
- -4.233823299407959,
- -4.286869049072266,
- -4.4695281982421875,
- -4.121842384338379,
- -1.4972978830337524,
- -0.9989351034164429,
- -1.422027349472046,
- -1.2346546649932861,
- -2.2228097915649414,
- -2.000976085662842,
- -2.127882480621338,
- -4.581174373626709,
- -4.083948135375977,
- 2.5844061374664307,
- 2.6696746349334717,
- 2.439190149307251,
- 2.836972236633301,
- 3.768427848815918,
- 3.901214361190796,
- 4.03761625289917,
- 3.712953805923462,
- 3.7559714317321777,
- 3.856983184814453,
- 4.166917324066162,
- -2.2912299633026123,
- -2.089019775390625,
- -1.982771635055542,
- 0.2804890275001526,
- 0.14649292826652527,
- -0.02719704993069172,
- 0.35809698700904846,
- -0.09706947952508926,
- -0.06142881140112877,
- -0.6113005876541138,
- -0.263994425535202,
- 4.316342830657959,
- 4.358631610870361,
- 4.577394962310791,
- 4.1251115798950195,
- 2.637986421585083,
- 2.9547457695007324,
- 2.78865909576416,
- 1.622883915901184,
- 1.6951839923858643,
- 1.6690202951431274,
- 1.4459738731384277,
- 5,
- 1.4305493831634521,
- 1.2514207363128662,
- 1.230926275253296,
- 1.0252352952957153,
- 1.0430431365966797,
- 1.0417221784591675,
- 1.277311086654663,
- 0.8228275179862976,
- -2.6111531257629395,
- -0.8876737952232361,
- -0.6530675888061523,
- -0.8721553087234497,
- -1.1404987573623657,
- -3.7799670696258545,
- -3.7419769763946533,
- -3.7747626304626465,
- -3.765298843383789,
- -1.3552204370498657,
- -1.448533058166504,
- 1.976080060005188,
- 2.3143045902252197,
- 2.006865978240967,
- 4.718459129333496,
- 5,
- 5,
- 5,
- -0.21346406638622284,
- -0.3900603652000427,
- -0.7078602910041809,
- 2.546725273132324,
- 2.2419445514678955,
- 2.62286114692688,
- 2.31475830078125,
- 2.815099000930786,
- 0.17036111652851105,
- 0.35399267077445984,
- 0.22068481147289276,
- 0.5616357326507568,
- 2.168175220489502,
- 2.396758794784546,
- 2.032904624938965,
- 1.9458956718444824,
- 1.672920823097229,
- -1.9237370491027832,
- -1.7913600206375122,
- -2.1189286708831787,
- -4.244471549987793,
- -4.725438117980957,
- -4.62848424911499,
- -4.6635870933532715,
- -4.4014410972595215,
- -0.39015352725982666,
- -3.62326979637146,
- -3.6562275886535645,
- -3.3212900161743164,
- -2.650617837905884,
- -2.9336674213409424,
- -2.5238282680511475,
- -2.854623556137085,
- 3.359579563140869,
- 3.281346321105957,
- 3.4625306129455566,
- -1.6233601570129395,
- -1.4790972471237183,
- 3.500380516052246,
- 4.63165283203125,
- 4.554935932159424,
- 4.720632076263428,
- -0.6211792826652527,
- -0.9868704080581665,
- -0.2744942903518677,
- -0.23266896605491638,
- -0.4965898394584656,
- -0.32649561762809753,
- -1.423138976097107,
- -1.7905021905899048,
- -1.4218405485153198,
- -3.732257604598999,
- -3.5719547271728516,
- -3.941251754760742,
- -3.9911673069000244,
- 2.76228666305542,
- 3.034092664718628,
- 2.5956602096557617,
- 3.0007383823394775,
- -2.4493157863616943,
- 1.5511066913604736,
- 1.313583254814148,
- 0.09208802133798599,
- 0.2716134786605835,
- 0.33897581696510315,
- -2.9448187351226807,
- -3.1763267517089844,
- -2.965965747833252,
- 2.055418014526367,
- 1.7646766901016235,
- 2.0915160179138184,
- 1.9841140508651733,
- 0.7309734225273132,
- 0.8535610437393188,
- 1.1015901565551758,
- 1.1043431758880615,
- -3.231236696243286,
- -3.466428518295288,
- -3.2163987159729004,
- 1.5548237562179565,
- -2.620222806930542,
- -2.8454513549804688,
- -2.381518602371216,
- -1.7730915546417236,
- -2.034778118133545,
- -1.792545199394226,
- 0.23506808280944824,
- 0.15298357605934143,
- -0.12086783349514008,
- -0.0009967255173251033,
- 3.0469939708709717,
- 3.3803346157073975,
- 3.5396389961242676,
- 3.4276304244995117,
- -3.4141626358032227,
- -3.28906512260437,
- -3.1413207054138184,
- -2.9626805782318115,
- -3.5331058502197266,
- -2.7990610599517822,
- -2.5825302600860596,
- 1.0379852056503296,
- 1.3705062866210938,
- 1.090142846107483,
- 1.1630381345748901,
- -0.7285075783729553,
- -0.5913762450218201,
- -0.41392114758491516,
- 0.37851566076278687,
- 0.2083987444639206,
- 0.536102294921875,
- 4.585145950317383,
- 4.314233303070068,
- 4.690446853637695,
- 4.508464336395264,
- 0.5570757389068604,
- 0.7471429109573364,
- 0.8703640103340149,
- 0.735404372215271,
- 1.950286626815796,
- -2.459625482559204,
- -2.3318281173706055,
- -4.318643569946289,
- -2.7759718894958496,
- -2.491568088531494,
- -2.487426280975342,
- 3.034865140914917,
- 1.392642855644226,
- 3.841580390930176,
- -1.7278932332992554,
- -1.9114822149276733,
- -1.5143166780471802,
- -1.7121433019638062,
- 4.3564581871032715,
- 4.085196018218994,
- 4.489546298980713,
- 0.03738686069846153,
- 0.4072064459323883,
- 0.3515777885913849,
- 4.740171909332275,
- 5,
- 5,
- -3.7102108001708984,
- -3.5805227756500244,
- -3.250467300415039,
- -3.6381490230560303,
- -5,
- -4.672852039337158,
- -5,
- -5,
- 3.9007976055145264,
- 4.133395671844482,
- 4.175212860107422,
- 4.236222267150879,
- 1.3414992094039917,
- 1.545016884803772,
- 1.7293202877044678,
- 1.7089415788650513,
- 1.5792618989944458,
- 1.938088297843933,
- -4.447057247161865,
- -4.589023590087891,
- -4.721797943115234,
- -5,
- -4.662319183349609,
- -4.697544574737549,
- -4.536230564117432,
- 5,
- 5,
- 5,
- 2.2066378593444824,
- 1.9319493770599365,
- 2.258507013320923,
- 2.2539353370666504,
- 2.732060194015503,
- -2.9786436557769775,
- -2.8140065670013428,
- -2.7915046215057373,
- -2.627666711807251,
- 0.9115676283836365,
- -0.532065212726593,
- -0.5675407648086548,
- -0.5571060180664062,
- -2.564318895339966,
- -4.4288010597229,
- -4.226881980895996,
- -4.208695411682129,
- -4.0041913986206055,
- -4.3078436851501465,
- -4.320655345916748,
- 2.809098720550537,
- 2.785369634628296,
- 5,
- 4.710524559020996,
- 5,
- 5,
- -4.560494422912598,
- -4.414031982421875,
- -4.710155963897705,
- 0.027450760826468468,
- -0.09511373937129974,
- 0.3111163377761841,
- 4.47791862487793,
- 4.311753749847412,
- 2.278442859649658,
- 2.3220880031585693,
- 1.0773473978042603,
- 0.6730288863182068,
- 1.7689932584762573,
- 1.6555397510528564,
- 1.9800528287887573,
- 2.0714244842529297,
- -0.6446894407272339,
- -0.43192827701568604,
- -3.7548670768737793,
- -3.300417423248291,
- -1.1125221252441406,
- -0.6115882396697998,
- -2.978154420852661,
- -3.3732173442840576,
- -3.242103338241577,
- 1.2596628665924072,
- -3.6130688190460205,
- -3.133923292160034,
- -3.3986732959747314,
- -3.5859854221343994,
- -3.520331621170044,
- -3.851719617843628,
- -3.865055561065674,
- 0.5590431690216064,
- 0.6265019774436951,
- -0.03324676677584648,
- 2.4285573959350586,
- 2.5746889114379883,
- 2.7181601524353027,
- 2.378453016281128,
- 3.447817087173462,
- 2.445730209350586,
- 2.310244083404541,
- 2.6667962074279785,
- -4.695241928100586,
- -5,
- -4.548861980438232,
- -0.33884161710739136,
- -0.5452479720115662,
- -0.44265344738960266,
- -1.2199991941452026,
- -1.154729962348938,
- -0.9447287917137146,
- -0.8053910136222839,
- 3.9948537349700928,
- 3.997985601425171,
- 4.207438945770264,
- 2.2636070251464844,
- 2.816199541091919,
- 3.2298614978790283,
- 3.0754427909851074,
- 3.1898257732391357,
- -2.0362820625305176,
- -1.695935845375061,
- -2.8119935989379883,
- -2.5727436542510986,
- 3.0221409797668457,
- 3.255614995956421,
- 3.368884563446045,
- 3.2635715007781982,
- 4.541206359863281,
- 3.801682472229004,
- 4.062766075134277,
- 3.6565608978271484,
- 2.893397092819214,
- 3.020784378051758,
- 2.637270450592041,
- 2.978060007095337,
- 0.706810474395752,
- 0.7772684097290039,
- 0.8003952503204346,
- -0.22241777181625366,
- -0.1280590295791626,
- -2.9058010578155518,
- -0.3929927349090576,
- -1.6517680883407593,
- 4.374144554138184,
- 4.208742141723633,
- 1.0169200897216797,
- 0.6947392225265503,
- 0.6771532297134399,
- -4.339812278747559,
- 3.8944802284240723,
- 3.9562127590179443,
- 2.033257246017456,
- 1.9155778884887695,
- 1.3438067436218262,
- 1.0825568437576294,
- -1.7339566946029663,
- -1.3611284494400024,
- -1.3337901830673218,
- -1.2508692741394043,
- -2.2653911113739014,
- -2.2419567108154297,
- -3.1367833614349365,
- -1.81843900680542,
- -2.1527793407440186,
- -1.6042685508728027,
- -1.647326946258545,
- 4.628890037536621,
- 4.72548246383667,
- 2.286425828933716,
- 1.9910200834274292,
- 2.3555381298065186,
- 2.0931544303894043,
- 3.7614736557006836,
- 3.912747859954834,
- -4.636204242706299,
- -4.488008499145508,
- 0.4070380926132202,
- -0.13350971043109894,
- 0.19662299752235413,
- 0.13111887872219086,
- -0.7308740019798279,
- -0.5450983643531799,
- -0.6622709035873413,
- 0.003929497674107552,
- 0.24031925201416016,
- -0.22965681552886963,
- -0.0660269558429718,
- -0.17119362950325012,
- -0.18464888632297516,
- -0.0036181053146719933,
- -0.7095974087715149,
- 1.9864104986190796,
- -2.5475826263427734,
- -2.7074756622314453,
- -2.891202926635742,
- -2.509110927581787,
- 2.9578778743743896,
- 3.029849052429199,
- 2.3168818950653076,
- 3.536309242248535,
- 3.2530806064605713,
- -3.741461992263794,
- -2.821955680847168,
- -3.082059383392334,
- -2.9099485874176025,
- -2.7286927700042725,
- -0.6247063279151917,
- -0.3622240722179413,
- -0.4216044247150421,
- 1.6000310182571411,
- 5,
- 5,
- -1.6445059776306152,
- 0.2146318256855011,
- -4.1633453369140625,
- -4.1257829666137695,
- -3.817925214767456,
- -3.784167766571045,
- -1.2936067581176758,
- 1.8930131196975708,
- 1.5624295473098755,
- 1.5452696084976196,
- -1.8079805374145508,
- -1.6008325815200806,
- 1.2422401905059814,
- 1.4802297353744507,
- 1.4433354139328003,
- 1.5805444717407227,
- 0.7913298010826111,
- 2.578340768814087,
- 2.6075079441070557,
- -0.813774585723877,
- -5,
- -5,
- -4.7412261962890625,
- -4.72172212600708,
- 1.3737642765045166,
- 1.2108287811279297,
- 1.3925875425338745,
- 1.4203695058822632,
- 0.5987880825996399,
- -4.71983003616333,
- -5,
- -5,
- -4.692821025848389,
- 1.909011960029602,
- 1.7303102016448975,
- 1.6846473217010498,
- 5,
- -3.5527470111846924,
- 0.37845441699028015,
- -1.9841102361679077,
- 3.145871162414551,
- 1.289706826210022,
- 0.7273845076560974,
- 0.720970630645752,
- 1.0219862461090088,
- 0.8861194849014282,
- -4.596095085144043,
- -4.253779888153076,
- -4.743481159210205,
- -1.5359901189804077,
- 3.121032953262329,
- -4.488008499145508,
- -1.1460216045379639,
- 4.6934332847595215,
- 4.375402450561523,
- 4.680056095123291,
- -4.230134010314941,
- -3.7863848209381104,
- -4.4221673011779785,
- -4.591073989868164,
- 4.1638264656066895,
- 4.340243339538574,
- 4.488320350646973,
- -2.5075998306274414,
- 1.917682409286499,
- 4.661116600036621,
- 4.636397361755371,
- 4.488320350646973,
- 5,
- -3.489121437072754,
- -1.138638973236084,
- -0.7274905443191528,
- -4.574654579162598,
- -4.382515907287598,
- -3.1639509201049805,
- -2.7766637802124023,
- 0.7139411568641663,
- 0.4993683397769928,
- 0.7703021764755249,
- 0.901824951171875,
- -1.5355284214019775,
- -2.1874425411224365,
- -2.3504247665405273,
- -4.327395915985107,
- -2.3662376403808594,
- -3.6765761375427246,
- 1.808962345123291,
- 4.351280689239502,
- 4.706614017486572,
- -3.448230266571045,
- -3.3269059658050537,
- -1.3753197193145752,
- -1.1046783924102783,
- -1.4444420337677002,
- 0.29257264733314514,
- 0.009619895368814468,
- 0.32545214891433716,
- 0.23237977921962738,
- 1.4445356130599976,
- -1.2714718580245972,
- -1.4109042882919312,
- 4.735227108001709,
- -3.157381772994995,
- -5,
- -4.624974727630615,
- 4.58084774017334,
- 4.646906852722168,
- -4.253415107727051,
- -3.6714272499084473,
- -4.048503875732422,
- -3.91367769241333,
- -0.662963330745697,
- -0.45707225799560547,
- -0.3023490607738495,
- -0.10872425138950348,
- -0.40253975987434387,
- -0.7720760107040405,
- -2.228641986846924,
- -2.0955162048339844,
- -1.9311330318450928,
- 4.527668476104736,
- 4.4020185470581055,
- 4.253148078918457,
- 4.159819602966309,
- 0.06420236825942993,
- 4.135446548461914,
- -0.9258043766021729,
- -0.8058002591133118,
- 4.537054061889648,
- 4.744240760803223,
- -0.8789688944816589,
- 0.3651331961154938,
- 0.7293714880943298,
- -0.06956324726343155,
- -0.08140537887811661,
- 1.721306324005127,
- -3.6552634239196777,
- -3.3976213932037354,
- -3.114668607711792,
- -2.9648706912994385,
- -2.7460291385650635,
- 0.9609786868095398,
- 1.0764851570129395,
- -2.625852346420288,
- -2.673210859298706,
- -2.3928139209747314,
- 3.227536678314209,
- 3.531540632247925,
- 3.7912299633026123,
- 3.446416139602661,
- 1.760624647140503,
- 1.2702659368515015,
- 1.4204895496368408,
- 1.1356712579727173,
- 1.1212012767791748,
- -0.7966426014900208,
- -4.596960067749023,
- -2.358410358428955,
- -2.481785297393799,
- -2.317129611968994,
- 2.1517908573150635,
- 1.9424786567687988,
- 4.65165901184082,
- -4.577237129211426,
- 3.162456750869751,
- 3.290433168411255,
- 3.418100118637085,
- -3.9114646911621094,
- 0.9896045327186584,
- -0.19112993776798248,
- 2.6939661502838135,
- 3.0167806148529053,
- 2.893794298171997,
- 3.0206243991851807,
- 1.2407162189483643,
- -0.46050986647605896,
- 5,
- 4.663840293884277,
- 5,
- -3.103480339050293,
- -2.277939558029175,
- -2.125932216644287,
- -1.824216604232788,
- -2.0925588607788086,
- 2.68068528175354,
- -4.7859697341918945,
- -4.575015544891357,
- 2.8520922660827637,
- -3.2595419883728027,
- -4.203586101531982,
- -4.2565202713012695,
- -3.767660140991211,
- -3.32572078704834,
- 0.5733931660652161,
- 0.5859797596931458,
- 0.6658535599708557,
- 4.556863307952881,
- 5,
- 5,
- -2.477255344390869,
- 0.25908347964286804,
- 0.25868678092956543,
- 0.49322885274887085,
- -5,
- -0.1877877414226532,
- -5,
- -5,
- 3.983049154281616,
- -2.6407032012939453,
- 0.5915303230285645,
- 1.0867373943328857,
- -1.214605450630188,
- -1.4895960092544556,
- 2.3244974613189697,
- 1.0752484798431396,
- 3.5134105682373047,
- 3.492990732192993,
- -4.003303050994873,
- -4.055683612823486,
- -4.244694709777832,
- -4.091361999511719,
- 2.220043897628784,
- 2.544774293899536,
- -5,
- 3.5021090507507324,
- 3.226494312286377,
- 1.4538578987121582,
- 0.25620901584625244,
- -4.075596809387207,
- -4.281928539276123,
- -4.1883087158203125,
- -4.555990695953369,
- -4.334146976470947,
- -4.165266990661621,
- 4.628626346588135,
- 4.596282482147217,
- 4.575169086456299,
- -4.123189449310303,
- -3.8626294136047363,
- -3.69762921333313,
- 3.6556200981140137,
- -4.1212477684021,
- -3.785296678543091,
- -1.9285658597946167,
- -3.4919838905334473,
- 5,
- -1.8179099559783936,
- -4.580845355987549,
- -4.697874546051025,
- -4.374136447906494,
- 2.7386975288391113,
- 3.034958839416504,
- 2.8929836750030518,
- 2.8669273853302,
- -5,
- -1.5589079856872559,
- 1.9696201086044312,
- 3.9466171264648438,
- -3.894467353820801,
- -1.4353413581848145,
- 0.6438999772071838,
- -3.559412717819214,
- 2.898449182510376,
- 4.226627349853516,
- -5,
- -5,
- -4.580845355987549,
- -2.0328192710876465,
- 4.1754069328308105,
- 4.199225902557373,
- 4.34015417098999,
- -2.9041290283203125,
- 2.497323513031006,
- -1.7650561332702637,
- -0.5644856095314026,
- -5,
- -5,
- 3.0372588634490967,
- 3.8829185962677,
- 3.6070923805236816,
- 3.8541207313537598,
- 3.8192059993743896,
- -2.6382784843444824,
- -4.700376033782959,
- 2.501884937286377,
- 4.065597057342529,
- 1.0171412229537964,
- 5,
- -4.651655673980713,
- -0.8031032681465149,
- 1.2622673511505127,
- 1.2936519384384155,
- 1.369748592376709,
- 4.189074516296387,
- 4.076688766479492,
- 5,
- 0.7270625233650208,
- 0.995764970779419,
- -0.8975422382354736,
- -1.5903971195220947,
- 3.329392194747925,
- 3.4523019790649414,
- -1.0810967683792114,
- -0.5812257528305054,
- 2.644548177719116,
- 2.6585214138031006,
- 5,
- 3.7732388973236084,
- 0.9950934052467346,
- 0.8841180801391602,
- 3.8183670043945312,
- -0.6460126042366028,
- 2.1103804111480713,
- 2.3608930110931396,
- 1.3835891485214233,
- 3.4795989990234375,
- 1.769286036491394,
- 1.7716087102890015,
- -5,
- -5,
- -5,
- -1.426405906677246,
- -2.7312746047973633,
- -5,
- 0.47139957547187805,
- 3.8471028804779053,
- 0.7896639108657837,
- -1.2268297672271729,
- -4.720064640045166,
- 2.7558088302612305,
- 3.023494243621826,
- 3.7829294204711914,
- -1.891106128692627,
- 3.048088550567627,
- 0.008336871862411499,
- 0.07599930465221405,
- -1.3721232414245605,
- -1.032981276512146,
- -0.6021665930747986,
- 1.735460877418518,
- 1.5383501052856445,
- 2.478435516357422,
- -3.304556131362915,
- -2.378432035446167,
- -0.4857358932495117,
- -2.097623586654663,
- -3.2147445678710938,
- -1.8128300905227661,
- 3.589271306991577,
- 3.373690366744995,
- -3.5193681716918945,
- 3.53788161277771,
- -1.1633410453796387,
- -3.841488838195801,
- -3.562544822692871,
- -5,
- -4.628747463226318,
- -0.3776344060897827,
- -1.9576623439788818,
- -2.3299407958984375,
- -2.3134829998016357,
- 0.5879091620445251,
- 0.39716675877571106,
- 5,
- -4.527527809143066,
- 2.8390586376190186,
- 0.3319953382015228,
- -0.2031165361404419,
- 5,
- 5,
- 5,
- -5,
- 2.2759742736816406,
- 4.30157470703125,
- -0.7995855808258057,
- -0.05464247241616249,
- -1.3260889053344727,
- -1.0919172763824463,
- -1.5666868686676025,
- 0.6270329356193542,
- 2.468057155609131,
- -2.5841712951660156,
- -4.339723110198975,
- 5,
- 5,
- 0.5067524909973145,
- 0.7723978161811829,
- 3.510948657989502,
- 4.363494873046875,
- -3.0252578258514404,
- -1.2719022035598755,
- 4.58084774017334,
- 5,
- 4.526966571807861,
- -5,
- -5,
- -5,
- 5,
- 4.227243900299072,
- 4.085610389709473,
- -4.363025188446045,
- -1.356877088546753,
- -1.0370725393295288,
- 1.1098798513412476,
- -1.7669402360916138,
- 3.0309200286865234,
- 1.8378273248672485,
- -1.0789508819580078,
- 1.8391550779342651,
- 0.4916764497756958,
- -3.601686716079712,
- -0.24966329336166382,
- 4.12544059753418,
- -5,
- -5,
- 1.536503791809082,
- 1.7359037399291992,
- 5,
- -3.840538263320923,
- -5,
- -5,
- -5,
- 4.124938011169434,
- -4.646697998046875,
- -5,
- 4.167131423950195,
- -3.3831329345703125,
- -3.5020036697387695,
- 3.266669988632202,
- -0.9436191916465759,
- -1.5299025774002075,
- -1.982384204864502,
- 3.6774818897247314,
- -2.2120511531829834,
- -0.3448413610458374,
- -3.386986017227173,
- -3.1074790954589844,
- -0.4411892294883728,
- -0.3736647963523865,
- -5,
- -5,
- -1.2011436223983765,
- -1.1121392250061035,
- -2.1613833904266357,
- -2.2924811840057373,
- 3.104656934738159,
- 2.610442638397217,
- 5,
- -5,
- -2.3681676387786865,
- 3.672323226928711,
- 3.7326676845550537,
- 0.1613098382949829,
- 0.2413194328546524,
- 1.3728821277618408,
- 0.4339759051799774,
- 0.35695144534111023,
- -2.493479013442993,
- 2.1896910667419434,
- 4.700502395629883,
- 5,
- -1.016597032546997,
- 0.6210448145866394,
- 0.6637445688247681,
- 5,
- -1.0216628313064575,
- -0.23358485102653503,
- 3.3018922805786133,
- 1.8105369806289673,
- 0.955568790435791,
- -3.7231528759002686,
- -3.9804978370666504,
- -1.2900493144989014,
- 4.1124267578125,
- -3.540820360183716,
- -5,
- -3.8975656032562256,
- 1.2156816720962524,
- 0.7590240836143494,
- 3.5594608783721924,
- -3.283069372177124,
- -5,
- -3.2769768238067627,
- 0.1670776754617691,
- -0.7176233530044556,
- 0.9799598455429077,
- 1.3872452974319458,
- -2.0572428703308105,
- -3.3091535568237305,
- -1.3487980365753174,
- -4.625357627868652,
- -2.012728691101074,
- -5,
- 0.8194661736488342,
- -1.579920768737793,
- -1.5731505155563354,
- -4.639402389526367,
- -1.7494895458221436,
- -3.0217342376708984,
- -1.5556175708770752,
- 2.022423028945923,
- -2.8629543781280518,
- 1.2468470335006714,
- 1.9912384748458862,
- -1.0789836645126343,
- -0.08867280930280685,
- -1.3601857423782349,
- 0.519882321357727,
- 2.222944498062134,
- 0.5680000185966492,
- 2.373995542526245,
- -2.9980807304382324,
- 3.2855708599090576
- ],
- "y": [
- -0.9644528031349182,
- -0.5014916062355042,
- -0.9228641390800476,
- -0.9955595135688782,
- 0.2492223083972931,
- 0.057115908712148666,
- -0.16631139814853668,
- -0.06584170460700989,
- 0.10396039485931396,
- -0.31133314967155457,
- -0.041115161031484604,
- -0.04820563644170761,
- -0.949433445930481,
- -0.8801339268684387,
- -0.5981799364089966,
- -0.9736314415931702,
- -0.43101099133491516,
- -0.4243756830692291,
- -0.4731490910053253,
- -0.6577183604240417,
- 0.2146396040916443,
- 0.5974391102790833,
- 0.2125028818845749,
- 0.43337777256965637,
- 0.4884589910507202,
- 0.6967326402664185,
- 0.6029126048088074,
- 0.23680882155895233,
- 0.6917465329170227,
- 0.4850515127182007,
- 0.18376414477825165,
- 0.48162636160850525,
- -0.6320042610168457,
- -0.7730603814125061,
- -0.9154437184333801,
- -0.9334678649902344,
- -0.937618613243103,
- -0.6324880123138428,
- -0.9645949602127075,
- -0.8584909439086914,
- -0.021662965416908264,
- -0.19917190074920654,
- -0.40617337822914124,
- 0.01375947892665863,
- 0.6443992257118225,
- 0.2646108865737915,
- 0.3110242187976837,
- 0.4987179636955261,
- 0.2822154462337494,
- 0.22283178567886353,
- 0.3027957081794739,
- 0.48568424582481384,
- -0.004136862698942423,
- 0.24444110691547394,
- 0.3975219428539276,
- 0.06679671257734299,
- 0.3392251133918762,
- 0.4178438186645508,
- 0.0005444167763926089,
- 0.26371410489082336,
- 0.6860716342926025,
- 0.5389652252197266,
- 0.2810700237751007,
- 0.29595068097114563,
- -0.0028515858575701714,
- -0.914943516254425,
- -0.8317362070083618,
- -0.5160342454910278,
- 0.1723458170890808,
- -0.24010129272937775,
- 0.11037452518939972,
- -0.04924260079860687,
- 0.9950059056282043,
- 0.5880264043807983,
- 0.590488612651825,
- 0.6281570792198181,
- -0.1020033061504364,
- 0.12514355778694153,
- 0.26880502700805664,
- -0.06841706484556198,
- 0.07446050643920898,
- -0.19104579091072083,
- 0.17392556369304657,
- -0.010952293872833252,
- 0.8551027774810791,
- 0.8424614071846008,
- 0.4966377019882202,
- 0.9818977117538452,
- -0.7847625613212585,
- -0.3964613676071167,
- -0.7274291515350342,
- 0.9931104183197021,
- 0.990178644657135,
- 0.9477092027664185,
- -0.7309668660163879,
- -0.8255475759506226,
- -0.5082603693008423,
- -0.8930004835128784,
- 0.4194926917552948,
- 0.20234280824661255,
- 0.382354199886322,
- 0.04821555316448212,
- -0.22185000777244568,
- -0.2684493958950043,
- -0.2542339563369751,
- -0.6113150715827942,
- -0.749304473400116,
- 0.9967495203018188,
- 0.6226924657821655,
- 0.9509856700897217,
- 0.9614278674125671,
- -0.5285993218421936,
- -0.26093634963035583,
- -0.44633013010025024,
- -0.7162333726882935,
- 0.37243372201919556,
- 0.7037805914878845,
- 0.5981281399726868,
- 0.8595001101493835,
- -0.2422453761100769,
- -0.2717275023460388,
- -0.342314749956131,
- -0.36787569522857666,
- -0.0067490083165466785,
- -0.12062981724739075,
- -0.10932574421167374,
- 0.7730425596237183,
- 0.7197641730308533,
- 0.5498804450035095,
- 0.8838788866996765,
- -0.4682152271270752,
- -0.8429638743400574,
- -0.7152993083000183,
- 0.16587448120117188,
- 0.17635276913642883,
- 0.4282841980457306,
- -0.06333015114068985,
- 0.0034832851961255074,
- 0.09057462960481644,
- -0.7059872150421143,
- -0.3774401545524597,
- -0.6989597082138062,
- -0.5003755688667297,
- 0.7566817402839661,
- 0.44234010577201843,
- 0.45263102650642395,
- 0.5166338682174683,
- 0.16024252772331238,
- 0.5950716137886047,
- -0.18073487281799316,
- 0.0018878098344430327,
- -0.2708609104156494,
- -0.25196877121925354,
- -0.11142797023057938,
- -0.43370550870895386,
- -0.15656259655952454,
- -0.039399806410074234,
- 0.46687936782836914,
- 0.32242169976234436,
- 0.6205798983573914,
- 0.6568413972854614,
- 0.2932124137878418,
- 0.286562442779541,
- 0.5216072797775269,
- -0.9623097777366638,
- -0.9981469511985779,
- -0.6364484429359436,
- -0.9993236660957336,
- -0.07432012259960175,
- 0.42001017928123474,
- 0.34383609890937805,
- -0.08206897974014282,
- 0.17495545744895935,
- -0.6187282204627991,
- -0.17506438493728638,
- -0.16744637489318848,
- -0.3097870349884033,
- -0.4293544590473175,
- -0.34442025423049927,
- -0.08278083801269531,
- 0.040901072323322296,
- -0.20948979258537292,
- -0.8171733617782593,
- -0.6349214315414429,
- -0.63686603307724,
- -0.34542766213417053,
- 0.9818851351737976,
- 0.7231388688087463,
- -0.4980590343475342,
- -0.5276463031768799,
- -0.6645891070365906,
- 0.6138550639152527,
- 0.7307949662208557,
- 0.565581202507019,
- 0.8974766731262207,
- 0.2210589051246643,
- -0.04366305470466614,
- 0.2200208306312561,
- 0.9976720213890076,
- 0.9910743236541748,
- 0.04993176832795143,
- 0.2965986132621765,
- 0.3659362196922302,
- -0.6525683999061584,
- -0.4112653136253357,
- -0.9211462140083313,
- -0.8424838185310364,
- -0.9637735486030579,
- -0.9835269451141357,
- -0.9970294237136841,
- -0.9710226655006409,
- -0.9704429507255554,
- -0.000344896805472672,
- 0.21921929717063904,
- -0.13210053741931915,
- 0.1057116687297821,
- -0.5773980617523193,
- -0.8491992354393005,
- -0.9644528031349182,
- -0.9644528031349182,
- 0.18421055376529694,
- -0.34306600689888,
- -0.6099089980125427,
- -0.522908627986908,
- 0.5520397424697876,
- 0.6777611374855042,
- 0.7900189757347107,
- 0.8836524486541748,
- 0.998988151550293,
- 0.6972864270210266,
- 0.9325829744338989,
- -0.7420949339866638,
- -0.8717162013053894,
- 0.3239639103412628,
- 0.3646659553050995,
- 0.18762114644050598,
- 0.4323038160800934,
- 0.49042609333992004,
- 0.4172574579715729,
- -0.4056946337223053,
- -0.7565715909004211,
- -0.8770694732666016,
- -0.6713137626647949,
- 0.3914759159088135,
- 0.5560338497161865,
- 0.401335746049881,
- 0.6967827081680298,
- 0.5735718011856079,
- 0.9659417867660522,
- 0.4600377678871155,
- -0.7376769781112671,
- -0.7612969279289246,
- -0.8649499416351318,
- -0.9680713415145874,
- -0.07136695086956024,
- 0.08702337741851807,
- -0.0012019457062706351,
- -0.40912172198295593,
- -0.006982382852584124,
- -0.2469279021024704,
- 0.2634161114692688,
- 0.19823867082595825,
- 0.6264614462852478,
- -0.0895332545042038,
- 0.15487948060035706,
- 0.010749834589660168,
- 0.21317049860954285,
- 0.3579390347003937,
- 0.6785242557525635,
- 0.4390743672847748,
- 0.2672802209854126,
- -0.8758218884468079,
- -0.963442862033844,
- -0.9812936782836914,
- 0.47073882818222046,
- 0.4233376085758209,
- 0.6527111530303955,
- 0.6982703804969788,
- 0.6721965670585632,
- 0.9104544520378113,
- 0.8594658970832825,
- 0.9712696671485901,
- 0.7178391218185425,
- 0.9804772734642029,
- 0.9899379014968872,
- -0.272844135761261,
- -0.23376643657684326,
- -0.262163907289505,
- 0.03704443946480751,
- -0.4075758457183838,
- -0.7010478377342224,
- -0.20673303306102753,
- -0.5571584105491638,
- -0.8706849217414856,
- -0.48726165294647217,
- -0.2910931706428528,
- -0.002765015931800008,
- 0.05970108136534691,
- 0.3084672689437866,
- 0.15337669849395752,
- -0.6174674034118652,
- -0.6328142881393433,
- -0.5624826550483704,
- 0.1400715708732605,
- 0.3191937208175659,
- 0.02131892368197441,
- -0.09887219220399857,
- -0.13459566235542297,
- 0.031372569501399994,
- -0.23347316682338715,
- -0.1083475649356842,
- 0.10015857964754105,
- -0.15261906385421753,
- -0.3190996050834656,
- 0.5962103009223938,
- 0.944227933883667,
- 0.6263585686683655,
- -0.03721585124731064,
- -0.14064188301563263,
- -0.12287423759698868,
- 0.1620333045721054,
- 0.051118478178977966,
- 0.025942236185073853,
- 0.9509856700897217,
- 0.07660112529993057,
- -0.2148650735616684,
- -0.2792571783065796,
- -0.3916383981704712,
- -0.5475131869316101,
- -0.3573049306869507,
- -0.5381907820701599,
- 0.5642790794372559,
- 0.39763057231903076,
- 0.4926196038722992,
- 0.6876794695854187,
- 0.9853602051734924,
- 0.9853602051734924,
- 0.2784459888935089,
- 0.33439427614212036,
- 0.3757942020893097,
- 0.5680580735206604,
- -0.202531099319458,
- 0.04602264240384102,
- 0.1253708153963089,
- -0.053822703659534454,
- -0.09523261338472366,
- -0.3647562861442566,
- 0.055967457592487335,
- -0.18043585121631622,
- -0.36183372139930725,
- -0.26616132259368896,
- 0.5843426585197449,
- 0.7874525785446167,
- 0.3204408586025238,
- 0.46942922472953796,
- -0.3549381494522095,
- -0.15470989048480988,
- -0.28662583231925964,
- -0.45677778124809265,
- -0.14482297003269196,
- -0.3699699342250824,
- -0.31996339559555054,
- 0,
- 0.03902474418282509,
- -0.4207833707332611,
- 0.5997176170349121,
- 0.34521904587745667,
- 0.260562002658844,
- 0.301216721534729,
- -0.39678168296813965,
- -0.9933051466941833,
- -0.48806899785995483,
- -0.9801273941993713,
- -0.9932265877723694,
- -0.00268577691167593,
- -0.4860992431640625,
- -0.718903660774231,
- -0.22610677778720856,
- 0.40737977623939514,
- 0.7242735624313354,
- 0.9194390773773193,
- 0.992190957069397,
- 0.5167772769927979,
- -0.8444285988807678,
- -0.6822850704193115,
- 0.6697694063186646,
- 0.9455884695053101,
- -0.563209056854248,
- -0.6827536821365356,
- -0.6466551423072815,
- -1,
- 0.00808846578001976,
- -0.21341004967689514,
- -0.08499597012996674,
- -0.22998903691768646,
- -0.6067743301391602,
- -0.49108201265335083,
- -0.5265984535217285,
- -0.9826362729072571,
- -0.23542766273021698,
- -0.2631172835826874,
- -0.38973894715309143,
- -0.510794460773468,
- 0.614811897277832,
- 0.9284683465957642,
- 0.980880856513977,
- 0.6759928464889526,
- 0.7887943387031555,
- 0.334210067987442,
- 0.8685921430587769,
- 0.9433988928794861,
- 0.3017013370990753,
- 0.322925865650177,
- 0.0030513221863657236,
- -0.08400421589612961,
- 0.1492752730846405,
- 0.15100379288196564,
- 0.2531687021255493,
- 0.22673995792865753,
- 0.08318476378917694,
- -0.09412675350904465,
- -0.10312476009130478,
- 0.00051957240793854,
- 0.1938382387161255,
- -0.429431289434433,
- -0.6668448448181152,
- 0.27889484167099,
- -0.9699349999427795,
- -0.6830593347549438,
- -0.9178845286369324,
- -0.8040575385093689,
- -0.03522491827607155,
- 0.586391270160675,
- 0.9315357804298401,
- 0.7273709177970886,
- 0.23738005757331848,
- 0.16160446405410767,
- 0.196137934923172,
- 0.6648127436637878,
- 0.9904631972312927,
- 0.9321214556694031,
- -0.9826473593711853,
- -0.5793296098709106,
- -0.5139965415000916,
- -0.9829296469688416,
- 0.10490112006664276,
- 0.26333707571029663,
- 0.015549364499747753,
- 0.7950919270515442,
- -0.22844749689102173,
- 0.08410408347845078,
- -0.014554033055901527,
- -0.40973183512687683,
- -0.6088537573814392,
- -0.7200993895530701,
- -0.25975117087364197,
- -0.05376914516091347,
- 0.25696367025375366,
- -0.02727169543504715,
- -0.9200538992881775,
- -0.9851748943328857,
- 0.2039009928703308,
- -0.18674251437187195,
- -0.0373150035738945,
- 0.0003531149122864008,
- 0.7743528485298157,
- 0.49138516187667847,
- 0.8453116416931152,
- 0.8113861680030823,
- -0.2243531048297882,
- 0.17102263867855072,
- 0.13133029639720917,
- -0.8719936609268188,
- -0.7000458240509033,
- -0.5028141736984253,
- 0.5621294975280762,
- -0.48999398946762085,
- 1,
- 0.9576523303985596,
- -0.41538330912590027,
- -0.5296134352684021,
- -0.5272583365440369,
- 0.26668936014175415,
- 0.9760602116584778,
- 0.874788224697113,
- -0.8827227354049683,
- -0.9637153744697571,
- -0.5040878057479858,
- -0.27172648906707764,
- 0.274967223405838,
- -0.01066218875348568,
- 0.29421308636665344,
- 0.1539771407842636,
- 0.15297439694404602,
- 0.35023635625839233,
- -0.21796944737434387,
- 0.8537461161613464,
- 0.9835426211357117,
- 0.9496530294418335,
- 0.9985606074333191,
- -0.2221001833677292,
- 0.4310095012187958,
- 0.6029019355773926,
- 0.7001603841781616,
- 0.8360967636108398,
- 0.519031286239624,
- -0.9936496019363403,
- -0.9828091859817505,
- 0.26668936014175415,
- 0.5236851572990417,
- 0.49962037801742554,
- 0.5692272782325745,
- 0.22008033096790314,
- 0.2918113172054291,
- -0.005608721170574427,
- 0.03870052844285965,
- 0.26892536878585815,
- -0.1814487725496292,
- 0.06543553620576859,
- 0.08210965245962143,
- -0.09493392705917358,
- 0.23452402651309967,
- 0.04021294042468071,
- -0.09652941673994064,
- 0.6716895699501038,
- 0.8282829523086548,
- -0.5790790915489197,
- -0.7159784436225891,
- -0.874889612197876,
- -0.9411375522613525,
- -0.25209754705429077,
- -0.6056337356567383,
- -0.4996890425682068,
- 0.268974632024765,
- 0.4170511066913605,
- 0.2456361949443817,
- 0.17661170661449432,
- -0.6461558938026428,
- -0.8366621732711792,
- -0.9373155832290649,
- 0.6573933362960815,
- 0.764940083026886,
- 0.4581672251224518,
- 0.012059792876243591,
- -0.36481741070747375,
- 0.047285694628953934,
- -0.19150404632091522,
- -0.06492480635643005,
- 0.2849947214126587,
- 0.49767422676086426,
- 0.28277072310447693,
- 0.54390949010849,
- 0.1638433039188385,
- -0.31062552332878113,
- -0.08801092207431793,
- -0.47230759263038635,
- -0.2938145399093628,
- -0.0704847201704979,
- 0.6260424852371216,
- 0.39466437697410583,
- 0.31425905227661133,
- 0.7220942974090576,
- -0.7903173565864563,
- 0.2835279703140259,
- 0.6021785140037537,
- 0.5951641798019409,
- 0.3522506654262543,
- 0.5202761888504028,
- 0.6336329579353333,
- 0.44877156615257263,
- 0.5989428758621216,
- 0.9741127490997314,
- 0.9952908158302307,
- 0.6856418251991272,
- -0.18962796032428741,
- 0.14198823273181915,
- 0.027870045974850655,
- -0.2665543556213379,
- -0.12062981724739075,
- -0.35000452399253845,
- -0.6031556725502014,
- -0.7968862652778625,
- -0.9509775042533875,
- 0.2576938569545746,
- -0.17726917564868927,
- 0.9844260215759277,
- -0.4435259699821472,
- -0.1699523627758026,
- 0.6966899037361145,
- 0.9935153722763062,
- 0.994518518447876,
- 0.9067777991294861,
- -0.9979760646820068,
- -0.9827584624290466,
- -0.01198972761631012,
- 0.004887382499873638,
- 0.9262871146202087,
- -0.011220625601708889,
- 0.20926238596439362,
- 0.08175507932901382,
- 0.13949643075466156,
- 0.24324852228164673,
- 0.2432398945093155,
- -0.03161051869392395,
- 0.41032442450523376,
- 0.5218767523765564,
- -0.1977277398109436,
- 0.07446050643920898,
- -0.20594902336597443,
- -0.3251917064189911,
- -0.6149249076843262,
- 0.4732542634010315,
- 0.07446050643920898,
- 0.3481038212776184,
- 0.22188933193683624,
- 0.2149362415075302,
- -0.24006293714046478,
- -0.2876802384853363,
- 0.41702282428741455,
- 0.19047819077968597,
- -0.2501949965953827,
- -0.15160758793354034,
- 0.43379339575767517,
- 0.0909355953335762,
- 0.451621413230896,
- 0.5065004825592041,
- -0.9908729195594788,
- -0.08206022530794144,
- -0.027877792716026306,
- 0.5542229413986206,
- -0.38842886686325073,
- 0.9741654992103577,
- -0.3724351227283478,
- -0.1986246407032013,
- -0.3232215344905853,
- 0.7665350437164307,
- 0.5796975493431091,
- -0.6754114627838135,
- -0.8743530511856079,
- -0.8580234050750732,
- 0.7657902240753174,
- 0.6770547032356262,
- 0.5566800236701965,
- 0.935212254524231,
- -0.584112286567688,
- 0.017612561583518982,
- -0.36803585290908813,
- -0.5247402191162109,
- 0.4970661997795105,
- -0.6998907327651978,
- -0.5846438407897949,
- 0.9509856700897217,
- 0.8254937529563904,
- 0.6614059805870056,
- 0.5184406042098999,
- -0.5043556690216064,
- -0.8817981481552124,
- -0.6980621218681335,
- -0.3875381350517273,
- -0.9762217998504639,
- -0.9982428550720215,
- 0.2067089080810547,
- 0.11346746981143951,
- 0.01595616154372692,
- -0.2828061878681183,
- 0.014170551672577858,
- 0.6205798983573914,
- -0.8973569869995117,
- -0.7388009428977966,
- -0.5494065880775452,
- -0.8166348338127136,
- 0.5313565731048584,
- -0.004518178757280111,
- 0.48383238911628723,
- -0.4977671205997467,
- -0.11393170058727264,
- -0.1845625638961792,
- -0.3601009249687195,
- -0.314405232667923,
- 0.48286524415016174,
- 0.20714795589447021,
- 0.040663253515958786,
- -0.9531037211418152,
- -0.26953038573265076,
- -0.4040994942188263,
- -0.26528051495552063,
- 0.23274151980876923,
- -0.6318374872207642,
- -0.9665676951408386,
- 0.005913611501455307,
- 0.49386274814605713,
- 0.23279796540737152,
- 0.24144552648067474,
- 0.3414899408817291,
- 0.30328240990638733,
- -0.9941494464874268,
- -0.3179697096347809,
- -0.25289952754974365,
- -0.4826950430870056,
- -0.992070198059082,
- -0.9115789532661438,
- -0.5940829515457153,
- -0.5463100671768188,
- -0.9485341310501099,
- -0.6519872546195984,
- -0.9987034797668457,
- -0.5913269519805908,
- -0.7342608571052551,
- 1,
- 0.45685240626335144,
- -0.0836566612124443,
- -0.5427722334861755,
- -0.2221001833677292,
- -0.9979760646820068,
- -0.7426897883415222,
- 0.4536954462528229,
- -0.5354653596878052,
- -0.5605345368385315,
- -0.24477224051952362,
- -0.31265220046043396,
- -0.8582495450973511,
- -0.2184845358133316,
- -0.8255475759506226,
- -0.8973569869995117,
- -0.9509775042533875,
- 0.7109987735748291,
- -0.3486618995666504,
- -0.5666218400001526,
- 0.0820944681763649,
- 0.28015971183776855,
- -0.9690587520599365,
- -0.6733459830284119,
- -0.929873526096344,
- 0.05627104640007019,
- -0.5349896550178528,
- -0.49556639790534973,
- -0.2316868156194687,
- -0.2666398584842682,
- -0.5846438407897949,
- 0.9041470885276794,
- 0.34881946444511414,
- 0.73880535364151,
- -0.4977671205997467,
- -0.620514452457428,
- 0.3705782890319824,
- -0.3981460928916931,
- -0.7447241544723511,
- -0.5671089291572571,
- -0.7126420140266418,
- 0.3201524019241333,
- -0.9361801147460938,
- -0.021949056535959244,
- 0.26071488857269287,
- 0.11704500019550323,
- -0.09812191873788834,
- -0.6564890742301941,
- 0.5860076546669006,
- 0.23305492103099823,
- 0.1070864275097847,
- 0.02329915389418602,
- -0.2407625913619995,
- 0.3414646089076996,
- 0.6114945411682129,
- 0.0007608749438077211,
- -0.18877489864826202,
- -0.06473154574632645,
- -0.5393319725990295,
- -0.37636464834213257,
- -0.2776724100112915,
- 0.407381534576416,
- 0.5711175799369812,
- 0.10242214798927307,
- -0.5774988532066345,
- 0.5009621977806091,
- 0.7229906320571899,
- 0.5307389497756958,
- 0.8771102428436279,
- -0.6564419269561768,
- -0.41044551134109497,
- -0.6564419269561768,
- -0.7309668660163879,
- -0.9828091859817505,
- -0.9828091859817505,
- -0.31996339559555054,
- 0.02778959460556507,
- -0.18145851790905,
- -0.4760945737361908,
- -0.6159340143203735,
- -0.5961918830871582,
- -0.6848282217979431,
- -0.251895934343338,
- 0.29486724734306335,
- 0.40002304315567017,
- 0.9899379014968872,
- 0.7229412794113159,
- 0.9807852506637573,
- -0.7337335348129272,
- -0.8108888864517212,
- -0.5162743926048279,
- -0.6094732284545898,
- -0.9194790720939636,
- 0.5308945178985596,
- 0.01500244252383709,
- -0.7993972897529602,
- 0.9984241127967834,
- -0.012843931093811989,
- -0.8668404221534729,
- 0.990543007850647,
- 0.0920555591583252,
- -0.31916898488998413,
- 0.9374285340309143,
- 0.7959373593330383,
- 0.8754876255989075,
- -0.8362293243408203,
- -0.6582773923873901,
- -0.9916395545005798,
- -0.8973569869995117,
- 0.061656251549720764,
- 0.5361354351043701,
- 0.36971715092658997,
- -0.4583832919597626,
- -0.46862149238586426,
- -0.9807852506637573,
- -0.9511585831642151,
- -0.27999889850616455,
- 0.038460005074739456,
- 0.1938815712928772,
- 0.19310392439365387,
- 0.5270761847496033,
- 0.5389652252197266,
- -0.5263717770576477,
- 0.31121960282325745,
- 0.13053779304027557,
- 0.2712872624397278,
- 0.9807852506637573,
- -0.97075355052948,
- 0.9580817818641663,
- 0.7310782670974731,
- 0.5388161540031433,
- 0.9519411325454712,
- 0.8434329628944397,
- -0.4833066761493683,
- -0.20707954466342926,
- -0.5099445581436157,
- -0.6608012318611145,
- -0.018839603289961815,
- -0.7309668660163879,
- -0.5254232883453369,
- 0.3551715314388275,
- -0.21630725264549255,
- -0.39276570081710815,
- -0.07621423900127411,
- 0.02646898478269577,
- 0.3646659553050995,
- 0.8563774824142456,
- 0.5865227580070496,
- 0.46233615279197693,
- 0.8343841433525085,
- -0.8973569869995117,
- -0.5947028398513794,
- -0.8064454793930054,
- 0.570570170879364,
- 0.5161767601966858,
- 0.48175233602523804,
- 0.4885003864765167,
- -0.38643592596054077,
- -0.4773034155368805,
- -0.38785600662231445,
- 0.8576608896255493,
- -0.9899351596832275,
- 0.9875081777572632,
- -0.1636705994606018,
- -0.9172571897506714,
- -0.16427050530910492,
- -0.4349454939365387,
- -0.9953550100326538,
- -0.9971668124198914,
- 0.6962160468101501,
- 0.5453452467918396,
- -0.05568347126245499,
- -0.6601232290267944,
- -0.842789351940155,
- -0.2496166080236435,
- -0.8420789837837219,
- -0.8744059801101685,
- -0.834104597568512,
- -0.9026780724525452,
- 0.9523860216140747,
- 0.9934259653091431,
- -0.7173683643341064,
- -0.9974165558815002,
- 0.3086850345134735,
- -0.8398857116699219,
- -0.2520681619644165,
- -0.2881055772304535,
- -0.17640793323516846,
- -0.8340798020362854,
- 0.803859293460846,
- -0.5375675559043884,
- -0.35286054015159607,
- -0.40147092938423157,
- -0.5391048192977905,
- -0.4075758457183838,
- -0.06929513067007065,
- 0.4999752938747406,
- 0.5083998441696167,
- 0.7683452367782593,
- 0.44873738288879395,
- 0.1870150864124298,
- 0.44929590821266174,
- 0.7604588270187378,
- -0.253332257270813,
- 0.7990961074829102,
- -0.4588089883327484,
- -0.36481741070747375,
- -0.2928994297981262,
- -0.620514452457428,
- -0.8754743337631226,
- -0.6474624276161194,
- -0.7147241830825806,
- -0.8206048011779785,
- 0.8667620420455933,
- 0.8917268514633179,
- 0.9518074989318848,
- -0.5455569624900818,
- 0.06518997251987457,
- -0.1746850311756134,
- 0.711083710193634,
- -0.7957763075828552,
- -0.23037903010845184,
- 0.4979412853717804,
- -0.9531556367874146,
- -0.9841888546943665,
- 0.04183444380760193,
- 0.8254937529563904,
- 0.9814017415046692,
- -0.5506122708320618,
- 0.9509856700897217,
- 0.8974766731262207,
- 0.8271036744117737,
- 0.6565945744514465,
- 0.5882179737091064,
- 0.4074084758758545,
- 0.1779918372631073,
- 0.8254937529563904,
- 0.3646659553050995,
- 0.6998251676559448,
- -0.25461456179618835,
- -0.16163697838783264,
- 0.5031144618988037,
- 0.056570108979940414,
- 0.4599801003932953,
- 0.22676178812980652,
- -0.27921000123023987,
- -0.5993555784225464,
- 0.9872598648071289,
- -0.1492013782262802,
- -0.11010982096195221,
- 0.08578278124332428,
- -0.176510289311409,
- 0.12077020108699799,
- -0.08411595970392227,
- 0.9915391802787781,
- 0.7307949662208557,
- 0.8754876255989075,
- -0.2441762387752533,
- -0.14552778005599976,
- -0.2168065309524536,
- -0.4977671205997467,
- 0.6998251676559448,
- 0.5844343304634094,
- -0.4977671205997467,
- -0.5964337587356567,
- 0.16315852105617523,
- 0.7636315226554871,
- 0.265627384185791,
- 0.9430791139602661,
- 0.6161730289459229,
- 0.9977315664291382,
- 0.9039280414581299,
- -0.06703191250562668,
- 0.4994438886642456,
- 0.4858933091163635,
- 0.9834839701652527,
- 0.880670964717865,
- 0.8490715026855469,
- 0.9645264744758606,
- -0.9836878776550293,
- 0.020235415548086166,
- 0.6966110467910767,
- 0.9339800477027893,
- 0.5601944327354431,
- -0.00601609330624342,
- 0.22188933193683624,
- 0.06982731819152832,
- 0.42058631777763367,
- -0.20701900124549866,
- -0.5002540349960327,
- -0.9948720335960388,
- -0.6225435733795166,
- 0.29936158657073975,
- -0.9993430376052856,
- -0.8705465197563171,
- 0.9978688955307007,
- 0.9816693663597107,
- -0.2221001833677292,
- -0.07432012259960175,
- 0.005510379560291767,
- 0.93561190366745,
- 0.769040584564209,
- 0.4979412853717804,
- 0.09552592039108276,
- -0.4952143132686615,
- 0.8628236055374146,
- 0.891992449760437,
- 0.3251786231994629,
- -0.9622695446014404,
- -0.9051315188407898,
- 0.6972473859786987,
- -0.9227719902992249,
- -0.9991018772125244,
- 0.9954250454902649,
- -0.2867448031902313,
- 0.40268635749816895,
- 0.14126500487327576,
- 0.9529435634613037,
- 0.6507450938224792,
- 0.27342158555984497,
- -0.9639715552330017,
- -0.971455454826355,
- 0.9434934258460999,
- 0.7417119145393372,
- 0.922407329082489,
- 0.7960216403007507,
- 0.39301806688308716,
- 0.44151046872138977,
- 0.9164034128189087,
- -0.45337846875190735,
- -0.7604051232337952,
- -0.9881238341331482,
- 0.3329641819000244,
- 0.5564926266670227,
- -0.7899213433265686,
- 0.7021987438201904,
- -0.9409090876579285,
- 0.8222968578338623,
- -0.1262354850769043,
- 0.9899379014968872,
- 0.8101232051849365,
- 0.4139884412288666,
- 0.4850161373615265,
- 0.8455127477645874,
- -0.7117887139320374,
- -0.9599732160568237,
- 0.32545220851898193,
- -0.017274606972932816,
- 0.0917535200715065,
- 0.9274268746376038,
- 0.7069732546806335
- ],
- "z": [
- 0.24893133342266083,
- 0.06961314380168915,
- 0.38458311557769775,
- 0.045085154473781586,
- -0.2524856626987457,
- -0.6164182424545288,
- -0.4557993710041046,
- -0.09390309453010559,
- -0.6660021543502808,
- -0.5890951156616211,
- -0.9959505200386047,
- -0.6060599088668823,
- -0.298443466424942,
- -0.4645257592201233,
- -0.23048292100429535,
- -0.21867342293262482,
- -0.31317806243896484,
- 0.07732536643743515,
- -0.3414348065853119,
- -0.05248579755425453,
- -0.10382933914661407,
- -0.019813725724816322,
- 0.2175561636686325,
- 0.13014905154705048,
- 0.40530869364738464,
- 0.7156205773353577,
- 0.7926167249679565,
- 0.4570474326610565,
- -0.13187628984451294,
- 0.12653519213199615,
- -0.22819986939430237,
- -0.3281902074813843,
- 0.28013405203819275,
- 0.6267420649528503,
- 0.39846572279930115,
- 0.3510749340057373,
- -0.33739176392555237,
- -0.18817365169525146,
- -0.24846261739730835,
- -0.5050169229507446,
- -0.5259588956832886,
- -0.26771974563598633,
- -0.446445107460022,
- -0.248659148812294,
- 0.24804984033107758,
- 0.18279309570789337,
- 0.03786000609397888,
- -0.07831154018640518,
- -0.20537401735782623,
- 0.22865191102027893,
- 0.03590712696313858,
- 0.0510106198489666,
- -0.5112490653991699,
- -0.4819660484790802,
- -0.5647855401039124,
- -0.9934210777282715,
- -0.9370624423027039,
- -0.3811916410923004,
- -0.5316653251647949,
- -0.5263366103172302,
- -0.7243698835372925,
- -0.8403451442718506,
- -0.5899010300636292,
- -0.9501896500587463,
- -0.9997191429138184,
- 0.3994015157222748,
- 0.5550714731216431,
- 0.1366790235042572,
- 0.33598801493644714,
- 0.49225300550460815,
- 0.6483957171440125,
- 0.3165377676486969,
- 0.05070596933364868,
- 0.3658945858478546,
- 0.07349245995283127,
- 0.02135220356285572,
- 0.9899535775184631,
- 0.6588714122772217,
- 0.9584241509437561,
- 0.7039474248886108,
- 0.9926663041114807,
- 0.5769069790840149,
- 0.6764622330665588,
- 0.998921275138855,
- 0.5113556385040283,
- 0.5350059866905212,
- 0.4005412459373474,
- 0.18379539251327515,
- -0.6124829649925232,
- -0.916515052318573,
- -0.6823439002037048,
- 0.06995134800672531,
- -0.09971776604652405,
- 0.30412760376930237,
- -0.678033173084259,
- -0.5627862811088562,
- -0.42405495047569275,
- -0.4404540956020355,
- -0.22640195488929749,
- -0.2587750554084778,
- -0.5708564519882202,
- -0.5173807144165039,
- -0.9726678133010864,
- -0.6065524220466614,
- -0.9628442525863647,
- -0.060457516461610794,
- 0.07383366674184799,
- 0.033002905547618866,
- -0.26771634817123413,
- -0.29332637786865234,
- -0.2589031755924225,
- 0.4012563228607178,
- 0.6697467565536499,
- 0.37911468744277954,
- 0.6959860324859619,
- -0.3439806401729584,
- -0.709836483001709,
- -0.36161622405052185,
- -0.5031288266181946,
- -0.37700721621513367,
- -0.027168434113264084,
- 0.1186046227812767,
- 0.9283714294433594,
- 0.6873116493225098,
- 0.9881190061569214,
- 0.9892323613166809,
- 0.6267638206481934,
- 0.6916837096214294,
- 0.3116864562034607,
- 0.45751941204071045,
- -0.30098357796669006,
- -0.5340659618377686,
- -0.070583276450634,
- 0.9836627840995789,
- 0.9826307892799377,
- 0.2885918915271759,
- 0.23875781893730164,
- -0.0010253038490191102,
- -0.01305148471146822,
- -0.7080255746841431,
- -0.5416524410247803,
- -0.7137928605079651,
- -0.8609718084335327,
- -0.6466995477676392,
- -0.22543102502822876,
- -0.46304792165756226,
- 0.40055951476097107,
- 0.5511629581451416,
- 0.4643996059894562,
- -0.24696844816207886,
- 0.0023746946826577187,
- -0.121971994638443,
- 0.09900698065757751,
- 0.24953289330005646,
- 0.22445939481258392,
- 0.10599268972873688,
- -0.02011456899344921,
- 0.4988115429878235,
- 0.9421597123146057,
- 0.7781175374984741,
- 0.7483584880828857,
- -0.9510202407836914,
- -0.5498870611190796,
- -0.8496232032775879,
- -0.25599583983421326,
- -0.018814457580447197,
- 0.0450722798705101,
- 0.006867034826427698,
- 0.9926801323890686,
- -0.33451950550079346,
- -0.6014363765716553,
- -0.3249167501926422,
- -0.42981573939323425,
- -0.7796371579170227,
- -0.6329610347747803,
- -0.9835079908370972,
- -0.9459924101829529,
- -0.5039926767349243,
- -0.4338308274745941,
- -0.25865885615348816,
- -0.6047350168228149,
- -0.20979124307632446,
- 0.5729902386665344,
- 0.7663477659225464,
- 0.29461243748664856,
- 0.5809187293052673,
- -0.18392319977283478,
- 0.020668039098381996,
- -0.27200955152511597,
- 0.03924412652850151,
- 0.0195060633122921,
- 0.3324436545372009,
- 0.6782426834106445,
- 0.17382746934890747,
- 0.4320796728134155,
- 0.20146599411964417,
- 0.37333109974861145,
- 0.5286331176757812,
- -0.02363656461238861,
- -0.0906238928437233,
- 0.5550857782363892,
- 0.5451454520225525,
- 0.5945549011230469,
- -0.7518652677536011,
- -0.5248426795005798,
- -0.387797087430954,
- -0.5349641442298889,
- -0.25117042660713196,
- 0.1672535389661789,
- -0.030160700902342796,
- 0.2272733896970749,
- 0.22918443381786346,
- 0.0007958645583130419,
- -0.47246626019477844,
- -0.26326435804367065,
- -0.2667330503463745,
- 0.2950707972049713,
- 0.5224003791809082,
- 0.24893133342266083,
- 0.24893133342266083,
- -0.3438313901424408,
- 0.2669813930988312,
- -0.05906572937965393,
- 0.3875717222690582,
- 0.2657814919948578,
- 0.7311900854110718,
- 0.6060779690742493,
- 0.45794302225112915,
- -0.010273333638906479,
- 0.1575591117143631,
- 0.3539920449256897,
- -0.6644736528396606,
- -0.48027414083480835,
- -0.9416919350624084,
- 0.9293450713157654,
- 0.4946977198123932,
- 0.5810832977294922,
- 0.8662898540496826,
- 0.9053993225097656,
- 0.5155513882637024,
- 0.6468337774276733,
- 0.4702588617801666,
- 0.11277738958597183,
- -0.048379454761743546,
- -0.2031347006559372,
- -0.4603961706161499,
- -0.1806602030992508,
- 0.10649269074201584,
- 0.24402277171611786,
- 0.22087182104587555,
- 0.6698569059371948,
- 0.6410759091377258,
- 0.4929329752922058,
- 0.23700262606143951,
- -0.37436285614967346,
- -0.2582411468029022,
- 0.000663433806039393,
- -0.9097479581832886,
- -0.6664299368858337,
- -0.9650605320930481,
- 0.4332942068576813,
- 0.19210495054721832,
- 0.2930695116519928,
- 0.23533089458942413,
- 0.6286520957946777,
- 0.6442918181419373,
- 0.34618571400642395,
- -0.006241363473236561,
- 0.1833106428384781,
- 0.29168185591697693,
- -0.002174111781641841,
- 0.47259294986724854,
- 0.25226056575775146,
- 0.1899283230304718,
- 0.1295872926712036,
- -0.14776815474033356,
- -0.007787336595356464,
- 0.1263086497783661,
- 0.15495635569095612,
- 0.40780001878738403,
- 0.5031928420066833,
- 0.22645917534828186,
- 0.04210563376545906,
- 0.1961057186126709,
- -0.10216209292411804,
- 0.28054866194725037,
- 0.4921416640281677,
- 0.18888798356056213,
- 0.29682838916778564,
- 0.9105742573738098,
- 0.7120792269706726,
- 0.46320977807044983,
- 0.830166220664978,
- 0.48220357298851013,
- -0.8679813146591187,
- -0.9516631364822388,
- 0.47452154755592346,
- 0.7259277701377869,
- 0.6084266901016235,
- 0.9848937392234802,
- -0.23830050230026245,
- -0.76807701587677,
- -0.44848307967185974,
- -0.24442195892333984,
- 0.0057609472423791885,
- 0.04943608120083809,
- -0.038206059485673904,
- -0.20376498997211456,
- -0.33428671956062317,
- -0.4373824894428253,
- -0.42244595289230347,
- -0.6520264744758606,
- -0.36086952686309814,
- -0.6188114285469055,
- 0.1818607598543167,
- -0.31560376286506653,
- -0.2107848972082138,
- -0.6734336614608765,
- 0.9861479997634888,
- 0.9878979325294495,
- 0.9840410947799683,
- 0.34084373712539673,
- -0.6104958653450012,
- 0.29332637786865234,
- 0.6329606175422668,
- 0.4734562635421753,
- 0.6387461423873901,
- 0.9190930128097534,
- -0.34333351254463196,
- -0.19907696545124054,
- -0.007516813464462757,
- 0.35606294870376587,
- 0.5664986968040466,
- 0.2380324900150299,
- 0.02087165042757988,
- 0.1486402451992035,
- -0.1486402451992035,
- -0.5884139537811279,
- -0.24894261360168457,
- -0.5900663137435913,
- -0.4645562767982483,
- 0.22966508567333221,
- 0.30052053928375244,
- 0.25223761796951294,
- 0.4725068509578705,
- 0.9906204342842102,
- 0.53376704454422,
- 0.5839667320251465,
- 0.9822286367416382,
- -0.5414755940437317,
- -0.959226131439209,
- -0.8078566789627075,
- -0.6092051267623901,
- -0.634707510471344,
- -0.5340558290481567,
- 0.20579388737678528,
- 0.5619252324104309,
- 0.020743170753121376,
- -0.8842752575874329,
- -0.9857361912727356,
- -0.5279218554496765,
- -0.9429054260253906,
- 0,
- -0.4684806168079376,
- -0.21044278144836426,
- -0.7952387928962708,
- -0.9352442026138306,
- -0.9609246850013733,
- -0.4732184112071991,
- 0.23765499889850616,
- -0.0679740384221077,
- -0.14824911952018738,
- 0.19725912809371948,
- -0.06877187639474869,
- -0.07851611077785492,
- 0.8686026334762573,
- 0.6927322745323181,
- 0.6234987378120422,
- 0.5488587021827698,
- -0.19145558774471283,
- -0.3909909725189209,
- -0.07928632199764252,
- -0.3109854459762573,
- 0.5313256978988647,
- 0.03555777668952942,
- 0.0490003265440464,
- 0.31111860275268555,
- 0.10442136228084564,
- 0.17511685192584991,
- -0.11836609244346619,
- 0,
- -0.01821127161383629,
- -0.3708040714263916,
- -0.2981916069984436,
- -0.46162664890289307,
- -0.1726837307214737,
- -0.123359814286232,
- 0.4126456081867218,
- 0.17629684507846832,
- 0.43020865321159363,
- -0.16406390070915222,
- -0.29134809970855713,
- -0.3465260863304138,
- -0.1638673096895218,
- -0.36755621433258057,
- -0.19412018358707428,
- -0.2797713577747345,
- 0.6075701713562012,
- 0.654580295085907,
- -0.4861188530921936,
- -0.31833672523498535,
- -0.5780981779098511,
- -0.6000235080718994,
- -0.004480898380279541,
- 0.06860040128231049,
- -0.24482126533985138,
- 0.28688132762908936,
- -0.9631673693656921,
- -0.971184492111206,
- -0.5911328792572021,
- -0.9907293319702148,
- 0.5847785472869873,
- 0.9999487996101379,
- 0.5352766513824463,
- -0.8988922834396362,
- -0.7401489019393921,
- 0.9553634524345398,
- -0.23085886240005493,
- -0.11746350675821304,
- -0.3938993215560913,
- -0.5889719724655151,
- -0.2792058289051056,
- -0.3732108473777771,
- -0.3574441075325012,
- -0.6824148297309875,
- -0.22026440501213074,
- -0.5700737833976746,
- -0.5176344513893127,
- 0.12050525844097137,
- -0.09682867676019669,
- -0.35551348328590393,
- -0.17618408799171448,
- -0.2755252420902252,
- 0.04571164771914482,
- -0.17331843078136444,
- -0.9896681308746338,
- -0.6911693215370178,
- -0.5965977907180786,
- -0.5998966097831726,
- -0.9706664681434631,
- -0.9917164444923401,
- -0.6897068619728088,
- -0.9094218611717224,
- 0.78774094581604,
- 0.6912752389907837,
- 0.0785423144698143,
- 0.016106540337204933,
- -0.22879524528980255,
- 0.013991397805511951,
- -0.38984066247940063,
- -0.15052154660224915,
- -0.5829851031303406,
- -0.23330901563167572,
- 0.059916771948337555,
- 0.0003111835103482008,
- 0.6251672506332397,
- 0.31113284826278687,
- 0.5296736359596252,
- -0.5800420045852661,
- 0.5752048492431641,
- 0.6355389952659607,
- 0.25313037633895874,
- -0.47975510358810425,
- -0.7129015326499939,
- 0.2674548923969269,
- -0.20113208889961243,
- 0.3797936737537384,
- 1.1691379777549558e-15,
- -0.2713494598865509,
- 0.40313920378685,
- 0.845343828201294,
- 0.39367449283599854,
- -0.9590659737586975,
- -0.2106667459011078,
- -0.47452685236930847,
- -0.4596824049949646,
- -0.25136223435401917,
- 0.15601640939712524,
- 0.08271649479866028,
- 0.9565548896789551,
- 0.7303852438926697,
- 0.6288405656814575,
- 0.9848345518112183,
- -0.09036430716514587,
- -0.42064154148101807,
- -0.9738449454307556,
- -0.5138938426971436,
- -0.16709473729133606,
- -0.2977195680141449,
- 0.014614290557801723,
- 0.9725919365882874,
- -0.593136191368103,
- 0.7926254868507385,
- 0.7128075361251831,
- 0.5469134449958801,
- 0.4639262855052948,
- -0.06447644531726837,
- 0.17454104125499725,
- -0.9590659737586975,
- -0.8485125303268433,
- -0.8613754510879517,
- -0.8202615976333618,
- -0.9732046723365784,
- -0.44705015420913696,
- -0.9994475841522217,
- -0.7387363910675049,
- -0.9583876729011536,
- 0.5713192224502563,
- 0.6820598244667053,
- 0.6784961819648743,
- 0.9906498193740845,
- -0.9688231945037842,
- -0.6363033056259155,
- -0.9904927015304565,
- -0.09575266391038895,
- -0.5594531893730164,
- 0.3919374942779541,
- 0.6962965726852417,
- 0.4743371605873108,
- 0.32579144835472107,
- -0.036251384764909744,
- 0.30545035004615784,
- -0.3993871510028839,
- -0.16404372453689575,
- -0.05687348172068596,
- 0.06529530882835388,
- -0.2403002232313156,
- -0.21965867280960083,
- -0.5458555817604065,
- -0.33839061856269836,
- -0.7479055523872375,
- -0.6366367340087891,
- -0.8835325837135315,
- -0.998812198638916,
- 0.9292991161346436,
- 0.5906811952590942,
- 0.1568344235420227,
- 0.329791784286499,
- 0.6214436292648315,
- 0.8624156713485718,
- 0.9541876912117004,
- 0.8377023935317993,
- 0.16098438203334808,
- 0.5198801755905151,
- 0.4614923894405365,
- 0.4828778803348541,
- -0.4090541899204254,
- -0.6571433544158936,
- 0.7736345529556274,
- 0.9174755811691284,
- 0.5050711035728455,
- 0.6888444423675537,
- -0.6057143807411194,
- 0.9539580345153809,
- 0.7932191491127014,
- 0.3558451235294342,
- -0.294318825006485,
- -0.43747037649154663,
- -0.2859049141407013,
- -0.5471164584159851,
- 0.3661544919013977,
- 0.21708662807941437,
- 0.047813039273023605,
- -0.10936380922794342,
- -0.9813233017921448,
- 0.6716124415397644,
- 0.9972550272941589,
- 0.9591069221496582,
- 0.9881190061569214,
- -0.5873571634292603,
- -0.7924172282218933,
- -0.597710132598877,
- -0.2933533787727356,
- 0.6591892242431641,
- 0.982540488243103,
- 0.15812546014785767,
- 0.5574328303337097,
- 0.3088320791721344,
- -0.15484392642974854,
- 0.06583964824676514,
- 0.0556543804705143,
- -0.41467854380607605,
- -0.020549282431602478,
- -0.17505614459514618,
- -0.6844256520271301,
- -0.14388316869735718,
- 0.37474673986434937,
- -0.9988948702812195,
- -0.18562301993370056,
- 0.21414516866207123,
- 0.1545124351978302,
- -0.0718170553445816,
- 0.09742579609155655,
- 0.2770216763019562,
- -0.1361367404460907,
- 0.23760713636875153,
- -0.979985237121582,
- -0.9926663041114807,
- -0.9774913191795349,
- -0.16620796918869019,
- 0.3408176600933075,
- -0.8754684329032898,
- -0.9926663041114807,
- -0.9343691468238831,
- -0.9726558923721313,
- 0.3258844017982483,
- -0.6285980939865112,
- -0.9526984095573425,
- 0.5530601739883423,
- 0.4029441475868225,
- -0.15432234108448029,
- -0.25908252596855164,
- 0.4096115529537201,
- 0.43439316749572754,
- -0.8870314359664917,
- -0.41186952590942383,
- 0.09266889840364456,
- 0.2557157576084137,
- 0.6775721907615662,
- -0.4413914978504181,
- 0.13172948360443115,
- 0.21691279113292694,
- -0.9269883036613464,
- 0.30631664395332336,
- 0.21891158819198608,
- -0.6346932053565979,
- -0.3447767496109009,
- 0.130438894033432,
- 0.47534096240997314,
- 0.5058916211128235,
- -0.6356008052825928,
- -0.24553059041500092,
- -0.17978045344352722,
- -0.34532439708709717,
- -0.2420850694179535,
- -0.4619636535644531,
- -0.4826432168483734,
- 0.5221319198608398,
- 0.029748890548944473,
- -0.7130288481712341,
- -0.8076095581054688,
- 0.29332637786865234,
- 0.5628518462181091,
- 0.06730208545923233,
- 0.4723880887031555,
- -0.12552547454833984,
- -0.4614121615886688,
- 0.08412102609872818,
- -0.13070812821388245,
- -0.2101341336965561,
- 0.01784065179526806,
- 0.9772608280181885,
- 0.9888244271278381,
- 0.998428463935852,
- 0.9541769623756409,
- 0.9986042976379395,
- -0.7781175374984741,
- 0.43230360746383667,
- 0.6684873104095459,
- 0.2304299771785736,
- -0.5736464858055115,
- -0.844412088394165,
- 0.00047851071576587856,
- -0.8698142766952515,
- -0.8623660206794739,
- -0.6524214744567871,
- 0.4876599907875061,
- 0.41059526801109314,
- 0.11519432067871094,
- 0.027569491416215897,
- -0.18464042246341705,
- 0.07333831489086151,
- -0.28634411096572876,
- -0.628840982913971,
- -0.4625285863876343,
- -0.7084884643554688,
- 0.13881811499595642,
- 0.013083233498036861,
- -0.2419593632221222,
- -0.9994175434112549,
- -0.8644529581069946,
- -0.969346821308136,
- 0.6237660050392151,
- 0.3980129659175873,
- 0.07845746725797653,
- 0.059401463717222214,
- 0.9435102343559265,
- 0.6205036044120789,
- 0.8704222440719604,
- 0.0805128887295723,
- 0.40569618344306946,
- 0.7998630404472351,
- -0.15637905895709991,
- -0.30140817165374756,
- -0.10545636713504791,
- 0.013164041563868523,
- -0.8021248579025269,
- -0.674019455909729,
- 1.1381953347961641e-15,
- 0.8842353820800781,
- 0.70960932970047,
- 0.8383103013038635,
- 0.9725919365882874,
- -0.020549282431602478,
- 0.6637487411499023,
- -0.4817539155483246,
- 0.842215895652771,
- 0.827395498752594,
- 0.5711965560913086,
- 0.9451232552528381,
- -0.505468487739563,
- -0.5622516870498657,
- 0.5627862811088562,
- 0.43230360746383667,
- 0.2933533787727356,
- -0.7023643851280212,
- 0.5701262354850769,
- 0.32938721776008606,
- -0.9919143915176392,
- -0.9549797773361206,
- 0.23374751210212708,
- 0.026159776374697685,
- -0.36292386054992676,
- 0.9944577813148499,
- 0.021349981427192688,
- -0.4515495300292969,
- -0.0596543550491333,
- -0.054855652153491974,
- -0.8076095581054688,
- -0.4196002781391144,
- -0.4410720765590668,
- -0.6684819459915161,
- 0.8623660206794739,
- 0.7781712412834167,
- -0.4617902934551239,
- 0.9156145453453064,
- 0.6612699031829834,
- 0.8220000267028809,
- 0.7003620862960815,
- 0.9428480863571167,
- 0.3421337604522705,
- 0.009491427801549435,
- -0.024708475917577744,
- -0.243136465549469,
- -0.6658512353897095,
- 0.05885906517505646,
- -0.12039002776145935,
- -0.9692688584327698,
- -0.9894528985023499,
- -0.712857186794281,
- 0.9669307470321655,
- 0.9363831281661987,
- 0.7855737209320068,
- 0.0020480032544583082,
- 0.48156502842903137,
- 0.23229436576366425,
- 0.2777603268623352,
- 0.9257963299751282,
- 0.6556273102760315,
- -0.9106780886650085,
- -0.3095446527004242,
- 0.9899122714996338,
- -0.8134732842445374,
- 0.8606582283973694,
- 0.6877522468566895,
- 0.4117426872253418,
- 0.4701825976371765,
- 0.7486863732337952,
- 0.544661283493042,
- 0.7486863732337952,
- 0.678033173084259,
- 0.17454104125499725,
- -0.17454104125499725,
- -0.9429054260253906,
- -0.9972629547119141,
- -0.7024728059768677,
- 0.484409362077713,
- -0.7819303274154663,
- -0.7981323003768921,
- -0.7253903150558472,
- -0.28735053539276123,
- 0.36599305272102356,
- -0.9146113395690918,
- -0.10216209292411804,
- 0.01893974095582962,
- 0.19509032368659973,
- -0.6746619939804077,
- -0.580647885799408,
- -0.8524736762046814,
- -0.38539648056030273,
- 0.3909161388874054,
- 0.8446590304374695,
- -0.9985224008560181,
- 0.5946504473686218,
- -0.01600003056228161,
- 0.40821167826652527,
- 0.48939603567123413,
- -0.09601835906505585,
- -0.9909332990646362,
- -0.5974749326705933,
- 0.33801841735839844,
- 0.5988664031028748,
- 0.47321829199790955,
- 0.5466654896736145,
- -0.08516772836446762,
- -0.08488517999649048,
- -0.43230360746383667,
- -0.9939273595809937,
- -0.8418577313423157,
- 0.37960660457611084,
- 0.3056824207305908,
- -0.3595028221607208,
- -0.19509032368659973,
- -0.29275640845298767,
- -0.9550285339355469,
- 0.9962120056152344,
- 0.9809043407440186,
- 0.6006340980529785,
- 0.8467000126838684,
- -0.8403451442718506,
- -0.8470764756202698,
- 0.2801212966442108,
- -0.9871431589126587,
- 0.08321216702461243,
- 0.19509032368659973,
- 0.22816050052642822,
- -0.2699337899684906,
- -0.6778974533081055,
- -0.8404248356819153,
- 0.2901766896247864,
- 0.5331884622573853,
- 0.44227609038352966,
- 0.9771484136581421,
- 0.8558570742607117,
- -0.7451087236404419,
- 0.9981444478034973,
- -0.678033173084259,
- -0.8475834727287292,
- 0.3360883593559265,
- 0.9743492007255554,
- -0.282871812582016,
- -0.22345055639743805,
- 0.3189956545829773,
- -0.9293450713157654,
- 0.5089709162712097,
- 0.8060675263404846,
- 0.8813042640686035,
- -0.5501174926757812,
- 0.43230360746383667,
- 0.399971067905426,
- 0.5860621929168701,
- -0.8191595077514648,
- 0.8525258898735046,
- 0.4839176535606384,
- 0.43716105818748474,
- 0.44707098603248596,
- -0.004523725248873234,
- -0.0728132501244545,
- -0.5065698027610779,
- 0.10219016671180725,
- 0.12683188915252686,
- 0.46737194061279297,
- -0.39507293701171875,
- 0.14336158335208893,
- 0.5697399377822876,
- -0.04716167598962784,
- -0.02876582369208336,
- 0.716044545173645,
- 0.8369349837303162,
- -0.3292773365974426,
- 0.7456651926040649,
- 0.5343924760818481,
- -0.9642449021339417,
- -0.535721480846405,
- -0.4752419590950012,
- 0.5506404638290405,
- 0.42234858870506287,
- 0.2887100875377655,
- -0.06674723327159882,
- 0.6946030259132385,
- 0.02623007260262966,
- 0.946326732635498,
- -0.5398248434066772,
- -0.9635012149810791,
- -0.9525694251060486,
- -0.5915231704711914,
- -0.5506868362426758,
- 0.5892135500907898,
- -0.8410922288894653,
- -0.9329262375831604,
- -0.9138374328613281,
- 0.8402705788612366,
- 0.9105742573738098,
- -0.9931750297546387,
- -0.4777680039405823,
- -0.8566827178001404,
- -0.6324874758720398,
- 0.8885729312896729,
- 0.9815806150436401,
- -0.13777193427085876,
- -0.6420971155166626,
- -0.5806383490562439,
- 0.5950174927711487,
- -0.8831895589828491,
- -0.9292991161346436,
- -0.515745222568512,
- -0.7781712412834167,
- -0.47324317693710327,
- 0.7560555934906006,
- -0.6978248953819275,
- 0.5688090324401855,
- 0.48954278230667114,
- -0.4428369104862213,
- -0.2906172573566437,
- -0.8368217945098877,
- -0.9935793280601501,
- 0.982795000076294,
- -0.7022608518600464,
- -0.5990626811981201,
- 0.4099653661251068,
- 0.8622729182243347,
- -0.286173015832901,
- 0.16053339838981628,
- 0.6610923409461975,
- 0.5628518462181091,
- 0.18883104622364044,
- 0.8341196775436401,
- -0.29332637786865234,
- -0.4320796728134155,
- -0.5608901381492615,
- -0.7485610842704773,
- -0.06010530889034271,
- 0.21931923925876617,
- -0.22103886306285858,
- -0.5628518462181091,
- 0.9293450713157654,
- 0.7130826711654663,
- 0.9627287983894348,
- 0.9840801358222961,
- -0.8595077991485596,
- 0.31655168533325195,
- 0.882563591003418,
- 0.971177875995636,
- -0.9552678465843201,
- 0.7955359220504761,
- -0.12935291230678558,
- 0.9853049516677856,
- -0.33821555972099304,
- 0.9915511608123779,
- -0.9826152324676514,
- -0.9881051778793335,
- 0.9917153120040894,
- 0.08590389788150787,
- -0.6782426834106445,
- 0.47321829199790955,
- -0.17458701133728027,
- -0.445766419172287,
- -0.648909866809845,
- -0.8623660206794739,
- 0.7130826711654663,
- 0.807781457901001,
- 0.8623660206794739,
- -0.31360378861427307,
- 0.9839302897453308,
- 0.6382311582565308,
- -0.9593880772590637,
- 0.3193909227848053,
- -0.7817341685295105,
- 0.023031573742628098,
- -0.4200100302696228,
- 0.9933979511260986,
- -0.8614697456359863,
- -0.8687127232551575,
- 0.16769032180309296,
- 0.46352097392082214,
- -0.5226393938064575,
- -0.24868835508823395,
- 0.16562004387378693,
- 0.3897646963596344,
- 0.7157204151153564,
- 0.3493865430355072,
- -0.8276746273040771,
- -0.9994074702262878,
- 0.9726558923721313,
- -0.2598225772380829,
- 0.9036200046539307,
- 0.9771667718887329,
- 0.8610367178916931,
- -0.05206523463129997,
- 0.20172397792339325,
- -0.9491549134254456,
- 0.006670048926025629,
- 0.48246243596076965,
- 0.02163754589855671,
- 0.1861138790845871,
- -0.9725919365882874,
- -0.9926801323890686,
- -0.9994572997093201,
- 0.34400707483291626,
- 0.6316402554512024,
- -0.8622729182243347,
- 0.6931447386741638,
- 0.8637305498123169,
- -0.49691101908683777,
- 0.4423399865627289,
- 0.9413233995437622,
- 0.2561284601688385,
- 0.4177584648132324,
- -0.7151981592178345,
- 0.3847554624080658,
- 0.00911870226264,
- 0.04645007848739624,
- 0.9529821872711182,
- 0.9131877422332764,
- 0.9860866069793701,
- -0.28687211871147156,
- 0.7533616423606873,
- 0.525320291519165,
- -0.2505177855491638,
- 0.22584663331508636,
- -0.31802502274513245,
- -0.664940357208252,
- 0.3854376971721649,
- -0.5987637042999268,
- 0.9183555841445923,
- -0.8924358487129211,
- -0.39667022228240967,
- -0.8860922455787659,
- 0.642162561416626,
- -0.12058087438344955,
- -0.9389616847038269,
- -0.830712616443634,
- -0.606196939945221,
- -0.7111347317695618,
- -0.3265444338321686,
- -0.56674724817276,
- 0.9875668883323669,
- -0.10216209292411804,
- 0.5815808773040771,
- 0.9071466326713562,
- -0.8691815733909607,
- -0.5292973518371582,
- -0.7014018893241882,
- 0.2636984586715698,
- 0.9412404298782349,
- 0.9982985854148865,
- 0.9909630417823792,
- -0.3709893822669983,
- -0.7072163224220276
- ]
- }
- ],
- "layout": {
- "height": 500,
- "scene": {
- "aspectmode": "data"
- },
- "template": {
- "data": {
- "bar": [
- {
- "error_x": {
- "color": "#2a3f5f"
- },
- "error_y": {
- "color": "#2a3f5f"
- },
- "marker": {
- "line": {
- "color": "#E5ECF6",
- "width": 0.5
- },
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "bar"
- }
- ],
- "barpolar": [
- {
- "marker": {
- "line": {
- "color": "#E5ECF6",
- "width": 0.5
- },
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "barpolar"
- }
- ],
- "carpet": [
- {
- "aaxis": {
- "endlinecolor": "#2a3f5f",
- "gridcolor": "white",
- "linecolor": "white",
- "minorgridcolor": "white",
- "startlinecolor": "#2a3f5f"
- },
- "baxis": {
- "endlinecolor": "#2a3f5f",
- "gridcolor": "white",
- "linecolor": "white",
- "minorgridcolor": "white",
- "startlinecolor": "#2a3f5f"
- },
- "type": "carpet"
- }
- ],
- "choropleth": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "choropleth"
- }
- ],
- "contour": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "contour"
- }
- ],
- "contourcarpet": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "contourcarpet"
- }
- ],
- "heatmap": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "heatmap"
- }
- ],
- "heatmapgl": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "heatmapgl"
- }
- ],
- "histogram": [
- {
- "marker": {
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "histogram"
- }
- ],
- "histogram2d": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "histogram2d"
- }
- ],
- "histogram2dcontour": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "histogram2dcontour"
- }
- ],
- "mesh3d": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "mesh3d"
- }
- ],
- "parcoords": [
- {
- "line": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "parcoords"
- }
- ],
- "pie": [
- {
- "automargin": true,
- "type": "pie"
- }
- ],
- "scatter": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatter"
- }
- ],
- "scatter3d": [
- {
- "line": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatter3d"
- }
- ],
- "scattercarpet": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattercarpet"
- }
- ],
- "scattergeo": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattergeo"
- }
- ],
- "scattergl": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattergl"
- }
- ],
- "scattermapbox": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattermapbox"
- }
- ],
- "scatterpolar": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterpolar"
- }
- ],
- "scatterpolargl": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterpolargl"
- }
- ],
- "scatterternary": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterternary"
- }
- ],
- "surface": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "surface"
- }
- ],
- "table": [
- {
- "cells": {
- "fill": {
- "color": "#EBF0F8"
- },
- "line": {
- "color": "white"
- }
- },
- "header": {
- "fill": {
- "color": "#C8D4E3"
- },
- "line": {
- "color": "white"
- }
- },
- "type": "table"
- }
- ]
- },
- "layout": {
- "annotationdefaults": {
- "arrowcolor": "#2a3f5f",
- "arrowhead": 0,
- "arrowwidth": 1
- },
- "autotypenumbers": "strict",
- "coloraxis": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "colorscale": {
- "diverging": [
- [
- 0,
- "#8e0152"
- ],
- [
- 0.1,
- "#c51b7d"
- ],
- [
- 0.2,
- "#de77ae"
- ],
- [
- 0.3,
- "#f1b6da"
- ],
- [
- 0.4,
- "#fde0ef"
- ],
- [
- 0.5,
- "#f7f7f7"
- ],
- [
- 0.6,
- "#e6f5d0"
- ],
- [
- 0.7,
- "#b8e186"
- ],
- [
- 0.8,
- "#7fbc41"
- ],
- [
- 0.9,
- "#4d9221"
- ],
- [
- 1,
- "#276419"
- ]
- ],
- "sequential": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "sequentialminus": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ]
- },
- "colorway": [
- "#636efa",
- "#EF553B",
- "#00cc96",
- "#ab63fa",
- "#FFA15A",
- "#19d3f3",
- "#FF6692",
- "#B6E880",
- "#FF97FF",
- "#FECB52"
- ],
- "font": {
- "color": "#2a3f5f"
- },
- "geo": {
- "bgcolor": "white",
- "lakecolor": "white",
- "landcolor": "#E5ECF6",
- "showlakes": true,
- "showland": true,
- "subunitcolor": "white"
- },
- "hoverlabel": {
- "align": "left"
- },
- "hovermode": "closest",
- "mapbox": {
- "style": "light"
- },
- "paper_bgcolor": "white",
- "plot_bgcolor": "#E5ECF6",
- "polar": {
- "angularaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "bgcolor": "#E5ECF6",
- "radialaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- }
- },
- "scene": {
- "xaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- },
- "yaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- },
- "zaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- }
- },
- "shapedefaults": {
- "line": {
- "color": "#2a3f5f"
- }
- },
- "ternary": {
- "aaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "baxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "bgcolor": "#E5ECF6",
- "caxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- }
- },
- "title": {
- "x": 0.05
- },
- "xaxis": {
- "automargin": true,
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": "",
- "title": {
- "standoff": 15
- },
- "zerolinecolor": "white",
- "zerolinewidth": 2
- },
- "yaxis": {
- "automargin": true,
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": "",
- "title": {
- "standoff": 15
- },
- "zerolinecolor": "white",
- "zerolinewidth": 2
- }
- }
- },
- "title": {
- "text": "Stochastic Results"
- },
- "width": 500,
- "xaxis": {
- "range": [
- -5,
- 5
- ]
- },
- "yaxis": {
- "range": [
- -1,
- 0.9999999999999999
- ]
- }
- }
- },
- "text/html": [
- " "
- ]
- },
- "metadata": {},
- "output_type": "display_data"
- },
- {
- "data": {
- "text/html": [
- " \n",
- " "
- ]
- },
- "metadata": {},
- "output_type": "display_data"
- },
- {
- "data": {
- "application/vnd.plotly.v1+json": {
- "config": {
- "linkText": "Export to plot.ly",
- "plotlyServerURL": "https://plot.ly",
- "showLink": false
- },
- "data": [
- {
- "marker": {
- "color": [
- 1565.224247,
- 1818.911328,
- 1922.47678,
- 1794.591662,
- 11221.832806,
- 10794.41376,
- 12893.225008,
- 12187.049807,
- 1345.121457,
- 1395.235998,
- 1407.277092,
- 1576.922575,
- 1635.088976,
- 1842.884785,
- 2022.056003,
- 1954.357444,
- 22269.938468,
- 19490.78128,
- 18656.609971,
- 21215.78276,
- 3423.891452,
- 2841.518872,
- 3216.957591,
- 3630.277363,
- 4195.806906,
- 4873.44433,
- 4170.196427,
- 4831.775357,
- 30275.682043,
- 31249.051993,
- 29245.695302,
- 32047.639268,
- 20658.792651,
- 20956.914957,
- 19645.764327,
- 22020.389133,
- 22959.236333,
- 24428.624824,
- 25101.203399,
- 25551.452841,
- 471.239802,
- 429.843113,
- 508.623088,
- 560.942909,
- 13086.620537,
- 13144.088836,
- 11830.03781,
- 13005.561052,
- 1719.676337,
- 1697.870045,
- 1950.988248,
- 1595.186823,
- 24149.579047,
- 20634.725206,
- 23264.45391,
- 22061.580822,
- 985.683333,
- 932.740161,
- 979.803708,
- 1181.024752,
- 354.999306,
- 526.395841,
- 353.345939,
- 416.28719,
- 348.085864,
- 24060.170595,
- 22642.92807,
- 23451.830795,
- 1328.561265,
- 1173.773788,
- 1164.887821,
- 1026.933212,
- 25113.389199,
- 24245.538865,
- 22292.560699,
- 27308.690851,
- 813.704888,
- 806.212751,
- 899.798717,
- 974.743232,
- 30378.504905,
- 32364.791354,
- 33649.664743,
- 32514.40482,
- 660.893186,
- 822.616904,
- 803.08697,
- 710.384566,
- 1307.833854,
- 1382.955037,
- 1493.398978,
- 2454.970968,
- 2992.704245,
- 3081.39456,
- 31755.523752,
- 39080.706873,
- 33044.209835,
- 32006.979231,
- 15810.050163,
- 14426.00843,
- 15129.602588,
- 15115.1645,
- 13520.192653,
- 14376.115281,
- 12018.989155,
- 17097.367949,
- 19109.717634,
- 17615.960033,
- 17922.40358,
- 16745.201696,
- 19730.373842,
- 3046.469553,
- 2648.347339,
- 2551.515518,
- 2850.611329,
- 3093.245676,
- 2791.222085,
- 2678.953483,
- 2942.052861,
- 10093.426983,
- 9723.119499,
- 11188.92264,
- 319.202405,
- 311.289874,
- 241.745461,
- 361.374258,
- 2151.636378,
- 2881.357799,
- 2310.112744,
- 2490.225368,
- 1469.670615,
- 1647.931206,
- 1552.261565,
- 204.363427,
- 383.978411,
- 14797.713488,
- 15681.448726,
- 14180.828657,
- 16632.519956,
- 23687.616108,
- 25033.543907,
- 25820.795168,
- 23192.849931,
- 23368.13313,
- 24448.632052,
- 27554.866417,
- 1451.230062,
- 1630.821948,
- 1707.085133,
- 5455.987831,
- 5124.987042,
- 4751.273205,
- 5648.034717,
- 4609.774732,
- 4656.983898,
- 3589.753185,
- 4273.545331,
- 29204.340751,
- 29253.469376,
- 31652.691289,
- 26898.313179,
- 14986.415883,
- 17172.253749,
- 15782.678685,
- 10030.252862,
- 10222.075778,
- 10246.035128,
- 9223.19773,
- 39080.706873,
- 9214.018308,
- 8490.991445,
- 8415.221431,
- 7729.472556,
- 7521.496596,
- 7711.710858,
- 8534.351226,
- 6814.03615,
- 1190.719602,
- 3079.887878,
- 3499.104935,
- 3089.427177,
- 2729.124187,
- 505.414467,
- 515.242785,
- 520.26973,
- 522.002968,
- 2336.843037,
- 2270.489158,
- 11740.140058,
- 13430.467631,
- 11739.81457,
- 33112.669057,
- 39080.706873,
- 39080.706873,
- 39080.706873,
- 4374.73274,
- 4016.770071,
- 3395.227348,
- 14421.037748,
- 12685.904001,
- 15262.129542,
- 13175.877825,
- 16320.259313,
- 5102.235025,
- 5657.804578,
- 5252.841223,
- 6093.533022,
- 12422.171919,
- 13824.078274,
- 11543.238822,
- 11205.69758,
- 10048.541308,
- 1787.401232,
- 1901.41049,
- 1576.381168,
- 330.838884,
- 170.989284,
- 187.613529,
- 173.414623,
- 257.960397,
- 3967.113363,
- 592.493716,
- 584.792098,
- 744.075369,
- 1171.294494,
- 965.203075,
- 1249.433578,
- 1003.243012,
- 20084.285918,
- 19701.484494,
- 20898.636235,
- 2020.125587,
- 2172.890137,
- 21259.714819,
- 32114.210204,
- 31777.861652,
- 33225.530183,
- 3513.27016,
- 2902.741593,
- 4174.668888,
- 4163.496761,
- 3678.027401,
- 4055.084026,
- 2338.316477,
- 1903.632424,
- 2344.791772,
- 546.744255,
- 625.641964,
- 437.391528,
- 427.039563,
- 16220.101864,
- 17853.137943,
- 15141.889195,
- 17666.23541,
- 1302.944496,
- 9653.031217,
- 8685.145823,
- 4917.592293,
- 5424.914879,
- 5523.998366,
- 982.865076,
- 854.719011,
- 961.711469,
- 12045.88419,
- 10536.333774,
- 12115.227079,
- 11657.757414,
- 6765.393138,
- 7104.891234,
- 7923.045378,
- 7959.853089,
- 744.755037,
- 644.966091,
- 770.590133,
- 9711.929454,
- 1196.355464,
- 1038.795101,
- 1380.530997,
- 1912.795858,
- 1640.567119,
- 1851.02117,
- 5231.371516,
- 5070.064929,
- 4464.203642,
- 4719.564727,
- 18184.519149,
- 20294.218332,
- 21524.483777,
- 20828.819892,
- 675.943475,
- 728.960502,
- 864.644525,
- 952.109281,
- 603.823006,
- 1047.524637,
- 1185.37806,
- 7744.644239,
- 8835.595945,
- 7892.716433,
- 8017.532669,
- 3358.960635,
- 3509.378573,
- 3893.301069,
- 5684.016347,
- 5233.971389,
- 6149.266561,
- 31889.203488,
- 29000.772641,
- 32798.918494,
- 30757.312671,
- 6225.612789,
- 6810.796216,
- 7189.617471,
- 6699.273703,
- 11509.966048,
- 1295.722486,
- 1419.110363,
- 297.31435,
- 1081.143565,
- 1270.408445,
- 1276.514874,
- 18071.17748,
- 8993.092569,
- 24171.730052,
- 1996.326597,
- 1811.885413,
- 2252.817487,
- 1994.730239,
- 29086.414505,
- 26696.020551,
- 30612.064917,
- 4842.472307,
- 5789.434164,
- 5601.393606,
- 33268.514195,
- 39080.706873,
- 39080.706873,
- 561.543428,
- 624.690877,
- 780.062687,
- 596.296057,
- 0,
- 184.556662,
- 0,
- 0,
- 24521.167108,
- 27195.377752,
- 27670.88771,
- 27833.128212,
- 8807.603137,
- 9628.133732,
- 10299.298556,
- 10350.135049,
- 9734.912044,
- 11459.248234,
- 256.617594,
- 212.474208,
- 164.727301,
- 0,
- 170.206612,
- 169.345003,
- 212.989704,
- 39080.706873,
- 39080.706873,
- 39080.706873,
- 12700.058712,
- 11329.764573,
- 13068.371509,
- 13176.216653,
- 16207.613159,
- 913.336749,
- 1054.937054,
- 1036.342525,
- 1136.522317,
- 7355.246252,
- 3574.37007,
- 3549.183835,
- 3660.559549,
- 1236.472665,
- 250.974209,
- 313.802964,
- 322.041613,
- 426.540352,
- 296.501711,
- 300.991035,
- 16360.377139,
- 15929.880937,
- 39080.706873,
- 32890.475301,
- 39080.706873,
- 39080.706873,
- 214.964371,
- 267.567414,
- 163.406497,
- 4852.811438,
- 4555.602776,
- 5539.93795,
- 30674.760816,
- 28392.072514,
- 13194.946064,
- 13585.330388,
- 7866.918048,
- 6510.334391,
- 10728.009775,
- 10157.679151,
- 11549.873796,
- 12045.269402,
- 3478.204493,
- 3904.105983,
- 534.577619,
- 732.401615,
- 2734.885683,
- 3489.985535,
- 971.299729,
- 739.779548,
- 807.871865,
- 8456.197878,
- 585.612337,
- 844.683207,
- 709.734657,
- 587.453854,
- 645.048726,
- 475.309249,
- 484.206617,
- 6058.103793,
- 6234.821247,
- 4636.958551,
- 13916.13966,
- 15019.616594,
- 15722.531258,
- 13612.431691,
- 21118.935458,
- 14034.7119,
- 12948.357657,
- 15194.404222,
- 170.72239,
- 0,
- 214.41869,
- 4093.870116,
- 3572.107346,
- 3718.666571,
- 2555.942911,
- 2692.216658,
- 3025.490217,
- 3215.729169,
- 25645.668086,
- 25827.272159,
- 27950.338337,
- 12813.937646,
- 16055.99292,
- 19042.152853,
- 17911.484167,
- 18773.149219,
- 1642.417848,
- 1991.69974,
- 1063.743219,
- 1222.018228,
- 17812.534432,
- 19584.476628,
- 20023.783934,
- 19162.93295,
- 31225.71776,
- 24131.212369,
- 26629.513708,
- 22698.989541,
- 16624.132278,
- 17834.678953,
- 14910.965963,
- 17331.611386,
- 6641.550988,
- 6891.014537,
- 6996.393223,
- 4207.05468,
- 4428.56328,
- 1001.112644,
- 3960.716737,
- 2086.089407,
- 29369.047956,
- 27699.717043,
- 7622.351589,
- 6458.757,
- 6483.817811,
- 276.746212,
- 24697.671603,
- 25266.286353,
- 11733.970611,
- 11220.877593,
- 8882.19471,
- 7905.528054,
- 1920.555225,
- 2409.404716,
- 2445.407049,
- 2501.508816,
- 1479.908811,
- 1487.111928,
- 846.715614,
- 1836.477364,
- 1528.933084,
- 2090.421473,
- 2030.997275,
- 32178.137996,
- 33128.611268,
- 12795.990351,
- 11419.205109,
- 13335.344786,
- 12067.769108,
- 23191.112273,
- 24468.72048,
- 182.318781,
- 223.45704,
- 5773.585825,
- 4247.307556,
- 5124.183093,
- 5043.610536,
- 3169.165626,
- 3590.898654,
- 3288.909174,
- 4764.949606,
- 5349.042627,
- 4284.128962,
- 4505.576537,
- 4198.113201,
- 4319.771079,
- 4653.302575,
- 3367.387496,
- 11566.89429,
- 1243.155154,
- 1110.788273,
- 970.878153,
- 1239.645458,
- 17462.526858,
- 18070.699387,
- 13500.874663,
- 21823.570878,
- 19635.208952,
- 545.74738,
- 1056.646068,
- 874.522853,
- 953.377038,
- 1073.897008,
- 3349.112609,
- 3816.599071,
- 3687.975363,
- 9756.397987,
- 39080.706873,
- 39080.706873,
- 2101.20511,
- 5288.152428,
- 357.632976,
- 359.579561,
- 484.849849,
- 503.538786,
- 2518.517481,
- 11162.405683,
- 9662.952957,
- 9617.231197,
- 1893.671283,
- 2130.770952,
- 8283.613701,
- 9162.115122,
- 9134.320009,
- 9577.346691,
- 6630.623063,
- 14594.167704,
- 14690.813304,
- 3217.502248,
- 0,
- 0,
- 158.489371,
- 163.964977,
- 8866.332292,
- 8159.115947,
- 8807.404638,
- 9114.429165,
- 6190.539148,
- 171.771889,
- 0,
- 0,
- 164.859897,
- 11388.309148,
- 10463.968435,
- 10341.500199,
- 39080.706873,
- 627.077586,
- 5671.433868,
- 1685.45896,
- 18752.923121,
- 8589.104078,
- 6680.980066,
- 6488.865235,
- 7521.679664,
- 7046.014356,
- 191.113765,
- 319.687317,
- 156.950438,
- 2225.00435,
- 18297.507351,
- 225.541288,
- 2724.342608,
- 33153.569317,
- 29994.376791,
- 33061.554283,
- 335.6551,
- 520.165386,
- 258.105873,
- 212.625559,
- 27107.823646,
- 29052.207417,
- 30390.73185,
- 1255.991305,
- 11263.136572,
- 32395.182165,
- 32015.770211,
- 30664.745409,
- 39080.706873,
- 671.464938,
- 2694.17022,
- 3243.515866,
- 218.548089,
- 280.603993,
- 855.368673,
- 1088.569772,
- 6702.956042,
- 6066.355985,
- 6854.313271,
- 7288.013403,
- 2135.97204,
- 1553.657021,
- 1399.553014,
- 285.127222,
- 1376.094607,
- 551.749519,
- 10734.312264,
- 29600.381323,
- 33009.904924,
- 667.446167,
- 737.667025,
- 2404.589037,
- 2745.568997,
- 2292.232326,
- 5436.636823,
- 4754.890887,
- 5510.5987,
- 5223.183046,
- 9295.784305,
- 2556.885272,
- 2367.488453,
- 33189.47066,
- 853.726387,
- 0,
- 175.063817,
- 31543.112279,
- 32302.508299,
- 317.105956,
- 572.290092,
- 411.744382,
- 468.481131,
- 3469.712998,
- 3852.910448,
- 4062.329859,
- 4446.789064,
- 3888.317798,
- 3239.341261,
- 1450.111955,
- 1584.444976,
- 1739.029901,
- 31092.865151,
- 29447.237645,
- 28048.726038,
- 27412.588566,
- 4844.124006,
- 27075.170801,
- 3033.713518,
- 3080.134247,
- 30763.59859,
- 33047.549635,
- 3084.518261,
- 5672.728089,
- 6717.658333,
- 4627.358531,
- 4620.645169,
- 10488.136334,
- 583.562571,
- 706.343421,
- 867.811417,
- 960.19698,
- 1106.74379,
- 7385.512032,
- 7580.071122,
- 1155.013263,
- 1123.939735,
- 1306.053745,
- 19394.102548,
- 21708.69301,
- 23866.669683,
- 20659.771125,
- 10435.400548,
- 8506.953367,
- 8990.806531,
- 7894.600863,
- 7898.462834,
- 3196.98732,
- 207.511194,
- 1342.747955,
- 1277.779061,
- 1375.087613,
- 12375.356285,
- 11366.013515,
- 32201.00245,
- 206.428619,
- 18913.06314,
- 19473.77271,
- 20495.135862,
- 469.09133,
- 7377.800729,
- 4295.661846,
- 15767.981083,
- 17684.895453,
- 17231.167077,
- 17881.141502,
- 8275.478852,
- 3808.911623,
- 39080.706873,
- 32283.164533,
- 39080.706873,
- 842.906748,
- 1455.81625,
- 1583.458021,
- 1829.958154,
- 1574.891247,
- 15641.999558,
- 147.857046,
- 197.435176,
- 16652.56973,
- 786.423169,
- 352.29945,
- 330.329431,
- 531.360636,
- 726.916554,
- 6138.75971,
- 6324.451098,
- 6484.107881,
- 31459.992889,
- 39080.706873,
- 39080.706873,
- 1288.277242,
- 5200.216467,
- 5283.919962,
- 5804.284562,
- 0,
- 4279.030552,
- 0,
- 0,
- 25775.721028,
- 1170.90326,
- 6230.502429,
- 7872.681922,
- 2537.615391,
- 2212.923845,
- 13576.50164,
- 7724.313425,
- 21485.985823,
- 21298.068074,
- 428.140567,
- 400.826556,
- 331.793111,
- 388.551813,
- 12751.239999,
- 14869.714628,
- 0,
- 21458.883778,
- 19346.328032,
- 9317.618602,
- 5350.620293,
- 376.486666,
- 311.654681,
- 336.398843,
- 209.097003,
- 293.663675,
- 345.724696,
- 32037.811091,
- 31507.712292,
- 31295.393304,
- 372.135623,
- 470.184264,
- 558.100119,
- 22324.195336,
- 373.018863,
- 513.858548,
- 1721.157195,
- 666.218709,
- 39080.706873,
- 1839.438688,
- 199.857679,
- 174.504831,
- 272.405423,
- 15749.024885,
- 17496.487442,
- 16585.601395,
- 16636.201562,
- 0,
- 2100.28447,
- 11474.79039,
- 24838.952192,
- 463.096737,
- 2339.860957,
- 6173.532592,
- 611.32216,
- 16530.591089,
- 27916.788724,
- 0,
- 0,
- 207.197393,
- 1639.426936,
- 27355.806261,
- 26995.905245,
- 28511.366391,
- 983.926357,
- 14210.273267,
- 1935.540684,
- 3648.399359,
- 0,
- 0,
- 17671.52007,
- 24623.169573,
- 22036.222446,
- 24038.294338,
- 24021.202888,
- 1169.706839,
- 148.849584,
- 14269.153068,
- 26596.673947,
- 7622.540277,
- 39080.706873,
- 177.904916,
- 3199.862074,
- 8407.733198,
- 8561.556374,
- 8732.143125,
- 27622.358303,
- 26389.145904,
- 39080.706873,
- 6562.297667,
- 7379.129256,
- 2967.481252,
- 2107.468043,
- 19785.413828,
- 20953.039168,
- 2795.859236,
- 3562.699614,
- 15362.201212,
- 15464.898729,
- 39080.706873,
- 23511.759808,
- 7478.038735,
- 7150.276802,
- 23879.590146,
- 3347.579024,
- 12076.652231,
- 13698.164555,
- 8931.549878,
- 21053.092984,
- 10403.570025,
- 10616.884473,
- 0,
- 0,
- 0,
- 2361.808041,
- 1103.476378,
- 0,
- 5818.275757,
- 24214.125171,
- 6635.359748,
- 2606.015232,
- 171.936137,
- 16055.532701,
- 17612.035622,
- 23597.578067,
- 1757.991872,
- 17903.405195,
- 4681.278603,
- 4850.246942,
- 2357.36547,
- 2789.861152,
- 3516.757381,
- 10236.888837,
- 9559.775237,
- 13985.164003,
- 730.404527,
- 1345.734571,
- 3729.021544,
- 1569.157205,
- 779.73235,
- 1839.590158,
- 22168.619126,
- 20408.375319,
- 646.668956,
- 21562.278811,
- 2589.058683,
- 480.26355,
- 592.415366,
- 0,
- 188.067256,
- 3836.512775,
- 1725.625842,
- 1380.923337,
- 1399.917938,
- 6237.498796,
- 5721.453022,
- 39080.706873,
- 212.038529,
- 16382.201402,
- 5495.676534,
- 4285.908728,
- 39080.706873,
- 39080.706873,
- 39080.706873,
- 0,
- 13148.787414,
- 28118.729286,
- 3184.030732,
- 4604.699547,
- 2393.127138,
- 2675.640798,
- 2111.080138,
- 6334.316729,
- 14071.493772,
- 1203.071752,
- 282.193167,
- 39080.706873,
- 39080.706873,
- 5947.88827,
- 6583.632284,
- 21354.595532,
- 29360.713789,
- 883.99247,
- 2509.596645,
- 31465.557157,
- 39080.706873,
- 31010.773178,
- 0,
- 0,
- 0,
- 39080.706873,
- 27856.543698,
- 26377.713237,
- 279.287783,
- 2369.900188,
- 2780.982856,
- 7913.050323,
- 1956.467938,
- 17783.746012,
- 10738.206206,
- 2685.079153,
- 10790.608227,
- 5864.677666,
- 574.166931,
- 4259.243598,
- 26652.014956,
- 0,
- 0,
- 9442.740819,
- 10381.612021,
- 39080.706873,
- 476.111071,
- 0,
- 0,
- 0,
- 26608.236251,
- 174.1379,
- 0,
- 27194.642483,
- 719.662943,
- 627.427205,
- 19515.502501,
- 2875.612689,
- 2116.238956,
- 1675.281244,
- 22641.700777,
- 1469.397928,
- 3965.357246,
- 701.323369,
- 835.296288,
- 3837.824301,
- 3987.036853,
- 0,
- 0,
- 2583.086252,
- 2739.381655,
- 1531.857327,
- 1436.245221,
- 18099.296,
- 14900.854602,
- 39080.706873,
- 0,
- 1367.990745,
- 22442.848462,
- 22901.148449,
- 5078.553507,
- 5347.805452,
- 8838.30172,
- 5735.091989,
- 5471.475196,
- 1279.419824,
- 12538.31871,
- 32477.818001,
- 39080.706873,
- 2804.435878,
- 6266.276308,
- 6439.80459,
- 39080.706873,
- 2845.602368,
- 4151.775997,
- 19644.495154,
- 10682.799177,
- 7282.096179,
- 537.109338,
- 429.757827,
- 2428.465389,
- 26278.066235,
- 623.282083,
- 0,
- 447.252327,
- 8163.969048,
- 6658.188944,
- 21648.187016,
- 762.003388,
- 0,
- 754.610925,
- 5057.885795,
- 3187.533237,
- 7408.761237,
- 8708.944777,
- 1586.82541,
- 725.614148,
- 2362.431269,
- 178.793746,
- 1632.767548,
- 0,
- 6704.965994,
- 2100.184942,
- 2094.940904,
- 170.819651,
- 1913.453666,
- 857.738935,
- 2119.99269,
- 11678.045403,
- 984.866496,
- 8241.466013,
- 11419.897505,
- 2670.023256,
- 4414.899186,
- 2306.774209,
- 5879.33931,
- 12490.313327,
- 6143.441017,
- 13407.595289,
- 905.529349,
- 19513.576088
- ],
- "colorbar": {
- "thickness": 20,
- "title": {
- "text": "A"
- }
- },
- "colorscale": [
- [
- 0,
- "#0508b8"
- ],
- [
- 0.08333333333333333,
- "#1910d8"
- ],
- [
- 0.16666666666666666,
- "#3c19f0"
- ],
- [
- 0.25,
- "#6b1cfb"
- ],
- [
- 0.3333333333333333,
- "#981cfd"
- ],
- [
- 0.4166666666666667,
- "#bf1cfd"
- ],
- [
- 0.5,
- "#dd2bfd"
- ],
- [
- 0.5833333333333334,
- "#f246fe"
- ],
- [
- 0.6666666666666666,
- "#fc67fd"
- ],
- [
- 0.75,
- "#fe88fc"
- ],
- [
- 0.8333333333333334,
- "#fea5fd"
- ],
- [
- 0.9166666666666666,
- "#febefe"
- ],
- [
- 1,
- "#fec3fe"
- ]
- ],
- "size": 5
- },
- "mode": "markers",
- "name": "A",
- "type": "scatter3d",
- "x": [
- -2.101682662963867,
- -1.887513518333435,
- -1.7570427656173706,
- -1.8541388511657715,
- 1.8749754428863525,
- 1.80832040309906,
- 2.1825294494628906,
- 2.062222480773926,
- -2.38004469871521,
- -2.3056769371032715,
- -2.2629430294036865,
- -2.0936312675476074,
- -1.9997928142547607,
- -1.7547287940979004,
- -1.6898266077041626,
- -1.6704288721084595,
- 3.5905017852783203,
- 3.2578799724578857,
- 3.160881519317627,
- 3.4964303970336914,
- -0.6913178563117981,
- -1.0443613529205322,
- -0.8108569979667664,
- -0.5850074887275696,
- -0.293684720993042,
- 0.0675533190369606,
- -0.271133154630661,
- 0.018742907792329788,
- 4.4305853843688965,
- 4.508673667907715,
- 4.325611114501953,
- 4.611989498138428,
- 3.4338648319244385,
- 3.488844871520996,
- 3.289395570755005,
- 3.6204428672790527,
- 3.71138858795166,
- 3.857684850692749,
- 3.974630117416382,
- 4.003854274749756,
- -3.9132473468780518,
- -4.0064496994018555,
- -3.8273096084594727,
- -3.709832191467285,
- 2.3001842498779297,
- 2.2914557456970215,
- 2.0052285194396973,
- 2.2628118991851807,
- -1.980513334274292,
- -2.0251479148864746,
- -1.7515032291412354,
- -2.1317431926727295,
- 3.794757843017578,
- 3.3874454498291016,
- 3.7147281169891357,
- 3.586693048477173,
- -2.8868887424468994,
- -3.001088857650757,
- -2.9482247829437256,
- -2.6325371265411377,
- -4.134808540344238,
- -3.772261619567871,
- -4.165527820587158,
- -3.994203805923462,
- -4.163450241088867,
- 3.875136137008667,
- 3.7112133502960205,
- 3.765407085418701,
- -2.4520857334136963,
- -2.657001495361328,
- -2.6662352085113525,
- -2.8774945735931396,
- 3.942436933517456,
- 3.8352348804473877,
- 3.6082088947296143,
- 4.133811950683594,
- -3.171978712081909,
- -3.221795082092285,
- -3.0311388969421387,
- -2.9480156898498535,
- 4.4702277183532715,
- 4.6418352127075195,
- 4.766424655914307,
- 4.669127941131592,
- -3.4734950065612793,
- -3.1584713459014893,
- -3.2440361976623535,
- -3.3585245609283447,
- -2.429314613342285,
- -2.2996301651000977,
- -2.1834332942962646,
- -1.2482850551605225,
- -0.8828672766685486,
- -0.8636268973350525,
- 4.625131607055664,
- 5,
- 4.731442928314209,
- 4.639413356781006,
- 2.726271152496338,
- 2.482100486755371,
- 2.630417823791504,
- 2.613208293914795,
- 2.359410285949707,
- 2.4850215911865234,
- 2.0713677406311035,
- 2.9034955501556396,
- 3.2096197605133057,
- 3.0044784545898438,
- 3.031195640563965,
- 2.8652327060699463,
- 3.303494453430176,
- -0.9179192781448364,
- -1.1669803857803345,
- -1.2644528150558472,
- -1.0285327434539795,
- -0.8682996034622192,
- -1.0111645460128784,
- -1.1425732374191284,
- -0.9068978428840637,
- 1.6444306373596191,
- 1.5535091161727905,
- 1.877994418144226,
- -4.233823299407959,
- -4.286869049072266,
- -4.4695281982421875,
- -4.121842384338379,
- -1.4972978830337524,
- -0.9989351034164429,
- -1.422027349472046,
- -1.2346546649932861,
- -2.2228097915649414,
- -2.000976085662842,
- -2.127882480621338,
- -4.581174373626709,
- -4.083948135375977,
- 2.5844061374664307,
- 2.6696746349334717,
- 2.439190149307251,
- 2.836972236633301,
- 3.768427848815918,
- 3.901214361190796,
- 4.03761625289917,
- 3.712953805923462,
- 3.7559714317321777,
- 3.856983184814453,
- 4.166917324066162,
- -2.2912299633026123,
- -2.089019775390625,
- -1.982771635055542,
- 0.2804890275001526,
- 0.14649292826652527,
- -0.02719704993069172,
- 0.35809698700904846,
- -0.09706947952508926,
- -0.06142881140112877,
- -0.6113005876541138,
- -0.263994425535202,
- 4.316342830657959,
- 4.358631610870361,
- 4.577394962310791,
- 4.1251115798950195,
- 2.637986421585083,
- 2.9547457695007324,
- 2.78865909576416,
- 1.622883915901184,
- 1.6951839923858643,
- 1.6690202951431274,
- 1.4459738731384277,
- 5,
- 1.4305493831634521,
- 1.2514207363128662,
- 1.230926275253296,
- 1.0252352952957153,
- 1.0430431365966797,
- 1.0417221784591675,
- 1.277311086654663,
- 0.8228275179862976,
- -2.6111531257629395,
- -0.8876737952232361,
- -0.6530675888061523,
- -0.8721553087234497,
- -1.1404987573623657,
- -3.7799670696258545,
- -3.7419769763946533,
- -3.7747626304626465,
- -3.765298843383789,
- -1.3552204370498657,
- -1.448533058166504,
- 1.976080060005188,
- 2.3143045902252197,
- 2.006865978240967,
- 4.718459129333496,
- 5,
- 5,
- 5,
- -0.21346406638622284,
- -0.3900603652000427,
- -0.7078602910041809,
- 2.546725273132324,
- 2.2419445514678955,
- 2.62286114692688,
- 2.31475830078125,
- 2.815099000930786,
- 0.17036111652851105,
- 0.35399267077445984,
- 0.22068481147289276,
- 0.5616357326507568,
- 2.168175220489502,
- 2.396758794784546,
- 2.032904624938965,
- 1.9458956718444824,
- 1.672920823097229,
- -1.9237370491027832,
- -1.7913600206375122,
- -2.1189286708831787,
- -4.244471549987793,
- -4.725438117980957,
- -4.62848424911499,
- -4.6635870933532715,
- -4.4014410972595215,
- -0.39015352725982666,
- -3.62326979637146,
- -3.6562275886535645,
- -3.3212900161743164,
- -2.650617837905884,
- -2.9336674213409424,
- -2.5238282680511475,
- -2.854623556137085,
- 3.359579563140869,
- 3.281346321105957,
- 3.4625306129455566,
- -1.6233601570129395,
- -1.4790972471237183,
- 3.500380516052246,
- 4.63165283203125,
- 4.554935932159424,
- 4.720632076263428,
- -0.6211792826652527,
- -0.9868704080581665,
- -0.2744942903518677,
- -0.23266896605491638,
- -0.4965898394584656,
- -0.32649561762809753,
- -1.423138976097107,
- -1.7905021905899048,
- -1.4218405485153198,
- -3.732257604598999,
- -3.5719547271728516,
- -3.941251754760742,
- -3.9911673069000244,
- 2.76228666305542,
- 3.034092664718628,
- 2.5956602096557617,
- 3.0007383823394775,
- -2.4493157863616943,
- 1.5511066913604736,
- 1.313583254814148,
- 0.09208802133798599,
- 0.2716134786605835,
- 0.33897581696510315,
- -2.9448187351226807,
- -3.1763267517089844,
- -2.965965747833252,
- 2.055418014526367,
- 1.7646766901016235,
- 2.0915160179138184,
- 1.9841140508651733,
- 0.7309734225273132,
- 0.8535610437393188,
- 1.1015901565551758,
- 1.1043431758880615,
- -3.231236696243286,
- -3.466428518295288,
- -3.2163987159729004,
- 1.5548237562179565,
- -2.620222806930542,
- -2.8454513549804688,
- -2.381518602371216,
- -1.7730915546417236,
- -2.034778118133545,
- -1.792545199394226,
- 0.23506808280944824,
- 0.15298357605934143,
- -0.12086783349514008,
- -0.0009967255173251033,
- 3.0469939708709717,
- 3.3803346157073975,
- 3.5396389961242676,
- 3.4276304244995117,
- -3.4141626358032227,
- -3.28906512260437,
- -3.1413207054138184,
- -2.9626805782318115,
- -3.5331058502197266,
- -2.7990610599517822,
- -2.5825302600860596,
- 1.0379852056503296,
- 1.3705062866210938,
- 1.090142846107483,
- 1.1630381345748901,
- -0.7285075783729553,
- -0.5913762450218201,
- -0.41392114758491516,
- 0.37851566076278687,
- 0.2083987444639206,
- 0.536102294921875,
- 4.585145950317383,
- 4.314233303070068,
- 4.690446853637695,
- 4.508464336395264,
- 0.5570757389068604,
- 0.7471429109573364,
- 0.8703640103340149,
- 0.735404372215271,
- 1.950286626815796,
- -2.459625482559204,
- -2.3318281173706055,
- -4.318643569946289,
- -2.7759718894958496,
- -2.491568088531494,
- -2.487426280975342,
- 3.034865140914917,
- 1.392642855644226,
- 3.841580390930176,
- -1.7278932332992554,
- -1.9114822149276733,
- -1.5143166780471802,
- -1.7121433019638062,
- 4.3564581871032715,
- 4.085196018218994,
- 4.489546298980713,
- 0.03738686069846153,
- 0.4072064459323883,
- 0.3515777885913849,
- 4.740171909332275,
- 5,
- 5,
- -3.7102108001708984,
- -3.5805227756500244,
- -3.250467300415039,
- -3.6381490230560303,
- -5,
- -4.672852039337158,
- -5,
- -5,
- 3.9007976055145264,
- 4.133395671844482,
- 4.175212860107422,
- 4.236222267150879,
- 1.3414992094039917,
- 1.545016884803772,
- 1.7293202877044678,
- 1.7089415788650513,
- 1.5792618989944458,
- 1.938088297843933,
- -4.447057247161865,
- -4.589023590087891,
- -4.721797943115234,
- -5,
- -4.662319183349609,
- -4.697544574737549,
- -4.536230564117432,
- 5,
- 5,
- 5,
- 2.2066378593444824,
- 1.9319493770599365,
- 2.258507013320923,
- 2.2539353370666504,
- 2.732060194015503,
- -2.9786436557769775,
- -2.8140065670013428,
- -2.7915046215057373,
- -2.627666711807251,
- 0.9115676283836365,
- -0.532065212726593,
- -0.5675407648086548,
- -0.5571060180664062,
- -2.564318895339966,
- -4.4288010597229,
- -4.226881980895996,
- -4.208695411682129,
- -4.0041913986206055,
- -4.3078436851501465,
- -4.320655345916748,
- 2.809098720550537,
- 2.785369634628296,
- 5,
- 4.710524559020996,
- 5,
- 5,
- -4.560494422912598,
- -4.414031982421875,
- -4.710155963897705,
- 0.027450760826468468,
- -0.09511373937129974,
- 0.3111163377761841,
- 4.47791862487793,
- 4.311753749847412,
- 2.278442859649658,
- 2.3220880031585693,
- 1.0773473978042603,
- 0.6730288863182068,
- 1.7689932584762573,
- 1.6555397510528564,
- 1.9800528287887573,
- 2.0714244842529297,
- -0.6446894407272339,
- -0.43192827701568604,
- -3.7548670768737793,
- -3.300417423248291,
- -1.1125221252441406,
- -0.6115882396697998,
- -2.978154420852661,
- -3.3732173442840576,
- -3.242103338241577,
- 1.2596628665924072,
- -3.6130688190460205,
- -3.133923292160034,
- -3.3986732959747314,
- -3.5859854221343994,
- -3.520331621170044,
- -3.851719617843628,
- -3.865055561065674,
- 0.5590431690216064,
- 0.6265019774436951,
- -0.03324676677584648,
- 2.4285573959350586,
- 2.5746889114379883,
- 2.7181601524353027,
- 2.378453016281128,
- 3.447817087173462,
- 2.445730209350586,
- 2.310244083404541,
- 2.6667962074279785,
- -4.695241928100586,
- -5,
- -4.548861980438232,
- -0.33884161710739136,
- -0.5452479720115662,
- -0.44265344738960266,
- -1.2199991941452026,
- -1.154729962348938,
- -0.9447287917137146,
- -0.8053910136222839,
- 3.9948537349700928,
- 3.997985601425171,
- 4.207438945770264,
- 2.2636070251464844,
- 2.816199541091919,
- 3.2298614978790283,
- 3.0754427909851074,
- 3.1898257732391357,
- -2.0362820625305176,
- -1.695935845375061,
- -2.8119935989379883,
- -2.5727436542510986,
- 3.0221409797668457,
- 3.255614995956421,
- 3.368884563446045,
- 3.2635715007781982,
- 4.541206359863281,
- 3.801682472229004,
- 4.062766075134277,
- 3.6565608978271484,
- 2.893397092819214,
- 3.020784378051758,
- 2.637270450592041,
- 2.978060007095337,
- 0.706810474395752,
- 0.7772684097290039,
- 0.8003952503204346,
- -0.22241777181625366,
- -0.1280590295791626,
- -2.9058010578155518,
- -0.3929927349090576,
- -1.6517680883407593,
- 4.374144554138184,
- 4.208742141723633,
- 1.0169200897216797,
- 0.6947392225265503,
- 0.6771532297134399,
- -4.339812278747559,
- 3.8944802284240723,
- 3.9562127590179443,
- 2.033257246017456,
- 1.9155778884887695,
- 1.3438067436218262,
- 1.0825568437576294,
- -1.7339566946029663,
- -1.3611284494400024,
- -1.3337901830673218,
- -1.2508692741394043,
- -2.2653911113739014,
- -2.2419567108154297,
- -3.1367833614349365,
- -1.81843900680542,
- -2.1527793407440186,
- -1.6042685508728027,
- -1.647326946258545,
- 4.628890037536621,
- 4.72548246383667,
- 2.286425828933716,
- 1.9910200834274292,
- 2.3555381298065186,
- 2.0931544303894043,
- 3.7614736557006836,
- 3.912747859954834,
- -4.636204242706299,
- -4.488008499145508,
- 0.4070380926132202,
- -0.13350971043109894,
- 0.19662299752235413,
- 0.13111887872219086,
- -0.7308740019798279,
- -0.5450983643531799,
- -0.6622709035873413,
- 0.003929497674107552,
- 0.24031925201416016,
- -0.22965681552886963,
- -0.0660269558429718,
- -0.17119362950325012,
- -0.18464888632297516,
- -0.0036181053146719933,
- -0.7095974087715149,
- 1.9864104986190796,
- -2.5475826263427734,
- -2.7074756622314453,
- -2.891202926635742,
- -2.509110927581787,
- 2.9578778743743896,
- 3.029849052429199,
- 2.3168818950653076,
- 3.536309242248535,
- 3.2530806064605713,
- -3.741461992263794,
- -2.821955680847168,
- -3.082059383392334,
- -2.9099485874176025,
- -2.7286927700042725,
- -0.6247063279151917,
- -0.3622240722179413,
- -0.4216044247150421,
- 1.6000310182571411,
- 5,
- 5,
- -1.6445059776306152,
- 0.2146318256855011,
- -4.1633453369140625,
- -4.1257829666137695,
- -3.817925214767456,
- -3.784167766571045,
- -1.2936067581176758,
- 1.8930131196975708,
- 1.5624295473098755,
- 1.5452696084976196,
- -1.8079805374145508,
- -1.6008325815200806,
- 1.2422401905059814,
- 1.4802297353744507,
- 1.4433354139328003,
- 1.5805444717407227,
- 0.7913298010826111,
- 2.578340768814087,
- 2.6075079441070557,
- -0.813774585723877,
- -5,
- -5,
- -4.7412261962890625,
- -4.72172212600708,
- 1.3737642765045166,
- 1.2108287811279297,
- 1.3925875425338745,
- 1.4203695058822632,
- 0.5987880825996399,
- -4.71983003616333,
- -5,
- -5,
- -4.692821025848389,
- 1.909011960029602,
- 1.7303102016448975,
- 1.6846473217010498,
- 5,
- -3.5527470111846924,
- 0.37845441699028015,
- -1.9841102361679077,
- 3.145871162414551,
- 1.289706826210022,
- 0.7273845076560974,
- 0.720970630645752,
- 1.0219862461090088,
- 0.8861194849014282,
- -4.596095085144043,
- -4.253779888153076,
- -4.743481159210205,
- -1.5359901189804077,
- 3.121032953262329,
- -4.488008499145508,
- -1.1460216045379639,
- 4.6934332847595215,
- 4.375402450561523,
- 4.680056095123291,
- -4.230134010314941,
- -3.7863848209381104,
- -4.4221673011779785,
- -4.591073989868164,
- 4.1638264656066895,
- 4.340243339538574,
- 4.488320350646973,
- -2.5075998306274414,
- 1.917682409286499,
- 4.661116600036621,
- 4.636397361755371,
- 4.488320350646973,
- 5,
- -3.489121437072754,
- -1.138638973236084,
- -0.7274905443191528,
- -4.574654579162598,
- -4.382515907287598,
- -3.1639509201049805,
- -2.7766637802124023,
- 0.7139411568641663,
- 0.4993683397769928,
- 0.7703021764755249,
- 0.901824951171875,
- -1.5355284214019775,
- -2.1874425411224365,
- -2.3504247665405273,
- -4.327395915985107,
- -2.3662376403808594,
- -3.6765761375427246,
- 1.808962345123291,
- 4.351280689239502,
- 4.706614017486572,
- -3.448230266571045,
- -3.3269059658050537,
- -1.3753197193145752,
- -1.1046783924102783,
- -1.4444420337677002,
- 0.29257264733314514,
- 0.009619895368814468,
- 0.32545214891433716,
- 0.23237977921962738,
- 1.4445356130599976,
- -1.2714718580245972,
- -1.4109042882919312,
- 4.735227108001709,
- -3.157381772994995,
- -5,
- -4.624974727630615,
- 4.58084774017334,
- 4.646906852722168,
- -4.253415107727051,
- -3.6714272499084473,
- -4.048503875732422,
- -3.91367769241333,
- -0.662963330745697,
- -0.45707225799560547,
- -0.3023490607738495,
- -0.10872425138950348,
- -0.40253975987434387,
- -0.7720760107040405,
- -2.228641986846924,
- -2.0955162048339844,
- -1.9311330318450928,
- 4.527668476104736,
- 4.4020185470581055,
- 4.253148078918457,
- 4.159819602966309,
- 0.06420236825942993,
- 4.135446548461914,
- -0.9258043766021729,
- -0.8058002591133118,
- 4.537054061889648,
- 4.744240760803223,
- -0.8789688944816589,
- 0.3651331961154938,
- 0.7293714880943298,
- -0.06956324726343155,
- -0.08140537887811661,
- 1.721306324005127,
- -3.6552634239196777,
- -3.3976213932037354,
- -3.114668607711792,
- -2.9648706912994385,
- -2.7460291385650635,
- 0.9609786868095398,
- 1.0764851570129395,
- -2.625852346420288,
- -2.673210859298706,
- -2.3928139209747314,
- 3.227536678314209,
- 3.531540632247925,
- 3.7912299633026123,
- 3.446416139602661,
- 1.760624647140503,
- 1.2702659368515015,
- 1.4204895496368408,
- 1.1356712579727173,
- 1.1212012767791748,
- -0.7966426014900208,
- -4.596960067749023,
- -2.358410358428955,
- -2.481785297393799,
- -2.317129611968994,
- 2.1517908573150635,
- 1.9424786567687988,
- 4.65165901184082,
- -4.577237129211426,
- 3.162456750869751,
- 3.290433168411255,
- 3.418100118637085,
- -3.9114646911621094,
- 0.9896045327186584,
- -0.19112993776798248,
- 2.6939661502838135,
- 3.0167806148529053,
- 2.893794298171997,
- 3.0206243991851807,
- 1.2407162189483643,
- -0.46050986647605896,
- 5,
- 4.663840293884277,
- 5,
- -3.103480339050293,
- -2.277939558029175,
- -2.125932216644287,
- -1.824216604232788,
- -2.0925588607788086,
- 2.68068528175354,
- -4.7859697341918945,
- -4.575015544891357,
- 2.8520922660827637,
- -3.2595419883728027,
- -4.203586101531982,
- -4.2565202713012695,
- -3.767660140991211,
- -3.32572078704834,
- 0.5733931660652161,
- 0.5859797596931458,
- 0.6658535599708557,
- 4.556863307952881,
- 5,
- 5,
- -2.477255344390869,
- 0.25908347964286804,
- 0.25868678092956543,
- 0.49322885274887085,
- -5,
- -0.1877877414226532,
- -5,
- -5,
- 3.983049154281616,
- -2.6407032012939453,
- 0.5915303230285645,
- 1.0867373943328857,
- -1.214605450630188,
- -1.4895960092544556,
- 2.3244974613189697,
- 1.0752484798431396,
- 3.5134105682373047,
- 3.492990732192993,
- -4.003303050994873,
- -4.055683612823486,
- -4.244694709777832,
- -4.091361999511719,
- 2.220043897628784,
- 2.544774293899536,
- -5,
- 3.5021090507507324,
- 3.226494312286377,
- 1.4538578987121582,
- 0.25620901584625244,
- -4.075596809387207,
- -4.281928539276123,
- -4.1883087158203125,
- -4.555990695953369,
- -4.334146976470947,
- -4.165266990661621,
- 4.628626346588135,
- 4.596282482147217,
- 4.575169086456299,
- -4.123189449310303,
- -3.8626294136047363,
- -3.69762921333313,
- 3.6556200981140137,
- -4.1212477684021,
- -3.785296678543091,
- -1.9285658597946167,
- -3.4919838905334473,
- 5,
- -1.8179099559783936,
- -4.580845355987549,
- -4.697874546051025,
- -4.374136447906494,
- 2.7386975288391113,
- 3.034958839416504,
- 2.8929836750030518,
- 2.8669273853302,
- -5,
- -1.5589079856872559,
- 1.9696201086044312,
- 3.9466171264648438,
- -3.894467353820801,
- -1.4353413581848145,
- 0.6438999772071838,
- -3.559412717819214,
- 2.898449182510376,
- 4.226627349853516,
- -5,
- -5,
- -4.580845355987549,
- -2.0328192710876465,
- 4.1754069328308105,
- 4.199225902557373,
- 4.34015417098999,
- -2.9041290283203125,
- 2.497323513031006,
- -1.7650561332702637,
- -0.5644856095314026,
- -5,
- -5,
- 3.0372588634490967,
- 3.8829185962677,
- 3.6070923805236816,
- 3.8541207313537598,
- 3.8192059993743896,
- -2.6382784843444824,
- -4.700376033782959,
- 2.501884937286377,
- 4.065597057342529,
- 1.0171412229537964,
- 5,
- -4.651655673980713,
- -0.8031032681465149,
- 1.2622673511505127,
- 1.2936519384384155,
- 1.369748592376709,
- 4.189074516296387,
- 4.076688766479492,
- 5,
- 0.7270625233650208,
- 0.995764970779419,
- -0.8975422382354736,
- -1.5903971195220947,
- 3.329392194747925,
- 3.4523019790649414,
- -1.0810967683792114,
- -0.5812257528305054,
- 2.644548177719116,
- 2.6585214138031006,
- 5,
- 3.7732388973236084,
- 0.9950934052467346,
- 0.8841180801391602,
- 3.8183670043945312,
- -0.6460126042366028,
- 2.1103804111480713,
- 2.3608930110931396,
- 1.3835891485214233,
- 3.4795989990234375,
- 1.769286036491394,
- 1.7716087102890015,
- -5,
- -5,
- -5,
- -1.426405906677246,
- -2.7312746047973633,
- -5,
- 0.47139957547187805,
- 3.8471028804779053,
- 0.7896639108657837,
- -1.2268297672271729,
- -4.720064640045166,
- 2.7558088302612305,
- 3.023494243621826,
- 3.7829294204711914,
- -1.891106128692627,
- 3.048088550567627,
- 0.008336871862411499,
- 0.07599930465221405,
- -1.3721232414245605,
- -1.032981276512146,
- -0.6021665930747986,
- 1.735460877418518,
- 1.5383501052856445,
- 2.478435516357422,
- -3.304556131362915,
- -2.378432035446167,
- -0.4857358932495117,
- -2.097623586654663,
- -3.2147445678710938,
- -1.8128300905227661,
- 3.589271306991577,
- 3.373690366744995,
- -3.5193681716918945,
- 3.53788161277771,
- -1.1633410453796387,
- -3.841488838195801,
- -3.562544822692871,
- -5,
- -4.628747463226318,
- -0.3776344060897827,
- -1.9576623439788818,
- -2.3299407958984375,
- -2.3134829998016357,
- 0.5879091620445251,
- 0.39716675877571106,
- 5,
- -4.527527809143066,
- 2.8390586376190186,
- 0.3319953382015228,
- -0.2031165361404419,
- 5,
- 5,
- 5,
- -5,
- 2.2759742736816406,
- 4.30157470703125,
- -0.7995855808258057,
- -0.05464247241616249,
- -1.3260889053344727,
- -1.0919172763824463,
- -1.5666868686676025,
- 0.6270329356193542,
- 2.468057155609131,
- -2.5841712951660156,
- -4.339723110198975,
- 5,
- 5,
- 0.5067524909973145,
- 0.7723978161811829,
- 3.510948657989502,
- 4.363494873046875,
- -3.0252578258514404,
- -1.2719022035598755,
- 4.58084774017334,
- 5,
- 4.526966571807861,
- -5,
- -5,
- -5,
- 5,
- 4.227243900299072,
- 4.085610389709473,
- -4.363025188446045,
- -1.356877088546753,
- -1.0370725393295288,
- 1.1098798513412476,
- -1.7669402360916138,
- 3.0309200286865234,
- 1.8378273248672485,
- -1.0789508819580078,
- 1.8391550779342651,
- 0.4916764497756958,
- -3.601686716079712,
- -0.24966329336166382,
- 4.12544059753418,
- -5,
- -5,
- 1.536503791809082,
- 1.7359037399291992,
- 5,
- -3.840538263320923,
- -5,
- -5,
- -5,
- 4.124938011169434,
- -4.646697998046875,
- -5,
- 4.167131423950195,
- -3.3831329345703125,
- -3.5020036697387695,
- 3.266669988632202,
- -0.9436191916465759,
- -1.5299025774002075,
- -1.982384204864502,
- 3.6774818897247314,
- -2.2120511531829834,
- -0.3448413610458374,
- -3.386986017227173,
- -3.1074790954589844,
- -0.4411892294883728,
- -0.3736647963523865,
- -5,
- -5,
- -1.2011436223983765,
- -1.1121392250061035,
- -2.1613833904266357,
- -2.2924811840057373,
- 3.104656934738159,
- 2.610442638397217,
- 5,
- -5,
- -2.3681676387786865,
- 3.672323226928711,
- 3.7326676845550537,
- 0.1613098382949829,
- 0.2413194328546524,
- 1.3728821277618408,
- 0.4339759051799774,
- 0.35695144534111023,
- -2.493479013442993,
- 2.1896910667419434,
- 4.700502395629883,
- 5,
- -1.016597032546997,
- 0.6210448145866394,
- 0.6637445688247681,
- 5,
- -1.0216628313064575,
- -0.23358485102653503,
- 3.3018922805786133,
- 1.8105369806289673,
- 0.955568790435791,
- -3.7231528759002686,
- -3.9804978370666504,
- -1.2900493144989014,
- 4.1124267578125,
- -3.540820360183716,
- -5,
- -3.8975656032562256,
- 1.2156816720962524,
- 0.7590240836143494,
- 3.5594608783721924,
- -3.283069372177124,
- -5,
- -3.2769768238067627,
- 0.1670776754617691,
- -0.7176233530044556,
- 0.9799598455429077,
- 1.3872452974319458,
- -2.0572428703308105,
- -3.3091535568237305,
- -1.3487980365753174,
- -4.625357627868652,
- -2.012728691101074,
- -5,
- 0.8194661736488342,
- -1.579920768737793,
- -1.5731505155563354,
- -4.639402389526367,
- -1.7494895458221436,
- -3.0217342376708984,
- -1.5556175708770752,
- 2.022423028945923,
- -2.8629543781280518,
- 1.2468470335006714,
- 1.9912384748458862,
- -1.0789836645126343,
- -0.08867280930280685,
- -1.3601857423782349,
- 0.519882321357727,
- 2.222944498062134,
- 0.5680000185966492,
- 2.373995542526245,
- -2.9980807304382324,
- 3.2855708599090576
- ],
- "y": [
- -0.9644528031349182,
- -0.5014916062355042,
- -0.9228641390800476,
- -0.9955595135688782,
- 0.2492223083972931,
- 0.057115908712148666,
- -0.16631139814853668,
- -0.06584170460700989,
- 0.10396039485931396,
- -0.31133314967155457,
- -0.041115161031484604,
- -0.04820563644170761,
- -0.949433445930481,
- -0.8801339268684387,
- -0.5981799364089966,
- -0.9736314415931702,
- -0.43101099133491516,
- -0.4243756830692291,
- -0.4731490910053253,
- -0.6577183604240417,
- 0.2146396040916443,
- 0.5974391102790833,
- 0.2125028818845749,
- 0.43337777256965637,
- 0.4884589910507202,
- 0.6967326402664185,
- 0.6029126048088074,
- 0.23680882155895233,
- 0.6917465329170227,
- 0.4850515127182007,
- 0.18376414477825165,
- 0.48162636160850525,
- -0.6320042610168457,
- -0.7730603814125061,
- -0.9154437184333801,
- -0.9334678649902344,
- -0.937618613243103,
- -0.6324880123138428,
- -0.9645949602127075,
- -0.8584909439086914,
- -0.021662965416908264,
- -0.19917190074920654,
- -0.40617337822914124,
- 0.01375947892665863,
- 0.6443992257118225,
- 0.2646108865737915,
- 0.3110242187976837,
- 0.4987179636955261,
- 0.2822154462337494,
- 0.22283178567886353,
- 0.3027957081794739,
- 0.48568424582481384,
- -0.004136862698942423,
- 0.24444110691547394,
- 0.3975219428539276,
- 0.06679671257734299,
- 0.3392251133918762,
- 0.4178438186645508,
- 0.0005444167763926089,
- 0.26371410489082336,
- 0.6860716342926025,
- 0.5389652252197266,
- 0.2810700237751007,
- 0.29595068097114563,
- -0.0028515858575701714,
- -0.914943516254425,
- -0.8317362070083618,
- -0.5160342454910278,
- 0.1723458170890808,
- -0.24010129272937775,
- 0.11037452518939972,
- -0.04924260079860687,
- 0.9950059056282043,
- 0.5880264043807983,
- 0.590488612651825,
- 0.6281570792198181,
- -0.1020033061504364,
- 0.12514355778694153,
- 0.26880502700805664,
- -0.06841706484556198,
- 0.07446050643920898,
- -0.19104579091072083,
- 0.17392556369304657,
- -0.010952293872833252,
- 0.8551027774810791,
- 0.8424614071846008,
- 0.4966377019882202,
- 0.9818977117538452,
- -0.7847625613212585,
- -0.3964613676071167,
- -0.7274291515350342,
- 0.9931104183197021,
- 0.990178644657135,
- 0.9477092027664185,
- -0.7309668660163879,
- -0.8255475759506226,
- -0.5082603693008423,
- -0.8930004835128784,
- 0.4194926917552948,
- 0.20234280824661255,
- 0.382354199886322,
- 0.04821555316448212,
- -0.22185000777244568,
- -0.2684493958950043,
- -0.2542339563369751,
- -0.6113150715827942,
- -0.749304473400116,
- 0.9967495203018188,
- 0.6226924657821655,
- 0.9509856700897217,
- 0.9614278674125671,
- -0.5285993218421936,
- -0.26093634963035583,
- -0.44633013010025024,
- -0.7162333726882935,
- 0.37243372201919556,
- 0.7037805914878845,
- 0.5981281399726868,
- 0.8595001101493835,
- -0.2422453761100769,
- -0.2717275023460388,
- -0.342314749956131,
- -0.36787569522857666,
- -0.0067490083165466785,
- -0.12062981724739075,
- -0.10932574421167374,
- 0.7730425596237183,
- 0.7197641730308533,
- 0.5498804450035095,
- 0.8838788866996765,
- -0.4682152271270752,
- -0.8429638743400574,
- -0.7152993083000183,
- 0.16587448120117188,
- 0.17635276913642883,
- 0.4282841980457306,
- -0.06333015114068985,
- 0.0034832851961255074,
- 0.09057462960481644,
- -0.7059872150421143,
- -0.3774401545524597,
- -0.6989597082138062,
- -0.5003755688667297,
- 0.7566817402839661,
- 0.44234010577201843,
- 0.45263102650642395,
- 0.5166338682174683,
- 0.16024252772331238,
- 0.5950716137886047,
- -0.18073487281799316,
- 0.0018878098344430327,
- -0.2708609104156494,
- -0.25196877121925354,
- -0.11142797023057938,
- -0.43370550870895386,
- -0.15656259655952454,
- -0.039399806410074234,
- 0.46687936782836914,
- 0.32242169976234436,
- 0.6205798983573914,
- 0.6568413972854614,
- 0.2932124137878418,
- 0.286562442779541,
- 0.5216072797775269,
- -0.9623097777366638,
- -0.9981469511985779,
- -0.6364484429359436,
- -0.9993236660957336,
- -0.07432012259960175,
- 0.42001017928123474,
- 0.34383609890937805,
- -0.08206897974014282,
- 0.17495545744895935,
- -0.6187282204627991,
- -0.17506438493728638,
- -0.16744637489318848,
- -0.3097870349884033,
- -0.4293544590473175,
- -0.34442025423049927,
- -0.08278083801269531,
- 0.040901072323322296,
- -0.20948979258537292,
- -0.8171733617782593,
- -0.6349214315414429,
- -0.63686603307724,
- -0.34542766213417053,
- 0.9818851351737976,
- 0.7231388688087463,
- -0.4980590343475342,
- -0.5276463031768799,
- -0.6645891070365906,
- 0.6138550639152527,
- 0.7307949662208557,
- 0.565581202507019,
- 0.8974766731262207,
- 0.2210589051246643,
- -0.04366305470466614,
- 0.2200208306312561,
- 0.9976720213890076,
- 0.9910743236541748,
- 0.04993176832795143,
- 0.2965986132621765,
- 0.3659362196922302,
- -0.6525683999061584,
- -0.4112653136253357,
- -0.9211462140083313,
- -0.8424838185310364,
- -0.9637735486030579,
- -0.9835269451141357,
- -0.9970294237136841,
- -0.9710226655006409,
- -0.9704429507255554,
- -0.000344896805472672,
- 0.21921929717063904,
- -0.13210053741931915,
- 0.1057116687297821,
- -0.5773980617523193,
- -0.8491992354393005,
- -0.9644528031349182,
- -0.9644528031349182,
- 0.18421055376529694,
- -0.34306600689888,
- -0.6099089980125427,
- -0.522908627986908,
- 0.5520397424697876,
- 0.6777611374855042,
- 0.7900189757347107,
- 0.8836524486541748,
- 0.998988151550293,
- 0.6972864270210266,
- 0.9325829744338989,
- -0.7420949339866638,
- -0.8717162013053894,
- 0.3239639103412628,
- 0.3646659553050995,
- 0.18762114644050598,
- 0.4323038160800934,
- 0.49042609333992004,
- 0.4172574579715729,
- -0.4056946337223053,
- -0.7565715909004211,
- -0.8770694732666016,
- -0.6713137626647949,
- 0.3914759159088135,
- 0.5560338497161865,
- 0.401335746049881,
- 0.6967827081680298,
- 0.5735718011856079,
- 0.9659417867660522,
- 0.4600377678871155,
- -0.7376769781112671,
- -0.7612969279289246,
- -0.8649499416351318,
- -0.9680713415145874,
- -0.07136695086956024,
- 0.08702337741851807,
- -0.0012019457062706351,
- -0.40912172198295593,
- -0.006982382852584124,
- -0.2469279021024704,
- 0.2634161114692688,
- 0.19823867082595825,
- 0.6264614462852478,
- -0.0895332545042038,
- 0.15487948060035706,
- 0.010749834589660168,
- 0.21317049860954285,
- 0.3579390347003937,
- 0.6785242557525635,
- 0.4390743672847748,
- 0.2672802209854126,
- -0.8758218884468079,
- -0.963442862033844,
- -0.9812936782836914,
- 0.47073882818222046,
- 0.4233376085758209,
- 0.6527111530303955,
- 0.6982703804969788,
- 0.6721965670585632,
- 0.9104544520378113,
- 0.8594658970832825,
- 0.9712696671485901,
- 0.7178391218185425,
- 0.9804772734642029,
- 0.9899379014968872,
- -0.272844135761261,
- -0.23376643657684326,
- -0.262163907289505,
- 0.03704443946480751,
- -0.4075758457183838,
- -0.7010478377342224,
- -0.20673303306102753,
- -0.5571584105491638,
- -0.8706849217414856,
- -0.48726165294647217,
- -0.2910931706428528,
- -0.002765015931800008,
- 0.05970108136534691,
- 0.3084672689437866,
- 0.15337669849395752,
- -0.6174674034118652,
- -0.6328142881393433,
- -0.5624826550483704,
- 0.1400715708732605,
- 0.3191937208175659,
- 0.02131892368197441,
- -0.09887219220399857,
- -0.13459566235542297,
- 0.031372569501399994,
- -0.23347316682338715,
- -0.1083475649356842,
- 0.10015857964754105,
- -0.15261906385421753,
- -0.3190996050834656,
- 0.5962103009223938,
- 0.944227933883667,
- 0.6263585686683655,
- -0.03721585124731064,
- -0.14064188301563263,
- -0.12287423759698868,
- 0.1620333045721054,
- 0.051118478178977966,
- 0.025942236185073853,
- 0.9509856700897217,
- 0.07660112529993057,
- -0.2148650735616684,
- -0.2792571783065796,
- -0.3916383981704712,
- -0.5475131869316101,
- -0.3573049306869507,
- -0.5381907820701599,
- 0.5642790794372559,
- 0.39763057231903076,
- 0.4926196038722992,
- 0.6876794695854187,
- 0.9853602051734924,
- 0.9853602051734924,
- 0.2784459888935089,
- 0.33439427614212036,
- 0.3757942020893097,
- 0.5680580735206604,
- -0.202531099319458,
- 0.04602264240384102,
- 0.1253708153963089,
- -0.053822703659534454,
- -0.09523261338472366,
- -0.3647562861442566,
- 0.055967457592487335,
- -0.18043585121631622,
- -0.36183372139930725,
- -0.26616132259368896,
- 0.5843426585197449,
- 0.7874525785446167,
- 0.3204408586025238,
- 0.46942922472953796,
- -0.3549381494522095,
- -0.15470989048480988,
- -0.28662583231925964,
- -0.45677778124809265,
- -0.14482297003269196,
- -0.3699699342250824,
- -0.31996339559555054,
- 0,
- 0.03902474418282509,
- -0.4207833707332611,
- 0.5997176170349121,
- 0.34521904587745667,
- 0.260562002658844,
- 0.301216721534729,
- -0.39678168296813965,
- -0.9933051466941833,
- -0.48806899785995483,
- -0.9801273941993713,
- -0.9932265877723694,
- -0.00268577691167593,
- -0.4860992431640625,
- -0.718903660774231,
- -0.22610677778720856,
- 0.40737977623939514,
- 0.7242735624313354,
- 0.9194390773773193,
- 0.992190957069397,
- 0.5167772769927979,
- -0.8444285988807678,
- -0.6822850704193115,
- 0.6697694063186646,
- 0.9455884695053101,
- -0.563209056854248,
- -0.6827536821365356,
- -0.6466551423072815,
- -1,
- 0.00808846578001976,
- -0.21341004967689514,
- -0.08499597012996674,
- -0.22998903691768646,
- -0.6067743301391602,
- -0.49108201265335083,
- -0.5265984535217285,
- -0.9826362729072571,
- -0.23542766273021698,
- -0.2631172835826874,
- -0.38973894715309143,
- -0.510794460773468,
- 0.614811897277832,
- 0.9284683465957642,
- 0.980880856513977,
- 0.6759928464889526,
- 0.7887943387031555,
- 0.334210067987442,
- 0.8685921430587769,
- 0.9433988928794861,
- 0.3017013370990753,
- 0.322925865650177,
- 0.0030513221863657236,
- -0.08400421589612961,
- 0.1492752730846405,
- 0.15100379288196564,
- 0.2531687021255493,
- 0.22673995792865753,
- 0.08318476378917694,
- -0.09412675350904465,
- -0.10312476009130478,
- 0.00051957240793854,
- 0.1938382387161255,
- -0.429431289434433,
- -0.6668448448181152,
- 0.27889484167099,
- -0.9699349999427795,
- -0.6830593347549438,
- -0.9178845286369324,
- -0.8040575385093689,
- -0.03522491827607155,
- 0.586391270160675,
- 0.9315357804298401,
- 0.7273709177970886,
- 0.23738005757331848,
- 0.16160446405410767,
- 0.196137934923172,
- 0.6648127436637878,
- 0.9904631972312927,
- 0.9321214556694031,
- -0.9826473593711853,
- -0.5793296098709106,
- -0.5139965415000916,
- -0.9829296469688416,
- 0.10490112006664276,
- 0.26333707571029663,
- 0.015549364499747753,
- 0.7950919270515442,
- -0.22844749689102173,
- 0.08410408347845078,
- -0.014554033055901527,
- -0.40973183512687683,
- -0.6088537573814392,
- -0.7200993895530701,
- -0.25975117087364197,
- -0.05376914516091347,
- 0.25696367025375366,
- -0.02727169543504715,
- -0.9200538992881775,
- -0.9851748943328857,
- 0.2039009928703308,
- -0.18674251437187195,
- -0.0373150035738945,
- 0.0003531149122864008,
- 0.7743528485298157,
- 0.49138516187667847,
- 0.8453116416931152,
- 0.8113861680030823,
- -0.2243531048297882,
- 0.17102263867855072,
- 0.13133029639720917,
- -0.8719936609268188,
- -0.7000458240509033,
- -0.5028141736984253,
- 0.5621294975280762,
- -0.48999398946762085,
- 1,
- 0.9576523303985596,
- -0.41538330912590027,
- -0.5296134352684021,
- -0.5272583365440369,
- 0.26668936014175415,
- 0.9760602116584778,
- 0.874788224697113,
- -0.8827227354049683,
- -0.9637153744697571,
- -0.5040878057479858,
- -0.27172648906707764,
- 0.274967223405838,
- -0.01066218875348568,
- 0.29421308636665344,
- 0.1539771407842636,
- 0.15297439694404602,
- 0.35023635625839233,
- -0.21796944737434387,
- 0.8537461161613464,
- 0.9835426211357117,
- 0.9496530294418335,
- 0.9985606074333191,
- -0.2221001833677292,
- 0.4310095012187958,
- 0.6029019355773926,
- 0.7001603841781616,
- 0.8360967636108398,
- 0.519031286239624,
- -0.9936496019363403,
- -0.9828091859817505,
- 0.26668936014175415,
- 0.5236851572990417,
- 0.49962037801742554,
- 0.5692272782325745,
- 0.22008033096790314,
- 0.2918113172054291,
- -0.005608721170574427,
- 0.03870052844285965,
- 0.26892536878585815,
- -0.1814487725496292,
- 0.06543553620576859,
- 0.08210965245962143,
- -0.09493392705917358,
- 0.23452402651309967,
- 0.04021294042468071,
- -0.09652941673994064,
- 0.6716895699501038,
- 0.8282829523086548,
- -0.5790790915489197,
- -0.7159784436225891,
- -0.874889612197876,
- -0.9411375522613525,
- -0.25209754705429077,
- -0.6056337356567383,
- -0.4996890425682068,
- 0.268974632024765,
- 0.4170511066913605,
- 0.2456361949443817,
- 0.17661170661449432,
- -0.6461558938026428,
- -0.8366621732711792,
- -0.9373155832290649,
- 0.6573933362960815,
- 0.764940083026886,
- 0.4581672251224518,
- 0.012059792876243591,
- -0.36481741070747375,
- 0.047285694628953934,
- -0.19150404632091522,
- -0.06492480635643005,
- 0.2849947214126587,
- 0.49767422676086426,
- 0.28277072310447693,
- 0.54390949010849,
- 0.1638433039188385,
- -0.31062552332878113,
- -0.08801092207431793,
- -0.47230759263038635,
- -0.2938145399093628,
- -0.0704847201704979,
- 0.6260424852371216,
- 0.39466437697410583,
- 0.31425905227661133,
- 0.7220942974090576,
- -0.7903173565864563,
- 0.2835279703140259,
- 0.6021785140037537,
- 0.5951641798019409,
- 0.3522506654262543,
- 0.5202761888504028,
- 0.6336329579353333,
- 0.44877156615257263,
- 0.5989428758621216,
- 0.9741127490997314,
- 0.9952908158302307,
- 0.6856418251991272,
- -0.18962796032428741,
- 0.14198823273181915,
- 0.027870045974850655,
- -0.2665543556213379,
- -0.12062981724739075,
- -0.35000452399253845,
- -0.6031556725502014,
- -0.7968862652778625,
- -0.9509775042533875,
- 0.2576938569545746,
- -0.17726917564868927,
- 0.9844260215759277,
- -0.4435259699821472,
- -0.1699523627758026,
- 0.6966899037361145,
- 0.9935153722763062,
- 0.994518518447876,
- 0.9067777991294861,
- -0.9979760646820068,
- -0.9827584624290466,
- -0.01198972761631012,
- 0.004887382499873638,
- 0.9262871146202087,
- -0.011220625601708889,
- 0.20926238596439362,
- 0.08175507932901382,
- 0.13949643075466156,
- 0.24324852228164673,
- 0.2432398945093155,
- -0.03161051869392395,
- 0.41032442450523376,
- 0.5218767523765564,
- -0.1977277398109436,
- 0.07446050643920898,
- -0.20594902336597443,
- -0.3251917064189911,
- -0.6149249076843262,
- 0.4732542634010315,
- 0.07446050643920898,
- 0.3481038212776184,
- 0.22188933193683624,
- 0.2149362415075302,
- -0.24006293714046478,
- -0.2876802384853363,
- 0.41702282428741455,
- 0.19047819077968597,
- -0.2501949965953827,
- -0.15160758793354034,
- 0.43379339575767517,
- 0.0909355953335762,
- 0.451621413230896,
- 0.5065004825592041,
- -0.9908729195594788,
- -0.08206022530794144,
- -0.027877792716026306,
- 0.5542229413986206,
- -0.38842886686325073,
- 0.9741654992103577,
- -0.3724351227283478,
- -0.1986246407032013,
- -0.3232215344905853,
- 0.7665350437164307,
- 0.5796975493431091,
- -0.6754114627838135,
- -0.8743530511856079,
- -0.8580234050750732,
- 0.7657902240753174,
- 0.6770547032356262,
- 0.5566800236701965,
- 0.935212254524231,
- -0.584112286567688,
- 0.017612561583518982,
- -0.36803585290908813,
- -0.5247402191162109,
- 0.4970661997795105,
- -0.6998907327651978,
- -0.5846438407897949,
- 0.9509856700897217,
- 0.8254937529563904,
- 0.6614059805870056,
- 0.5184406042098999,
- -0.5043556690216064,
- -0.8817981481552124,
- -0.6980621218681335,
- -0.3875381350517273,
- -0.9762217998504639,
- -0.9982428550720215,
- 0.2067089080810547,
- 0.11346746981143951,
- 0.01595616154372692,
- -0.2828061878681183,
- 0.014170551672577858,
- 0.6205798983573914,
- -0.8973569869995117,
- -0.7388009428977966,
- -0.5494065880775452,
- -0.8166348338127136,
- 0.5313565731048584,
- -0.004518178757280111,
- 0.48383238911628723,
- -0.4977671205997467,
- -0.11393170058727264,
- -0.1845625638961792,
- -0.3601009249687195,
- -0.314405232667923,
- 0.48286524415016174,
- 0.20714795589447021,
- 0.040663253515958786,
- -0.9531037211418152,
- -0.26953038573265076,
- -0.4040994942188263,
- -0.26528051495552063,
- 0.23274151980876923,
- -0.6318374872207642,
- -0.9665676951408386,
- 0.005913611501455307,
- 0.49386274814605713,
- 0.23279796540737152,
- 0.24144552648067474,
- 0.3414899408817291,
- 0.30328240990638733,
- -0.9941494464874268,
- -0.3179697096347809,
- -0.25289952754974365,
- -0.4826950430870056,
- -0.992070198059082,
- -0.9115789532661438,
- -0.5940829515457153,
- -0.5463100671768188,
- -0.9485341310501099,
- -0.6519872546195984,
- -0.9987034797668457,
- -0.5913269519805908,
- -0.7342608571052551,
- 1,
- 0.45685240626335144,
- -0.0836566612124443,
- -0.5427722334861755,
- -0.2221001833677292,
- -0.9979760646820068,
- -0.7426897883415222,
- 0.4536954462528229,
- -0.5354653596878052,
- -0.5605345368385315,
- -0.24477224051952362,
- -0.31265220046043396,
- -0.8582495450973511,
- -0.2184845358133316,
- -0.8255475759506226,
- -0.8973569869995117,
- -0.9509775042533875,
- 0.7109987735748291,
- -0.3486618995666504,
- -0.5666218400001526,
- 0.0820944681763649,
- 0.28015971183776855,
- -0.9690587520599365,
- -0.6733459830284119,
- -0.929873526096344,
- 0.05627104640007019,
- -0.5349896550178528,
- -0.49556639790534973,
- -0.2316868156194687,
- -0.2666398584842682,
- -0.5846438407897949,
- 0.9041470885276794,
- 0.34881946444511414,
- 0.73880535364151,
- -0.4977671205997467,
- -0.620514452457428,
- 0.3705782890319824,
- -0.3981460928916931,
- -0.7447241544723511,
- -0.5671089291572571,
- -0.7126420140266418,
- 0.3201524019241333,
- -0.9361801147460938,
- -0.021949056535959244,
- 0.26071488857269287,
- 0.11704500019550323,
- -0.09812191873788834,
- -0.6564890742301941,
- 0.5860076546669006,
- 0.23305492103099823,
- 0.1070864275097847,
- 0.02329915389418602,
- -0.2407625913619995,
- 0.3414646089076996,
- 0.6114945411682129,
- 0.0007608749438077211,
- -0.18877489864826202,
- -0.06473154574632645,
- -0.5393319725990295,
- -0.37636464834213257,
- -0.2776724100112915,
- 0.407381534576416,
- 0.5711175799369812,
- 0.10242214798927307,
- -0.5774988532066345,
- 0.5009621977806091,
- 0.7229906320571899,
- 0.5307389497756958,
- 0.8771102428436279,
- -0.6564419269561768,
- -0.41044551134109497,
- -0.6564419269561768,
- -0.7309668660163879,
- -0.9828091859817505,
- -0.9828091859817505,
- -0.31996339559555054,
- 0.02778959460556507,
- -0.18145851790905,
- -0.4760945737361908,
- -0.6159340143203735,
- -0.5961918830871582,
- -0.6848282217979431,
- -0.251895934343338,
- 0.29486724734306335,
- 0.40002304315567017,
- 0.9899379014968872,
- 0.7229412794113159,
- 0.9807852506637573,
- -0.7337335348129272,
- -0.8108888864517212,
- -0.5162743926048279,
- -0.6094732284545898,
- -0.9194790720939636,
- 0.5308945178985596,
- 0.01500244252383709,
- -0.7993972897529602,
- 0.9984241127967834,
- -0.012843931093811989,
- -0.8668404221534729,
- 0.990543007850647,
- 0.0920555591583252,
- -0.31916898488998413,
- 0.9374285340309143,
- 0.7959373593330383,
- 0.8754876255989075,
- -0.8362293243408203,
- -0.6582773923873901,
- -0.9916395545005798,
- -0.8973569869995117,
- 0.061656251549720764,
- 0.5361354351043701,
- 0.36971715092658997,
- -0.4583832919597626,
- -0.46862149238586426,
- -0.9807852506637573,
- -0.9511585831642151,
- -0.27999889850616455,
- 0.038460005074739456,
- 0.1938815712928772,
- 0.19310392439365387,
- 0.5270761847496033,
- 0.5389652252197266,
- -0.5263717770576477,
- 0.31121960282325745,
- 0.13053779304027557,
- 0.2712872624397278,
- 0.9807852506637573,
- -0.97075355052948,
- 0.9580817818641663,
- 0.7310782670974731,
- 0.5388161540031433,
- 0.9519411325454712,
- 0.8434329628944397,
- -0.4833066761493683,
- -0.20707954466342926,
- -0.5099445581436157,
- -0.6608012318611145,
- -0.018839603289961815,
- -0.7309668660163879,
- -0.5254232883453369,
- 0.3551715314388275,
- -0.21630725264549255,
- -0.39276570081710815,
- -0.07621423900127411,
- 0.02646898478269577,
- 0.3646659553050995,
- 0.8563774824142456,
- 0.5865227580070496,
- 0.46233615279197693,
- 0.8343841433525085,
- -0.8973569869995117,
- -0.5947028398513794,
- -0.8064454793930054,
- 0.570570170879364,
- 0.5161767601966858,
- 0.48175233602523804,
- 0.4885003864765167,
- -0.38643592596054077,
- -0.4773034155368805,
- -0.38785600662231445,
- 0.8576608896255493,
- -0.9899351596832275,
- 0.9875081777572632,
- -0.1636705994606018,
- -0.9172571897506714,
- -0.16427050530910492,
- -0.4349454939365387,
- -0.9953550100326538,
- -0.9971668124198914,
- 0.6962160468101501,
- 0.5453452467918396,
- -0.05568347126245499,
- -0.6601232290267944,
- -0.842789351940155,
- -0.2496166080236435,
- -0.8420789837837219,
- -0.8744059801101685,
- -0.834104597568512,
- -0.9026780724525452,
- 0.9523860216140747,
- 0.9934259653091431,
- -0.7173683643341064,
- -0.9974165558815002,
- 0.3086850345134735,
- -0.8398857116699219,
- -0.2520681619644165,
- -0.2881055772304535,
- -0.17640793323516846,
- -0.8340798020362854,
- 0.803859293460846,
- -0.5375675559043884,
- -0.35286054015159607,
- -0.40147092938423157,
- -0.5391048192977905,
- -0.4075758457183838,
- -0.06929513067007065,
- 0.4999752938747406,
- 0.5083998441696167,
- 0.7683452367782593,
- 0.44873738288879395,
- 0.1870150864124298,
- 0.44929590821266174,
- 0.7604588270187378,
- -0.253332257270813,
- 0.7990961074829102,
- -0.4588089883327484,
- -0.36481741070747375,
- -0.2928994297981262,
- -0.620514452457428,
- -0.8754743337631226,
- -0.6474624276161194,
- -0.7147241830825806,
- -0.8206048011779785,
- 0.8667620420455933,
- 0.8917268514633179,
- 0.9518074989318848,
- -0.5455569624900818,
- 0.06518997251987457,
- -0.1746850311756134,
- 0.711083710193634,
- -0.7957763075828552,
- -0.23037903010845184,
- 0.4979412853717804,
- -0.9531556367874146,
- -0.9841888546943665,
- 0.04183444380760193,
- 0.8254937529563904,
- 0.9814017415046692,
- -0.5506122708320618,
- 0.9509856700897217,
- 0.8974766731262207,
- 0.8271036744117737,
- 0.6565945744514465,
- 0.5882179737091064,
- 0.4074084758758545,
- 0.1779918372631073,
- 0.8254937529563904,
- 0.3646659553050995,
- 0.6998251676559448,
- -0.25461456179618835,
- -0.16163697838783264,
- 0.5031144618988037,
- 0.056570108979940414,
- 0.4599801003932953,
- 0.22676178812980652,
- -0.27921000123023987,
- -0.5993555784225464,
- 0.9872598648071289,
- -0.1492013782262802,
- -0.11010982096195221,
- 0.08578278124332428,
- -0.176510289311409,
- 0.12077020108699799,
- -0.08411595970392227,
- 0.9915391802787781,
- 0.7307949662208557,
- 0.8754876255989075,
- -0.2441762387752533,
- -0.14552778005599976,
- -0.2168065309524536,
- -0.4977671205997467,
- 0.6998251676559448,
- 0.5844343304634094,
- -0.4977671205997467,
- -0.5964337587356567,
- 0.16315852105617523,
- 0.7636315226554871,
- 0.265627384185791,
- 0.9430791139602661,
- 0.6161730289459229,
- 0.9977315664291382,
- 0.9039280414581299,
- -0.06703191250562668,
- 0.4994438886642456,
- 0.4858933091163635,
- 0.9834839701652527,
- 0.880670964717865,
- 0.8490715026855469,
- 0.9645264744758606,
- -0.9836878776550293,
- 0.020235415548086166,
- 0.6966110467910767,
- 0.9339800477027893,
- 0.5601944327354431,
- -0.00601609330624342,
- 0.22188933193683624,
- 0.06982731819152832,
- 0.42058631777763367,
- -0.20701900124549866,
- -0.5002540349960327,
- -0.9948720335960388,
- -0.6225435733795166,
- 0.29936158657073975,
- -0.9993430376052856,
- -0.8705465197563171,
- 0.9978688955307007,
- 0.9816693663597107,
- -0.2221001833677292,
- -0.07432012259960175,
- 0.005510379560291767,
- 0.93561190366745,
- 0.769040584564209,
- 0.4979412853717804,
- 0.09552592039108276,
- -0.4952143132686615,
- 0.8628236055374146,
- 0.891992449760437,
- 0.3251786231994629,
- -0.9622695446014404,
- -0.9051315188407898,
- 0.6972473859786987,
- -0.9227719902992249,
- -0.9991018772125244,
- 0.9954250454902649,
- -0.2867448031902313,
- 0.40268635749816895,
- 0.14126500487327576,
- 0.9529435634613037,
- 0.6507450938224792,
- 0.27342158555984497,
- -0.9639715552330017,
- -0.971455454826355,
- 0.9434934258460999,
- 0.7417119145393372,
- 0.922407329082489,
- 0.7960216403007507,
- 0.39301806688308716,
- 0.44151046872138977,
- 0.9164034128189087,
- -0.45337846875190735,
- -0.7604051232337952,
- -0.9881238341331482,
- 0.3329641819000244,
- 0.5564926266670227,
- -0.7899213433265686,
- 0.7021987438201904,
- -0.9409090876579285,
- 0.8222968578338623,
- -0.1262354850769043,
- 0.9899379014968872,
- 0.8101232051849365,
- 0.4139884412288666,
- 0.4850161373615265,
- 0.8455127477645874,
- -0.7117887139320374,
- -0.9599732160568237,
- 0.32545220851898193,
- -0.017274606972932816,
- 0.0917535200715065,
- 0.9274268746376038,
- 0.7069732546806335
- ],
- "z": [
- 0.24893133342266083,
- 0.06961314380168915,
- 0.38458311557769775,
- 0.045085154473781586,
- -0.2524856626987457,
- -0.6164182424545288,
- -0.4557993710041046,
- -0.09390309453010559,
- -0.6660021543502808,
- -0.5890951156616211,
- -0.9959505200386047,
- -0.6060599088668823,
- -0.298443466424942,
- -0.4645257592201233,
- -0.23048292100429535,
- -0.21867342293262482,
- -0.31317806243896484,
- 0.07732536643743515,
- -0.3414348065853119,
- -0.05248579755425453,
- -0.10382933914661407,
- -0.019813725724816322,
- 0.2175561636686325,
- 0.13014905154705048,
- 0.40530869364738464,
- 0.7156205773353577,
- 0.7926167249679565,
- 0.4570474326610565,
- -0.13187628984451294,
- 0.12653519213199615,
- -0.22819986939430237,
- -0.3281902074813843,
- 0.28013405203819275,
- 0.6267420649528503,
- 0.39846572279930115,
- 0.3510749340057373,
- -0.33739176392555237,
- -0.18817365169525146,
- -0.24846261739730835,
- -0.5050169229507446,
- -0.5259588956832886,
- -0.26771974563598633,
- -0.446445107460022,
- -0.248659148812294,
- 0.24804984033107758,
- 0.18279309570789337,
- 0.03786000609397888,
- -0.07831154018640518,
- -0.20537401735782623,
- 0.22865191102027893,
- 0.03590712696313858,
- 0.0510106198489666,
- -0.5112490653991699,
- -0.4819660484790802,
- -0.5647855401039124,
- -0.9934210777282715,
- -0.9370624423027039,
- -0.3811916410923004,
- -0.5316653251647949,
- -0.5263366103172302,
- -0.7243698835372925,
- -0.8403451442718506,
- -0.5899010300636292,
- -0.9501896500587463,
- -0.9997191429138184,
- 0.3994015157222748,
- 0.5550714731216431,
- 0.1366790235042572,
- 0.33598801493644714,
- 0.49225300550460815,
- 0.6483957171440125,
- 0.3165377676486969,
- 0.05070596933364868,
- 0.3658945858478546,
- 0.07349245995283127,
- 0.02135220356285572,
- 0.9899535775184631,
- 0.6588714122772217,
- 0.9584241509437561,
- 0.7039474248886108,
- 0.9926663041114807,
- 0.5769069790840149,
- 0.6764622330665588,
- 0.998921275138855,
- 0.5113556385040283,
- 0.5350059866905212,
- 0.4005412459373474,
- 0.18379539251327515,
- -0.6124829649925232,
- -0.916515052318573,
- -0.6823439002037048,
- 0.06995134800672531,
- -0.09971776604652405,
- 0.30412760376930237,
- -0.678033173084259,
- -0.5627862811088562,
- -0.42405495047569275,
- -0.4404540956020355,
- -0.22640195488929749,
- -0.2587750554084778,
- -0.5708564519882202,
- -0.5173807144165039,
- -0.9726678133010864,
- -0.6065524220466614,
- -0.9628442525863647,
- -0.060457516461610794,
- 0.07383366674184799,
- 0.033002905547618866,
- -0.26771634817123413,
- -0.29332637786865234,
- -0.2589031755924225,
- 0.4012563228607178,
- 0.6697467565536499,
- 0.37911468744277954,
- 0.6959860324859619,
- -0.3439806401729584,
- -0.709836483001709,
- -0.36161622405052185,
- -0.5031288266181946,
- -0.37700721621513367,
- -0.027168434113264084,
- 0.1186046227812767,
- 0.9283714294433594,
- 0.6873116493225098,
- 0.9881190061569214,
- 0.9892323613166809,
- 0.6267638206481934,
- 0.6916837096214294,
- 0.3116864562034607,
- 0.45751941204071045,
- -0.30098357796669006,
- -0.5340659618377686,
- -0.070583276450634,
- 0.9836627840995789,
- 0.9826307892799377,
- 0.2885918915271759,
- 0.23875781893730164,
- -0.0010253038490191102,
- -0.01305148471146822,
- -0.7080255746841431,
- -0.5416524410247803,
- -0.7137928605079651,
- -0.8609718084335327,
- -0.6466995477676392,
- -0.22543102502822876,
- -0.46304792165756226,
- 0.40055951476097107,
- 0.5511629581451416,
- 0.4643996059894562,
- -0.24696844816207886,
- 0.0023746946826577187,
- -0.121971994638443,
- 0.09900698065757751,
- 0.24953289330005646,
- 0.22445939481258392,
- 0.10599268972873688,
- -0.02011456899344921,
- 0.4988115429878235,
- 0.9421597123146057,
- 0.7781175374984741,
- 0.7483584880828857,
- -0.9510202407836914,
- -0.5498870611190796,
- -0.8496232032775879,
- -0.25599583983421326,
- -0.018814457580447197,
- 0.0450722798705101,
- 0.006867034826427698,
- 0.9926801323890686,
- -0.33451950550079346,
- -0.6014363765716553,
- -0.3249167501926422,
- -0.42981573939323425,
- -0.7796371579170227,
- -0.6329610347747803,
- -0.9835079908370972,
- -0.9459924101829529,
- -0.5039926767349243,
- -0.4338308274745941,
- -0.25865885615348816,
- -0.6047350168228149,
- -0.20979124307632446,
- 0.5729902386665344,
- 0.7663477659225464,
- 0.29461243748664856,
- 0.5809187293052673,
- -0.18392319977283478,
- 0.020668039098381996,
- -0.27200955152511597,
- 0.03924412652850151,
- 0.0195060633122921,
- 0.3324436545372009,
- 0.6782426834106445,
- 0.17382746934890747,
- 0.4320796728134155,
- 0.20146599411964417,
- 0.37333109974861145,
- 0.5286331176757812,
- -0.02363656461238861,
- -0.0906238928437233,
- 0.5550857782363892,
- 0.5451454520225525,
- 0.5945549011230469,
- -0.7518652677536011,
- -0.5248426795005798,
- -0.387797087430954,
- -0.5349641442298889,
- -0.25117042660713196,
- 0.1672535389661789,
- -0.030160700902342796,
- 0.2272733896970749,
- 0.22918443381786346,
- 0.0007958645583130419,
- -0.47246626019477844,
- -0.26326435804367065,
- -0.2667330503463745,
- 0.2950707972049713,
- 0.5224003791809082,
- 0.24893133342266083,
- 0.24893133342266083,
- -0.3438313901424408,
- 0.2669813930988312,
- -0.05906572937965393,
- 0.3875717222690582,
- 0.2657814919948578,
- 0.7311900854110718,
- 0.6060779690742493,
- 0.45794302225112915,
- -0.010273333638906479,
- 0.1575591117143631,
- 0.3539920449256897,
- -0.6644736528396606,
- -0.48027414083480835,
- -0.9416919350624084,
- 0.9293450713157654,
- 0.4946977198123932,
- 0.5810832977294922,
- 0.8662898540496826,
- 0.9053993225097656,
- 0.5155513882637024,
- 0.6468337774276733,
- 0.4702588617801666,
- 0.11277738958597183,
- -0.048379454761743546,
- -0.2031347006559372,
- -0.4603961706161499,
- -0.1806602030992508,
- 0.10649269074201584,
- 0.24402277171611786,
- 0.22087182104587555,
- 0.6698569059371948,
- 0.6410759091377258,
- 0.4929329752922058,
- 0.23700262606143951,
- -0.37436285614967346,
- -0.2582411468029022,
- 0.000663433806039393,
- -0.9097479581832886,
- -0.6664299368858337,
- -0.9650605320930481,
- 0.4332942068576813,
- 0.19210495054721832,
- 0.2930695116519928,
- 0.23533089458942413,
- 0.6286520957946777,
- 0.6442918181419373,
- 0.34618571400642395,
- -0.006241363473236561,
- 0.1833106428384781,
- 0.29168185591697693,
- -0.002174111781641841,
- 0.47259294986724854,
- 0.25226056575775146,
- 0.1899283230304718,
- 0.1295872926712036,
- -0.14776815474033356,
- -0.007787336595356464,
- 0.1263086497783661,
- 0.15495635569095612,
- 0.40780001878738403,
- 0.5031928420066833,
- 0.22645917534828186,
- 0.04210563376545906,
- 0.1961057186126709,
- -0.10216209292411804,
- 0.28054866194725037,
- 0.4921416640281677,
- 0.18888798356056213,
- 0.29682838916778564,
- 0.9105742573738098,
- 0.7120792269706726,
- 0.46320977807044983,
- 0.830166220664978,
- 0.48220357298851013,
- -0.8679813146591187,
- -0.9516631364822388,
- 0.47452154755592346,
- 0.7259277701377869,
- 0.6084266901016235,
- 0.9848937392234802,
- -0.23830050230026245,
- -0.76807701587677,
- -0.44848307967185974,
- -0.24442195892333984,
- 0.0057609472423791885,
- 0.04943608120083809,
- -0.038206059485673904,
- -0.20376498997211456,
- -0.33428671956062317,
- -0.4373824894428253,
- -0.42244595289230347,
- -0.6520264744758606,
- -0.36086952686309814,
- -0.6188114285469055,
- 0.1818607598543167,
- -0.31560376286506653,
- -0.2107848972082138,
- -0.6734336614608765,
- 0.9861479997634888,
- 0.9878979325294495,
- 0.9840410947799683,
- 0.34084373712539673,
- -0.6104958653450012,
- 0.29332637786865234,
- 0.6329606175422668,
- 0.4734562635421753,
- 0.6387461423873901,
- 0.9190930128097534,
- -0.34333351254463196,
- -0.19907696545124054,
- -0.007516813464462757,
- 0.35606294870376587,
- 0.5664986968040466,
- 0.2380324900150299,
- 0.02087165042757988,
- 0.1486402451992035,
- -0.1486402451992035,
- -0.5884139537811279,
- -0.24894261360168457,
- -0.5900663137435913,
- -0.4645562767982483,
- 0.22966508567333221,
- 0.30052053928375244,
- 0.25223761796951294,
- 0.4725068509578705,
- 0.9906204342842102,
- 0.53376704454422,
- 0.5839667320251465,
- 0.9822286367416382,
- -0.5414755940437317,
- -0.959226131439209,
- -0.8078566789627075,
- -0.6092051267623901,
- -0.634707510471344,
- -0.5340558290481567,
- 0.20579388737678528,
- 0.5619252324104309,
- 0.020743170753121376,
- -0.8842752575874329,
- -0.9857361912727356,
- -0.5279218554496765,
- -0.9429054260253906,
- 0,
- -0.4684806168079376,
- -0.21044278144836426,
- -0.7952387928962708,
- -0.9352442026138306,
- -0.9609246850013733,
- -0.4732184112071991,
- 0.23765499889850616,
- -0.0679740384221077,
- -0.14824911952018738,
- 0.19725912809371948,
- -0.06877187639474869,
- -0.07851611077785492,
- 0.8686026334762573,
- 0.6927322745323181,
- 0.6234987378120422,
- 0.5488587021827698,
- -0.19145558774471283,
- -0.3909909725189209,
- -0.07928632199764252,
- -0.3109854459762573,
- 0.5313256978988647,
- 0.03555777668952942,
- 0.0490003265440464,
- 0.31111860275268555,
- 0.10442136228084564,
- 0.17511685192584991,
- -0.11836609244346619,
- 0,
- -0.01821127161383629,
- -0.3708040714263916,
- -0.2981916069984436,
- -0.46162664890289307,
- -0.1726837307214737,
- -0.123359814286232,
- 0.4126456081867218,
- 0.17629684507846832,
- 0.43020865321159363,
- -0.16406390070915222,
- -0.29134809970855713,
- -0.3465260863304138,
- -0.1638673096895218,
- -0.36755621433258057,
- -0.19412018358707428,
- -0.2797713577747345,
- 0.6075701713562012,
- 0.654580295085907,
- -0.4861188530921936,
- -0.31833672523498535,
- -0.5780981779098511,
- -0.6000235080718994,
- -0.004480898380279541,
- 0.06860040128231049,
- -0.24482126533985138,
- 0.28688132762908936,
- -0.9631673693656921,
- -0.971184492111206,
- -0.5911328792572021,
- -0.9907293319702148,
- 0.5847785472869873,
- 0.9999487996101379,
- 0.5352766513824463,
- -0.8988922834396362,
- -0.7401489019393921,
- 0.9553634524345398,
- -0.23085886240005493,
- -0.11746350675821304,
- -0.3938993215560913,
- -0.5889719724655151,
- -0.2792058289051056,
- -0.3732108473777771,
- -0.3574441075325012,
- -0.6824148297309875,
- -0.22026440501213074,
- -0.5700737833976746,
- -0.5176344513893127,
- 0.12050525844097137,
- -0.09682867676019669,
- -0.35551348328590393,
- -0.17618408799171448,
- -0.2755252420902252,
- 0.04571164771914482,
- -0.17331843078136444,
- -0.9896681308746338,
- -0.6911693215370178,
- -0.5965977907180786,
- -0.5998966097831726,
- -0.9706664681434631,
- -0.9917164444923401,
- -0.6897068619728088,
- -0.9094218611717224,
- 0.78774094581604,
- 0.6912752389907837,
- 0.0785423144698143,
- 0.016106540337204933,
- -0.22879524528980255,
- 0.013991397805511951,
- -0.38984066247940063,
- -0.15052154660224915,
- -0.5829851031303406,
- -0.23330901563167572,
- 0.059916771948337555,
- 0.0003111835103482008,
- 0.6251672506332397,
- 0.31113284826278687,
- 0.5296736359596252,
- -0.5800420045852661,
- 0.5752048492431641,
- 0.6355389952659607,
- 0.25313037633895874,
- -0.47975510358810425,
- -0.7129015326499939,
- 0.2674548923969269,
- -0.20113208889961243,
- 0.3797936737537384,
- 1.1691379777549558e-15,
- -0.2713494598865509,
- 0.40313920378685,
- 0.845343828201294,
- 0.39367449283599854,
- -0.9590659737586975,
- -0.2106667459011078,
- -0.47452685236930847,
- -0.4596824049949646,
- -0.25136223435401917,
- 0.15601640939712524,
- 0.08271649479866028,
- 0.9565548896789551,
- 0.7303852438926697,
- 0.6288405656814575,
- 0.9848345518112183,
- -0.09036430716514587,
- -0.42064154148101807,
- -0.9738449454307556,
- -0.5138938426971436,
- -0.16709473729133606,
- -0.2977195680141449,
- 0.014614290557801723,
- 0.9725919365882874,
- -0.593136191368103,
- 0.7926254868507385,
- 0.7128075361251831,
- 0.5469134449958801,
- 0.4639262855052948,
- -0.06447644531726837,
- 0.17454104125499725,
- -0.9590659737586975,
- -0.8485125303268433,
- -0.8613754510879517,
- -0.8202615976333618,
- -0.9732046723365784,
- -0.44705015420913696,
- -0.9994475841522217,
- -0.7387363910675049,
- -0.9583876729011536,
- 0.5713192224502563,
- 0.6820598244667053,
- 0.6784961819648743,
- 0.9906498193740845,
- -0.9688231945037842,
- -0.6363033056259155,
- -0.9904927015304565,
- -0.09575266391038895,
- -0.5594531893730164,
- 0.3919374942779541,
- 0.6962965726852417,
- 0.4743371605873108,
- 0.32579144835472107,
- -0.036251384764909744,
- 0.30545035004615784,
- -0.3993871510028839,
- -0.16404372453689575,
- -0.05687348172068596,
- 0.06529530882835388,
- -0.2403002232313156,
- -0.21965867280960083,
- -0.5458555817604065,
- -0.33839061856269836,
- -0.7479055523872375,
- -0.6366367340087891,
- -0.8835325837135315,
- -0.998812198638916,
- 0.9292991161346436,
- 0.5906811952590942,
- 0.1568344235420227,
- 0.329791784286499,
- 0.6214436292648315,
- 0.8624156713485718,
- 0.9541876912117004,
- 0.8377023935317993,
- 0.16098438203334808,
- 0.5198801755905151,
- 0.4614923894405365,
- 0.4828778803348541,
- -0.4090541899204254,
- -0.6571433544158936,
- 0.7736345529556274,
- 0.9174755811691284,
- 0.5050711035728455,
- 0.6888444423675537,
- -0.6057143807411194,
- 0.9539580345153809,
- 0.7932191491127014,
- 0.3558451235294342,
- -0.294318825006485,
- -0.43747037649154663,
- -0.2859049141407013,
- -0.5471164584159851,
- 0.3661544919013977,
- 0.21708662807941437,
- 0.047813039273023605,
- -0.10936380922794342,
- -0.9813233017921448,
- 0.6716124415397644,
- 0.9972550272941589,
- 0.9591069221496582,
- 0.9881190061569214,
- -0.5873571634292603,
- -0.7924172282218933,
- -0.597710132598877,
- -0.2933533787727356,
- 0.6591892242431641,
- 0.982540488243103,
- 0.15812546014785767,
- 0.5574328303337097,
- 0.3088320791721344,
- -0.15484392642974854,
- 0.06583964824676514,
- 0.0556543804705143,
- -0.41467854380607605,
- -0.020549282431602478,
- -0.17505614459514618,
- -0.6844256520271301,
- -0.14388316869735718,
- 0.37474673986434937,
- -0.9988948702812195,
- -0.18562301993370056,
- 0.21414516866207123,
- 0.1545124351978302,
- -0.0718170553445816,
- 0.09742579609155655,
- 0.2770216763019562,
- -0.1361367404460907,
- 0.23760713636875153,
- -0.979985237121582,
- -0.9926663041114807,
- -0.9774913191795349,
- -0.16620796918869019,
- 0.3408176600933075,
- -0.8754684329032898,
- -0.9926663041114807,
- -0.9343691468238831,
- -0.9726558923721313,
- 0.3258844017982483,
- -0.6285980939865112,
- -0.9526984095573425,
- 0.5530601739883423,
- 0.4029441475868225,
- -0.15432234108448029,
- -0.25908252596855164,
- 0.4096115529537201,
- 0.43439316749572754,
- -0.8870314359664917,
- -0.41186952590942383,
- 0.09266889840364456,
- 0.2557157576084137,
- 0.6775721907615662,
- -0.4413914978504181,
- 0.13172948360443115,
- 0.21691279113292694,
- -0.9269883036613464,
- 0.30631664395332336,
- 0.21891158819198608,
- -0.6346932053565979,
- -0.3447767496109009,
- 0.130438894033432,
- 0.47534096240997314,
- 0.5058916211128235,
- -0.6356008052825928,
- -0.24553059041500092,
- -0.17978045344352722,
- -0.34532439708709717,
- -0.2420850694179535,
- -0.4619636535644531,
- -0.4826432168483734,
- 0.5221319198608398,
- 0.029748890548944473,
- -0.7130288481712341,
- -0.8076095581054688,
- 0.29332637786865234,
- 0.5628518462181091,
- 0.06730208545923233,
- 0.4723880887031555,
- -0.12552547454833984,
- -0.4614121615886688,
- 0.08412102609872818,
- -0.13070812821388245,
- -0.2101341336965561,
- 0.01784065179526806,
- 0.9772608280181885,
- 0.9888244271278381,
- 0.998428463935852,
- 0.9541769623756409,
- 0.9986042976379395,
- -0.7781175374984741,
- 0.43230360746383667,
- 0.6684873104095459,
- 0.2304299771785736,
- -0.5736464858055115,
- -0.844412088394165,
- 0.00047851071576587856,
- -0.8698142766952515,
- -0.8623660206794739,
- -0.6524214744567871,
- 0.4876599907875061,
- 0.41059526801109314,
- 0.11519432067871094,
- 0.027569491416215897,
- -0.18464042246341705,
- 0.07333831489086151,
- -0.28634411096572876,
- -0.628840982913971,
- -0.4625285863876343,
- -0.7084884643554688,
- 0.13881811499595642,
- 0.013083233498036861,
- -0.2419593632221222,
- -0.9994175434112549,
- -0.8644529581069946,
- -0.969346821308136,
- 0.6237660050392151,
- 0.3980129659175873,
- 0.07845746725797653,
- 0.059401463717222214,
- 0.9435102343559265,
- 0.6205036044120789,
- 0.8704222440719604,
- 0.0805128887295723,
- 0.40569618344306946,
- 0.7998630404472351,
- -0.15637905895709991,
- -0.30140817165374756,
- -0.10545636713504791,
- 0.013164041563868523,
- -0.8021248579025269,
- -0.674019455909729,
- 1.1381953347961641e-15,
- 0.8842353820800781,
- 0.70960932970047,
- 0.8383103013038635,
- 0.9725919365882874,
- -0.020549282431602478,
- 0.6637487411499023,
- -0.4817539155483246,
- 0.842215895652771,
- 0.827395498752594,
- 0.5711965560913086,
- 0.9451232552528381,
- -0.505468487739563,
- -0.5622516870498657,
- 0.5627862811088562,
- 0.43230360746383667,
- 0.2933533787727356,
- -0.7023643851280212,
- 0.5701262354850769,
- 0.32938721776008606,
- -0.9919143915176392,
- -0.9549797773361206,
- 0.23374751210212708,
- 0.026159776374697685,
- -0.36292386054992676,
- 0.9944577813148499,
- 0.021349981427192688,
- -0.4515495300292969,
- -0.0596543550491333,
- -0.054855652153491974,
- -0.8076095581054688,
- -0.4196002781391144,
- -0.4410720765590668,
- -0.6684819459915161,
- 0.8623660206794739,
- 0.7781712412834167,
- -0.4617902934551239,
- 0.9156145453453064,
- 0.6612699031829834,
- 0.8220000267028809,
- 0.7003620862960815,
- 0.9428480863571167,
- 0.3421337604522705,
- 0.009491427801549435,
- -0.024708475917577744,
- -0.243136465549469,
- -0.6658512353897095,
- 0.05885906517505646,
- -0.12039002776145935,
- -0.9692688584327698,
- -0.9894528985023499,
- -0.712857186794281,
- 0.9669307470321655,
- 0.9363831281661987,
- 0.7855737209320068,
- 0.0020480032544583082,
- 0.48156502842903137,
- 0.23229436576366425,
- 0.2777603268623352,
- 0.9257963299751282,
- 0.6556273102760315,
- -0.9106780886650085,
- -0.3095446527004242,
- 0.9899122714996338,
- -0.8134732842445374,
- 0.8606582283973694,
- 0.6877522468566895,
- 0.4117426872253418,
- 0.4701825976371765,
- 0.7486863732337952,
- 0.544661283493042,
- 0.7486863732337952,
- 0.678033173084259,
- 0.17454104125499725,
- -0.17454104125499725,
- -0.9429054260253906,
- -0.9972629547119141,
- -0.7024728059768677,
- 0.484409362077713,
- -0.7819303274154663,
- -0.7981323003768921,
- -0.7253903150558472,
- -0.28735053539276123,
- 0.36599305272102356,
- -0.9146113395690918,
- -0.10216209292411804,
- 0.01893974095582962,
- 0.19509032368659973,
- -0.6746619939804077,
- -0.580647885799408,
- -0.8524736762046814,
- -0.38539648056030273,
- 0.3909161388874054,
- 0.8446590304374695,
- -0.9985224008560181,
- 0.5946504473686218,
- -0.01600003056228161,
- 0.40821167826652527,
- 0.48939603567123413,
- -0.09601835906505585,
- -0.9909332990646362,
- -0.5974749326705933,
- 0.33801841735839844,
- 0.5988664031028748,
- 0.47321829199790955,
- 0.5466654896736145,
- -0.08516772836446762,
- -0.08488517999649048,
- -0.43230360746383667,
- -0.9939273595809937,
- -0.8418577313423157,
- 0.37960660457611084,
- 0.3056824207305908,
- -0.3595028221607208,
- -0.19509032368659973,
- -0.29275640845298767,
- -0.9550285339355469,
- 0.9962120056152344,
- 0.9809043407440186,
- 0.6006340980529785,
- 0.8467000126838684,
- -0.8403451442718506,
- -0.8470764756202698,
- 0.2801212966442108,
- -0.9871431589126587,
- 0.08321216702461243,
- 0.19509032368659973,
- 0.22816050052642822,
- -0.2699337899684906,
- -0.6778974533081055,
- -0.8404248356819153,
- 0.2901766896247864,
- 0.5331884622573853,
- 0.44227609038352966,
- 0.9771484136581421,
- 0.8558570742607117,
- -0.7451087236404419,
- 0.9981444478034973,
- -0.678033173084259,
- -0.8475834727287292,
- 0.3360883593559265,
- 0.9743492007255554,
- -0.282871812582016,
- -0.22345055639743805,
- 0.3189956545829773,
- -0.9293450713157654,
- 0.5089709162712097,
- 0.8060675263404846,
- 0.8813042640686035,
- -0.5501174926757812,
- 0.43230360746383667,
- 0.399971067905426,
- 0.5860621929168701,
- -0.8191595077514648,
- 0.8525258898735046,
- 0.4839176535606384,
- 0.43716105818748474,
- 0.44707098603248596,
- -0.004523725248873234,
- -0.0728132501244545,
- -0.5065698027610779,
- 0.10219016671180725,
- 0.12683188915252686,
- 0.46737194061279297,
- -0.39507293701171875,
- 0.14336158335208893,
- 0.5697399377822876,
- -0.04716167598962784,
- -0.02876582369208336,
- 0.716044545173645,
- 0.8369349837303162,
- -0.3292773365974426,
- 0.7456651926040649,
- 0.5343924760818481,
- -0.9642449021339417,
- -0.535721480846405,
- -0.4752419590950012,
- 0.5506404638290405,
- 0.42234858870506287,
- 0.2887100875377655,
- -0.06674723327159882,
- 0.6946030259132385,
- 0.02623007260262966,
- 0.946326732635498,
- -0.5398248434066772,
- -0.9635012149810791,
- -0.9525694251060486,
- -0.5915231704711914,
- -0.5506868362426758,
- 0.5892135500907898,
- -0.8410922288894653,
- -0.9329262375831604,
- -0.9138374328613281,
- 0.8402705788612366,
- 0.9105742573738098,
- -0.9931750297546387,
- -0.4777680039405823,
- -0.8566827178001404,
- -0.6324874758720398,
- 0.8885729312896729,
- 0.9815806150436401,
- -0.13777193427085876,
- -0.6420971155166626,
- -0.5806383490562439,
- 0.5950174927711487,
- -0.8831895589828491,
- -0.9292991161346436,
- -0.515745222568512,
- -0.7781712412834167,
- -0.47324317693710327,
- 0.7560555934906006,
- -0.6978248953819275,
- 0.5688090324401855,
- 0.48954278230667114,
- -0.4428369104862213,
- -0.2906172573566437,
- -0.8368217945098877,
- -0.9935793280601501,
- 0.982795000076294,
- -0.7022608518600464,
- -0.5990626811981201,
- 0.4099653661251068,
- 0.8622729182243347,
- -0.286173015832901,
- 0.16053339838981628,
- 0.6610923409461975,
- 0.5628518462181091,
- 0.18883104622364044,
- 0.8341196775436401,
- -0.29332637786865234,
- -0.4320796728134155,
- -0.5608901381492615,
- -0.7485610842704773,
- -0.06010530889034271,
- 0.21931923925876617,
- -0.22103886306285858,
- -0.5628518462181091,
- 0.9293450713157654,
- 0.7130826711654663,
- 0.9627287983894348,
- 0.9840801358222961,
- -0.8595077991485596,
- 0.31655168533325195,
- 0.882563591003418,
- 0.971177875995636,
- -0.9552678465843201,
- 0.7955359220504761,
- -0.12935291230678558,
- 0.9853049516677856,
- -0.33821555972099304,
- 0.9915511608123779,
- -0.9826152324676514,
- -0.9881051778793335,
- 0.9917153120040894,
- 0.08590389788150787,
- -0.6782426834106445,
- 0.47321829199790955,
- -0.17458701133728027,
- -0.445766419172287,
- -0.648909866809845,
- -0.8623660206794739,
- 0.7130826711654663,
- 0.807781457901001,
- 0.8623660206794739,
- -0.31360378861427307,
- 0.9839302897453308,
- 0.6382311582565308,
- -0.9593880772590637,
- 0.3193909227848053,
- -0.7817341685295105,
- 0.023031573742628098,
- -0.4200100302696228,
- 0.9933979511260986,
- -0.8614697456359863,
- -0.8687127232551575,
- 0.16769032180309296,
- 0.46352097392082214,
- -0.5226393938064575,
- -0.24868835508823395,
- 0.16562004387378693,
- 0.3897646963596344,
- 0.7157204151153564,
- 0.3493865430355072,
- -0.8276746273040771,
- -0.9994074702262878,
- 0.9726558923721313,
- -0.2598225772380829,
- 0.9036200046539307,
- 0.9771667718887329,
- 0.8610367178916931,
- -0.05206523463129997,
- 0.20172397792339325,
- -0.9491549134254456,
- 0.006670048926025629,
- 0.48246243596076965,
- 0.02163754589855671,
- 0.1861138790845871,
- -0.9725919365882874,
- -0.9926801323890686,
- -0.9994572997093201,
- 0.34400707483291626,
- 0.6316402554512024,
- -0.8622729182243347,
- 0.6931447386741638,
- 0.8637305498123169,
- -0.49691101908683777,
- 0.4423399865627289,
- 0.9413233995437622,
- 0.2561284601688385,
- 0.4177584648132324,
- -0.7151981592178345,
- 0.3847554624080658,
- 0.00911870226264,
- 0.04645007848739624,
- 0.9529821872711182,
- 0.9131877422332764,
- 0.9860866069793701,
- -0.28687211871147156,
- 0.7533616423606873,
- 0.525320291519165,
- -0.2505177855491638,
- 0.22584663331508636,
- -0.31802502274513245,
- -0.664940357208252,
- 0.3854376971721649,
- -0.5987637042999268,
- 0.9183555841445923,
- -0.8924358487129211,
- -0.39667022228240967,
- -0.8860922455787659,
- 0.642162561416626,
- -0.12058087438344955,
- -0.9389616847038269,
- -0.830712616443634,
- -0.606196939945221,
- -0.7111347317695618,
- -0.3265444338321686,
- -0.56674724817276,
- 0.9875668883323669,
- -0.10216209292411804,
- 0.5815808773040771,
- 0.9071466326713562,
- -0.8691815733909607,
- -0.5292973518371582,
- -0.7014018893241882,
- 0.2636984586715698,
- 0.9412404298782349,
- 0.9982985854148865,
- 0.9909630417823792,
- -0.3709893822669983,
- -0.7072163224220276
- ]
- }
- ],
- "layout": {
- "height": 500,
- "scene": {
- "aspectmode": "data"
- },
- "template": {
- "data": {
- "bar": [
- {
- "error_x": {
- "color": "#2a3f5f"
- },
- "error_y": {
- "color": "#2a3f5f"
- },
- "marker": {
- "line": {
- "color": "#E5ECF6",
- "width": 0.5
- },
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "bar"
- }
- ],
- "barpolar": [
- {
- "marker": {
- "line": {
- "color": "#E5ECF6",
- "width": 0.5
- },
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "barpolar"
- }
- ],
- "carpet": [
- {
- "aaxis": {
- "endlinecolor": "#2a3f5f",
- "gridcolor": "white",
- "linecolor": "white",
- "minorgridcolor": "white",
- "startlinecolor": "#2a3f5f"
- },
- "baxis": {
- "endlinecolor": "#2a3f5f",
- "gridcolor": "white",
- "linecolor": "white",
- "minorgridcolor": "white",
- "startlinecolor": "#2a3f5f"
- },
- "type": "carpet"
- }
- ],
- "choropleth": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "choropleth"
- }
- ],
- "contour": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "contour"
- }
- ],
- "contourcarpet": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "contourcarpet"
- }
- ],
- "heatmap": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "heatmap"
- }
- ],
- "heatmapgl": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "heatmapgl"
- }
- ],
- "histogram": [
- {
- "marker": {
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "histogram"
- }
- ],
- "histogram2d": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "histogram2d"
- }
- ],
- "histogram2dcontour": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "histogram2dcontour"
- }
- ],
- "mesh3d": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "mesh3d"
- }
- ],
- "parcoords": [
- {
- "line": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "parcoords"
- }
- ],
- "pie": [
- {
- "automargin": true,
- "type": "pie"
- }
- ],
- "scatter": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatter"
- }
- ],
- "scatter3d": [
- {
- "line": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatter3d"
- }
- ],
- "scattercarpet": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattercarpet"
- }
- ],
- "scattergeo": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattergeo"
- }
- ],
- "scattergl": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattergl"
- }
- ],
- "scattermapbox": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattermapbox"
- }
- ],
- "scatterpolar": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterpolar"
- }
- ],
- "scatterpolargl": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterpolargl"
- }
- ],
- "scatterternary": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterternary"
- }
- ],
- "surface": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "surface"
- }
- ],
- "table": [
- {
- "cells": {
- "fill": {
- "color": "#EBF0F8"
- },
- "line": {
- "color": "white"
- }
- },
- "header": {
- "fill": {
- "color": "#C8D4E3"
- },
- "line": {
- "color": "white"
- }
- },
- "type": "table"
- }
- ]
- },
- "layout": {
- "annotationdefaults": {
- "arrowcolor": "#2a3f5f",
- "arrowhead": 0,
- "arrowwidth": 1
- },
- "autotypenumbers": "strict",
- "coloraxis": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "colorscale": {
- "diverging": [
- [
- 0,
- "#8e0152"
- ],
- [
- 0.1,
- "#c51b7d"
- ],
- [
- 0.2,
- "#de77ae"
- ],
- [
- 0.3,
- "#f1b6da"
- ],
- [
- 0.4,
- "#fde0ef"
- ],
- [
- 0.5,
- "#f7f7f7"
- ],
- [
- 0.6,
- "#e6f5d0"
- ],
- [
- 0.7,
- "#b8e186"
- ],
- [
- 0.8,
- "#7fbc41"
- ],
- [
- 0.9,
- "#4d9221"
- ],
- [
- 1,
- "#276419"
- ]
- ],
- "sequential": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "sequentialminus": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ]
- },
- "colorway": [
- "#636efa",
- "#EF553B",
- "#00cc96",
- "#ab63fa",
- "#FFA15A",
- "#19d3f3",
- "#FF6692",
- "#B6E880",
- "#FF97FF",
- "#FECB52"
- ],
- "font": {
- "color": "#2a3f5f"
- },
- "geo": {
- "bgcolor": "white",
- "lakecolor": "white",
- "landcolor": "#E5ECF6",
- "showlakes": true,
- "showland": true,
- "subunitcolor": "white"
- },
- "hoverlabel": {
- "align": "left"
- },
- "hovermode": "closest",
- "mapbox": {
- "style": "light"
- },
- "paper_bgcolor": "white",
- "plot_bgcolor": "#E5ECF6",
- "polar": {
- "angularaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "bgcolor": "#E5ECF6",
- "radialaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- }
- },
- "scene": {
- "xaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- },
- "yaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- },
- "zaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- }
- },
- "shapedefaults": {
- "line": {
- "color": "#2a3f5f"
- }
- },
- "ternary": {
- "aaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "baxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "bgcolor": "#E5ECF6",
- "caxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- }
- },
- "title": {
- "x": 0.05
- },
- "xaxis": {
- "automargin": true,
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": "",
- "title": {
- "standoff": 15
- },
- "zerolinecolor": "white",
- "zerolinewidth": 2
- },
- "yaxis": {
- "automargin": true,
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": "",
- "title": {
- "standoff": 15
- },
- "zerolinecolor": "white",
- "zerolinewidth": 2
- }
- }
- },
- "title": {
- "text": "Deterministic Results"
- },
- "width": 500,
- "xaxis": {
- "range": [
- -5,
- 5
- ]
- },
- "yaxis": {
- "range": [
- -1,
- 0.9999999999999999
- ]
- }
- }
- },
- "text/html": [
- " "
- ]
- },
- "metadata": {},
- "output_type": "display_data"
- }
- ],
+ "outputs": [],
"source": [
"results.plot_species('A', t_ndx=200, width=None, height=None, title=\"Raw Stochastic Results\")\n",
"results.plot_species('A', t_ndx=200, concentration=True, width=None, height=None, title=\"Stochastic Results\")\n",
@@ -20087,19734 +369,36 @@
},
{
"cell_type": "code",
- "execution_count": 16,
+ "execution_count": null,
"metadata": {},
- "outputs": [
- {
- "data": {
- "application/vnd.plotly.v1+json": {
- "config": {
- "plotlyServerURL": "https://plot.ly"
- },
- "data": [
- {
- "type": "histogram",
- "x": [
- 9.564335374870252e+40,
- -1.4454895324466542e+42,
- -8.28529091594078e+41,
- 6.655263051687091e+39,
- -4.167134313102489e+44,
- -2.0651428088049316e+44,
- -3.2690895804201947e+44,
- -3.05829152315126e+44,
- 4.258358405426227e+41,
- -1.1495033915649353e+42,
- 2.6400533798096977e+41,
- -9.374395162499978e+42,
- 2.886258999805707e+41,
- -4.657456031210092e+40,
- -1.8131016645527998e+43,
- -6.795016793342594e+41,
- 1.9287052908618806e+45,
- 1.2832222801248469e+44,
- -9.667627070533012e+44,
- 1.5523794790609484e+44,
- -1.0593165688335335e+44,
- -1.406966187117799e+43,
- -4.940941705389235e+43,
- -2.0584344504460927e+44,
- -1.6574082870105647e+44,
- 2.9008069859190986e+43,
- -2.140293994672546e+41,
- -5.331365124656717e+44,
- 3.011657394675736e+44,
- 4.166342536300793e+45,
- -3.7433917203800574e+46,
- 3.841396175272953e+45,
- 1.821308978493024e+44,
- -4.912291623786151e+42,
- -7.627270159676832e+42,
- 1.3480695090599562e+43,
- -1.7455994372438277e+43,
- 7.558456748233028e+43,
- 1.647655709835341e+43,
- 2.353178888510054e+43,
- 2.48267608817669e+39,
- 7.309179254877736e+39,
- 3.17469028824278e+39,
- -8.924179041106582e+40,
- 1.72396858826551e+43,
- -1.6283778153656201e+43,
- -3.0417997380531657e+44,
- 7.361901210160562e+43,
- 2.0319593089861664e+42,
- 2.901677420880713e+41,
- 1.8873724444299784e+43,
- -9.193071250787455e+42,
- -5.817556954339484e+45,
- 2.7977108038390176e+45,
- -3.635671719825667e+44,
- 8.652175271531545e+43,
- -3.2318861519874297e+40,
- -4.001151962107059e+41,
- -8.757098895774662e+41,
- 1.5782152937580948e+42,
- -5.47265422000069e+38,
- -1.3425452265675508e+39,
- 4.385724103274985e+38,
- 1.3554379290714237e+38,
- 2.8140171006857547e+38,
- 1.157859357050345e+43,
- 5.4795938492988073e+42,
- -1.5901751621865987e+45,
- 4.713165496706625e+42,
- 1.360768223282482e+41,
- -1.9664754501640593e+41,
- -3.0935279210233503e+41,
- -5.39029209210632e+43,
- -1.253683628185929e+44,
- -3.4256786150178646e+43,
- 1.9353425053708486e+45,
- -1.2170078961773314e+39,
- 7.326177978189949e+40,
- 1.9556434920657186e+40,
- -3.6096676516583223e+40,
- 1.7035247921420814e+43,
- 4.681606859748907e+44,
- 9.412175473189375e+42,
- -1.3309501571195523e+42,
- -2.8271704178262976e+39,
- 2.976217070409151e+39,
- 1.140383789524173e+41,
- -4.4423644499897255e+38,
- 8.407215500569274e+40,
- 9.713231598910813e+40,
- -3.5366338966342286e+40,
- -1.3443603998251336e+41,
- 1.4811894102641899e+41,
- 8.737428355137302e+41,
- 1.4241706321929422e+43,
- 39178.998043,
- -3.3149171251907732e+44,
- 1.5907119577925537e+43,
- 1.409416293581588e+43,
- 3.06164722991684e+43,
- 2.8306548904332384e+43,
- 1.4275918605061097e+44,
- 1.7776275200621176e+42,
- 1.8026247658862234e+43,
- 1.139610894201508e+42,
- 6.295980914878367e+43,
- 5.090182433613915e+42,
- -2.0638546657308535e+42,
- -8.485504110066575e+43,
- 8.259360247229732e+42,
- 9.311954702353437e+42,
- -4.144900723681075e+43,
- 1.601144589373076e+43,
- 7.626860620926641e+43,
- 1.7380352580327717e+42,
- 1.251822817986756e+44,
- -1.452727329804208e+42,
- -1.7066742769507752e+43,
- -1.3800192904332498e+42,
- 2.1970750406452966e+45,
- -4.5359929304025176e+45,
- 1.1421790468740873e+45,
- -1.0641329701151342e+38,
- -7.993235286001864e+38,
- 2.8463971544074144e+36,
- 6.433939968255725e+36,
- -1.4341658048968593e+41,
- 8.871853946893403e+41,
- -1.0773785788029425e+43,
- -1.8610762924443435e+42,
- -4.767568674184886e+42,
- 1.2458689095486543e+41,
- 5.423912666528586e+41,
- 3.2825005971949355e+37,
- 2.96761008204409e+37,
- 1.4748263412440772e+44,
- 1.3489787491864136e+44,
- -8.663702131783416e+42,
- 1.824769705108145e+44,
- -7.4271623184253425e+40,
- -2.262341377550644e+44,
- 1.1001644148166116e+43,
- 2.5649570144154863e+43,
- -1.1675572053027592e+44,
- 6.757784679712686e+44,
- 5.175605216815304e+45,
- 3.132245547229214e+41,
- -3.351741595173048e+42,
- -2.349195444900006e+41,
- 1.8392094186744633e+45,
- -6.9050024072857945e+44,
- -1.0375050676347564e+45,
- 9.603750522519297e+45,
- -4.452057725979254e+44,
- -8.712271745721374e+45,
- -7.687817331879186e+42,
- 5.46675804296618e+44,
- -8.854366607270226e+44,
- 3.916756297204354e+43,
- 2.240792825149249e+43,
- 4.194232572686198e+43,
- 5.536925434779725e+42,
- -5.0959759925690945e+44,
- 7.3500382862362e+42,
- 9.98340919868387e+43,
- 2.827668844977951e+43,
- 4.2373948241486146e+44,
- -1.3330613777772656e+43,
- 39178.998043,
- 8.52798448890278e+44,
- 2.9358353079663036e+44,
- -5.273026335167347e+45,
- -2.2831059219686678e+45,
- -2.306480620377954e+44,
- -1.5763111894180687e+45,
- 8.954079285806066e+43,
- 2.232663555621556e+43,
- 1.1740565734735734e+42,
- -3.311030321742244e+42,
- -6.448166064691689e+44,
- 3.2290970151602054e+43,
- 1.2532467845899274e+44,
- 4.310485983453444e+38,
- 9.661220886345965e+38,
- 1.5450384988860207e+39,
- 6.214694120806666e+38,
- 3.382500784081691e+41,
- -3.763219950872245e+41,
- 3.847818118835562e+44,
- -2.204050764381127e+44,
- 3.578888722345277e+43,
- -6.029063012970963e+44,
- 39178.998043,
- 39178.998043,
- 39178.998043,
- 1.8793749472763718e+45,
- 5.909454833677983e+44,
- -2.3650581863073414e+44,
- -1.7261378993169338e+42,
- 3.1081319882352897e+42,
- 1.9213009365216726e+44,
- -1.2985453626259044e+43,
- 8.651996403023845e+43,
- 1.9147279480307568e+43,
- -1.7452826712631575e+45,
- -2.962316314787208e+44,
- -3.404094038469323e+44,
- -1.0952918102270685e+43,
- 3.0304918230999637e+42,
- -5.2297552645168734e+42,
- -1.204636750698826e+43,
- 1.7415278677345026e+43,
- 2.5075388318287354e+43,
- 3.2425339120940594e+43,
- -3.876933568204713e+42,
- 8.401185087040827e+39,
- 1.516515009751044e+38,
- 1.6588586986434912e+37,
- 1.333897426811004e+37,
- -2.899128933369879e+37,
- 2.9531649039366176e+43,
- -2.0924509706735737e+40,
- -1.556335459243086e+40,
- -2.7386434202528606e+40,
- -6.918478106785382e+40,
- 1.9008992126260093e+40,
- -1.4847659191390339e+40,
- 3.3294543218236885e+39,
- 5.287725588273299e+42,
- 9.33594363588744e+43,
- 4.078767531693869e+42,
- -5.127929302011834e+41,
- -2.3184349332462407e+42,
- 7.133754816379477e+42,
- 2.1522958336030716e+43,
- -4.0213707238073955e+44,
- -8.140670238155586e+43,
- 5.3184625956679176e+42,
- 4.521864403650602e+42,
- 1.1110028356850898e+45,
- 5.424054443062773e+43,
- -4.250979862078851e+42,
- 1.1022831587770228e+45,
- -1.1993443399114708e+42,
- 5.341781472762434e+42,
- -9.652516506663115e+42,
- -3.1644491138880768e+38,
- -5.641779949899312e+40,
- 6.263962767522669e+38,
- 2.2623060572917806e+40,
- -4.6339172458956965e+42,
- -3.747802222130256e+42,
- -1.4417350927256363e+42,
- -5.865344317500531e+42,
- 8.096776983975275e+41,
- 1.3444218931627568e+44,
- -8.936515836047544e+44,
- 9.118600103205794e+43,
- 2.476466141353122e+44,
- 5.217255474456338e+43,
- -6.819928610587707e+41,
- 1.1545369567218071e+41,
- -2.6485465948856824e+40,
- -1.3735697419718695e+44,
- 5.140153595902848e+43,
- -5.058430633039506e+42,
- -1.2238084228763777e+44,
- -4.6074202104315155e+45,
- 3.421130057354718e+44,
- -1.5772131359925465e+45,
- -2.7744419849692913e+45,
- 1.0577054013064893e+39,
- 7.23460848078698e+37,
- 3.978157697946791e+39,
- 1.0805058689363693e+45,
- 1.7676434897989414e+42,
- -4.3439585406114895e+41,
- 8.284374907960003e+41,
- -2.254931810198256e+41,
- 6.171376231711321e+40,
- 1.4040551494889661e+41,
- 1.4952725532719714e+43,
- 2.485187392440164e+44,
- -3.716022432647291e+42,
- -1.1579495818468716e+43,
- -1.2447807224678851e+44,
- 2.55251266591185e+44,
- -7.883409147428197e+44,
- 3.3415150106135526e+45,
- -4.275916671252055e+39,
- -8.10541769428962e+38,
- 2.6906630822868477e+41,
- -1.0953310379313462e+39,
- 2.3517662539063114e+38,
- -3.689203992852621e+40,
- 4.436290668192385e+40,
- 2.114652366503814e+45,
- -4.948606314713763e+43,
- -5.294117289227356e+44,
- 3.2698380493167043e+43,
- -1.4264818137708471e+44,
- -1.6010365325063356e+43,
- 1.4704578472464367e+44,
- -5.688210355687085e+44,
- -2.4906404825536348e+45,
- 1.2823628526359352e+46,
- 3.1651114262032164e+45,
- 2.737750739507377e+45,
- 2.6752947614027853e+45,
- 9.465112604426098e+44,
- 1.2244893710869959e+45,
- -4.781481967006476e+44,
- 1.7695116661719382e+45,
- -1.1094946070998386e+45,
- -1.7059832765617288e+44,
- 2.0210968670673977e+40,
- 1.032777756261992e+42,
- -1.026352856632856e+38,
- -7.707792681715387e+39,
- -6.767805508528665e+39,
- -4.540728785228407e+38,
- -1.5084387545854478e+45,
- 5.387256093065528e+44,
- -1.073094686510598e+43,
- -1.5644455593435186e+42,
- 4.117271731570439e+42,
- -8.86759801083276e+42,
- 1.1502186261097951e+41,
- -1.7724448581089028e+44,
- -2.3181805775806062e+45,
- -8.630332168172036e+44,
- 3.2310622914486516e+44,
- -2.3199703986509824e+44,
- -1.2667628499158872e+45,
- -5.451976456829913e+44,
- 39178.998043,
- 39178.998043,
- -2.3274642286345066e+40,
- -4.526737712752115e+40,
- 3.5896113954779104e+40,
- -3.706682010081101e+39,
- 0,
- 1.4690552617011498e+39,
- 0,
- 0,
- 1.0553006254515326e+44,
- 7.750994463466926e+44,
- -4.024505215492102e+44,
- 4.8485659077374e+43,
- -1.2529773448335404e+45,
- 2.707904882275324e+43,
- -7.718435996722826e+42,
- -1.0707066370848503e+43,
- 1.8819038014696732e+43,
- -9.622760770548537e+42,
- -1.6351653563629055e+39,
- 1.9521281433174533e+38,
- 1.6572849840013355e+38,
- 0,
- 9.837933467326836e+36,
- 1.756821326149861e+38,
- 2.6888507174667494e+37,
- 39178.998043,
- 39178.998043,
- 39178.998043,
- -4.216143032708572e+42,
- 2.962194326495376e+42,
- -2.6602497478011887e+42,
- 2.113888987056868e+44,
- 4.59893327789211e+44,
- -2.923961045540547e+39,
- -2.7185795025029546e+41,
- -7.719828080360626e+39,
- -1.7428339449623906e+40,
- 1.7761513599771513e+46,
- -1.0485242319164447e+43,
- -2.4741436508072634e+43,
- 4.4319842953943866e+42,
- -9.855669029146284e+40,
- -1.0099249731953492e+39,
- -7.51555695656406e+38,
- -2.7350968977699495e+38,
- 3.038660273012947e+40,
- -8.632699416535792e+37,
- -7.78800818319108e+38,
- -2.1983400844797442e+43,
- -3.3517812355732386e+42,
- 39178.998043,
- 1.453052340131468e+44,
- 39178.998043,
- 39178.998043,
- -5.765191982376325e+38,
- -1.798872893773805e+39,
- -6.871727087534396e+37,
- -3.112578524404599e+45,
- -9.214202783049836e+44,
- 1.0866683292437415e+46,
- 3.0094954842653167e+44,
- 3.549215045346073e+43,
- -2.8682349516969756e+44,
- -1.023310725829948e+44,
- 1.1036532999132008e+46,
- 5.42233863980987e+45,
- -2.2170477280872404e+44,
- -1.3549744822323542e+43,
- 6.369610911789865e+42,
- 2.7895118082262815e+43,
- 6.15427087641121e+42,
- -4.792451772891727e+43,
- -4.6318430773643636e+38,
- 5.2654652084474243e+39,
- -1.1034557435709688e+43,
- -1.9911496805781103e+43,
- -2.7766861897480915e+41,
- 6.074821477269868e+40,
- 1.850389730421213e+41,
- -2.025199243998884e+45,
- -4.334230485227012e+39,
- 3.716501255460095e+39,
- 1.8033916571000032e+41,
- -3.4479134045449054e+39,
- -4.877249990435865e+40,
- 8.921306641777389e+38,
- 7.159727059365336e+39,
- 8.895974668471712e+42,
- -1.2253592799769057e+44,
- 8.450441676282184e+43,
- 4.030017112906037e+41,
- -8.541893694627705e+42,
- 4.4318250266473015e+42,
- -1.5564067458788274e+42,
- 7.739106140517533e+42,
- -1.7214296122696133e+43,
- -1.3364988372883892e+42,
- 9.426430342965526e+42,
- 6.2326218737390845e+38,
- 0,
- -1.5174654676509694e+39,
- -9.099083944214052e+43,
- 3.9355125957970865e+42,
- 3.857828534536414e+42,
- 6.56123970795974e+42,
- 1.0007235158942443e+44,
- -5.031748418736235e+44,
- -3.288257561342344e+42,
- -1.526906726787092e+44,
- -1.381150866504864e+44,
- 7.682093235777872e+45,
- -3.367287785901581e+42,
- -1.4139529682235332e+42,
- -5.641190740023374e+43,
- -1.2720331402847043e+44,
- -1.526460455871769e+43,
- 2.6438136286842874e+41,
- -5.161507011262781e+41,
- -2.4832921926002836e+41,
- 1.8959772825582015e+42,
- -2.4099754551974725e+44,
- 8.041541516097029e+43,
- -2.274113947019672e+43,
- -2.208779266773304e+42,
- 2.6313301957901298e+45,
- -9.603712752213689e+44,
- 1.6954109616293643e+46,
- -2.1774956699322192e+45,
- -2.1288634889268358e+42,
- -1.0240055282555547e+43,
- -4.4516629460131126e+42,
- 3.7862497432914265e+42,
- 8.180783688616667e+45,
- -2.1163591051413616e+45,
- 1.03220547392013e+46,
- 6.759223137052469e+42,
- 6.167886498619237e+43,
- -1.828837629665172e+41,
- -1.1112719554305036e+44,
- -1.6431712986449835e+43,
- -1.3132353179419065e+44,
- -1.5955620006207044e+44,
- 9.733301922491795e+45,
- -7.223608278241114e+44,
- 1.0310870779336167e+46,
- 4.789311660241936e+37,
- -9.758924181150145e+43,
- -1.9016545336929574e+44,
- -3.34012383944732e+42,
- 6.793800147308952e+42,
- -1.086402896564984e+45,
- 1.3837583702579408e+46,
- 9.78848135930156e+40,
- -3.141443253521662e+41,
- 2.517558595567229e+41,
- -8.761811216636633e+40,
- -3.801105119772983e+42,
- -4.6607514492855715e+42,
- 8.756613446625062e+39,
- -1.2329503032959188e+41,
- 8.521119382482112e+40,
- 2.3183005972086026e+41,
- 1.084630380500978e+41,
- -4.3132341635732205e+42,
- -1.2798229293414894e+44,
- -1.7415518824473214e+41,
- 2.426903889985578e+42,
- -8.005358187434676e+41,
- -2.5692855076847948e+42,
- 1.0001611390737809e+43,
- 4.3280487820783245e+43,
- 3.835737753474035e+37,
- -2.0064611381457837e+36,
- 3.1178159406852406e+43,
- -1.8379499463272402e+43,
- -6.201769878754079e+42,
- 6.0048733192761525e+44,
- -2.4711957666483193e+42,
- -1.7539743614677489e+43,
- -3.505981875537539e+42,
- -1.484769672482479e+45,
- -1.773719398772643e+45,
- 2.7448747469511612e+44,
- 7.059282062466431e+43,
- -2.0418321078427047e+43,
- 5.038240477874394e+44,
- 3.069587440090649e+43,
- 3.7536961930965577e+43,
- 1.977108736806453e+42,
- -1.1718091388689142e+41,
- -5.924835009538062e+39,
- 8.434039392928679e+39,
- -7.256426019315736e+40,
- 8.682580399477658e+43,
- -6.972434115589344e+43,
- -6.00650919322563e+43,
- -1.758624444197081e+45,
- 3.088380503152175e+44,
- -1.2986823609571535e+40,
- -3.781078820944235e+41,
- -2.125582229838644e+40,
- -3.402716050663252e+40,
- -2.155544180021214e+40,
- 4.2597491592183245e+41,
- 5.706295345434609e+41,
- -8.881641583675292e+42,
- -6.313831300076416e+42,
- 39178.998043,
- 39178.998043,
- 4.39885565081432e+42,
- -3.453955155920853e+44,
- -1.794510620007728e+39,
- -3.449009472363694e+37,
- 1.1361883947663213e+38,
- -4.68169166343388e+38,
- -1.537714424309696e+43,
- 2.1601810145144957e+44,
- -4.893199740723064e+44,
- -6.198942619362843e+44,
- 3.84595452820105e+43,
- 2.0756598586164855e+42,
- 4.0255531155473837e+43,
- 9.581501152231202e+42,
- 3.9147230184020496e+44,
- -1.0339390271329386e+43,
- -2.7398541523715664e+44,
- -7.79055946427509e+42,
- -8.085525908446761e+42,
- 5.554361650853185e+43,
- 0,
- 0,
- 3.2113465317219367e+38,
- 1.9336696672944434e+38,
- 2.280421579414336e+44,
- 2.802517433511016e+41,
- -1.3498405176461985e+43,
- -3.5182856854277555e+43,
- 3.295686187069249e+43,
- 3.3237383371387685e+37,
- 0,
- 0,
- 5.2923307577426554e+36,
- -3.676130041480647e+43,
- 1.1101340393735252e+43,
- 8.768898736640267e+43,
- 39178.998043,
- -3.452592681348335e+39,
- -3.205062692812036e+44,
- 3.0593211358171673e+40,
- -9.557974197811087e+43,
- 2.922170858191243e+43,
- 4.603390496990818e+44,
- 8.657324390131202e+42,
- 1.1658072343253066e+43,
- -2.419124929820371e+42,
- 1.0109033204488748e+37,
- -3.9445379571631537e+37,
- 9.057032628700582e+37,
- -1.6768562976326613e+44,
- -4.1011394214489916e+42,
- 2.346346283474583e+36,
- 7.659723508086473e+43,
- 2.6990931593268918e+44,
- 2.0861696761918692e+45,
- 1.752078544594183e+45,
- -1.1861692447295208e+40,
- -1.0958281074324059e+39,
- -4.204168584950205e+39,
- 1.3534881587320286e+39,
- -1.019644211022931e+44,
- -2.1623619312979596e+44,
- -2.3879021017756726e+44,
- 3.1994047709118428e+41,
- 8.996510287563618e+43,
- -9.292701264386159e+43,
- -1.3118876847147809e+44,
- -1.8176714925032752e+44,
- 39178.998043,
- -1.776120889117286e+40,
- 2.4915180843576642e+42,
- -1.1572765653204108e+43,
- 1.4318700347439334e+38,
- -6.459574926073916e+38,
- 1.2492286683073276e+41,
- -2.4409471503314875e+40,
- -1.3404535086036403e+45,
- 1.8844827564216927e+45,
- 6.944970293508661e+43,
- 3.495882784292698e+44,
- -1.5364450472212895e+42,
- -9.334453107204544e+42,
- 4.0945471596591274e+41,
- -3.171514239114648e+39,
- 3.2993933277445707e+41,
- 1.326740510818103e+38,
- -9.736259211358494e+42,
- -3.705768065661258e+45,
- -3.0532456540772044e+44,
- 7.995702664486982e+38,
- 3.3290268622717835e+40,
- 3.900537168361359e+43,
- 5.63783896117159e+42,
- -1.975850992747928e+42,
- -7.436611005455304e+42,
- 7.362574450451047e+43,
- 7.028016463581853e+44,
- -1.4865561187989898e+43,
- -3.012320918546622e+45,
- -6.758681964130903e+42,
- -1.8776250261794915e+43,
- 5.546090854567315e+43,
- 2.164675588205482e+41,
- 0,
- 1.5997618748419353e+37,
- -7.852649263893824e+43,
- -3.608769643800519e+41,
- -3.655263909926057e+39,
- -8.627409801273485e+39,
- 5.195534553808166e+39,
- 1.7991548170267802e+38,
- -2.853827399906305e+43,
- 1.2034164650247717e+45,
- 1.0469513883002384e+43,
- 2.2575203740311467e+43,
- 3.052395787420342e+42,
- 5.0220092017825503e+42,
- 1.8311140765697004e+40,
- 6.180295575975022e+40,
- 1.465790552168772e+41,
- -1.826227823354411e+44,
- 6.783731851649486e+42,
- 6.688475660278705e+42,
- -3.0673583909698315e+44,
- -2.662148617851758e+43,
- -2.7333127848854442e+44,
- 6.487349314194355e+43,
- -8.765682867250218e+41,
- -7.090681591198305e+43,
- -5.100543764319341e+44,
- -1.7523266628166091e+44,
- 1.2695546558532717e+46,
- -1.0374205690752205e+47,
- 1.1259002404147688e+44,
- -3.3733922723771616e+44,
- 1.8723140937580884e+45,
- -3.3126989594884926e+37,
- 3.1520034324957767e+40,
- -2.0188114469605143e+40,
- -5.65841083478548e+40,
- -5.161722413642058e+41,
- 1.0599633441952832e+46,
- -5.085150099600077e+44,
- 1.4759689442931038e+40,
- -1.996625267083334e+40,
- 8.322492668158772e+40,
- -1.8962503044214454e+44,
- -1.4908004106415002e+44,
- -1.9998593597241018e+45,
- 6.30275841209233e+40,
- 4.55099052257533e+43,
- -1.592029372708258e+45,
- 6.287054638132343e+42,
- -4.7091588293640725e+44,
- -5.713662414057076e+44,
- -1.895560455717416e+43,
- -1.6685981611126637e+38,
- 7.950608557290299e+40,
- 8.564215387472349e+41,
- -1.6321019348533044e+39,
- -5.234452096862851e+42,
- -4.033923981896862e+42,
- -4.551064593544007e+43,
- 4.3223346095498975e+37,
- -8.553556407387486e+43,
- -1.524042819507592e+43,
- 1.970445242369171e+42,
- 3.556429480094634e+38,
- -4.589483764833879e+44,
- -4.992141331937442e+43,
- -1.4840636032238238e+42,
- -2.7362908068777673e+41,
- 4.700958983406949e+43,
- 7.206176187768559e+42,
- -2.301541355148592e+44,
- 2.241200726180209e+44,
- 39178.998043,
- -2.051653880218144e+41,
- 39178.998043,
- 1.3292764885333704e+39,
- 2.5074295260740373e+41,
- 1.955696367497783e+42,
- -6.036788348393784e+41,
- -2.2610404309279013e+41,
- -4.357122148744561e+42,
- 7.518328956272759e+37,
- 1.2451531550346656e+37,
- 1.1655865109060048e+43,
- 8.214985800885291e+40,
- -7.643791603866205e+38,
- 4.77609613077037e+38,
- -4.6588399630213995e+39,
- 1.9118822957511886e+39,
- -1.9822789951857437e+41,
- -1.3975746601381792e+45,
- 2.6112283413388205e+43,
- -1.401327177929177e+43,
- 39178.998043,
- 39178.998043,
- -4.123273167817142e+40,
- -1.7608360743912358e+44,
- -5.441442160068687e+44,
- -3.878003284319045e+44,
- 0,
- 1.1730515439487141e+44,
- 0,
- 0,
- 7.374214936966749e+45,
- 5.587110365850732e+41,
- 7.580222715008597e+45,
- 3.00254112953479e+44,
- -2.1450724115292684e+41,
- -1.470196021956162e+41,
- 1.6937827786810985e+43,
- -3.2654271263542916e+44,
- -1.8204707178994323e+43,
- -6.647437862635369e+42,
- 1.8045559698923255e+40,
- 5.388963886463272e+39,
- -1.978059419715823e+39,
- 2.362704019089084e+39,
- 4.484484860389631e+41,
- 2.1075893100880954e+42,
- 0,
- -3.6272923649237036e+44,
- -2.5698853704087996e+42,
- 2.0269251590760277e+43,
- 6.450063683210905e+43,
- -9.634750558409025e+37,
- -1.0844541147982538e+39,
- -1.3908155259159315e+38,
- 1.2339937611746228e+37,
- -8.339308336575533e+38,
- -1.8305490588343504e+38,
- -4.962390067257501e+42,
- 6.185330756890478e+42,
- 4.501387392949879e+43,
- 2.705643843980368e+38,
- -8.620995790086036e+38,
- -1.2538324911984846e+40,
- 8.270013023644542e+44,
- 2.1140791044806817e+35,
- -3.148606235412687e+38,
- -2.0514838330657462e+41,
- -1.4248856595577194e+40,
- 39178.998043,
- -3.288513558753313e+41,
- 9.360169656503599e+37,
- 4.812843065783014e+38,
- -5.992646921601673e+37,
- 6.743531614049926e+42,
- 1.5287193214399258e+43,
- 4.1929824879899294e+42,
- 8.025194967887439e+43,
- 0,
- -2.189698394106856e+41,
- 5.72094551053624e+41,
- 2.6838091420045614e+43,
- 4.3957239632062414e+38,
- -1.1953355671026292e+43,
- -2.2472582976686357e+44,
- -6.365899828215895e+38,
- -1.2513175523757382e+40,
- -2.9595743030516392e+44,
- 0,
- 0,
- 2.4878773818360405e+35,
- 1.7499547540025216e+41,
- 6.657177242350187e+43,
- 1.7169187293438821e+43,
- 2.8416278615780114e+43,
- -1.819245306420406e+40,
- -1.3287192396705139e+42,
- 4.570308312680581e+42,
- 5.263838503346144e+44,
- 0,
- 0,
- 1.3426576036791389e+43,
- 5.487691538399858e+42,
- 8.220737445153357e+42,
- 1.1787475872308156e+43,
- 4.8892107349507854e+44,
- -1.599288627224123e+40,
- 2.3636293296342876e+37,
- -1.595834225244175e+42,
- -1.0255674044154628e+45,
- 1.3060610129076321e+44,
- 39178.998043,
- 2.9587174001252496e+37,
- -1.1183726671610172e+43,
- -3.0745823495380497e+43,
- -4.0486777252534947e+43,
- -8.823827694255485e+42,
- -1.0155442868339115e+44,
- -1.2423713740114476e+42,
- 39178.998043,
- -2.7114814586788782e+44,
- -3.886081939353941e+44,
- -2.6187850533762998e+42,
- -1.000558412011573e+41,
- -2.111887786648245e+43,
- -3.816047851410242e+42,
- 5.160216672036807e+43,
- -1.5289689102408277e+43,
- 4.733075060984353e+43,
- 8.943375157738434e+43,
- 39178.998043,
- -3.3068283300052875e+43,
- 6.955784394372669e+43,
- 7.694549442663598e+43,
- 8.336794938068314e+42,
- 1.3831464295793367e+42,
- -7.969781028044762e+42,
- -4.553240005337418e+43,
- -1.2528887995827837e+44,
- -1.8141724257546486e+43,
- -4.3297529277535384e+42,
- -1.0591521575734324e+44,
- 0,
- 0,
- 0,
- 1.9503460970237816e+43,
- -4.466486108394874e+40,
- 0,
- 2.460776573366117e+43,
- -4.477200133430212e+45,
- -5.066443227423433e+44,
- 7.499327331018496e+43,
- 3.986560398889814e+37,
- -7.068911928549942e+41,
- 5.0184970058956536e+41,
- 1.404046495029229e+43,
- 4.308000631207351e+40,
- -2.5525335891163157e+44,
- -5.433037865026808e+43,
- -9.320173425783983e+43,
- -2.551122821209884e+40,
- 2.5861871566040308e+42,
- -1.0294960946425435e+43,
- 1.2527426779671818e+43,
- 1.287098561476273e+43,
- -1.5936159902046293e+42,
- 4.32697680436258e+39,
- -6.4947455267931415e+40,
- -1.2616056418392115e+43,
- 4.512574106157367e+40,
- 1.0146199782537708e+38,
- -5.975491406604375e+41,
- 5.756064410298624e+43,
- 5.237550707979098e+44,
- 1.9392805699321562e+38,
- 7.993936409104716e+42,
- -1.0513047003419562e+42,
- -3.0833737263062254e+38,
- -9.714363746478723e+38,
- 0,
- 1.3284937399663194e+37,
- -8.295565209787231e+42,
- -3.242555267384807e+42,
- 7.902270481277261e+40,
- 6.204387411778243e+40,
- 6.789448273800443e+43,
- 4.3973412781889025e+43,
- 39178.998043,
- -3.201146991588937e+37,
- 1.5016510510021003e+44,
- 5.645752877471417e+43,
- 7.722291884227824e+43,
- 39178.998043,
- 39178.998043,
- 39178.998043,
- 0,
- 2.183410784194122e+42,
- 6.93353038619768e+42,
- -1.2531280394600736e+43,
- 2.543299528754044e+42,
- 2.6327428510882916e+41,
- -7.784029998413734e+41,
- -4.638444704751045e+41,
- 4.743394055092457e+43,
- -1.8864631261022542e+42,
- 1.554996386320466e+40,
- -2.8348609694406235e+37,
- 39178.998043,
- 39178.998043,
- -4.211634926782804e+44,
- -1.7148408084081898e+44,
- 1.4677472763766223e+44,
- -1.1704044939116792e+43,
- 4.9879748557077615e+39,
- 1.3551238937946354e+41,
- -1.4175181152946981e+44,
- 39178.998043,
- -1.8330701573655583e+44,
- 0,
- 0,
- 0,
- 39178.998043,
- -9.261327898950873e+43,
- 3.0382535125282964e+43,
- -4.2394289996130823e+37,
- -2.401244719884461e+41,
- 4.4987675067292105e+42,
- 1.895037966851609e+43,
- 5.478450654698708e+42,
- 1.4940560692740381e+43,
- -1.460925076973971e+42,
- -3.005890334311539e+41,
- 2.001516198830606e+43,
- 1.0853275666587061e+41,
- -3.5268990381472695e+38,
- 2.9273912989016114e+44,
- 2.691782108987836e+43,
- 0,
- 0,
- 6.000113386880942e+43,
- -1.6175968516225232e+43,
- 39178.998043,
- 4.5838294302679425e+38,
- 0,
- 0,
- 0,
- -2.9613787787692476e+43,
- 4.4115828319447496e+36,
- 0,
- 2.629005265263733e+43,
- -1.1629306708162563e+39,
- -1.412625528512675e+39,
- 3.7617574818745454e+42,
- -3.698687127012522e+41,
- 2.0059471795829555e+41,
- -1.678922762115535e+41,
- -2.0436908075007254e+42,
- 4.650201309045743e+40,
- 6.139896466679185e+42,
- 1.1551078433636346e+39,
- -2.3315685441753476e+38,
- 2.5466896955723816e+42,
- -1.913775302698656e+42,
- 0,
- 0,
- 6.477701097867758e+42,
- 3.293547371008937e+43,
- 2.22813036538002e+40,
- 7.0803185024446515e+40,
- -3.022533870947158e+43,
- -3.048729525870819e+41,
- 39178.998043,
- 0,
- 1.779765565392244e+40,
- 3.466685425742989e+43,
- 6.866363841559475e+43,
- -2.543659794204213e+44,
- 5.000885473309796e+44,
- 7.076148266741163e+42,
- -3.457726310287747e+44,
- -3.358292925728559e+44,
- 1.8976470965026243e+40,
- 5.346676013551e+42,
- -2.0265744163781746e+43,
- 39178.998043,
- -4.878688220186485e+41,
- 5.401347842359418e+43,
- 7.281699808410123e+43,
- 39178.998043,
- 2.9064660927273605e+43,
- 3.769987880906863e+43,
- 1.8360252970209204e+41,
- -1.5915661664606833e+43,
- 1.425430744581399e+43,
- 6.338423440370668e+37,
- 7.636600512635e+37,
- -1.8867507681324835e+40,
- 7.387138844938381e+42,
- -6.056282160052055e+38,
- 0,
- 5.780118028988565e+38,
- 3.166387080075537e+43,
- -3.1889277803854604e+43,
- 1.0825890101844107e+43,
- 2.1326404849765855e+39,
- 0,
- 1.9170251310441534e+39,
- -1.3017028941775778e+44,
- 4.946835029544322e+41,
- 5.94564559674225e+42,
- -4.81927538479358e+42,
- -3.9165285922976503e+40,
- 1.2351290976201609e+39,
- 2.502879823637484e+40,
- 5.304158170070498e+37,
- -3.4496206011710992e+41,
- 0,
- -2.7371535112603864e+44,
- -1.407286134326929e+41,
- 4.614508487874808e+40,
- 1.8896752034941335e+37,
- -2.4437469586043083e+41,
- -1.690229978498245e+39,
- 2.5340399947199107e+41,
- -1.1531625460162024e+42,
- -9.53341748143993e+39,
- 1.3287320656763714e+43,
- 1.345835586141156e+42,
- -3.0722910325586965e+41,
- -1.1558978530932915e+43,
- -1.1890137052002735e+42,
- -2.0091659050776417e+44,
- -2.4391926384951327e+41,
- -1.1580994826947325e+44,
- -2.609812209344232e+42,
- 4.918024361935406e+38,
- -2.900825164343953e+43
- ]
- },
- {
- "type": "histogram",
- "x": [
- 0,
- 0,
- 0,
- 0,
- 16,
- 17,
- 32,
- 14,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 38,
- 30,
- 32,
- 38,
- 0,
- 0,
- 0,
- 0,
- 0,
- 2,
- 0,
- 0,
- 66,
- 42,
- 56,
- 52,
- 41,
- 47,
- 37,
- 45,
- 37,
- 35,
- 41,
- 50,
- 0,
- 0,
- 0,
- 0,
- 29,
- 24,
- 21,
- 18,
- 0,
- 0,
- 0,
- 0,
- 41,
- 38,
- 42,
- 35,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 30,
- 37,
- 50,
- 0,
- 0,
- 0,
- 0,
- 44,
- 38,
- 39,
- 42,
- 0,
- 0,
- 0,
- 0,
- 56,
- 58,
- 58,
- 59,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 42,
- 63,
- 53,
- 56,
- 20,
- 25,
- 24,
- 34,
- 24,
- 24,
- 14,
- 30,
- 38,
- 31,
- 30,
- 35,
- 33,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 24,
- 13,
- 24,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 29,
- 29,
- 21,
- 29,
- 54,
- 43,
- 46,
- 42,
- 46,
- 43,
- 53,
- 0,
- 0,
- 0,
- 3,
- 3,
- 0,
- 3,
- 0,
- 0,
- 0,
- 0,
- 44,
- 45,
- 55,
- 43,
- 26,
- 32,
- 31,
- 19,
- 12,
- 11,
- 13,
- 87,
- 16,
- 16,
- 16,
- 10,
- 12,
- 15,
- 12,
- 5,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 13,
- 27,
- 16,
- 49,
- 57,
- 67,
- 51,
- 0,
- 0,
- 0,
- 25,
- 26,
- 31,
- 18,
- 24,
- 1,
- 5,
- 4,
- 6,
- 19,
- 23,
- 20,
- 13,
- 15,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 29,
- 37,
- 40,
- 0,
- 0,
- 36,
- 38,
- 44,
- 49,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 27,
- 40,
- 25,
- 30,
- 0,
- 9,
- 22,
- 1,
- 1,
- 4,
- 0,
- 0,
- 0,
- 22,
- 17,
- 21,
- 8,
- 4,
- 7,
- 7,
- 12,
- 0,
- 0,
- 0,
- 20,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 3,
- 3,
- 0,
- 0,
- 32,
- 30,
- 35,
- 30,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 10,
- 14,
- 17,
- 9,
- 0,
- 0,
- 0,
- 3,
- 2,
- 7,
- 64,
- 60,
- 50,
- 49,
- 4,
- 4,
- 7,
- 10,
- 15,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 30,
- 8,
- 43,
- 0,
- 0,
- 0,
- 0,
- 42,
- 46,
- 59,
- 1,
- 7,
- 3,
- 68,
- 57,
- 55,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 47,
- 44,
- 47,
- 51,
- 14,
- 20,
- 14,
- 19,
- 10,
- 16,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 61,
- 66,
- 57,
- 21,
- 18,
- 19,
- 13,
- 23,
- 0,
- 0,
- 0,
- 0,
- 10,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 27,
- 26,
- 57,
- 63,
- 56,
- 66,
- 0,
- 0,
- 0,
- 0,
- 0,
- 2,
- 48,
- 60,
- 16,
- 22,
- 9,
- 4,
- 15,
- 9,
- 23,
- 24,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 12,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 9,
- 2,
- 0,
- 40,
- 23,
- 35,
- 23,
- 34,
- 20,
- 25,
- 29,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 42,
- 41,
- 53,
- 19,
- 42,
- 38,
- 32,
- 35,
- 0,
- 0,
- 0,
- 0,
- 31,
- 46,
- 29,
- 33,
- 40,
- 47,
- 49,
- 38,
- 29,
- 36,
- 27,
- 34,
- 10,
- 4,
- 4,
- 0,
- 1,
- 0,
- 0,
- 0,
- 45,
- 41,
- 5,
- 4,
- 5,
- 0,
- 50,
- 49,
- 19,
- 17,
- 7,
- 11,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 62,
- 68,
- 24,
- 16,
- 23,
- 17,
- 41,
- 43,
- 0,
- 0,
- 6,
- 0,
- 1,
- 0,
- 0,
- 0,
- 0,
- 0,
- 4,
- 0,
- 0,
- 0,
- 0,
- 3,
- 0,
- 20,
- 0,
- 0,
- 0,
- 0,
- 33,
- 35,
- 31,
- 48,
- 44,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 18,
- 72,
- 56,
- 0,
- 1,
- 0,
- 0,
- 0,
- 0,
- 0,
- 15,
- 17,
- 13,
- 0,
- 0,
- 12,
- 15,
- 14,
- 7,
- 8,
- 21,
- 20,
- 0,
- 0,
- 0,
- 0,
- 0,
- 12,
- 9,
- 8,
- 6,
- 3,
- 0,
- 0,
- 0,
- 0,
- 14,
- 17,
- 27,
- 61,
- 0,
- 3,
- 0,
- 36,
- 8,
- 8,
- 4,
- 7,
- 7,
- 0,
- 0,
- 0,
- 0,
- 24,
- 0,
- 0,
- 53,
- 57,
- 68,
- 0,
- 0,
- 0,
- 0,
- 49,
- 53,
- 46,
- 0,
- 18,
- 43,
- 52,
- 48,
- 67,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 7,
- 3,
- 11,
- 16,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 15,
- 57,
- 41,
- 0,
- 0,
- 0,
- 0,
- 0,
- 2,
- 0,
- 1,
- 1,
- 16,
- 0,
- 0,
- 53,
- 0,
- 0,
- 0,
- 51,
- 55,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 56,
- 38,
- 46,
- 30,
- 2,
- 39,
- 0,
- 0,
- 47,
- 57,
- 0,
- 3,
- 6,
- 0,
- 0,
- 10,
- 0,
- 0,
- 0,
- 0,
- 0,
- 9,
- 13,
- 0,
- 0,
- 0,
- 33,
- 38,
- 30,
- 37,
- 21,
- 12,
- 12,
- 11,
- 9,
- 0,
- 0,
- 0,
- 0,
- 0,
- 25,
- 13,
- 55,
- 0,
- 33,
- 39,
- 21,
- 0,
- 8,
- 0,
- 20,
- 35,
- 34,
- 34,
- 13,
- 0,
- 60,
- 54,
- 71,
- 0,
- 0,
- 0,
- 0,
- 0,
- 22,
- 0,
- 0,
- 30,
- 0,
- 0,
- 0,
- 0,
- 0,
- 8,
- 10,
- 11,
- 50,
- 61,
- 57,
- 0,
- 2,
- 4,
- 5,
- 0,
- 0,
- 0,
- 0,
- 39,
- 0,
- 8,
- 15,
- 0,
- 0,
- 28,
- 12,
- 38,
- 41,
- 0,
- 0,
- 0,
- 0,
- 24,
- 27,
- 0,
- 41,
- 36,
- 13,
- 3,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 44,
- 62,
- 52,
- 0,
- 0,
- 0,
- 41,
- 0,
- 0,
- 0,
- 0,
- 69,
- 0,
- 0,
- 0,
- 0,
- 30,
- 24,
- 22,
- 23,
- 0,
- 0,
- 17,
- 41,
- 0,
- 0,
- 6,
- 0,
- 29,
- 56,
- 0,
- 0,
- 0,
- 0,
- 51,
- 46,
- 49,
- 0,
- 24,
- 0,
- 0,
- 0,
- 0,
- 32,
- 46,
- 44,
- 42,
- 37,
- 0,
- 0,
- 28,
- 40,
- 10,
- 48,
- 0,
- 0,
- 15,
- 6,
- 14,
- 67,
- 56,
- 58,
- 8,
- 10,
- 0,
- 0,
- 42,
- 23,
- 0,
- 0,
- 18,
- 25,
- 52,
- 40,
- 5,
- 8,
- 37,
- 0,
- 8,
- 24,
- 13,
- 47,
- 18,
- 22,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 7,
- 43,
- 8,
- 0,
- 0,
- 35,
- 29,
- 51,
- 0,
- 31,
- 1,
- 0,
- 0,
- 0,
- 0,
- 12,
- 19,
- 24,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 41,
- 34,
- 0,
- 35,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 3,
- 8,
- 50,
- 0,
- 21,
- 6,
- 0,
- 76,
- 78,
- 77,
- 0,
- 13,
- 52,
- 0,
- 0,
- 0,
- 0,
- 0,
- 3,
- 23,
- 0,
- 0,
- 67,
- 50,
- 2,
- 9,
- 35,
- 53,
- 0,
- 0,
- 59,
- 81,
- 43,
- 0,
- 0,
- 0,
- 62,
- 48,
- 47,
- 0,
- 0,
- 0,
- 9,
- 0,
- 22,
- 19,
- 0,
- 20,
- 3,
- 0,
- 0,
- 37,
- 0,
- 0,
- 11,
- 17,
- 57,
- 0,
- 0,
- 0,
- 0,
- 40,
- 0,
- 0,
- 53,
- 0,
- 0,
- 26,
- 0,
- 0,
- 0,
- 35,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 27,
- 28,
- 56,
- 0,
- 0,
- 41,
- 38,
- 0,
- 0,
- 20,
- 4,
- 4,
- 0,
- 15,
- 51,
- 53,
- 0,
- 7,
- 5,
- 65,
- 0,
- 0,
- 35,
- 10,
- 6,
- 0,
- 0,
- 0,
- 41,
- 0,
- 0,
- 0,
- 6,
- 5,
- 35,
- 0,
- 0,
- 0,
- 0,
- 0,
- 9,
- 10,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 7,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 20,
- 0,
- 9,
- 22,
- 0,
- 0,
- 0,
- 5,
- 23,
- 10,
- 30,
- 0,
- 36
- ]
- },
- {
- "type": "histogram",
- "x": [
- 0,
- 0,
- 0,
- 0,
- 328.9541314582948,
- 268.9107532664747,
- 574.8881662864021,
- 274.80076944215443,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 594.6698799705795,
- 769.073010664479,
- 444.9697559618994,
- 977.0395701025892,
- 0,
- 0,
- 0,
- 0,
- 0,
- 101.48163182463973,
- 0,
- 0,
- 1929.2604501607718,
- 785.7958053471533,
- 1034.8523487452414,
- 941.4831981460022,
- 1259.871554558584,
- 3158.3898931523418,
- 2328.2154543166375,
- 2609.9060433824384,
- 2136.3820081990875,
- 887.648998224702,
- 3865.3719242009993,
- 2641.310089804543,
- 0,
- 0,
- 0,
- 0,
- 807.956983255788,
- 592.7535873941071,
- 500.1905487804878,
- 391.1342894393742,
- 0,
- 0,
- 0,
- 0,
- 661.2796567797294,
- 565.5519340387849,
- 1058.5477732691484,
- 1190.9622975364093,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 3069.6817763225213,
- 4662.885948330183,
- 816.4598301763552,
- 0,
- 0,
- 0,
- 0,
- 2896.833234577655,
- 801.3665408380607,
- 703.6281956447219,
- 586.2237420615535,
- 0,
- 0,
- 0,
- 0,
- 2755.227552275523,
- 885.1178122329386,
- 2003.869541182974,
- 6556.284031559062,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 3453.379378391712,
- 6097.5609756097565,
- 1076.754296859128,
- 4359.333644714308,
- 481.069899456391,
- 563.7487033779822,
- 716.3965254768514,
- 705.4234615544214,
- 1534.9194167306216,
- 565.3044399952892,
- 679.3478260869565,
- 703.8618553798508,
- 1417.2758466358348,
- 1682.222704579987,
- 555.2265324252295,
- 1278.6322288386366,
- 1898.62493527415,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 403.2935641068728,
- 250.64589519145488,
- 494.1220069588849,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 407.1775574962793,
- 666.2990533958276,
- 598.6146347025456,
- 643.3436120416177,
- 2636.847502319449,
- 876.9067623786606,
- 4046.8021465646166,
- 2963.1720050797235,
- 1874.2615002240966,
- 987.574929376909,
- 872.1265077092693,
- 0,
- 0,
- 0,
- 73.41604874825637,
- 102.56760914903073,
- 0,
- 84.82723519764745,
- 0,
- 0,
- 0,
- 0,
- 721.7492577465019,
- 2444.0582228981098,
- 4304.272969165754,
- 2232.8383009658323,
- 1501.4147947104002,
- 630.8775111882184,
- 2753.1083481349915,
- 945.9795867562858,
- 1394.8622573520865,
- 248.90256595918,
- 710.0720996285776,
- 7819.521840733417,
- 244.3233008077939,
- 493.26386533896476,
- 347.9017177647314,
- 222.22222222222223,
- 397.15373159026973,
- 363.60991927859794,
- 511.11679018655764,
- 262.49475010499793,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 216.27736740533706,
- 518.3933645649336,
- 436.8719965050241,
- 1291.1385734236253,
- 4535.327816677276,
- 4299.005453962143,
- 7142.857142857143,
- 0,
- 0,
- 0,
- 933.3582228859436,
- 1411.5092290988057,
- 576.3367293820182,
- 341.99076624931126,
- 532.9306746014123,
- 67.60868095463458,
- 100.3854802441375,
- 186.74136321195144,
- 359.1954022988506,
- 881.2207226009925,
- 915.3864522805063,
- 3295.9789057350035,
- 1028.3996519262716,
- 2021.2909311413557,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1921.8025182239894,
- 832.2087269455691,
- 2728.1407720638385,
- 0,
- 0,
- 2937.33681462141,
- 2747.0541458830335,
- 1139.3355602164738,
- 1846.965699208443,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 990.9347818108415,
- 3726.1294829995345,
- 1509.5706780991486,
- 1804.7283883775492,
- 0,
- 237.14790124107404,
- 693.5249984238068,
- 56.12617163383286,
- 16.643919976032755,
- 257.46652935118436,
- 0,
- 0,
- 0,
- 506.2126092959043,
- 336.12116179290985,
- 400.29736375593296,
- 257.08593097242755,
- 72.1071512267229,
- 174.40267085233077,
- 152.97537096527458,
- 280.9120277166534,
- 0,
- 0,
- 0,
- 282.62559174733275,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 169.91391028545536,
- 98.63554167351636,
- 0,
- 0,
- 1008.3504017646133,
- 767.8132678132678,
- 839.4291881520566,
- 563.5390250774866,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 234.8961758902565,
- 376.7593315213004,
- 458.70321901729585,
- 469.4345921134988,
- 0,
- 0,
- 0,
- 86.11286526207014,
- 48.13014390913029,
- 178.84974066787603,
- 1591.8418107200598,
- 1721.4173002438677,
- 1233.1368535280046,
- 1192.3011412025207,
- 105.15247108307047,
- 80.70862169851294,
- 210.1281781886951,
- 261.4925997594268,
- 338.3560407831814,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 575.0321059592494,
- 173.79214459506431,
- 2848.625372639947,
- 0,
- 0,
- 0,
- 0,
- 859.2822946929089,
- 1053.282348361688,
- 927.3230227587075,
- 27.78395198933096,
- 189.5631922441574,
- 46.979970872418065,
- 1852.3563061836012,
- 5534.517914360617,
- 5839.261068053934,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1645.1398368861353,
- 765.7367605854406,
- 778.5452798621809,
- 2215.9461220942862,
- 311.0696351597565,
- 837.3456144023446,
- 1210.444406017638,
- 981.2529050250479,
- 250.52610482012224,
- 417.6346219101564,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 2402.236836923562,
- 3087.285994948077,
- 1830.501942901185,
- 1360.3679471399885,
- 629.5907660020986,
- 1040.070067878257,
- 215.7318287421175,
- 359.4311611189248,
- 0,
- 0,
- 0,
- 0,
- 232.35820340637127,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 442.6011835483501,
- 1544.4015444015445,
- 3424.2460651207493,
- 1742.6903820087964,
- 2807.5804672616064,
- 6558.028616852146,
- 0,
- 0,
- 0,
- 0,
- 0,
- 35.80635920939559,
- 1218.892839004571,
- 2654.9847338377804,
- 268.87141224709285,
- 535.6968929580208,
- 142.88889594513066,
- 74.79012022511826,
- 377.63399712998165,
- 394.71952984518225,
- 1427.5074478649453,
- 682.6326867284828,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 300.42058882435407,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 882.5259854873505,
- 141.86409419775856,
- 0,
- 3231.5398287283892,
- 538.1123953020448,
- 2421.47502421475,
- 1184.6510430079834,
- 835.0525591904902,
- 448.53106077595874,
- 1625.6990505917545,
- 1350.0302592989153,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 2341.528683726375,
- 1262.6651473622617,
- 877.4253360704589,
- 1321.0958142122097,
- 2364.998029168309,
- 1267.342582710779,
- 1074.3662917575962,
- 1250.1785969424204,
- 0,
- 0,
- 0,
- 0,
- 782.1962050867985,
- 1100.5047967654727,
- 1270.9264615654308,
- 3208.5561497326203,
- 762.5002382813245,
- 1457.3643410852712,
- 885.4994940002891,
- 1088.3886120181016,
- 1714.0492936934806,
- 547.4785570898473,
- 1817.0805572380375,
- 2450.273854136639,
- 161.96954972465176,
- 80.65979714061018,
- 92.52191612888303,
- 0,
- 52.75652862041678,
- 0,
- 0,
- 0,
- 2940.0235201881615,
- 2362.8400184416782,
- 101.27402726296815,
- 188.0229387985334,
- 106.91985287828244,
- 0,
- 2355.1577955723033,
- 2163.5464500176613,
- 1833.622852731133,
- 1233.2245194051504,
- 132.91055119904306,
- 275.9243465609793,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 6599.957419629551,
- 2807.0175438596493,
- 1963.5114129100875,
- 1384.3225471534868,
- 1037.2976142154873,
- 428.01752354096374,
- 2990.081680280047,
- 2042.561276838305,
- 0,
- 0,
- 186.6368047779022,
- 0,
- 44.08393581378946,
- 0,
- 0,
- 0,
- 0,
- 0,
- 84.60057951396968,
- 0,
- 0,
- 0,
- 0,
- 153.51550506601166,
- 0,
- 1476.886722788362,
- 0,
- 0,
- 0,
- 0,
- 838.4998475454822,
- 908.359502738055,
- 606.5586600923534,
- 1085.162661361427,
- 875.8136109397083,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 951.4747859181731,
- 4220.64599331731,
- 3684.9378166743436,
- 0,
- 33.67456896551724,
- 0,
- 0,
- 0,
- 0,
- 0,
- 311.85679535957087,
- 320.2712886209495,
- 248.91339728492923,
- 0,
- 0,
- 778.311064988974,
- 892.2198429693076,
- 311.53341195843257,
- 402.9936672423719,
- 587.2421639873743,
- 975.3378849101296,
- 1028.3305054244433,
- 0,
- 0,
- 0,
- 0,
- 0,
- 299.4161385298667,
- 463.29661278698654,
- 592.6364915919697,
- 163.82252559726965,
- 241.11879119112683,
- 0,
- 0,
- 0,
- 0,
- 383.22566517026166,
- 1232.9561937917028,
- 937.7930603313536,
- 6981.801533707222,
- 0,
- 111.85682326621924,
- 0,
- 995.9608255408622,
- 286.3585925475176,
- 188.763832849626,
- 491.8234353866962,
- 347.4807644576818,
- 393.2805213776055,
- 0,
- 0,
- 0,
- 0,
- 1452.4328249818445,
- 0,
- 0,
- 1277.1699840956192,
- 1498.8167236392321,
- 2255.8386411889596,
- 0,
- 0,
- 0,
- 0,
- 4661.339421613394,
- 3648.127753303965,
- 2018.783463530238,
- 0,
- 413.13778145011366,
- 4398.976982097186,
- 3756.1398439757295,
- 3293.084522502744,
- 3467.5499430700756,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 167.3400109966293,
- 63.32988537290747,
- 495.89757461004416,
- 345.7216940363008,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1271.2941774726671,
- 1150.492491522687,
- 1044.6392172849573,
- 0,
- 0,
- 0,
- 0,
- 0,
- 60.66672733339399,
- 0,
- 20.807324178110697,
- 72.90223809870963,
- 258.544073685061,
- 0,
- 0,
- 1925.8021147487373,
- 0,
- 0,
- 0,
- 2568.4931506849316,
- 4821.178120617111,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 3070.848870366309,
- 3157.1950814223997,
- 2936.4826045323975,
- 552.5472427892585,
- 118.7507421921387,
- 1710.2262760919136,
- 0,
- 0,
- 1700.0036170289723,
- 1335.9583743495991,
- 0,
- 51.25226364164417,
- 90.21064184871675,
- 0,
- 0,
- 187.35011990407673,
- 0,
- 0,
- 0,
- 0,
- 0,
- 163.71971185330713,
- 616.610539297064,
- 0,
- 0,
- 0,
- 741.2065944926104,
- 616.2728466940205,
- 709.8743522396536,
- 2447.5755771647814,
- 740.6101216716628,
- 272.93197170605225,
- 598.115934805363,
- 507.84856879039705,
- 319.1036732378386,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1155.9090068429812,
- 965.8964261832231,
- 6297.950303446697,
- 0,
- 752.0339098926642,
- 2037.9369807179808,
- 1290.0055285951228,
- 0,
- 408.1216202428323,
- 0,
- 1323.0138254944764,
- 4495.825305073859,
- 857.8926120306822,
- 1646.249939476105,
- 495.59681293126454,
- 0,
- 6629.834254143646,
- 5288.414454999511,
- 8383.516353760773,
- 0,
- 0,
- 0,
- 0,
- 0,
- 966.3108885667853,
- 0,
- 0,
- 937.4707040404987,
- 0,
- 0,
- 0,
- 0,
- 0,
- 441.25758411472697,
- 151.92027224112786,
- 663.5299794908916,
- 2098.6358866736623,
- 9813.384813384813,
- 3273.980470993682,
- 0,
- 282.60562385191463,
- 170.77231780728346,
- 429.8486932599725,
- 0,
- 0,
- 0,
- 0,
- 847.9551236057661,
- 0,
- 200.41586291554975,
- 299.3533966632075,
- 0,
- 0,
- 723.4768229032092,
- 406.0638873849486,
- 1835.305481767689,
- 2518.4275184275184,
- 0,
- 0,
- 0,
- 0,
- 992.8432548711372,
- 549.9317677251156,
- 0,
- 779.6900256727204,
- 2151.1801613385123,
- 934.9827387802071,
- 196.0399921584003,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 4613.126441602013,
- 6251.2603347449085,
- 1640.5338044609898,
- 0,
- 0,
- 0,
- 911.3946561152359,
- 0,
- 0,
- 0,
- 0,
- 3574.573900429985,
- 0,
- 0,
- 0,
- 0,
- 1536.3343063450607,
- 1586.4621893178212,
- 1408.3605402983164,
- 753.9500426145677,
- 0,
- 0,
- 1214.8931608661474,
- 2035.042438080111,
- 0,
- 0,
- 488.20179007323026,
- 0,
- 1363.1022326674502,
- 1673.2901066722445,
- 0,
- 0,
- 0,
- 0,
- 1380.3556445719544,
- 6177.813591189901,
- 3716.062490520249,
- 0,
- 1719.8136868505912,
- 0,
- 0,
- 0,
- 0,
- 1858.952015801092,
- 2047.3562399857576,
- 4287.245444801715,
- 5671.077504725898,
- 626.8211696144203,
- 0,
- 0,
- 1665.4770402093743,
- 933.1622535868424,
- 352.43532811729045,
- 3027.0542977864666,
- 0,
- 0,
- 739.7908857762873,
- 213.2044630800938,
- 1844.532279314888,
- 3134.6495742490874,
- 4231.844630847125,
- 4495.078663876618,
- 648.1406465202949,
- 645.9113809585325,
- 0,
- 0,
- 2022.4394471998844,
- 2055.039313795568,
- 0,
- 0,
- 478.67248165088824,
- 628.3459421419057,
- 4893.196574762398,
- 2916.940129803836,
- 211.79261267366994,
- 410.5300969877354,
- 2899.00493614354,
- 0,
- 440.50437751225155,
- 478.9941123640356,
- 558.7792821835375,
- 3242.0500793267574,
- 1450.560077363204,
- 635.9851988899168,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 376.70864277257556,
- 649.2133949331159,
- 408.4133142740453,
- 0,
- 0,
- 2760.2523659305994,
- 4026.1002360127723,
- 3639.4776279169346,
- 0,
- 748.6295249824917,
- 46.74644727000748,
- 0,
- 0,
- 0,
- 0,
- 1165.9541391371938,
- 907.9613877473,
- 1917.5455417066157,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 2147.496333542845,
- 558.0173970129657,
- 0,
- 1965.6295630686286,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 169.91391028545536,
- 445.9805998439068,
- 2925.858739540055,
- 0,
- 405.71870170015455,
- 303.1374728439347,
- 0,
- 10079.575596816976,
- 4489.983882109142,
- 5789.909015715467,
- 0,
- 469.8059340103357,
- 4773.707885798219,
- 0,
- 0,
- 0,
- 0,
- 0,
- 171.39918871050676,
- 1201.2325690708726,
- 0,
- 0,
- 3745.1089994410286,
- 4258.943781942078,
- 116.95222501608092,
- 526.6237565827969,
- 910.8179144872095,
- 3681.3224977425853,
- 0,
- 0,
- 3709.29209103483,
- 4253.9782574444625,
- 2135.054617676266,
- 0,
- 0,
- 0,
- 5627.666333847689,
- 4357.694053563323,
- 3182.7723979142684,
- 0,
- 0,
- 0,
- 547.4785570898473,
- 0,
- 874.9950284373384,
- 1278.8584505620247,
- 0,
- 902.4049090827054,
- 198.95218515816697,
- 0,
- 0,
- 3327.0389353475407,
- 0,
- 0,
- 458.44794531966323,
- 596.3656774012488,
- 4544.005102040816,
- 0,
- 0,
- 0,
- 0,
- 3429.355281207133,
- 0,
- 0,
- 3696.2131250435878,
- 0,
- 0,
- 1017.0950201463053,
- 0,
- 0,
- 0,
- 3780.5141499243896,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1263.2169926078413,
- 1560.323209807746,
- 8480.993487808571,
- 0,
- 0,
- 2823.108173242443,
- 1394.0861398488516,
- 0,
- 0,
- 1110.370863868532,
- 269.72353337828724,
- 309.59752321981426,
- 0,
- 792.2674694977025,
- 8562.793821356614,
- 5944.369672498879,
- 0,
- 382.1795151779865,
- 269.19349628512975,
- 13089.005235602095,
- 0,
- 0,
- 2841.6010392140943,
- 349.7359493582345,
- 731.0832216400632,
- 0,
- 0,
- 0,
- 5460.114529231589,
- 0,
- 0,
- 0,
- 579.2624058698591,
- 511.770726714432,
- 2503.3974679922753,
- 0,
- 0,
- 0,
- 0,
- 0,
- 669.1449814126394,
- 996.710854181202,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 499.5717956037682,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1088.139281828074,
- 0,
- 1030.5736860185505,
- 1168.0382267056011,
- 0,
- 0,
- 0,
- 436.5287235900122,
- 1934.8868511819635,
- 730.8338814587444,
- 1791.900609246207,
- 0,
- 1828.1535648994513
- ]
- }
- ],
- "layout": {
- "bargap": 0.2,
- "bargroupgap": 0.1,
- "template": {
- "data": {
- "bar": [
- {
- "error_x": {
- "color": "#2a3f5f"
- },
- "error_y": {
- "color": "#2a3f5f"
- },
- "marker": {
- "line": {
- "color": "#E5ECF6",
- "width": 0.5
- },
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "bar"
- }
- ],
- "barpolar": [
- {
- "marker": {
- "line": {
- "color": "#E5ECF6",
- "width": 0.5
- },
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "barpolar"
- }
- ],
- "carpet": [
- {
- "aaxis": {
- "endlinecolor": "#2a3f5f",
- "gridcolor": "white",
- "linecolor": "white",
- "minorgridcolor": "white",
- "startlinecolor": "#2a3f5f"
- },
- "baxis": {
- "endlinecolor": "#2a3f5f",
- "gridcolor": "white",
- "linecolor": "white",
- "minorgridcolor": "white",
- "startlinecolor": "#2a3f5f"
- },
- "type": "carpet"
- }
- ],
- "choropleth": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "choropleth"
- }
- ],
- "contour": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "contour"
- }
- ],
- "contourcarpet": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "contourcarpet"
- }
- ],
- "heatmap": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "heatmap"
- }
- ],
- "heatmapgl": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "heatmapgl"
- }
- ],
- "histogram": [
- {
- "marker": {
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "histogram"
- }
- ],
- "histogram2d": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "histogram2d"
- }
- ],
- "histogram2dcontour": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "histogram2dcontour"
- }
- ],
- "mesh3d": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "mesh3d"
- }
- ],
- "parcoords": [
- {
- "line": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "parcoords"
- }
- ],
- "pie": [
- {
- "automargin": true,
- "type": "pie"
- }
- ],
- "scatter": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatter"
- }
- ],
- "scatter3d": [
- {
- "line": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatter3d"
- }
- ],
- "scattercarpet": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattercarpet"
- }
- ],
- "scattergeo": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattergeo"
- }
- ],
- "scattergl": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattergl"
- }
- ],
- "scattermapbox": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattermapbox"
- }
- ],
- "scatterpolar": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterpolar"
- }
- ],
- "scatterpolargl": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterpolargl"
- }
- ],
- "scatterternary": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterternary"
- }
- ],
- "surface": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "surface"
- }
- ],
- "table": [
- {
- "cells": {
- "fill": {
- "color": "#EBF0F8"
- },
- "line": {
- "color": "white"
- }
- },
- "header": {
- "fill": {
- "color": "#C8D4E3"
- },
- "line": {
- "color": "white"
- }
- },
- "type": "table"
- }
- ]
- },
- "layout": {
- "annotationdefaults": {
- "arrowcolor": "#2a3f5f",
- "arrowhead": 0,
- "arrowwidth": 1
- },
- "autotypenumbers": "strict",
- "coloraxis": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "colorscale": {
- "diverging": [
- [
- 0,
- "#8e0152"
- ],
- [
- 0.1,
- "#c51b7d"
- ],
- [
- 0.2,
- "#de77ae"
- ],
- [
- 0.3,
- "#f1b6da"
- ],
- [
- 0.4,
- "#fde0ef"
- ],
- [
- 0.5,
- "#f7f7f7"
- ],
- [
- 0.6,
- "#e6f5d0"
- ],
- [
- 0.7,
- "#b8e186"
- ],
- [
- 0.8,
- "#7fbc41"
- ],
- [
- 0.9,
- "#4d9221"
- ],
- [
- 1,
- "#276419"
- ]
- ],
- "sequential": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "sequentialminus": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ]
- },
- "colorway": [
- "#636efa",
- "#EF553B",
- "#00cc96",
- "#ab63fa",
- "#FFA15A",
- "#19d3f3",
- "#FF6692",
- "#B6E880",
- "#FF97FF",
- "#FECB52"
- ],
- "font": {
- "color": "#2a3f5f"
- },
- "geo": {
- "bgcolor": "white",
- "lakecolor": "white",
- "landcolor": "#E5ECF6",
- "showlakes": true,
- "showland": true,
- "subunitcolor": "white"
- },
- "hoverlabel": {
- "align": "left"
- },
- "hovermode": "closest",
- "mapbox": {
- "style": "light"
- },
- "paper_bgcolor": "white",
- "plot_bgcolor": "#E5ECF6",
- "polar": {
- "angularaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "bgcolor": "#E5ECF6",
- "radialaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- }
- },
- "scene": {
- "xaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- },
- "yaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- },
- "zaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- }
- },
- "shapedefaults": {
- "line": {
- "color": "#2a3f5f"
- }
- },
- "ternary": {
- "aaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "baxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "bgcolor": "#E5ECF6",
- "caxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- }
- },
- "title": {
- "x": 0.05
- },
- "xaxis": {
- "automargin": true,
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": "",
- "title": {
- "standoff": 15
- },
- "zerolinecolor": "white",
- "zerolinewidth": 2
- },
- "yaxis": {
- "automargin": true,
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": "",
- "title": {
- "standoff": 15
- },
- "zerolinecolor": "white",
- "zerolinewidth": 2
- }
- }
- },
- "xaxis": {
- "title": {
- "text": "Value"
- }
- },
- "yaxis": {
- "title": {
- "text": "Count"
- }
- }
- }
- },
- "text/html": [
- " "
- ]
- },
- "metadata": {},
- "output_type": "display_data"
- }
- ],
+ "outputs": [],
+ "source": [
+ "check_accuracy(results2)"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "check_accuracy(results2, deterministic=True)"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "metadata": {},
+ "outputs": [],
"source": [
"analyze_data(results=results2, t_ndx=200)"
]
},
{
"cell_type": "code",
- "execution_count": 17,
+ "execution_count": null,
"metadata": {},
- "outputs": [
- {
- "data": {
- "text/html": [
- " \n",
- " "
- ]
- },
- "metadata": {},
- "output_type": "display_data"
- },
- {
- "data": {
- "application/vnd.plotly.v1+json": {
- "config": {
- "linkText": "Export to plot.ly",
- "plotlyServerURL": "https://plot.ly",
- "showLink": false
- },
- "data": [
- {
- "marker": {
- "color": [
- 0,
- 0,
- 0,
- 0,
- 16,
- 17,
- 32,
- 14,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 38,
- 30,
- 32,
- 38,
- 0,
- 0,
- 0,
- 0,
- 0,
- 2,
- 0,
- 0,
- 66,
- 42,
- 56,
- 52,
- 41,
- 47,
- 37,
- 45,
- 37,
- 35,
- 41,
- 50,
- 0,
- 0,
- 0,
- 0,
- 29,
- 24,
- 21,
- 18,
- 0,
- 0,
- 0,
- 0,
- 41,
- 38,
- 42,
- 35,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 30,
- 37,
- 50,
- 0,
- 0,
- 0,
- 0,
- 44,
- 38,
- 39,
- 42,
- 0,
- 0,
- 0,
- 0,
- 56,
- 58,
- 58,
- 59,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 42,
- 63,
- 53,
- 56,
- 20,
- 25,
- 24,
- 34,
- 24,
- 24,
- 14,
- 30,
- 38,
- 31,
- 30,
- 35,
- 33,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 24,
- 13,
- 24,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 29,
- 29,
- 21,
- 29,
- 54,
- 43,
- 46,
- 42,
- 46,
- 43,
- 53,
- 0,
- 0,
- 0,
- 3,
- 3,
- 0,
- 3,
- 0,
- 0,
- 0,
- 0,
- 44,
- 45,
- 55,
- 43,
- 26,
- 32,
- 31,
- 19,
- 12,
- 11,
- 13,
- 87,
- 16,
- 16,
- 16,
- 10,
- 12,
- 15,
- 12,
- 5,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 13,
- 27,
- 16,
- 49,
- 57,
- 67,
- 51,
- 0,
- 0,
- 0,
- 25,
- 26,
- 31,
- 18,
- 24,
- 1,
- 5,
- 4,
- 6,
- 19,
- 23,
- 20,
- 13,
- 15,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 29,
- 37,
- 40,
- 0,
- 0,
- 36,
- 38,
- 44,
- 49,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 27,
- 40,
- 25,
- 30,
- 0,
- 9,
- 22,
- 1,
- 1,
- 4,
- 0,
- 0,
- 0,
- 22,
- 17,
- 21,
- 8,
- 4,
- 7,
- 7,
- 12,
- 0,
- 0,
- 0,
- 20,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 3,
- 3,
- 0,
- 0,
- 32,
- 30,
- 35,
- 30,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 10,
- 14,
- 17,
- 9,
- 0,
- 0,
- 0,
- 3,
- 2,
- 7,
- 64,
- 60,
- 50,
- 49,
- 4,
- 4,
- 7,
- 10,
- 15,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 30,
- 8,
- 43,
- 0,
- 0,
- 0,
- 0,
- 42,
- 46,
- 59,
- 1,
- 7,
- 3,
- 68,
- 57,
- 55,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 47,
- 44,
- 47,
- 51,
- 14,
- 20,
- 14,
- 19,
- 10,
- 16,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 61,
- 66,
- 57,
- 21,
- 18,
- 19,
- 13,
- 23,
- 0,
- 0,
- 0,
- 0,
- 10,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 27,
- 26,
- 57,
- 63,
- 56,
- 66,
- 0,
- 0,
- 0,
- 0,
- 0,
- 2,
- 48,
- 60,
- 16,
- 22,
- 9,
- 4,
- 15,
- 9,
- 23,
- 24,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 12,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 9,
- 2,
- 0,
- 40,
- 23,
- 35,
- 23,
- 34,
- 20,
- 25,
- 29,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 42,
- 41,
- 53,
- 19,
- 42,
- 38,
- 32,
- 35,
- 0,
- 0,
- 0,
- 0,
- 31,
- 46,
- 29,
- 33,
- 40,
- 47,
- 49,
- 38,
- 29,
- 36,
- 27,
- 34,
- 10,
- 4,
- 4,
- 0,
- 1,
- 0,
- 0,
- 0,
- 45,
- 41,
- 5,
- 4,
- 5,
- 0,
- 50,
- 49,
- 19,
- 17,
- 7,
- 11,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 62,
- 68,
- 24,
- 16,
- 23,
- 17,
- 41,
- 43,
- 0,
- 0,
- 6,
- 0,
- 1,
- 0,
- 0,
- 0,
- 0,
- 0,
- 4,
- 0,
- 0,
- 0,
- 0,
- 3,
- 0,
- 20,
- 0,
- 0,
- 0,
- 0,
- 33,
- 35,
- 31,
- 48,
- 44,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 18,
- 72,
- 56,
- 0,
- 1,
- 0,
- 0,
- 0,
- 0,
- 0,
- 15,
- 17,
- 13,
- 0,
- 0,
- 12,
- 15,
- 14,
- 7,
- 8,
- 21,
- 20,
- 0,
- 0,
- 0,
- 0,
- 0,
- 12,
- 9,
- 8,
- 6,
- 3,
- 0,
- 0,
- 0,
- 0,
- 14,
- 17,
- 27,
- 61,
- 0,
- 3,
- 0,
- 36,
- 8,
- 8,
- 4,
- 7,
- 7,
- 0,
- 0,
- 0,
- 0,
- 24,
- 0,
- 0,
- 53,
- 57,
- 68,
- 0,
- 0,
- 0,
- 0,
- 49,
- 53,
- 46,
- 0,
- 18,
- 43,
- 52,
- 48,
- 67,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 7,
- 3,
- 11,
- 16,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 15,
- 57,
- 41,
- 0,
- 0,
- 0,
- 0,
- 0,
- 2,
- 0,
- 1,
- 1,
- 16,
- 0,
- 0,
- 53,
- 0,
- 0,
- 0,
- 51,
- 55,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 56,
- 38,
- 46,
- 30,
- 2,
- 39,
- 0,
- 0,
- 47,
- 57,
- 0,
- 3,
- 6,
- 0,
- 0,
- 10,
- 0,
- 0,
- 0,
- 0,
- 0,
- 9,
- 13,
- 0,
- 0,
- 0,
- 33,
- 38,
- 30,
- 37,
- 21,
- 12,
- 12,
- 11,
- 9,
- 0,
- 0,
- 0,
- 0,
- 0,
- 25,
- 13,
- 55,
- 0,
- 33,
- 39,
- 21,
- 0,
- 8,
- 0,
- 20,
- 35,
- 34,
- 34,
- 13,
- 0,
- 60,
- 54,
- 71,
- 0,
- 0,
- 0,
- 0,
- 0,
- 22,
- 0,
- 0,
- 30,
- 0,
- 0,
- 0,
- 0,
- 0,
- 8,
- 10,
- 11,
- 50,
- 61,
- 57,
- 0,
- 2,
- 4,
- 5,
- 0,
- 0,
- 0,
- 0,
- 39,
- 0,
- 8,
- 15,
- 0,
- 0,
- 28,
- 12,
- 38,
- 41,
- 0,
- 0,
- 0,
- 0,
- 24,
- 27,
- 0,
- 41,
- 36,
- 13,
- 3,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 44,
- 62,
- 52,
- 0,
- 0,
- 0,
- 41,
- 0,
- 0,
- 0,
- 0,
- 69,
- 0,
- 0,
- 0,
- 0,
- 30,
- 24,
- 22,
- 23,
- 0,
- 0,
- 17,
- 41,
- 0,
- 0,
- 6,
- 0,
- 29,
- 56,
- 0,
- 0,
- 0,
- 0,
- 51,
- 46,
- 49,
- 0,
- 24,
- 0,
- 0,
- 0,
- 0,
- 32,
- 46,
- 44,
- 42,
- 37,
- 0,
- 0,
- 28,
- 40,
- 10,
- 48,
- 0,
- 0,
- 15,
- 6,
- 14,
- 67,
- 56,
- 58,
- 8,
- 10,
- 0,
- 0,
- 42,
- 23,
- 0,
- 0,
- 18,
- 25,
- 52,
- 40,
- 5,
- 8,
- 37,
- 0,
- 8,
- 24,
- 13,
- 47,
- 18,
- 22,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 7,
- 43,
- 8,
- 0,
- 0,
- 35,
- 29,
- 51,
- 0,
- 31,
- 1,
- 0,
- 0,
- 0,
- 0,
- 12,
- 19,
- 24,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 41,
- 34,
- 0,
- 35,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 3,
- 8,
- 50,
- 0,
- 21,
- 6,
- 0,
- 76,
- 78,
- 77,
- 0,
- 13,
- 52,
- 0,
- 0,
- 0,
- 0,
- 0,
- 3,
- 23,
- 0,
- 0,
- 67,
- 50,
- 2,
- 9,
- 35,
- 53,
- 0,
- 0,
- 59,
- 81,
- 43,
- 0,
- 0,
- 0,
- 62,
- 48,
- 47,
- 0,
- 0,
- 0,
- 9,
- 0,
- 22,
- 19,
- 0,
- 20,
- 3,
- 0,
- 0,
- 37,
- 0,
- 0,
- 11,
- 17,
- 57,
- 0,
- 0,
- 0,
- 0,
- 40,
- 0,
- 0,
- 53,
- 0,
- 0,
- 26,
- 0,
- 0,
- 0,
- 35,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 27,
- 28,
- 56,
- 0,
- 0,
- 41,
- 38,
- 0,
- 0,
- 20,
- 4,
- 4,
- 0,
- 15,
- 51,
- 53,
- 0,
- 7,
- 5,
- 65,
- 0,
- 0,
- 35,
- 10,
- 6,
- 0,
- 0,
- 0,
- 41,
- 0,
- 0,
- 0,
- 6,
- 5,
- 35,
- 0,
- 0,
- 0,
- 0,
- 0,
- 9,
- 10,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 7,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 20,
- 0,
- 9,
- 22,
- 0,
- 0,
- 0,
- 5,
- 23,
- 10,
- 30,
- 0,
- 36
- ],
- "colorbar": {
- "thickness": 20,
- "title": {
- "text": "A"
- }
- },
- "colorscale": [
- [
- 0,
- "#0508b8"
- ],
- [
- 0.08333333333333333,
- "#1910d8"
- ],
- [
- 0.16666666666666666,
- "#3c19f0"
- ],
- [
- 0.25,
- "#6b1cfb"
- ],
- [
- 0.3333333333333333,
- "#981cfd"
- ],
- [
- 0.4166666666666667,
- "#bf1cfd"
- ],
- [
- 0.5,
- "#dd2bfd"
- ],
- [
- 0.5833333333333334,
- "#f246fe"
- ],
- [
- 0.6666666666666666,
- "#fc67fd"
- ],
- [
- 0.75,
- "#fe88fc"
- ],
- [
- 0.8333333333333334,
- "#fea5fd"
- ],
- [
- 0.9166666666666666,
- "#febefe"
- ],
- [
- 1,
- "#fec3fe"
- ]
- ],
- "size": 5
- },
- "mode": "markers",
- "name": "A",
- "type": "scatter3d",
- "x": [
- -2.101682662963867,
- -1.887513518333435,
- -1.7570427656173706,
- -1.8541388511657715,
- 1.8749754428863525,
- 1.80832040309906,
- 2.1825294494628906,
- 2.062222480773926,
- -2.38004469871521,
- -2.3056769371032715,
- -2.2629430294036865,
- -2.0936312675476074,
- -1.9997928142547607,
- -1.7547287940979004,
- -1.6898266077041626,
- -1.6704288721084595,
- 3.5905017852783203,
- 3.2578799724578857,
- 3.160881519317627,
- 3.4964303970336914,
- -0.6913178563117981,
- -1.0443613529205322,
- -0.8108569979667664,
- -0.5850074887275696,
- -0.293684720993042,
- 0.0675533190369606,
- -0.271133154630661,
- 0.018742907792329788,
- 4.4305853843688965,
- 4.508673667907715,
- 4.325611114501953,
- 4.611989498138428,
- 3.4338648319244385,
- 3.488844871520996,
- 3.289395570755005,
- 3.6204428672790527,
- 3.71138858795166,
- 3.857684850692749,
- 3.974630117416382,
- 4.003854274749756,
- -3.9132473468780518,
- -4.0064496994018555,
- -3.8273096084594727,
- -3.709832191467285,
- 2.3001842498779297,
- 2.2914557456970215,
- 2.0052285194396973,
- 2.2628118991851807,
- -1.980513334274292,
- -2.0251479148864746,
- -1.7515032291412354,
- -2.1317431926727295,
- 3.794757843017578,
- 3.3874454498291016,
- 3.7147281169891357,
- 3.586693048477173,
- -2.8868887424468994,
- -3.001088857650757,
- -2.9482247829437256,
- -2.6325371265411377,
- -4.134808540344238,
- -3.772261619567871,
- -4.165527820587158,
- -3.994203805923462,
- -4.163450241088867,
- 3.875136137008667,
- 3.7112133502960205,
- 3.765407085418701,
- -2.4520857334136963,
- -2.657001495361328,
- -2.6662352085113525,
- -2.8774945735931396,
- 3.942436933517456,
- 3.8352348804473877,
- 3.6082088947296143,
- 4.133811950683594,
- -3.171978712081909,
- -3.221795082092285,
- -3.0311388969421387,
- -2.9480156898498535,
- 4.4702277183532715,
- 4.6418352127075195,
- 4.766424655914307,
- 4.669127941131592,
- -3.4734950065612793,
- -3.1584713459014893,
- -3.2440361976623535,
- -3.3585245609283447,
- -2.429314613342285,
- -2.2996301651000977,
- -2.1834332942962646,
- -1.2482850551605225,
- -0.8828672766685486,
- -0.8636268973350525,
- 4.625131607055664,
- 5,
- 4.731442928314209,
- 4.639413356781006,
- 2.726271152496338,
- 2.482100486755371,
- 2.630417823791504,
- 2.613208293914795,
- 2.359410285949707,
- 2.4850215911865234,
- 2.0713677406311035,
- 2.9034955501556396,
- 3.2096197605133057,
- 3.0044784545898438,
- 3.031195640563965,
- 2.8652327060699463,
- 3.303494453430176,
- -0.9179192781448364,
- -1.1669803857803345,
- -1.2644528150558472,
- -1.0285327434539795,
- -0.8682996034622192,
- -1.0111645460128784,
- -1.1425732374191284,
- -0.9068978428840637,
- 1.6444306373596191,
- 1.5535091161727905,
- 1.877994418144226,
- -4.233823299407959,
- -4.286869049072266,
- -4.4695281982421875,
- -4.121842384338379,
- -1.4972978830337524,
- -0.9989351034164429,
- -1.422027349472046,
- -1.2346546649932861,
- -2.2228097915649414,
- -2.000976085662842,
- -2.127882480621338,
- -4.581174373626709,
- -4.083948135375977,
- 2.5844061374664307,
- 2.6696746349334717,
- 2.439190149307251,
- 2.836972236633301,
- 3.768427848815918,
- 3.901214361190796,
- 4.03761625289917,
- 3.712953805923462,
- 3.7559714317321777,
- 3.856983184814453,
- 4.166917324066162,
- -2.2912299633026123,
- -2.089019775390625,
- -1.982771635055542,
- 0.2804890275001526,
- 0.14649292826652527,
- -0.02719704993069172,
- 0.35809698700904846,
- -0.09706947952508926,
- -0.06142881140112877,
- -0.6113005876541138,
- -0.263994425535202,
- 4.316342830657959,
- 4.358631610870361,
- 4.577394962310791,
- 4.1251115798950195,
- 2.637986421585083,
- 2.9547457695007324,
- 2.78865909576416,
- 1.622883915901184,
- 1.6951839923858643,
- 1.6690202951431274,
- 1.4459738731384277,
- 5,
- 1.4305493831634521,
- 1.2514207363128662,
- 1.230926275253296,
- 1.0252352952957153,
- 1.0430431365966797,
- 1.0417221784591675,
- 1.277311086654663,
- 0.8228275179862976,
- -2.6111531257629395,
- -0.8876737952232361,
- -0.6530675888061523,
- -0.8721553087234497,
- -1.1404987573623657,
- -3.7799670696258545,
- -3.7419769763946533,
- -3.7747626304626465,
- -3.765298843383789,
- -1.3552204370498657,
- -1.448533058166504,
- 1.976080060005188,
- 2.3143045902252197,
- 2.006865978240967,
- 4.718459129333496,
- 5,
- 5,
- 5,
- -0.21346406638622284,
- -0.3900603652000427,
- -0.7078602910041809,
- 2.546725273132324,
- 2.2419445514678955,
- 2.62286114692688,
- 2.31475830078125,
- 2.815099000930786,
- 0.17036111652851105,
- 0.35399267077445984,
- 0.22068481147289276,
- 0.5616357326507568,
- 2.168175220489502,
- 2.396758794784546,
- 2.032904624938965,
- 1.9458956718444824,
- 1.672920823097229,
- -1.9237370491027832,
- -1.7913600206375122,
- -2.1189286708831787,
- -4.244471549987793,
- -4.725438117980957,
- -4.62848424911499,
- -4.6635870933532715,
- -4.4014410972595215,
- -0.39015352725982666,
- -3.62326979637146,
- -3.6562275886535645,
- -3.3212900161743164,
- -2.650617837905884,
- -2.9336674213409424,
- -2.5238282680511475,
- -2.854623556137085,
- 3.359579563140869,
- 3.281346321105957,
- 3.4625306129455566,
- -1.6233601570129395,
- -1.4790972471237183,
- 3.500380516052246,
- 4.63165283203125,
- 4.554935932159424,
- 4.720632076263428,
- -0.6211792826652527,
- -0.9868704080581665,
- -0.2744942903518677,
- -0.23266896605491638,
- -0.4965898394584656,
- -0.32649561762809753,
- -1.423138976097107,
- -1.7905021905899048,
- -1.4218405485153198,
- -3.732257604598999,
- -3.5719547271728516,
- -3.941251754760742,
- -3.9911673069000244,
- 2.76228666305542,
- 3.034092664718628,
- 2.5956602096557617,
- 3.0007383823394775,
- -2.4493157863616943,
- 1.5511066913604736,
- 1.313583254814148,
- 0.09208802133798599,
- 0.2716134786605835,
- 0.33897581696510315,
- -2.9448187351226807,
- -3.1763267517089844,
- -2.965965747833252,
- 2.055418014526367,
- 1.7646766901016235,
- 2.0915160179138184,
- 1.9841140508651733,
- 0.7309734225273132,
- 0.8535610437393188,
- 1.1015901565551758,
- 1.1043431758880615,
- -3.231236696243286,
- -3.466428518295288,
- -3.2163987159729004,
- 1.5548237562179565,
- -2.620222806930542,
- -2.8454513549804688,
- -2.381518602371216,
- -1.7730915546417236,
- -2.034778118133545,
- -1.792545199394226,
- 0.23506808280944824,
- 0.15298357605934143,
- -0.12086783349514008,
- -0.0009967255173251033,
- 3.0469939708709717,
- 3.3803346157073975,
- 3.5396389961242676,
- 3.4276304244995117,
- -3.4141626358032227,
- -3.28906512260437,
- -3.1413207054138184,
- -2.9626805782318115,
- -3.5331058502197266,
- -2.7990610599517822,
- -2.5825302600860596,
- 1.0379852056503296,
- 1.3705062866210938,
- 1.090142846107483,
- 1.1630381345748901,
- -0.7285075783729553,
- -0.5913762450218201,
- -0.41392114758491516,
- 0.37851566076278687,
- 0.2083987444639206,
- 0.536102294921875,
- 4.585145950317383,
- 4.314233303070068,
- 4.690446853637695,
- 4.508464336395264,
- 0.5570757389068604,
- 0.7471429109573364,
- 0.8703640103340149,
- 0.735404372215271,
- 1.950286626815796,
- -2.459625482559204,
- -2.3318281173706055,
- -4.318643569946289,
- -2.7759718894958496,
- -2.491568088531494,
- -2.487426280975342,
- 3.034865140914917,
- 1.392642855644226,
- 3.841580390930176,
- -1.7278932332992554,
- -1.9114822149276733,
- -1.5143166780471802,
- -1.7121433019638062,
- 4.3564581871032715,
- 4.085196018218994,
- 4.489546298980713,
- 0.03738686069846153,
- 0.4072064459323883,
- 0.3515777885913849,
- 4.740171909332275,
- 5,
- 5,
- -3.7102108001708984,
- -3.5805227756500244,
- -3.250467300415039,
- -3.6381490230560303,
- -5,
- -4.672852039337158,
- -5,
- -5,
- 3.9007976055145264,
- 4.133395671844482,
- 4.175212860107422,
- 4.236222267150879,
- 1.3414992094039917,
- 1.545016884803772,
- 1.7293202877044678,
- 1.7089415788650513,
- 1.5792618989944458,
- 1.938088297843933,
- -4.447057247161865,
- -4.589023590087891,
- -4.721797943115234,
- -5,
- -4.662319183349609,
- -4.697544574737549,
- -4.536230564117432,
- 5,
- 5,
- 5,
- 2.2066378593444824,
- 1.9319493770599365,
- 2.258507013320923,
- 2.2539353370666504,
- 2.732060194015503,
- -2.9786436557769775,
- -2.8140065670013428,
- -2.7915046215057373,
- -2.627666711807251,
- 0.9115676283836365,
- -0.532065212726593,
- -0.5675407648086548,
- -0.5571060180664062,
- -2.564318895339966,
- -4.4288010597229,
- -4.226881980895996,
- -4.208695411682129,
- -4.0041913986206055,
- -4.3078436851501465,
- -4.320655345916748,
- 2.809098720550537,
- 2.785369634628296,
- 5,
- 4.710524559020996,
- 5,
- 5,
- -4.560494422912598,
- -4.414031982421875,
- -4.710155963897705,
- 0.027450760826468468,
- -0.09511373937129974,
- 0.3111163377761841,
- 4.47791862487793,
- 4.311753749847412,
- 2.278442859649658,
- 2.3220880031585693,
- 1.0773473978042603,
- 0.6730288863182068,
- 1.7689932584762573,
- 1.6555397510528564,
- 1.9800528287887573,
- 2.0714244842529297,
- -0.6446894407272339,
- -0.43192827701568604,
- -3.7548670768737793,
- -3.300417423248291,
- -1.1125221252441406,
- -0.6115882396697998,
- -2.978154420852661,
- -3.3732173442840576,
- -3.242103338241577,
- 1.2596628665924072,
- -3.6130688190460205,
- -3.133923292160034,
- -3.3986732959747314,
- -3.5859854221343994,
- -3.520331621170044,
- -3.851719617843628,
- -3.865055561065674,
- 0.5590431690216064,
- 0.6265019774436951,
- -0.03324676677584648,
- 2.4285573959350586,
- 2.5746889114379883,
- 2.7181601524353027,
- 2.378453016281128,
- 3.447817087173462,
- 2.445730209350586,
- 2.310244083404541,
- 2.6667962074279785,
- -4.695241928100586,
- -5,
- -4.548861980438232,
- -0.33884161710739136,
- -0.5452479720115662,
- -0.44265344738960266,
- -1.2199991941452026,
- -1.154729962348938,
- -0.9447287917137146,
- -0.8053910136222839,
- 3.9948537349700928,
- 3.997985601425171,
- 4.207438945770264,
- 2.2636070251464844,
- 2.816199541091919,
- 3.2298614978790283,
- 3.0754427909851074,
- 3.1898257732391357,
- -2.0362820625305176,
- -1.695935845375061,
- -2.8119935989379883,
- -2.5727436542510986,
- 3.0221409797668457,
- 3.255614995956421,
- 3.368884563446045,
- 3.2635715007781982,
- 4.541206359863281,
- 3.801682472229004,
- 4.062766075134277,
- 3.6565608978271484,
- 2.893397092819214,
- 3.020784378051758,
- 2.637270450592041,
- 2.978060007095337,
- 0.706810474395752,
- 0.7772684097290039,
- 0.8003952503204346,
- -0.22241777181625366,
- -0.1280590295791626,
- -2.9058010578155518,
- -0.3929927349090576,
- -1.6517680883407593,
- 4.374144554138184,
- 4.208742141723633,
- 1.0169200897216797,
- 0.6947392225265503,
- 0.6771532297134399,
- -4.339812278747559,
- 3.8944802284240723,
- 3.9562127590179443,
- 2.033257246017456,
- 1.9155778884887695,
- 1.3438067436218262,
- 1.0825568437576294,
- -1.7339566946029663,
- -1.3611284494400024,
- -1.3337901830673218,
- -1.2508692741394043,
- -2.2653911113739014,
- -2.2419567108154297,
- -3.1367833614349365,
- -1.81843900680542,
- -2.1527793407440186,
- -1.6042685508728027,
- -1.647326946258545,
- 4.628890037536621,
- 4.72548246383667,
- 2.286425828933716,
- 1.9910200834274292,
- 2.3555381298065186,
- 2.0931544303894043,
- 3.7614736557006836,
- 3.912747859954834,
- -4.636204242706299,
- -4.488008499145508,
- 0.4070380926132202,
- -0.13350971043109894,
- 0.19662299752235413,
- 0.13111887872219086,
- -0.7308740019798279,
- -0.5450983643531799,
- -0.6622709035873413,
- 0.003929497674107552,
- 0.24031925201416016,
- -0.22965681552886963,
- -0.0660269558429718,
- -0.17119362950325012,
- -0.18464888632297516,
- -0.0036181053146719933,
- -0.7095974087715149,
- 1.9864104986190796,
- -2.5475826263427734,
- -2.7074756622314453,
- -2.891202926635742,
- -2.509110927581787,
- 2.9578778743743896,
- 3.029849052429199,
- 2.3168818950653076,
- 3.536309242248535,
- 3.2530806064605713,
- -3.741461992263794,
- -2.821955680847168,
- -3.082059383392334,
- -2.9099485874176025,
- -2.7286927700042725,
- -0.6247063279151917,
- -0.3622240722179413,
- -0.4216044247150421,
- 1.6000310182571411,
- 5,
- 5,
- -1.6445059776306152,
- 0.2146318256855011,
- -4.1633453369140625,
- -4.1257829666137695,
- -3.817925214767456,
- -3.784167766571045,
- -1.2936067581176758,
- 1.8930131196975708,
- 1.5624295473098755,
- 1.5452696084976196,
- -1.8079805374145508,
- -1.6008325815200806,
- 1.2422401905059814,
- 1.4802297353744507,
- 1.4433354139328003,
- 1.5805444717407227,
- 0.7913298010826111,
- 2.578340768814087,
- 2.6075079441070557,
- -0.813774585723877,
- -5,
- -5,
- -4.7412261962890625,
- -4.72172212600708,
- 1.3737642765045166,
- 1.2108287811279297,
- 1.3925875425338745,
- 1.4203695058822632,
- 0.5987880825996399,
- -4.71983003616333,
- -5,
- -5,
- -4.692821025848389,
- 1.909011960029602,
- 1.7303102016448975,
- 1.6846473217010498,
- 5,
- -3.5527470111846924,
- 0.37845441699028015,
- -1.9841102361679077,
- 3.145871162414551,
- 1.289706826210022,
- 0.7273845076560974,
- 0.720970630645752,
- 1.0219862461090088,
- 0.8861194849014282,
- -4.596095085144043,
- -4.253779888153076,
- -4.743481159210205,
- -1.5359901189804077,
- 3.121032953262329,
- -4.488008499145508,
- -1.1460216045379639,
- 4.6934332847595215,
- 4.375402450561523,
- 4.680056095123291,
- -4.230134010314941,
- -3.7863848209381104,
- -4.4221673011779785,
- -4.591073989868164,
- 4.1638264656066895,
- 4.340243339538574,
- 4.488320350646973,
- -2.5075998306274414,
- 1.917682409286499,
- 4.661116600036621,
- 4.636397361755371,
- 4.488320350646973,
- 5,
- -3.489121437072754,
- -1.138638973236084,
- -0.7274905443191528,
- -4.574654579162598,
- -4.382515907287598,
- -3.1639509201049805,
- -2.7766637802124023,
- 0.7139411568641663,
- 0.4993683397769928,
- 0.7703021764755249,
- 0.901824951171875,
- -1.5355284214019775,
- -2.1874425411224365,
- -2.3504247665405273,
- -4.327395915985107,
- -2.3662376403808594,
- -3.6765761375427246,
- 1.808962345123291,
- 4.351280689239502,
- 4.706614017486572,
- -3.448230266571045,
- -3.3269059658050537,
- -1.3753197193145752,
- -1.1046783924102783,
- -1.4444420337677002,
- 0.29257264733314514,
- 0.009619895368814468,
- 0.32545214891433716,
- 0.23237977921962738,
- 1.4445356130599976,
- -1.2714718580245972,
- -1.4109042882919312,
- 4.735227108001709,
- -3.157381772994995,
- -5,
- -4.624974727630615,
- 4.58084774017334,
- 4.646906852722168,
- -4.253415107727051,
- -3.6714272499084473,
- -4.048503875732422,
- -3.91367769241333,
- -0.662963330745697,
- -0.45707225799560547,
- -0.3023490607738495,
- -0.10872425138950348,
- -0.40253975987434387,
- -0.7720760107040405,
- -2.228641986846924,
- -2.0955162048339844,
- -1.9311330318450928,
- 4.527668476104736,
- 4.4020185470581055,
- 4.253148078918457,
- 4.159819602966309,
- 0.06420236825942993,
- 4.135446548461914,
- -0.9258043766021729,
- -0.8058002591133118,
- 4.537054061889648,
- 4.744240760803223,
- -0.8789688944816589,
- 0.3651331961154938,
- 0.7293714880943298,
- -0.06956324726343155,
- -0.08140537887811661,
- 1.721306324005127,
- -3.6552634239196777,
- -3.3976213932037354,
- -3.114668607711792,
- -2.9648706912994385,
- -2.7460291385650635,
- 0.9609786868095398,
- 1.0764851570129395,
- -2.625852346420288,
- -2.673210859298706,
- -2.3928139209747314,
- 3.227536678314209,
- 3.531540632247925,
- 3.7912299633026123,
- 3.446416139602661,
- 1.760624647140503,
- 1.2702659368515015,
- 1.4204895496368408,
- 1.1356712579727173,
- 1.1212012767791748,
- -0.7966426014900208,
- -4.596960067749023,
- -2.358410358428955,
- -2.481785297393799,
- -2.317129611968994,
- 2.1517908573150635,
- 1.9424786567687988,
- 4.65165901184082,
- -4.577237129211426,
- 3.162456750869751,
- 3.290433168411255,
- 3.418100118637085,
- -3.9114646911621094,
- 0.9896045327186584,
- -0.19112993776798248,
- 2.6939661502838135,
- 3.0167806148529053,
- 2.893794298171997,
- 3.0206243991851807,
- 1.2407162189483643,
- -0.46050986647605896,
- 5,
- 4.663840293884277,
- 5,
- -3.103480339050293,
- -2.277939558029175,
- -2.125932216644287,
- -1.824216604232788,
- -2.0925588607788086,
- 2.68068528175354,
- -4.7859697341918945,
- -4.575015544891357,
- 2.8520922660827637,
- -3.2595419883728027,
- -4.203586101531982,
- -4.2565202713012695,
- -3.767660140991211,
- -3.32572078704834,
- 0.5733931660652161,
- 0.5859797596931458,
- 0.6658535599708557,
- 4.556863307952881,
- 5,
- 5,
- -2.477255344390869,
- 0.25908347964286804,
- 0.25868678092956543,
- 0.49322885274887085,
- -5,
- -0.1877877414226532,
- -5,
- -5,
- 3.983049154281616,
- -2.6407032012939453,
- 0.5915303230285645,
- 1.0867373943328857,
- -1.214605450630188,
- -1.4895960092544556,
- 2.3244974613189697,
- 1.0752484798431396,
- 3.5134105682373047,
- 3.492990732192993,
- -4.003303050994873,
- -4.055683612823486,
- -4.244694709777832,
- -4.091361999511719,
- 2.220043897628784,
- 2.544774293899536,
- -5,
- 3.5021090507507324,
- 3.226494312286377,
- 1.4538578987121582,
- 0.25620901584625244,
- -4.075596809387207,
- -4.281928539276123,
- -4.1883087158203125,
- -4.555990695953369,
- -4.334146976470947,
- -4.165266990661621,
- 4.628626346588135,
- 4.596282482147217,
- 4.575169086456299,
- -4.123189449310303,
- -3.8626294136047363,
- -3.69762921333313,
- 3.6556200981140137,
- -4.1212477684021,
- -3.785296678543091,
- -1.9285658597946167,
- -3.4919838905334473,
- 5,
- -1.8179099559783936,
- -4.580845355987549,
- -4.697874546051025,
- -4.374136447906494,
- 2.7386975288391113,
- 3.034958839416504,
- 2.8929836750030518,
- 2.8669273853302,
- -5,
- -1.5589079856872559,
- 1.9696201086044312,
- 3.9466171264648438,
- -3.894467353820801,
- -1.4353413581848145,
- 0.6438999772071838,
- -3.559412717819214,
- 2.898449182510376,
- 4.226627349853516,
- -5,
- -5,
- -4.580845355987549,
- -2.0328192710876465,
- 4.1754069328308105,
- 4.199225902557373,
- 4.34015417098999,
- -2.9041290283203125,
- 2.497323513031006,
- -1.7650561332702637,
- -0.5644856095314026,
- -5,
- -5,
- 3.0372588634490967,
- 3.8829185962677,
- 3.6070923805236816,
- 3.8541207313537598,
- 3.8192059993743896,
- -2.6382784843444824,
- -4.700376033782959,
- 2.501884937286377,
- 4.065597057342529,
- 1.0171412229537964,
- 5,
- -4.651655673980713,
- -0.8031032681465149,
- 1.2622673511505127,
- 1.2936519384384155,
- 1.369748592376709,
- 4.189074516296387,
- 4.076688766479492,
- 5,
- 0.7270625233650208,
- 0.995764970779419,
- -0.8975422382354736,
- -1.5903971195220947,
- 3.329392194747925,
- 3.4523019790649414,
- -1.0810967683792114,
- -0.5812257528305054,
- 2.644548177719116,
- 2.6585214138031006,
- 5,
- 3.7732388973236084,
- 0.9950934052467346,
- 0.8841180801391602,
- 3.8183670043945312,
- -0.6460126042366028,
- 2.1103804111480713,
- 2.3608930110931396,
- 1.3835891485214233,
- 3.4795989990234375,
- 1.769286036491394,
- 1.7716087102890015,
- -5,
- -5,
- -5,
- -1.426405906677246,
- -2.7312746047973633,
- -5,
- 0.47139957547187805,
- 3.8471028804779053,
- 0.7896639108657837,
- -1.2268297672271729,
- -4.720064640045166,
- 2.7558088302612305,
- 3.023494243621826,
- 3.7829294204711914,
- -1.891106128692627,
- 3.048088550567627,
- 0.008336871862411499,
- 0.07599930465221405,
- -1.3721232414245605,
- -1.032981276512146,
- -0.6021665930747986,
- 1.735460877418518,
- 1.5383501052856445,
- 2.478435516357422,
- -3.304556131362915,
- -2.378432035446167,
- -0.4857358932495117,
- -2.097623586654663,
- -3.2147445678710938,
- -1.8128300905227661,
- 3.589271306991577,
- 3.373690366744995,
- -3.5193681716918945,
- 3.53788161277771,
- -1.1633410453796387,
- -3.841488838195801,
- -3.562544822692871,
- -5,
- -4.628747463226318,
- -0.3776344060897827,
- -1.9576623439788818,
- -2.3299407958984375,
- -2.3134829998016357,
- 0.5879091620445251,
- 0.39716675877571106,
- 5,
- -4.527527809143066,
- 2.8390586376190186,
- 0.3319953382015228,
- -0.2031165361404419,
- 5,
- 5,
- 5,
- -5,
- 2.2759742736816406,
- 4.30157470703125,
- -0.7995855808258057,
- -0.05464247241616249,
- -1.3260889053344727,
- -1.0919172763824463,
- -1.5666868686676025,
- 0.6270329356193542,
- 2.468057155609131,
- -2.5841712951660156,
- -4.339723110198975,
- 5,
- 5,
- 0.5067524909973145,
- 0.7723978161811829,
- 3.510948657989502,
- 4.363494873046875,
- -3.0252578258514404,
- -1.2719022035598755,
- 4.58084774017334,
- 5,
- 4.526966571807861,
- -5,
- -5,
- -5,
- 5,
- 4.227243900299072,
- 4.085610389709473,
- -4.363025188446045,
- -1.356877088546753,
- -1.0370725393295288,
- 1.1098798513412476,
- -1.7669402360916138,
- 3.0309200286865234,
- 1.8378273248672485,
- -1.0789508819580078,
- 1.8391550779342651,
- 0.4916764497756958,
- -3.601686716079712,
- -0.24966329336166382,
- 4.12544059753418,
- -5,
- -5,
- 1.536503791809082,
- 1.7359037399291992,
- 5,
- -3.840538263320923,
- -5,
- -5,
- -5,
- 4.124938011169434,
- -4.646697998046875,
- -5,
- 4.167131423950195,
- -3.3831329345703125,
- -3.5020036697387695,
- 3.266669988632202,
- -0.9436191916465759,
- -1.5299025774002075,
- -1.982384204864502,
- 3.6774818897247314,
- -2.2120511531829834,
- -0.3448413610458374,
- -3.386986017227173,
- -3.1074790954589844,
- -0.4411892294883728,
- -0.3736647963523865,
- -5,
- -5,
- -1.2011436223983765,
- -1.1121392250061035,
- -2.1613833904266357,
- -2.2924811840057373,
- 3.104656934738159,
- 2.610442638397217,
- 5,
- -5,
- -2.3681676387786865,
- 3.672323226928711,
- 3.7326676845550537,
- 0.1613098382949829,
- 0.2413194328546524,
- 1.3728821277618408,
- 0.4339759051799774,
- 0.35695144534111023,
- -2.493479013442993,
- 2.1896910667419434,
- 4.700502395629883,
- 5,
- -1.016597032546997,
- 0.6210448145866394,
- 0.6637445688247681,
- 5,
- -1.0216628313064575,
- -0.23358485102653503,
- 3.3018922805786133,
- 1.8105369806289673,
- 0.955568790435791,
- -3.7231528759002686,
- -3.9804978370666504,
- -1.2900493144989014,
- 4.1124267578125,
- -3.540820360183716,
- -5,
- -3.8975656032562256,
- 1.2156816720962524,
- 0.7590240836143494,
- 3.5594608783721924,
- -3.283069372177124,
- -5,
- -3.2769768238067627,
- 0.1670776754617691,
- -0.7176233530044556,
- 0.9799598455429077,
- 1.3872452974319458,
- -2.0572428703308105,
- -3.3091535568237305,
- -1.3487980365753174,
- -4.625357627868652,
- -2.012728691101074,
- -5,
- 0.8194661736488342,
- -1.579920768737793,
- -1.5731505155563354,
- -4.639402389526367,
- -1.7494895458221436,
- -3.0217342376708984,
- -1.5556175708770752,
- 2.022423028945923,
- -2.8629543781280518,
- 1.2468470335006714,
- 1.9912384748458862,
- -1.0789836645126343,
- -0.08867280930280685,
- -1.3601857423782349,
- 0.519882321357727,
- 2.222944498062134,
- 0.5680000185966492,
- 2.373995542526245,
- -2.9980807304382324,
- 3.2855708599090576
- ],
- "y": [
- -0.9644528031349182,
- -0.5014916062355042,
- -0.9228641390800476,
- -0.9955595135688782,
- 0.2492223083972931,
- 0.057115908712148666,
- -0.16631139814853668,
- -0.06584170460700989,
- 0.10396039485931396,
- -0.31133314967155457,
- -0.041115161031484604,
- -0.04820563644170761,
- -0.949433445930481,
- -0.8801339268684387,
- -0.5981799364089966,
- -0.9736314415931702,
- -0.43101099133491516,
- -0.4243756830692291,
- -0.4731490910053253,
- -0.6577183604240417,
- 0.2146396040916443,
- 0.5974391102790833,
- 0.2125028818845749,
- 0.43337777256965637,
- 0.4884589910507202,
- 0.6967326402664185,
- 0.6029126048088074,
- 0.23680882155895233,
- 0.6917465329170227,
- 0.4850515127182007,
- 0.18376414477825165,
- 0.48162636160850525,
- -0.6320042610168457,
- -0.7730603814125061,
- -0.9154437184333801,
- -0.9334678649902344,
- -0.937618613243103,
- -0.6324880123138428,
- -0.9645949602127075,
- -0.8584909439086914,
- -0.021662965416908264,
- -0.19917190074920654,
- -0.40617337822914124,
- 0.01375947892665863,
- 0.6443992257118225,
- 0.2646108865737915,
- 0.3110242187976837,
- 0.4987179636955261,
- 0.2822154462337494,
- 0.22283178567886353,
- 0.3027957081794739,
- 0.48568424582481384,
- -0.004136862698942423,
- 0.24444110691547394,
- 0.3975219428539276,
- 0.06679671257734299,
- 0.3392251133918762,
- 0.4178438186645508,
- 0.0005444167763926089,
- 0.26371410489082336,
- 0.6860716342926025,
- 0.5389652252197266,
- 0.2810700237751007,
- 0.29595068097114563,
- -0.0028515858575701714,
- -0.914943516254425,
- -0.8317362070083618,
- -0.5160342454910278,
- 0.1723458170890808,
- -0.24010129272937775,
- 0.11037452518939972,
- -0.04924260079860687,
- 0.9950059056282043,
- 0.5880264043807983,
- 0.590488612651825,
- 0.6281570792198181,
- -0.1020033061504364,
- 0.12514355778694153,
- 0.26880502700805664,
- -0.06841706484556198,
- 0.07446050643920898,
- -0.19104579091072083,
- 0.17392556369304657,
- -0.010952293872833252,
- 0.8551027774810791,
- 0.8424614071846008,
- 0.4966377019882202,
- 0.9818977117538452,
- -0.7847625613212585,
- -0.3964613676071167,
- -0.7274291515350342,
- 0.9931104183197021,
- 0.990178644657135,
- 0.9477092027664185,
- -0.7309668660163879,
- -0.8255475759506226,
- -0.5082603693008423,
- -0.8930004835128784,
- 0.4194926917552948,
- 0.20234280824661255,
- 0.382354199886322,
- 0.04821555316448212,
- -0.22185000777244568,
- -0.2684493958950043,
- -0.2542339563369751,
- -0.6113150715827942,
- -0.749304473400116,
- 0.9967495203018188,
- 0.6226924657821655,
- 0.9509856700897217,
- 0.9614278674125671,
- -0.5285993218421936,
- -0.26093634963035583,
- -0.44633013010025024,
- -0.7162333726882935,
- 0.37243372201919556,
- 0.7037805914878845,
- 0.5981281399726868,
- 0.8595001101493835,
- -0.2422453761100769,
- -0.2717275023460388,
- -0.342314749956131,
- -0.36787569522857666,
- -0.0067490083165466785,
- -0.12062981724739075,
- -0.10932574421167374,
- 0.7730425596237183,
- 0.7197641730308533,
- 0.5498804450035095,
- 0.8838788866996765,
- -0.4682152271270752,
- -0.8429638743400574,
- -0.7152993083000183,
- 0.16587448120117188,
- 0.17635276913642883,
- 0.4282841980457306,
- -0.06333015114068985,
- 0.0034832851961255074,
- 0.09057462960481644,
- -0.7059872150421143,
- -0.3774401545524597,
- -0.6989597082138062,
- -0.5003755688667297,
- 0.7566817402839661,
- 0.44234010577201843,
- 0.45263102650642395,
- 0.5166338682174683,
- 0.16024252772331238,
- 0.5950716137886047,
- -0.18073487281799316,
- 0.0018878098344430327,
- -0.2708609104156494,
- -0.25196877121925354,
- -0.11142797023057938,
- -0.43370550870895386,
- -0.15656259655952454,
- -0.039399806410074234,
- 0.46687936782836914,
- 0.32242169976234436,
- 0.6205798983573914,
- 0.6568413972854614,
- 0.2932124137878418,
- 0.286562442779541,
- 0.5216072797775269,
- -0.9623097777366638,
- -0.9981469511985779,
- -0.6364484429359436,
- -0.9993236660957336,
- -0.07432012259960175,
- 0.42001017928123474,
- 0.34383609890937805,
- -0.08206897974014282,
- 0.17495545744895935,
- -0.6187282204627991,
- -0.17506438493728638,
- -0.16744637489318848,
- -0.3097870349884033,
- -0.4293544590473175,
- -0.34442025423049927,
- -0.08278083801269531,
- 0.040901072323322296,
- -0.20948979258537292,
- -0.8171733617782593,
- -0.6349214315414429,
- -0.63686603307724,
- -0.34542766213417053,
- 0.9818851351737976,
- 0.7231388688087463,
- -0.4980590343475342,
- -0.5276463031768799,
- -0.6645891070365906,
- 0.6138550639152527,
- 0.7307949662208557,
- 0.565581202507019,
- 0.8974766731262207,
- 0.2210589051246643,
- -0.04366305470466614,
- 0.2200208306312561,
- 0.9976720213890076,
- 0.9910743236541748,
- 0.04993176832795143,
- 0.2965986132621765,
- 0.3659362196922302,
- -0.6525683999061584,
- -0.4112653136253357,
- -0.9211462140083313,
- -0.8424838185310364,
- -0.9637735486030579,
- -0.9835269451141357,
- -0.9970294237136841,
- -0.9710226655006409,
- -0.9704429507255554,
- -0.000344896805472672,
- 0.21921929717063904,
- -0.13210053741931915,
- 0.1057116687297821,
- -0.5773980617523193,
- -0.8491992354393005,
- -0.9644528031349182,
- -0.9644528031349182,
- 0.18421055376529694,
- -0.34306600689888,
- -0.6099089980125427,
- -0.522908627986908,
- 0.5520397424697876,
- 0.6777611374855042,
- 0.7900189757347107,
- 0.8836524486541748,
- 0.998988151550293,
- 0.6972864270210266,
- 0.9325829744338989,
- -0.7420949339866638,
- -0.8717162013053894,
- 0.3239639103412628,
- 0.3646659553050995,
- 0.18762114644050598,
- 0.4323038160800934,
- 0.49042609333992004,
- 0.4172574579715729,
- -0.4056946337223053,
- -0.7565715909004211,
- -0.8770694732666016,
- -0.6713137626647949,
- 0.3914759159088135,
- 0.5560338497161865,
- 0.401335746049881,
- 0.6967827081680298,
- 0.5735718011856079,
- 0.9659417867660522,
- 0.4600377678871155,
- -0.7376769781112671,
- -0.7612969279289246,
- -0.8649499416351318,
- -0.9680713415145874,
- -0.07136695086956024,
- 0.08702337741851807,
- -0.0012019457062706351,
- -0.40912172198295593,
- -0.006982382852584124,
- -0.2469279021024704,
- 0.2634161114692688,
- 0.19823867082595825,
- 0.6264614462852478,
- -0.0895332545042038,
- 0.15487948060035706,
- 0.010749834589660168,
- 0.21317049860954285,
- 0.3579390347003937,
- 0.6785242557525635,
- 0.4390743672847748,
- 0.2672802209854126,
- -0.8758218884468079,
- -0.963442862033844,
- -0.9812936782836914,
- 0.47073882818222046,
- 0.4233376085758209,
- 0.6527111530303955,
- 0.6982703804969788,
- 0.6721965670585632,
- 0.9104544520378113,
- 0.8594658970832825,
- 0.9712696671485901,
- 0.7178391218185425,
- 0.9804772734642029,
- 0.9899379014968872,
- -0.272844135761261,
- -0.23376643657684326,
- -0.262163907289505,
- 0.03704443946480751,
- -0.4075758457183838,
- -0.7010478377342224,
- -0.20673303306102753,
- -0.5571584105491638,
- -0.8706849217414856,
- -0.48726165294647217,
- -0.2910931706428528,
- -0.002765015931800008,
- 0.05970108136534691,
- 0.3084672689437866,
- 0.15337669849395752,
- -0.6174674034118652,
- -0.6328142881393433,
- -0.5624826550483704,
- 0.1400715708732605,
- 0.3191937208175659,
- 0.02131892368197441,
- -0.09887219220399857,
- -0.13459566235542297,
- 0.031372569501399994,
- -0.23347316682338715,
- -0.1083475649356842,
- 0.10015857964754105,
- -0.15261906385421753,
- -0.3190996050834656,
- 0.5962103009223938,
- 0.944227933883667,
- 0.6263585686683655,
- -0.03721585124731064,
- -0.14064188301563263,
- -0.12287423759698868,
- 0.1620333045721054,
- 0.051118478178977966,
- 0.025942236185073853,
- 0.9509856700897217,
- 0.07660112529993057,
- -0.2148650735616684,
- -0.2792571783065796,
- -0.3916383981704712,
- -0.5475131869316101,
- -0.3573049306869507,
- -0.5381907820701599,
- 0.5642790794372559,
- 0.39763057231903076,
- 0.4926196038722992,
- 0.6876794695854187,
- 0.9853602051734924,
- 0.9853602051734924,
- 0.2784459888935089,
- 0.33439427614212036,
- 0.3757942020893097,
- 0.5680580735206604,
- -0.202531099319458,
- 0.04602264240384102,
- 0.1253708153963089,
- -0.053822703659534454,
- -0.09523261338472366,
- -0.3647562861442566,
- 0.055967457592487335,
- -0.18043585121631622,
- -0.36183372139930725,
- -0.26616132259368896,
- 0.5843426585197449,
- 0.7874525785446167,
- 0.3204408586025238,
- 0.46942922472953796,
- -0.3549381494522095,
- -0.15470989048480988,
- -0.28662583231925964,
- -0.45677778124809265,
- -0.14482297003269196,
- -0.3699699342250824,
- -0.31996339559555054,
- 0,
- 0.03902474418282509,
- -0.4207833707332611,
- 0.5997176170349121,
- 0.34521904587745667,
- 0.260562002658844,
- 0.301216721534729,
- -0.39678168296813965,
- -0.9933051466941833,
- -0.48806899785995483,
- -0.9801273941993713,
- -0.9932265877723694,
- -0.00268577691167593,
- -0.4860992431640625,
- -0.718903660774231,
- -0.22610677778720856,
- 0.40737977623939514,
- 0.7242735624313354,
- 0.9194390773773193,
- 0.992190957069397,
- 0.5167772769927979,
- -0.8444285988807678,
- -0.6822850704193115,
- 0.6697694063186646,
- 0.9455884695053101,
- -0.563209056854248,
- -0.6827536821365356,
- -0.6466551423072815,
- -1,
- 0.00808846578001976,
- -0.21341004967689514,
- -0.08499597012996674,
- -0.22998903691768646,
- -0.6067743301391602,
- -0.49108201265335083,
- -0.5265984535217285,
- -0.9826362729072571,
- -0.23542766273021698,
- -0.2631172835826874,
- -0.38973894715309143,
- -0.510794460773468,
- 0.614811897277832,
- 0.9284683465957642,
- 0.980880856513977,
- 0.6759928464889526,
- 0.7887943387031555,
- 0.334210067987442,
- 0.8685921430587769,
- 0.9433988928794861,
- 0.3017013370990753,
- 0.322925865650177,
- 0.0030513221863657236,
- -0.08400421589612961,
- 0.1492752730846405,
- 0.15100379288196564,
- 0.2531687021255493,
- 0.22673995792865753,
- 0.08318476378917694,
- -0.09412675350904465,
- -0.10312476009130478,
- 0.00051957240793854,
- 0.1938382387161255,
- -0.429431289434433,
- -0.6668448448181152,
- 0.27889484167099,
- -0.9699349999427795,
- -0.6830593347549438,
- -0.9178845286369324,
- -0.8040575385093689,
- -0.03522491827607155,
- 0.586391270160675,
- 0.9315357804298401,
- 0.7273709177970886,
- 0.23738005757331848,
- 0.16160446405410767,
- 0.196137934923172,
- 0.6648127436637878,
- 0.9904631972312927,
- 0.9321214556694031,
- -0.9826473593711853,
- -0.5793296098709106,
- -0.5139965415000916,
- -0.9829296469688416,
- 0.10490112006664276,
- 0.26333707571029663,
- 0.015549364499747753,
- 0.7950919270515442,
- -0.22844749689102173,
- 0.08410408347845078,
- -0.014554033055901527,
- -0.40973183512687683,
- -0.6088537573814392,
- -0.7200993895530701,
- -0.25975117087364197,
- -0.05376914516091347,
- 0.25696367025375366,
- -0.02727169543504715,
- -0.9200538992881775,
- -0.9851748943328857,
- 0.2039009928703308,
- -0.18674251437187195,
- -0.0373150035738945,
- 0.0003531149122864008,
- 0.7743528485298157,
- 0.49138516187667847,
- 0.8453116416931152,
- 0.8113861680030823,
- -0.2243531048297882,
- 0.17102263867855072,
- 0.13133029639720917,
- -0.8719936609268188,
- -0.7000458240509033,
- -0.5028141736984253,
- 0.5621294975280762,
- -0.48999398946762085,
- 1,
- 0.9576523303985596,
- -0.41538330912590027,
- -0.5296134352684021,
- -0.5272583365440369,
- 0.26668936014175415,
- 0.9760602116584778,
- 0.874788224697113,
- -0.8827227354049683,
- -0.9637153744697571,
- -0.5040878057479858,
- -0.27172648906707764,
- 0.274967223405838,
- -0.01066218875348568,
- 0.29421308636665344,
- 0.1539771407842636,
- 0.15297439694404602,
- 0.35023635625839233,
- -0.21796944737434387,
- 0.8537461161613464,
- 0.9835426211357117,
- 0.9496530294418335,
- 0.9985606074333191,
- -0.2221001833677292,
- 0.4310095012187958,
- 0.6029019355773926,
- 0.7001603841781616,
- 0.8360967636108398,
- 0.519031286239624,
- -0.9936496019363403,
- -0.9828091859817505,
- 0.26668936014175415,
- 0.5236851572990417,
- 0.49962037801742554,
- 0.5692272782325745,
- 0.22008033096790314,
- 0.2918113172054291,
- -0.005608721170574427,
- 0.03870052844285965,
- 0.26892536878585815,
- -0.1814487725496292,
- 0.06543553620576859,
- 0.08210965245962143,
- -0.09493392705917358,
- 0.23452402651309967,
- 0.04021294042468071,
- -0.09652941673994064,
- 0.6716895699501038,
- 0.8282829523086548,
- -0.5790790915489197,
- -0.7159784436225891,
- -0.874889612197876,
- -0.9411375522613525,
- -0.25209754705429077,
- -0.6056337356567383,
- -0.4996890425682068,
- 0.268974632024765,
- 0.4170511066913605,
- 0.2456361949443817,
- 0.17661170661449432,
- -0.6461558938026428,
- -0.8366621732711792,
- -0.9373155832290649,
- 0.6573933362960815,
- 0.764940083026886,
- 0.4581672251224518,
- 0.012059792876243591,
- -0.36481741070747375,
- 0.047285694628953934,
- -0.19150404632091522,
- -0.06492480635643005,
- 0.2849947214126587,
- 0.49767422676086426,
- 0.28277072310447693,
- 0.54390949010849,
- 0.1638433039188385,
- -0.31062552332878113,
- -0.08801092207431793,
- -0.47230759263038635,
- -0.2938145399093628,
- -0.0704847201704979,
- 0.6260424852371216,
- 0.39466437697410583,
- 0.31425905227661133,
- 0.7220942974090576,
- -0.7903173565864563,
- 0.2835279703140259,
- 0.6021785140037537,
- 0.5951641798019409,
- 0.3522506654262543,
- 0.5202761888504028,
- 0.6336329579353333,
- 0.44877156615257263,
- 0.5989428758621216,
- 0.9741127490997314,
- 0.9952908158302307,
- 0.6856418251991272,
- -0.18962796032428741,
- 0.14198823273181915,
- 0.027870045974850655,
- -0.2665543556213379,
- -0.12062981724739075,
- -0.35000452399253845,
- -0.6031556725502014,
- -0.7968862652778625,
- -0.9509775042533875,
- 0.2576938569545746,
- -0.17726917564868927,
- 0.9844260215759277,
- -0.4435259699821472,
- -0.1699523627758026,
- 0.6966899037361145,
- 0.9935153722763062,
- 0.994518518447876,
- 0.9067777991294861,
- -0.9979760646820068,
- -0.9827584624290466,
- -0.01198972761631012,
- 0.004887382499873638,
- 0.9262871146202087,
- -0.011220625601708889,
- 0.20926238596439362,
- 0.08175507932901382,
- 0.13949643075466156,
- 0.24324852228164673,
- 0.2432398945093155,
- -0.03161051869392395,
- 0.41032442450523376,
- 0.5218767523765564,
- -0.1977277398109436,
- 0.07446050643920898,
- -0.20594902336597443,
- -0.3251917064189911,
- -0.6149249076843262,
- 0.4732542634010315,
- 0.07446050643920898,
- 0.3481038212776184,
- 0.22188933193683624,
- 0.2149362415075302,
- -0.24006293714046478,
- -0.2876802384853363,
- 0.41702282428741455,
- 0.19047819077968597,
- -0.2501949965953827,
- -0.15160758793354034,
- 0.43379339575767517,
- 0.0909355953335762,
- 0.451621413230896,
- 0.5065004825592041,
- -0.9908729195594788,
- -0.08206022530794144,
- -0.027877792716026306,
- 0.5542229413986206,
- -0.38842886686325073,
- 0.9741654992103577,
- -0.3724351227283478,
- -0.1986246407032013,
- -0.3232215344905853,
- 0.7665350437164307,
- 0.5796975493431091,
- -0.6754114627838135,
- -0.8743530511856079,
- -0.8580234050750732,
- 0.7657902240753174,
- 0.6770547032356262,
- 0.5566800236701965,
- 0.935212254524231,
- -0.584112286567688,
- 0.017612561583518982,
- -0.36803585290908813,
- -0.5247402191162109,
- 0.4970661997795105,
- -0.6998907327651978,
- -0.5846438407897949,
- 0.9509856700897217,
- 0.8254937529563904,
- 0.6614059805870056,
- 0.5184406042098999,
- -0.5043556690216064,
- -0.8817981481552124,
- -0.6980621218681335,
- -0.3875381350517273,
- -0.9762217998504639,
- -0.9982428550720215,
- 0.2067089080810547,
- 0.11346746981143951,
- 0.01595616154372692,
- -0.2828061878681183,
- 0.014170551672577858,
- 0.6205798983573914,
- -0.8973569869995117,
- -0.7388009428977966,
- -0.5494065880775452,
- -0.8166348338127136,
- 0.5313565731048584,
- -0.004518178757280111,
- 0.48383238911628723,
- -0.4977671205997467,
- -0.11393170058727264,
- -0.1845625638961792,
- -0.3601009249687195,
- -0.314405232667923,
- 0.48286524415016174,
- 0.20714795589447021,
- 0.040663253515958786,
- -0.9531037211418152,
- -0.26953038573265076,
- -0.4040994942188263,
- -0.26528051495552063,
- 0.23274151980876923,
- -0.6318374872207642,
- -0.9665676951408386,
- 0.005913611501455307,
- 0.49386274814605713,
- 0.23279796540737152,
- 0.24144552648067474,
- 0.3414899408817291,
- 0.30328240990638733,
- -0.9941494464874268,
- -0.3179697096347809,
- -0.25289952754974365,
- -0.4826950430870056,
- -0.992070198059082,
- -0.9115789532661438,
- -0.5940829515457153,
- -0.5463100671768188,
- -0.9485341310501099,
- -0.6519872546195984,
- -0.9987034797668457,
- -0.5913269519805908,
- -0.7342608571052551,
- 1,
- 0.45685240626335144,
- -0.0836566612124443,
- -0.5427722334861755,
- -0.2221001833677292,
- -0.9979760646820068,
- -0.7426897883415222,
- 0.4536954462528229,
- -0.5354653596878052,
- -0.5605345368385315,
- -0.24477224051952362,
- -0.31265220046043396,
- -0.8582495450973511,
- -0.2184845358133316,
- -0.8255475759506226,
- -0.8973569869995117,
- -0.9509775042533875,
- 0.7109987735748291,
- -0.3486618995666504,
- -0.5666218400001526,
- 0.0820944681763649,
- 0.28015971183776855,
- -0.9690587520599365,
- -0.6733459830284119,
- -0.929873526096344,
- 0.05627104640007019,
- -0.5349896550178528,
- -0.49556639790534973,
- -0.2316868156194687,
- -0.2666398584842682,
- -0.5846438407897949,
- 0.9041470885276794,
- 0.34881946444511414,
- 0.73880535364151,
- -0.4977671205997467,
- -0.620514452457428,
- 0.3705782890319824,
- -0.3981460928916931,
- -0.7447241544723511,
- -0.5671089291572571,
- -0.7126420140266418,
- 0.3201524019241333,
- -0.9361801147460938,
- -0.021949056535959244,
- 0.26071488857269287,
- 0.11704500019550323,
- -0.09812191873788834,
- -0.6564890742301941,
- 0.5860076546669006,
- 0.23305492103099823,
- 0.1070864275097847,
- 0.02329915389418602,
- -0.2407625913619995,
- 0.3414646089076996,
- 0.6114945411682129,
- 0.0007608749438077211,
- -0.18877489864826202,
- -0.06473154574632645,
- -0.5393319725990295,
- -0.37636464834213257,
- -0.2776724100112915,
- 0.407381534576416,
- 0.5711175799369812,
- 0.10242214798927307,
- -0.5774988532066345,
- 0.5009621977806091,
- 0.7229906320571899,
- 0.5307389497756958,
- 0.8771102428436279,
- -0.6564419269561768,
- -0.41044551134109497,
- -0.6564419269561768,
- -0.7309668660163879,
- -0.9828091859817505,
- -0.9828091859817505,
- -0.31996339559555054,
- 0.02778959460556507,
- -0.18145851790905,
- -0.4760945737361908,
- -0.6159340143203735,
- -0.5961918830871582,
- -0.6848282217979431,
- -0.251895934343338,
- 0.29486724734306335,
- 0.40002304315567017,
- 0.9899379014968872,
- 0.7229412794113159,
- 0.9807852506637573,
- -0.7337335348129272,
- -0.8108888864517212,
- -0.5162743926048279,
- -0.6094732284545898,
- -0.9194790720939636,
- 0.5308945178985596,
- 0.01500244252383709,
- -0.7993972897529602,
- 0.9984241127967834,
- -0.012843931093811989,
- -0.8668404221534729,
- 0.990543007850647,
- 0.0920555591583252,
- -0.31916898488998413,
- 0.9374285340309143,
- 0.7959373593330383,
- 0.8754876255989075,
- -0.8362293243408203,
- -0.6582773923873901,
- -0.9916395545005798,
- -0.8973569869995117,
- 0.061656251549720764,
- 0.5361354351043701,
- 0.36971715092658997,
- -0.4583832919597626,
- -0.46862149238586426,
- -0.9807852506637573,
- -0.9511585831642151,
- -0.27999889850616455,
- 0.038460005074739456,
- 0.1938815712928772,
- 0.19310392439365387,
- 0.5270761847496033,
- 0.5389652252197266,
- -0.5263717770576477,
- 0.31121960282325745,
- 0.13053779304027557,
- 0.2712872624397278,
- 0.9807852506637573,
- -0.97075355052948,
- 0.9580817818641663,
- 0.7310782670974731,
- 0.5388161540031433,
- 0.9519411325454712,
- 0.8434329628944397,
- -0.4833066761493683,
- -0.20707954466342926,
- -0.5099445581436157,
- -0.6608012318611145,
- -0.018839603289961815,
- -0.7309668660163879,
- -0.5254232883453369,
- 0.3551715314388275,
- -0.21630725264549255,
- -0.39276570081710815,
- -0.07621423900127411,
- 0.02646898478269577,
- 0.3646659553050995,
- 0.8563774824142456,
- 0.5865227580070496,
- 0.46233615279197693,
- 0.8343841433525085,
- -0.8973569869995117,
- -0.5947028398513794,
- -0.8064454793930054,
- 0.570570170879364,
- 0.5161767601966858,
- 0.48175233602523804,
- 0.4885003864765167,
- -0.38643592596054077,
- -0.4773034155368805,
- -0.38785600662231445,
- 0.8576608896255493,
- -0.9899351596832275,
- 0.9875081777572632,
- -0.1636705994606018,
- -0.9172571897506714,
- -0.16427050530910492,
- -0.4349454939365387,
- -0.9953550100326538,
- -0.9971668124198914,
- 0.6962160468101501,
- 0.5453452467918396,
- -0.05568347126245499,
- -0.6601232290267944,
- -0.842789351940155,
- -0.2496166080236435,
- -0.8420789837837219,
- -0.8744059801101685,
- -0.834104597568512,
- -0.9026780724525452,
- 0.9523860216140747,
- 0.9934259653091431,
- -0.7173683643341064,
- -0.9974165558815002,
- 0.3086850345134735,
- -0.8398857116699219,
- -0.2520681619644165,
- -0.2881055772304535,
- -0.17640793323516846,
- -0.8340798020362854,
- 0.803859293460846,
- -0.5375675559043884,
- -0.35286054015159607,
- -0.40147092938423157,
- -0.5391048192977905,
- -0.4075758457183838,
- -0.06929513067007065,
- 0.4999752938747406,
- 0.5083998441696167,
- 0.7683452367782593,
- 0.44873738288879395,
- 0.1870150864124298,
- 0.44929590821266174,
- 0.7604588270187378,
- -0.253332257270813,
- 0.7990961074829102,
- -0.4588089883327484,
- -0.36481741070747375,
- -0.2928994297981262,
- -0.620514452457428,
- -0.8754743337631226,
- -0.6474624276161194,
- -0.7147241830825806,
- -0.8206048011779785,
- 0.8667620420455933,
- 0.8917268514633179,
- 0.9518074989318848,
- -0.5455569624900818,
- 0.06518997251987457,
- -0.1746850311756134,
- 0.711083710193634,
- -0.7957763075828552,
- -0.23037903010845184,
- 0.4979412853717804,
- -0.9531556367874146,
- -0.9841888546943665,
- 0.04183444380760193,
- 0.8254937529563904,
- 0.9814017415046692,
- -0.5506122708320618,
- 0.9509856700897217,
- 0.8974766731262207,
- 0.8271036744117737,
- 0.6565945744514465,
- 0.5882179737091064,
- 0.4074084758758545,
- 0.1779918372631073,
- 0.8254937529563904,
- 0.3646659553050995,
- 0.6998251676559448,
- -0.25461456179618835,
- -0.16163697838783264,
- 0.5031144618988037,
- 0.056570108979940414,
- 0.4599801003932953,
- 0.22676178812980652,
- -0.27921000123023987,
- -0.5993555784225464,
- 0.9872598648071289,
- -0.1492013782262802,
- -0.11010982096195221,
- 0.08578278124332428,
- -0.176510289311409,
- 0.12077020108699799,
- -0.08411595970392227,
- 0.9915391802787781,
- 0.7307949662208557,
- 0.8754876255989075,
- -0.2441762387752533,
- -0.14552778005599976,
- -0.2168065309524536,
- -0.4977671205997467,
- 0.6998251676559448,
- 0.5844343304634094,
- -0.4977671205997467,
- -0.5964337587356567,
- 0.16315852105617523,
- 0.7636315226554871,
- 0.265627384185791,
- 0.9430791139602661,
- 0.6161730289459229,
- 0.9977315664291382,
- 0.9039280414581299,
- -0.06703191250562668,
- 0.4994438886642456,
- 0.4858933091163635,
- 0.9834839701652527,
- 0.880670964717865,
- 0.8490715026855469,
- 0.9645264744758606,
- -0.9836878776550293,
- 0.020235415548086166,
- 0.6966110467910767,
- 0.9339800477027893,
- 0.5601944327354431,
- -0.00601609330624342,
- 0.22188933193683624,
- 0.06982731819152832,
- 0.42058631777763367,
- -0.20701900124549866,
- -0.5002540349960327,
- -0.9948720335960388,
- -0.6225435733795166,
- 0.29936158657073975,
- -0.9993430376052856,
- -0.8705465197563171,
- 0.9978688955307007,
- 0.9816693663597107,
- -0.2221001833677292,
- -0.07432012259960175,
- 0.005510379560291767,
- 0.93561190366745,
- 0.769040584564209,
- 0.4979412853717804,
- 0.09552592039108276,
- -0.4952143132686615,
- 0.8628236055374146,
- 0.891992449760437,
- 0.3251786231994629,
- -0.9622695446014404,
- -0.9051315188407898,
- 0.6972473859786987,
- -0.9227719902992249,
- -0.9991018772125244,
- 0.9954250454902649,
- -0.2867448031902313,
- 0.40268635749816895,
- 0.14126500487327576,
- 0.9529435634613037,
- 0.6507450938224792,
- 0.27342158555984497,
- -0.9639715552330017,
- -0.971455454826355,
- 0.9434934258460999,
- 0.7417119145393372,
- 0.922407329082489,
- 0.7960216403007507,
- 0.39301806688308716,
- 0.44151046872138977,
- 0.9164034128189087,
- -0.45337846875190735,
- -0.7604051232337952,
- -0.9881238341331482,
- 0.3329641819000244,
- 0.5564926266670227,
- -0.7899213433265686,
- 0.7021987438201904,
- -0.9409090876579285,
- 0.8222968578338623,
- -0.1262354850769043,
- 0.9899379014968872,
- 0.8101232051849365,
- 0.4139884412288666,
- 0.4850161373615265,
- 0.8455127477645874,
- -0.7117887139320374,
- -0.9599732160568237,
- 0.32545220851898193,
- -0.017274606972932816,
- 0.0917535200715065,
- 0.9274268746376038,
- 0.7069732546806335
- ],
- "z": [
- 0.24893133342266083,
- 0.06961314380168915,
- 0.38458311557769775,
- 0.045085154473781586,
- -0.2524856626987457,
- -0.6164182424545288,
- -0.4557993710041046,
- -0.09390309453010559,
- -0.6660021543502808,
- -0.5890951156616211,
- -0.9959505200386047,
- -0.6060599088668823,
- -0.298443466424942,
- -0.4645257592201233,
- -0.23048292100429535,
- -0.21867342293262482,
- -0.31317806243896484,
- 0.07732536643743515,
- -0.3414348065853119,
- -0.05248579755425453,
- -0.10382933914661407,
- -0.019813725724816322,
- 0.2175561636686325,
- 0.13014905154705048,
- 0.40530869364738464,
- 0.7156205773353577,
- 0.7926167249679565,
- 0.4570474326610565,
- -0.13187628984451294,
- 0.12653519213199615,
- -0.22819986939430237,
- -0.3281902074813843,
- 0.28013405203819275,
- 0.6267420649528503,
- 0.39846572279930115,
- 0.3510749340057373,
- -0.33739176392555237,
- -0.18817365169525146,
- -0.24846261739730835,
- -0.5050169229507446,
- -0.5259588956832886,
- -0.26771974563598633,
- -0.446445107460022,
- -0.248659148812294,
- 0.24804984033107758,
- 0.18279309570789337,
- 0.03786000609397888,
- -0.07831154018640518,
- -0.20537401735782623,
- 0.22865191102027893,
- 0.03590712696313858,
- 0.0510106198489666,
- -0.5112490653991699,
- -0.4819660484790802,
- -0.5647855401039124,
- -0.9934210777282715,
- -0.9370624423027039,
- -0.3811916410923004,
- -0.5316653251647949,
- -0.5263366103172302,
- -0.7243698835372925,
- -0.8403451442718506,
- -0.5899010300636292,
- -0.9501896500587463,
- -0.9997191429138184,
- 0.3994015157222748,
- 0.5550714731216431,
- 0.1366790235042572,
- 0.33598801493644714,
- 0.49225300550460815,
- 0.6483957171440125,
- 0.3165377676486969,
- 0.05070596933364868,
- 0.3658945858478546,
- 0.07349245995283127,
- 0.02135220356285572,
- 0.9899535775184631,
- 0.6588714122772217,
- 0.9584241509437561,
- 0.7039474248886108,
- 0.9926663041114807,
- 0.5769069790840149,
- 0.6764622330665588,
- 0.998921275138855,
- 0.5113556385040283,
- 0.5350059866905212,
- 0.4005412459373474,
- 0.18379539251327515,
- -0.6124829649925232,
- -0.916515052318573,
- -0.6823439002037048,
- 0.06995134800672531,
- -0.09971776604652405,
- 0.30412760376930237,
- -0.678033173084259,
- -0.5627862811088562,
- -0.42405495047569275,
- -0.4404540956020355,
- -0.22640195488929749,
- -0.2587750554084778,
- -0.5708564519882202,
- -0.5173807144165039,
- -0.9726678133010864,
- -0.6065524220466614,
- -0.9628442525863647,
- -0.060457516461610794,
- 0.07383366674184799,
- 0.033002905547618866,
- -0.26771634817123413,
- -0.29332637786865234,
- -0.2589031755924225,
- 0.4012563228607178,
- 0.6697467565536499,
- 0.37911468744277954,
- 0.6959860324859619,
- -0.3439806401729584,
- -0.709836483001709,
- -0.36161622405052185,
- -0.5031288266181946,
- -0.37700721621513367,
- -0.027168434113264084,
- 0.1186046227812767,
- 0.9283714294433594,
- 0.6873116493225098,
- 0.9881190061569214,
- 0.9892323613166809,
- 0.6267638206481934,
- 0.6916837096214294,
- 0.3116864562034607,
- 0.45751941204071045,
- -0.30098357796669006,
- -0.5340659618377686,
- -0.070583276450634,
- 0.9836627840995789,
- 0.9826307892799377,
- 0.2885918915271759,
- 0.23875781893730164,
- -0.0010253038490191102,
- -0.01305148471146822,
- -0.7080255746841431,
- -0.5416524410247803,
- -0.7137928605079651,
- -0.8609718084335327,
- -0.6466995477676392,
- -0.22543102502822876,
- -0.46304792165756226,
- 0.40055951476097107,
- 0.5511629581451416,
- 0.4643996059894562,
- -0.24696844816207886,
- 0.0023746946826577187,
- -0.121971994638443,
- 0.09900698065757751,
- 0.24953289330005646,
- 0.22445939481258392,
- 0.10599268972873688,
- -0.02011456899344921,
- 0.4988115429878235,
- 0.9421597123146057,
- 0.7781175374984741,
- 0.7483584880828857,
- -0.9510202407836914,
- -0.5498870611190796,
- -0.8496232032775879,
- -0.25599583983421326,
- -0.018814457580447197,
- 0.0450722798705101,
- 0.006867034826427698,
- 0.9926801323890686,
- -0.33451950550079346,
- -0.6014363765716553,
- -0.3249167501926422,
- -0.42981573939323425,
- -0.7796371579170227,
- -0.6329610347747803,
- -0.9835079908370972,
- -0.9459924101829529,
- -0.5039926767349243,
- -0.4338308274745941,
- -0.25865885615348816,
- -0.6047350168228149,
- -0.20979124307632446,
- 0.5729902386665344,
- 0.7663477659225464,
- 0.29461243748664856,
- 0.5809187293052673,
- -0.18392319977283478,
- 0.020668039098381996,
- -0.27200955152511597,
- 0.03924412652850151,
- 0.0195060633122921,
- 0.3324436545372009,
- 0.6782426834106445,
- 0.17382746934890747,
- 0.4320796728134155,
- 0.20146599411964417,
- 0.37333109974861145,
- 0.5286331176757812,
- -0.02363656461238861,
- -0.0906238928437233,
- 0.5550857782363892,
- 0.5451454520225525,
- 0.5945549011230469,
- -0.7518652677536011,
- -0.5248426795005798,
- -0.387797087430954,
- -0.5349641442298889,
- -0.25117042660713196,
- 0.1672535389661789,
- -0.030160700902342796,
- 0.2272733896970749,
- 0.22918443381786346,
- 0.0007958645583130419,
- -0.47246626019477844,
- -0.26326435804367065,
- -0.2667330503463745,
- 0.2950707972049713,
- 0.5224003791809082,
- 0.24893133342266083,
- 0.24893133342266083,
- -0.3438313901424408,
- 0.2669813930988312,
- -0.05906572937965393,
- 0.3875717222690582,
- 0.2657814919948578,
- 0.7311900854110718,
- 0.6060779690742493,
- 0.45794302225112915,
- -0.010273333638906479,
- 0.1575591117143631,
- 0.3539920449256897,
- -0.6644736528396606,
- -0.48027414083480835,
- -0.9416919350624084,
- 0.9293450713157654,
- 0.4946977198123932,
- 0.5810832977294922,
- 0.8662898540496826,
- 0.9053993225097656,
- 0.5155513882637024,
- 0.6468337774276733,
- 0.4702588617801666,
- 0.11277738958597183,
- -0.048379454761743546,
- -0.2031347006559372,
- -0.4603961706161499,
- -0.1806602030992508,
- 0.10649269074201584,
- 0.24402277171611786,
- 0.22087182104587555,
- 0.6698569059371948,
- 0.6410759091377258,
- 0.4929329752922058,
- 0.23700262606143951,
- -0.37436285614967346,
- -0.2582411468029022,
- 0.000663433806039393,
- -0.9097479581832886,
- -0.6664299368858337,
- -0.9650605320930481,
- 0.4332942068576813,
- 0.19210495054721832,
- 0.2930695116519928,
- 0.23533089458942413,
- 0.6286520957946777,
- 0.6442918181419373,
- 0.34618571400642395,
- -0.006241363473236561,
- 0.1833106428384781,
- 0.29168185591697693,
- -0.002174111781641841,
- 0.47259294986724854,
- 0.25226056575775146,
- 0.1899283230304718,
- 0.1295872926712036,
- -0.14776815474033356,
- -0.007787336595356464,
- 0.1263086497783661,
- 0.15495635569095612,
- 0.40780001878738403,
- 0.5031928420066833,
- 0.22645917534828186,
- 0.04210563376545906,
- 0.1961057186126709,
- -0.10216209292411804,
- 0.28054866194725037,
- 0.4921416640281677,
- 0.18888798356056213,
- 0.29682838916778564,
- 0.9105742573738098,
- 0.7120792269706726,
- 0.46320977807044983,
- 0.830166220664978,
- 0.48220357298851013,
- -0.8679813146591187,
- -0.9516631364822388,
- 0.47452154755592346,
- 0.7259277701377869,
- 0.6084266901016235,
- 0.9848937392234802,
- -0.23830050230026245,
- -0.76807701587677,
- -0.44848307967185974,
- -0.24442195892333984,
- 0.0057609472423791885,
- 0.04943608120083809,
- -0.038206059485673904,
- -0.20376498997211456,
- -0.33428671956062317,
- -0.4373824894428253,
- -0.42244595289230347,
- -0.6520264744758606,
- -0.36086952686309814,
- -0.6188114285469055,
- 0.1818607598543167,
- -0.31560376286506653,
- -0.2107848972082138,
- -0.6734336614608765,
- 0.9861479997634888,
- 0.9878979325294495,
- 0.9840410947799683,
- 0.34084373712539673,
- -0.6104958653450012,
- 0.29332637786865234,
- 0.6329606175422668,
- 0.4734562635421753,
- 0.6387461423873901,
- 0.9190930128097534,
- -0.34333351254463196,
- -0.19907696545124054,
- -0.007516813464462757,
- 0.35606294870376587,
- 0.5664986968040466,
- 0.2380324900150299,
- 0.02087165042757988,
- 0.1486402451992035,
- -0.1486402451992035,
- -0.5884139537811279,
- -0.24894261360168457,
- -0.5900663137435913,
- -0.4645562767982483,
- 0.22966508567333221,
- 0.30052053928375244,
- 0.25223761796951294,
- 0.4725068509578705,
- 0.9906204342842102,
- 0.53376704454422,
- 0.5839667320251465,
- 0.9822286367416382,
- -0.5414755940437317,
- -0.959226131439209,
- -0.8078566789627075,
- -0.6092051267623901,
- -0.634707510471344,
- -0.5340558290481567,
- 0.20579388737678528,
- 0.5619252324104309,
- 0.020743170753121376,
- -0.8842752575874329,
- -0.9857361912727356,
- -0.5279218554496765,
- -0.9429054260253906,
- 0,
- -0.4684806168079376,
- -0.21044278144836426,
- -0.7952387928962708,
- -0.9352442026138306,
- -0.9609246850013733,
- -0.4732184112071991,
- 0.23765499889850616,
- -0.0679740384221077,
- -0.14824911952018738,
- 0.19725912809371948,
- -0.06877187639474869,
- -0.07851611077785492,
- 0.8686026334762573,
- 0.6927322745323181,
- 0.6234987378120422,
- 0.5488587021827698,
- -0.19145558774471283,
- -0.3909909725189209,
- -0.07928632199764252,
- -0.3109854459762573,
- 0.5313256978988647,
- 0.03555777668952942,
- 0.0490003265440464,
- 0.31111860275268555,
- 0.10442136228084564,
- 0.17511685192584991,
- -0.11836609244346619,
- 0,
- -0.01821127161383629,
- -0.3708040714263916,
- -0.2981916069984436,
- -0.46162664890289307,
- -0.1726837307214737,
- -0.123359814286232,
- 0.4126456081867218,
- 0.17629684507846832,
- 0.43020865321159363,
- -0.16406390070915222,
- -0.29134809970855713,
- -0.3465260863304138,
- -0.1638673096895218,
- -0.36755621433258057,
- -0.19412018358707428,
- -0.2797713577747345,
- 0.6075701713562012,
- 0.654580295085907,
- -0.4861188530921936,
- -0.31833672523498535,
- -0.5780981779098511,
- -0.6000235080718994,
- -0.004480898380279541,
- 0.06860040128231049,
- -0.24482126533985138,
- 0.28688132762908936,
- -0.9631673693656921,
- -0.971184492111206,
- -0.5911328792572021,
- -0.9907293319702148,
- 0.5847785472869873,
- 0.9999487996101379,
- 0.5352766513824463,
- -0.8988922834396362,
- -0.7401489019393921,
- 0.9553634524345398,
- -0.23085886240005493,
- -0.11746350675821304,
- -0.3938993215560913,
- -0.5889719724655151,
- -0.2792058289051056,
- -0.3732108473777771,
- -0.3574441075325012,
- -0.6824148297309875,
- -0.22026440501213074,
- -0.5700737833976746,
- -0.5176344513893127,
- 0.12050525844097137,
- -0.09682867676019669,
- -0.35551348328590393,
- -0.17618408799171448,
- -0.2755252420902252,
- 0.04571164771914482,
- -0.17331843078136444,
- -0.9896681308746338,
- -0.6911693215370178,
- -0.5965977907180786,
- -0.5998966097831726,
- -0.9706664681434631,
- -0.9917164444923401,
- -0.6897068619728088,
- -0.9094218611717224,
- 0.78774094581604,
- 0.6912752389907837,
- 0.0785423144698143,
- 0.016106540337204933,
- -0.22879524528980255,
- 0.013991397805511951,
- -0.38984066247940063,
- -0.15052154660224915,
- -0.5829851031303406,
- -0.23330901563167572,
- 0.059916771948337555,
- 0.0003111835103482008,
- 0.6251672506332397,
- 0.31113284826278687,
- 0.5296736359596252,
- -0.5800420045852661,
- 0.5752048492431641,
- 0.6355389952659607,
- 0.25313037633895874,
- -0.47975510358810425,
- -0.7129015326499939,
- 0.2674548923969269,
- -0.20113208889961243,
- 0.3797936737537384,
- 1.1691379777549558e-15,
- -0.2713494598865509,
- 0.40313920378685,
- 0.845343828201294,
- 0.39367449283599854,
- -0.9590659737586975,
- -0.2106667459011078,
- -0.47452685236930847,
- -0.4596824049949646,
- -0.25136223435401917,
- 0.15601640939712524,
- 0.08271649479866028,
- 0.9565548896789551,
- 0.7303852438926697,
- 0.6288405656814575,
- 0.9848345518112183,
- -0.09036430716514587,
- -0.42064154148101807,
- -0.9738449454307556,
- -0.5138938426971436,
- -0.16709473729133606,
- -0.2977195680141449,
- 0.014614290557801723,
- 0.9725919365882874,
- -0.593136191368103,
- 0.7926254868507385,
- 0.7128075361251831,
- 0.5469134449958801,
- 0.4639262855052948,
- -0.06447644531726837,
- 0.17454104125499725,
- -0.9590659737586975,
- -0.8485125303268433,
- -0.8613754510879517,
- -0.8202615976333618,
- -0.9732046723365784,
- -0.44705015420913696,
- -0.9994475841522217,
- -0.7387363910675049,
- -0.9583876729011536,
- 0.5713192224502563,
- 0.6820598244667053,
- 0.6784961819648743,
- 0.9906498193740845,
- -0.9688231945037842,
- -0.6363033056259155,
- -0.9904927015304565,
- -0.09575266391038895,
- -0.5594531893730164,
- 0.3919374942779541,
- 0.6962965726852417,
- 0.4743371605873108,
- 0.32579144835472107,
- -0.036251384764909744,
- 0.30545035004615784,
- -0.3993871510028839,
- -0.16404372453689575,
- -0.05687348172068596,
- 0.06529530882835388,
- -0.2403002232313156,
- -0.21965867280960083,
- -0.5458555817604065,
- -0.33839061856269836,
- -0.7479055523872375,
- -0.6366367340087891,
- -0.8835325837135315,
- -0.998812198638916,
- 0.9292991161346436,
- 0.5906811952590942,
- 0.1568344235420227,
- 0.329791784286499,
- 0.6214436292648315,
- 0.8624156713485718,
- 0.9541876912117004,
- 0.8377023935317993,
- 0.16098438203334808,
- 0.5198801755905151,
- 0.4614923894405365,
- 0.4828778803348541,
- -0.4090541899204254,
- -0.6571433544158936,
- 0.7736345529556274,
- 0.9174755811691284,
- 0.5050711035728455,
- 0.6888444423675537,
- -0.6057143807411194,
- 0.9539580345153809,
- 0.7932191491127014,
- 0.3558451235294342,
- -0.294318825006485,
- -0.43747037649154663,
- -0.2859049141407013,
- -0.5471164584159851,
- 0.3661544919013977,
- 0.21708662807941437,
- 0.047813039273023605,
- -0.10936380922794342,
- -0.9813233017921448,
- 0.6716124415397644,
- 0.9972550272941589,
- 0.9591069221496582,
- 0.9881190061569214,
- -0.5873571634292603,
- -0.7924172282218933,
- -0.597710132598877,
- -0.2933533787727356,
- 0.6591892242431641,
- 0.982540488243103,
- 0.15812546014785767,
- 0.5574328303337097,
- 0.3088320791721344,
- -0.15484392642974854,
- 0.06583964824676514,
- 0.0556543804705143,
- -0.41467854380607605,
- -0.020549282431602478,
- -0.17505614459514618,
- -0.6844256520271301,
- -0.14388316869735718,
- 0.37474673986434937,
- -0.9988948702812195,
- -0.18562301993370056,
- 0.21414516866207123,
- 0.1545124351978302,
- -0.0718170553445816,
- 0.09742579609155655,
- 0.2770216763019562,
- -0.1361367404460907,
- 0.23760713636875153,
- -0.979985237121582,
- -0.9926663041114807,
- -0.9774913191795349,
- -0.16620796918869019,
- 0.3408176600933075,
- -0.8754684329032898,
- -0.9926663041114807,
- -0.9343691468238831,
- -0.9726558923721313,
- 0.3258844017982483,
- -0.6285980939865112,
- -0.9526984095573425,
- 0.5530601739883423,
- 0.4029441475868225,
- -0.15432234108448029,
- -0.25908252596855164,
- 0.4096115529537201,
- 0.43439316749572754,
- -0.8870314359664917,
- -0.41186952590942383,
- 0.09266889840364456,
- 0.2557157576084137,
- 0.6775721907615662,
- -0.4413914978504181,
- 0.13172948360443115,
- 0.21691279113292694,
- -0.9269883036613464,
- 0.30631664395332336,
- 0.21891158819198608,
- -0.6346932053565979,
- -0.3447767496109009,
- 0.130438894033432,
- 0.47534096240997314,
- 0.5058916211128235,
- -0.6356008052825928,
- -0.24553059041500092,
- -0.17978045344352722,
- -0.34532439708709717,
- -0.2420850694179535,
- -0.4619636535644531,
- -0.4826432168483734,
- 0.5221319198608398,
- 0.029748890548944473,
- -0.7130288481712341,
- -0.8076095581054688,
- 0.29332637786865234,
- 0.5628518462181091,
- 0.06730208545923233,
- 0.4723880887031555,
- -0.12552547454833984,
- -0.4614121615886688,
- 0.08412102609872818,
- -0.13070812821388245,
- -0.2101341336965561,
- 0.01784065179526806,
- 0.9772608280181885,
- 0.9888244271278381,
- 0.998428463935852,
- 0.9541769623756409,
- 0.9986042976379395,
- -0.7781175374984741,
- 0.43230360746383667,
- 0.6684873104095459,
- 0.2304299771785736,
- -0.5736464858055115,
- -0.844412088394165,
- 0.00047851071576587856,
- -0.8698142766952515,
- -0.8623660206794739,
- -0.6524214744567871,
- 0.4876599907875061,
- 0.41059526801109314,
- 0.11519432067871094,
- 0.027569491416215897,
- -0.18464042246341705,
- 0.07333831489086151,
- -0.28634411096572876,
- -0.628840982913971,
- -0.4625285863876343,
- -0.7084884643554688,
- 0.13881811499595642,
- 0.013083233498036861,
- -0.2419593632221222,
- -0.9994175434112549,
- -0.8644529581069946,
- -0.969346821308136,
- 0.6237660050392151,
- 0.3980129659175873,
- 0.07845746725797653,
- 0.059401463717222214,
- 0.9435102343559265,
- 0.6205036044120789,
- 0.8704222440719604,
- 0.0805128887295723,
- 0.40569618344306946,
- 0.7998630404472351,
- -0.15637905895709991,
- -0.30140817165374756,
- -0.10545636713504791,
- 0.013164041563868523,
- -0.8021248579025269,
- -0.674019455909729,
- 1.1381953347961641e-15,
- 0.8842353820800781,
- 0.70960932970047,
- 0.8383103013038635,
- 0.9725919365882874,
- -0.020549282431602478,
- 0.6637487411499023,
- -0.4817539155483246,
- 0.842215895652771,
- 0.827395498752594,
- 0.5711965560913086,
- 0.9451232552528381,
- -0.505468487739563,
- -0.5622516870498657,
- 0.5627862811088562,
- 0.43230360746383667,
- 0.2933533787727356,
- -0.7023643851280212,
- 0.5701262354850769,
- 0.32938721776008606,
- -0.9919143915176392,
- -0.9549797773361206,
- 0.23374751210212708,
- 0.026159776374697685,
- -0.36292386054992676,
- 0.9944577813148499,
- 0.021349981427192688,
- -0.4515495300292969,
- -0.0596543550491333,
- -0.054855652153491974,
- -0.8076095581054688,
- -0.4196002781391144,
- -0.4410720765590668,
- -0.6684819459915161,
- 0.8623660206794739,
- 0.7781712412834167,
- -0.4617902934551239,
- 0.9156145453453064,
- 0.6612699031829834,
- 0.8220000267028809,
- 0.7003620862960815,
- 0.9428480863571167,
- 0.3421337604522705,
- 0.009491427801549435,
- -0.024708475917577744,
- -0.243136465549469,
- -0.6658512353897095,
- 0.05885906517505646,
- -0.12039002776145935,
- -0.9692688584327698,
- -0.9894528985023499,
- -0.712857186794281,
- 0.9669307470321655,
- 0.9363831281661987,
- 0.7855737209320068,
- 0.0020480032544583082,
- 0.48156502842903137,
- 0.23229436576366425,
- 0.2777603268623352,
- 0.9257963299751282,
- 0.6556273102760315,
- -0.9106780886650085,
- -0.3095446527004242,
- 0.9899122714996338,
- -0.8134732842445374,
- 0.8606582283973694,
- 0.6877522468566895,
- 0.4117426872253418,
- 0.4701825976371765,
- 0.7486863732337952,
- 0.544661283493042,
- 0.7486863732337952,
- 0.678033173084259,
- 0.17454104125499725,
- -0.17454104125499725,
- -0.9429054260253906,
- -0.9972629547119141,
- -0.7024728059768677,
- 0.484409362077713,
- -0.7819303274154663,
- -0.7981323003768921,
- -0.7253903150558472,
- -0.28735053539276123,
- 0.36599305272102356,
- -0.9146113395690918,
- -0.10216209292411804,
- 0.01893974095582962,
- 0.19509032368659973,
- -0.6746619939804077,
- -0.580647885799408,
- -0.8524736762046814,
- -0.38539648056030273,
- 0.3909161388874054,
- 0.8446590304374695,
- -0.9985224008560181,
- 0.5946504473686218,
- -0.01600003056228161,
- 0.40821167826652527,
- 0.48939603567123413,
- -0.09601835906505585,
- -0.9909332990646362,
- -0.5974749326705933,
- 0.33801841735839844,
- 0.5988664031028748,
- 0.47321829199790955,
- 0.5466654896736145,
- -0.08516772836446762,
- -0.08488517999649048,
- -0.43230360746383667,
- -0.9939273595809937,
- -0.8418577313423157,
- 0.37960660457611084,
- 0.3056824207305908,
- -0.3595028221607208,
- -0.19509032368659973,
- -0.29275640845298767,
- -0.9550285339355469,
- 0.9962120056152344,
- 0.9809043407440186,
- 0.6006340980529785,
- 0.8467000126838684,
- -0.8403451442718506,
- -0.8470764756202698,
- 0.2801212966442108,
- -0.9871431589126587,
- 0.08321216702461243,
- 0.19509032368659973,
- 0.22816050052642822,
- -0.2699337899684906,
- -0.6778974533081055,
- -0.8404248356819153,
- 0.2901766896247864,
- 0.5331884622573853,
- 0.44227609038352966,
- 0.9771484136581421,
- 0.8558570742607117,
- -0.7451087236404419,
- 0.9981444478034973,
- -0.678033173084259,
- -0.8475834727287292,
- 0.3360883593559265,
- 0.9743492007255554,
- -0.282871812582016,
- -0.22345055639743805,
- 0.3189956545829773,
- -0.9293450713157654,
- 0.5089709162712097,
- 0.8060675263404846,
- 0.8813042640686035,
- -0.5501174926757812,
- 0.43230360746383667,
- 0.399971067905426,
- 0.5860621929168701,
- -0.8191595077514648,
- 0.8525258898735046,
- 0.4839176535606384,
- 0.43716105818748474,
- 0.44707098603248596,
- -0.004523725248873234,
- -0.0728132501244545,
- -0.5065698027610779,
- 0.10219016671180725,
- 0.12683188915252686,
- 0.46737194061279297,
- -0.39507293701171875,
- 0.14336158335208893,
- 0.5697399377822876,
- -0.04716167598962784,
- -0.02876582369208336,
- 0.716044545173645,
- 0.8369349837303162,
- -0.3292773365974426,
- 0.7456651926040649,
- 0.5343924760818481,
- -0.9642449021339417,
- -0.535721480846405,
- -0.4752419590950012,
- 0.5506404638290405,
- 0.42234858870506287,
- 0.2887100875377655,
- -0.06674723327159882,
- 0.6946030259132385,
- 0.02623007260262966,
- 0.946326732635498,
- -0.5398248434066772,
- -0.9635012149810791,
- -0.9525694251060486,
- -0.5915231704711914,
- -0.5506868362426758,
- 0.5892135500907898,
- -0.8410922288894653,
- -0.9329262375831604,
- -0.9138374328613281,
- 0.8402705788612366,
- 0.9105742573738098,
- -0.9931750297546387,
- -0.4777680039405823,
- -0.8566827178001404,
- -0.6324874758720398,
- 0.8885729312896729,
- 0.9815806150436401,
- -0.13777193427085876,
- -0.6420971155166626,
- -0.5806383490562439,
- 0.5950174927711487,
- -0.8831895589828491,
- -0.9292991161346436,
- -0.515745222568512,
- -0.7781712412834167,
- -0.47324317693710327,
- 0.7560555934906006,
- -0.6978248953819275,
- 0.5688090324401855,
- 0.48954278230667114,
- -0.4428369104862213,
- -0.2906172573566437,
- -0.8368217945098877,
- -0.9935793280601501,
- 0.982795000076294,
- -0.7022608518600464,
- -0.5990626811981201,
- 0.4099653661251068,
- 0.8622729182243347,
- -0.286173015832901,
- 0.16053339838981628,
- 0.6610923409461975,
- 0.5628518462181091,
- 0.18883104622364044,
- 0.8341196775436401,
- -0.29332637786865234,
- -0.4320796728134155,
- -0.5608901381492615,
- -0.7485610842704773,
- -0.06010530889034271,
- 0.21931923925876617,
- -0.22103886306285858,
- -0.5628518462181091,
- 0.9293450713157654,
- 0.7130826711654663,
- 0.9627287983894348,
- 0.9840801358222961,
- -0.8595077991485596,
- 0.31655168533325195,
- 0.882563591003418,
- 0.971177875995636,
- -0.9552678465843201,
- 0.7955359220504761,
- -0.12935291230678558,
- 0.9853049516677856,
- -0.33821555972099304,
- 0.9915511608123779,
- -0.9826152324676514,
- -0.9881051778793335,
- 0.9917153120040894,
- 0.08590389788150787,
- -0.6782426834106445,
- 0.47321829199790955,
- -0.17458701133728027,
- -0.445766419172287,
- -0.648909866809845,
- -0.8623660206794739,
- 0.7130826711654663,
- 0.807781457901001,
- 0.8623660206794739,
- -0.31360378861427307,
- 0.9839302897453308,
- 0.6382311582565308,
- -0.9593880772590637,
- 0.3193909227848053,
- -0.7817341685295105,
- 0.023031573742628098,
- -0.4200100302696228,
- 0.9933979511260986,
- -0.8614697456359863,
- -0.8687127232551575,
- 0.16769032180309296,
- 0.46352097392082214,
- -0.5226393938064575,
- -0.24868835508823395,
- 0.16562004387378693,
- 0.3897646963596344,
- 0.7157204151153564,
- 0.3493865430355072,
- -0.8276746273040771,
- -0.9994074702262878,
- 0.9726558923721313,
- -0.2598225772380829,
- 0.9036200046539307,
- 0.9771667718887329,
- 0.8610367178916931,
- -0.05206523463129997,
- 0.20172397792339325,
- -0.9491549134254456,
- 0.006670048926025629,
- 0.48246243596076965,
- 0.02163754589855671,
- 0.1861138790845871,
- -0.9725919365882874,
- -0.9926801323890686,
- -0.9994572997093201,
- 0.34400707483291626,
- 0.6316402554512024,
- -0.8622729182243347,
- 0.6931447386741638,
- 0.8637305498123169,
- -0.49691101908683777,
- 0.4423399865627289,
- 0.9413233995437622,
- 0.2561284601688385,
- 0.4177584648132324,
- -0.7151981592178345,
- 0.3847554624080658,
- 0.00911870226264,
- 0.04645007848739624,
- 0.9529821872711182,
- 0.9131877422332764,
- 0.9860866069793701,
- -0.28687211871147156,
- 0.7533616423606873,
- 0.525320291519165,
- -0.2505177855491638,
- 0.22584663331508636,
- -0.31802502274513245,
- -0.664940357208252,
- 0.3854376971721649,
- -0.5987637042999268,
- 0.9183555841445923,
- -0.8924358487129211,
- -0.39667022228240967,
- -0.8860922455787659,
- 0.642162561416626,
- -0.12058087438344955,
- -0.9389616847038269,
- -0.830712616443634,
- -0.606196939945221,
- -0.7111347317695618,
- -0.3265444338321686,
- -0.56674724817276,
- 0.9875668883323669,
- -0.10216209292411804,
- 0.5815808773040771,
- 0.9071466326713562,
- -0.8691815733909607,
- -0.5292973518371582,
- -0.7014018893241882,
- 0.2636984586715698,
- 0.9412404298782349,
- 0.9982985854148865,
- 0.9909630417823792,
- -0.3709893822669983,
- -0.7072163224220276
- ]
- }
- ],
- "layout": {
- "height": 500,
- "scene": {
- "aspectmode": "data"
- },
- "template": {
- "data": {
- "bar": [
- {
- "error_x": {
- "color": "#2a3f5f"
- },
- "error_y": {
- "color": "#2a3f5f"
- },
- "marker": {
- "line": {
- "color": "#E5ECF6",
- "width": 0.5
- },
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "bar"
- }
- ],
- "barpolar": [
- {
- "marker": {
- "line": {
- "color": "#E5ECF6",
- "width": 0.5
- },
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "barpolar"
- }
- ],
- "carpet": [
- {
- "aaxis": {
- "endlinecolor": "#2a3f5f",
- "gridcolor": "white",
- "linecolor": "white",
- "minorgridcolor": "white",
- "startlinecolor": "#2a3f5f"
- },
- "baxis": {
- "endlinecolor": "#2a3f5f",
- "gridcolor": "white",
- "linecolor": "white",
- "minorgridcolor": "white",
- "startlinecolor": "#2a3f5f"
- },
- "type": "carpet"
- }
- ],
- "choropleth": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "choropleth"
- }
- ],
- "contour": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "contour"
- }
- ],
- "contourcarpet": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "contourcarpet"
- }
- ],
- "heatmap": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "heatmap"
- }
- ],
- "heatmapgl": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "heatmapgl"
- }
- ],
- "histogram": [
- {
- "marker": {
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "histogram"
- }
- ],
- "histogram2d": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "histogram2d"
- }
- ],
- "histogram2dcontour": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "histogram2dcontour"
- }
- ],
- "mesh3d": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "mesh3d"
- }
- ],
- "parcoords": [
- {
- "line": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "parcoords"
- }
- ],
- "pie": [
- {
- "automargin": true,
- "type": "pie"
- }
- ],
- "scatter": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatter"
- }
- ],
- "scatter3d": [
- {
- "line": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatter3d"
- }
- ],
- "scattercarpet": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattercarpet"
- }
- ],
- "scattergeo": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattergeo"
- }
- ],
- "scattergl": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattergl"
- }
- ],
- "scattermapbox": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattermapbox"
- }
- ],
- "scatterpolar": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterpolar"
- }
- ],
- "scatterpolargl": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterpolargl"
- }
- ],
- "scatterternary": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterternary"
- }
- ],
- "surface": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "surface"
- }
- ],
- "table": [
- {
- "cells": {
- "fill": {
- "color": "#EBF0F8"
- },
- "line": {
- "color": "white"
- }
- },
- "header": {
- "fill": {
- "color": "#C8D4E3"
- },
- "line": {
- "color": "white"
- }
- },
- "type": "table"
- }
- ]
- },
- "layout": {
- "annotationdefaults": {
- "arrowcolor": "#2a3f5f",
- "arrowhead": 0,
- "arrowwidth": 1
- },
- "autotypenumbers": "strict",
- "coloraxis": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "colorscale": {
- "diverging": [
- [
- 0,
- "#8e0152"
- ],
- [
- 0.1,
- "#c51b7d"
- ],
- [
- 0.2,
- "#de77ae"
- ],
- [
- 0.3,
- "#f1b6da"
- ],
- [
- 0.4,
- "#fde0ef"
- ],
- [
- 0.5,
- "#f7f7f7"
- ],
- [
- 0.6,
- "#e6f5d0"
- ],
- [
- 0.7,
- "#b8e186"
- ],
- [
- 0.8,
- "#7fbc41"
- ],
- [
- 0.9,
- "#4d9221"
- ],
- [
- 1,
- "#276419"
- ]
- ],
- "sequential": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "sequentialminus": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ]
- },
- "colorway": [
- "#636efa",
- "#EF553B",
- "#00cc96",
- "#ab63fa",
- "#FFA15A",
- "#19d3f3",
- "#FF6692",
- "#B6E880",
- "#FF97FF",
- "#FECB52"
- ],
- "font": {
- "color": "#2a3f5f"
- },
- "geo": {
- "bgcolor": "white",
- "lakecolor": "white",
- "landcolor": "#E5ECF6",
- "showlakes": true,
- "showland": true,
- "subunitcolor": "white"
- },
- "hoverlabel": {
- "align": "left"
- },
- "hovermode": "closest",
- "mapbox": {
- "style": "light"
- },
- "paper_bgcolor": "white",
- "plot_bgcolor": "#E5ECF6",
- "polar": {
- "angularaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "bgcolor": "#E5ECF6",
- "radialaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- }
- },
- "scene": {
- "xaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- },
- "yaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- },
- "zaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- }
- },
- "shapedefaults": {
- "line": {
- "color": "#2a3f5f"
- }
- },
- "ternary": {
- "aaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "baxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "bgcolor": "#E5ECF6",
- "caxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- }
- },
- "title": {
- "x": 0.05
- },
- "xaxis": {
- "automargin": true,
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": "",
- "title": {
- "standoff": 15
- },
- "zerolinecolor": "white",
- "zerolinewidth": 2
- },
- "yaxis": {
- "automargin": true,
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": "",
- "title": {
- "standoff": 15
- },
- "zerolinecolor": "white",
- "zerolinewidth": 2
- }
- }
- },
- "title": {
- "text": "Raw Stochastic Results"
- },
- "width": 500,
- "xaxis": {
- "range": [
- -5,
- 5
- ]
- },
- "yaxis": {
- "range": [
- -1,
- 0.9999999999999999
- ]
- }
- }
- },
- "text/html": [
- " "
- ]
- },
- "metadata": {},
- "output_type": "display_data"
- },
- {
- "data": {
- "text/html": [
- " \n",
- " "
- ]
- },
- "metadata": {},
- "output_type": "display_data"
- },
- {
- "data": {
- "application/vnd.plotly.v1+json": {
- "config": {
- "linkText": "Export to plot.ly",
- "plotlyServerURL": "https://plot.ly",
- "showLink": false
- },
- "data": [
- {
- "marker": {
- "color": [
- 0,
- 0,
- 0,
- 0,
- 328.9541314582948,
- 268.9107532664747,
- 574.8881662864021,
- 274.80076944215443,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 594.6698799705795,
- 769.073010664479,
- 444.9697559618994,
- 977.0395701025892,
- 0,
- 0,
- 0,
- 0,
- 0,
- 101.48163182463973,
- 0,
- 0,
- 1929.2604501607718,
- 785.7958053471533,
- 1034.8523487452414,
- 941.4831981460022,
- 1259.871554558584,
- 3158.3898931523418,
- 2328.2154543166375,
- 2609.9060433824384,
- 2136.3820081990875,
- 887.648998224702,
- 3865.3719242009993,
- 2641.310089804543,
- 0,
- 0,
- 0,
- 0,
- 807.956983255788,
- 592.7535873941071,
- 500.1905487804878,
- 391.1342894393742,
- 0,
- 0,
- 0,
- 0,
- 661.2796567797294,
- 565.5519340387849,
- 1058.5477732691484,
- 1190.9622975364093,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 3069.6817763225213,
- 4662.885948330183,
- 816.4598301763552,
- 0,
- 0,
- 0,
- 0,
- 2896.833234577655,
- 801.3665408380607,
- 703.6281956447219,
- 586.2237420615535,
- 0,
- 0,
- 0,
- 0,
- 2755.227552275523,
- 885.1178122329386,
- 2003.869541182974,
- 6556.284031559062,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 3453.379378391712,
- 6097.5609756097565,
- 1076.754296859128,
- 4359.333644714308,
- 481.069899456391,
- 563.7487033779822,
- 716.3965254768514,
- 705.4234615544214,
- 1534.9194167306216,
- 565.3044399952892,
- 679.3478260869565,
- 703.8618553798508,
- 1417.2758466358348,
- 1682.222704579987,
- 555.2265324252295,
- 1278.6322288386366,
- 1898.62493527415,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 403.2935641068728,
- 250.64589519145488,
- 494.1220069588849,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 407.1775574962793,
- 666.2990533958276,
- 598.6146347025456,
- 643.3436120416177,
- 2636.847502319449,
- 876.9067623786606,
- 4046.8021465646166,
- 2963.1720050797235,
- 1874.2615002240966,
- 987.574929376909,
- 872.1265077092693,
- 0,
- 0,
- 0,
- 73.41604874825637,
- 102.56760914903073,
- 0,
- 84.82723519764745,
- 0,
- 0,
- 0,
- 0,
- 721.7492577465019,
- 2444.0582228981098,
- 4304.272969165754,
- 2232.8383009658323,
- 1501.4147947104002,
- 630.8775111882184,
- 2753.1083481349915,
- 945.9795867562858,
- 1394.8622573520865,
- 248.90256595918,
- 710.0720996285776,
- 7819.521840733417,
- 244.3233008077939,
- 493.26386533896476,
- 347.9017177647314,
- 222.22222222222223,
- 397.15373159026973,
- 363.60991927859794,
- 511.11679018655764,
- 262.49475010499793,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 216.27736740533706,
- 518.3933645649336,
- 436.8719965050241,
- 1291.1385734236253,
- 4535.327816677276,
- 4299.005453962143,
- 7142.857142857143,
- 0,
- 0,
- 0,
- 933.3582228859436,
- 1411.5092290988057,
- 576.3367293820182,
- 341.99076624931126,
- 532.9306746014123,
- 67.60868095463458,
- 100.3854802441375,
- 186.74136321195144,
- 359.1954022988506,
- 881.2207226009925,
- 915.3864522805063,
- 3295.9789057350035,
- 1028.3996519262716,
- 2021.2909311413557,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1921.8025182239894,
- 832.2087269455691,
- 2728.1407720638385,
- 0,
- 0,
- 2937.33681462141,
- 2747.0541458830335,
- 1139.3355602164738,
- 1846.965699208443,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 990.9347818108415,
- 3726.1294829995345,
- 1509.5706780991486,
- 1804.7283883775492,
- 0,
- 237.14790124107404,
- 693.5249984238068,
- 56.12617163383286,
- 16.643919976032755,
- 257.46652935118436,
- 0,
- 0,
- 0,
- 506.2126092959043,
- 336.12116179290985,
- 400.29736375593296,
- 257.08593097242755,
- 72.1071512267229,
- 174.40267085233077,
- 152.97537096527458,
- 280.9120277166534,
- 0,
- 0,
- 0,
- 282.62559174733275,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 169.91391028545536,
- 98.63554167351636,
- 0,
- 0,
- 1008.3504017646133,
- 767.8132678132678,
- 839.4291881520566,
- 563.5390250774866,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 234.8961758902565,
- 376.7593315213004,
- 458.70321901729585,
- 469.4345921134988,
- 0,
- 0,
- 0,
- 86.11286526207014,
- 48.13014390913029,
- 178.84974066787603,
- 1591.8418107200598,
- 1721.4173002438677,
- 1233.1368535280046,
- 1192.3011412025207,
- 105.15247108307047,
- 80.70862169851294,
- 210.1281781886951,
- 261.4925997594268,
- 338.3560407831814,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 575.0321059592494,
- 173.79214459506431,
- 2848.625372639947,
- 0,
- 0,
- 0,
- 0,
- 859.2822946929089,
- 1053.282348361688,
- 927.3230227587075,
- 27.78395198933096,
- 189.5631922441574,
- 46.979970872418065,
- 1852.3563061836012,
- 5534.517914360617,
- 5839.261068053934,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1645.1398368861353,
- 765.7367605854406,
- 778.5452798621809,
- 2215.9461220942862,
- 311.0696351597565,
- 837.3456144023446,
- 1210.444406017638,
- 981.2529050250479,
- 250.52610482012224,
- 417.6346219101564,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 2402.236836923562,
- 3087.285994948077,
- 1830.501942901185,
- 1360.3679471399885,
- 629.5907660020986,
- 1040.070067878257,
- 215.7318287421175,
- 359.4311611189248,
- 0,
- 0,
- 0,
- 0,
- 232.35820340637127,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 442.6011835483501,
- 1544.4015444015445,
- 3424.2460651207493,
- 1742.6903820087964,
- 2807.5804672616064,
- 6558.028616852146,
- 0,
- 0,
- 0,
- 0,
- 0,
- 35.80635920939559,
- 1218.892839004571,
- 2654.9847338377804,
- 268.87141224709285,
- 535.6968929580208,
- 142.88889594513066,
- 74.79012022511826,
- 377.63399712998165,
- 394.71952984518225,
- 1427.5074478649453,
- 682.6326867284828,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 300.42058882435407,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 882.5259854873505,
- 141.86409419775856,
- 0,
- 3231.5398287283892,
- 538.1123953020448,
- 2421.47502421475,
- 1184.6510430079834,
- 835.0525591904902,
- 448.53106077595874,
- 1625.6990505917545,
- 1350.0302592989153,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 2341.528683726375,
- 1262.6651473622617,
- 877.4253360704589,
- 1321.0958142122097,
- 2364.998029168309,
- 1267.342582710779,
- 1074.3662917575962,
- 1250.1785969424204,
- 0,
- 0,
- 0,
- 0,
- 782.1962050867985,
- 1100.5047967654727,
- 1270.9264615654308,
- 3208.5561497326203,
- 762.5002382813245,
- 1457.3643410852712,
- 885.4994940002891,
- 1088.3886120181016,
- 1714.0492936934806,
- 547.4785570898473,
- 1817.0805572380375,
- 2450.273854136639,
- 161.96954972465176,
- 80.65979714061018,
- 92.52191612888303,
- 0,
- 52.75652862041678,
- 0,
- 0,
- 0,
- 2940.0235201881615,
- 2362.8400184416782,
- 101.27402726296815,
- 188.0229387985334,
- 106.91985287828244,
- 0,
- 2355.1577955723033,
- 2163.5464500176613,
- 1833.622852731133,
- 1233.2245194051504,
- 132.91055119904306,
- 275.9243465609793,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 6599.957419629551,
- 2807.0175438596493,
- 1963.5114129100875,
- 1384.3225471534868,
- 1037.2976142154873,
- 428.01752354096374,
- 2990.081680280047,
- 2042.561276838305,
- 0,
- 0,
- 186.6368047779022,
- 0,
- 44.08393581378946,
- 0,
- 0,
- 0,
- 0,
- 0,
- 84.60057951396968,
- 0,
- 0,
- 0,
- 0,
- 153.51550506601166,
- 0,
- 1476.886722788362,
- 0,
- 0,
- 0,
- 0,
- 838.4998475454822,
- 908.359502738055,
- 606.5586600923534,
- 1085.162661361427,
- 875.8136109397083,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 951.4747859181731,
- 4220.64599331731,
- 3684.9378166743436,
- 0,
- 33.67456896551724,
- 0,
- 0,
- 0,
- 0,
- 0,
- 311.85679535957087,
- 320.2712886209495,
- 248.91339728492923,
- 0,
- 0,
- 778.311064988974,
- 892.2198429693076,
- 311.53341195843257,
- 402.9936672423719,
- 587.2421639873743,
- 975.3378849101296,
- 1028.3305054244433,
- 0,
- 0,
- 0,
- 0,
- 0,
- 299.4161385298667,
- 463.29661278698654,
- 592.6364915919697,
- 163.82252559726965,
- 241.11879119112683,
- 0,
- 0,
- 0,
- 0,
- 383.22566517026166,
- 1232.9561937917028,
- 937.7930603313536,
- 6981.801533707222,
- 0,
- 111.85682326621924,
- 0,
- 995.9608255408622,
- 286.3585925475176,
- 188.763832849626,
- 491.8234353866962,
- 347.4807644576818,
- 393.2805213776055,
- 0,
- 0,
- 0,
- 0,
- 1452.4328249818445,
- 0,
- 0,
- 1277.1699840956192,
- 1498.8167236392321,
- 2255.8386411889596,
- 0,
- 0,
- 0,
- 0,
- 4661.339421613394,
- 3648.127753303965,
- 2018.783463530238,
- 0,
- 413.13778145011366,
- 4398.976982097186,
- 3756.1398439757295,
- 3293.084522502744,
- 3467.5499430700756,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 167.3400109966293,
- 63.32988537290747,
- 495.89757461004416,
- 345.7216940363008,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1271.2941774726671,
- 1150.492491522687,
- 1044.6392172849573,
- 0,
- 0,
- 0,
- 0,
- 0,
- 60.66672733339399,
- 0,
- 20.807324178110697,
- 72.90223809870963,
- 258.544073685061,
- 0,
- 0,
- 1925.8021147487373,
- 0,
- 0,
- 0,
- 2568.4931506849316,
- 4821.178120617111,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 3070.848870366309,
- 3157.1950814223997,
- 2936.4826045323975,
- 552.5472427892585,
- 118.7507421921387,
- 1710.2262760919136,
- 0,
- 0,
- 1700.0036170289723,
- 1335.9583743495991,
- 0,
- 51.25226364164417,
- 90.21064184871675,
- 0,
- 0,
- 187.35011990407673,
- 0,
- 0,
- 0,
- 0,
- 0,
- 163.71971185330713,
- 616.610539297064,
- 0,
- 0,
- 0,
- 741.2065944926104,
- 616.2728466940205,
- 709.8743522396536,
- 2447.5755771647814,
- 740.6101216716628,
- 272.93197170605225,
- 598.115934805363,
- 507.84856879039705,
- 319.1036732378386,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1155.9090068429812,
- 965.8964261832231,
- 6297.950303446697,
- 0,
- 752.0339098926642,
- 2037.9369807179808,
- 1290.0055285951228,
- 0,
- 408.1216202428323,
- 0,
- 1323.0138254944764,
- 4495.825305073859,
- 857.8926120306822,
- 1646.249939476105,
- 495.59681293126454,
- 0,
- 6629.834254143646,
- 5288.414454999511,
- 8383.516353760773,
- 0,
- 0,
- 0,
- 0,
- 0,
- 966.3108885667853,
- 0,
- 0,
- 937.4707040404987,
- 0,
- 0,
- 0,
- 0,
- 0,
- 441.25758411472697,
- 151.92027224112786,
- 663.5299794908916,
- 2098.6358866736623,
- 9813.384813384813,
- 3273.980470993682,
- 0,
- 282.60562385191463,
- 170.77231780728346,
- 429.8486932599725,
- 0,
- 0,
- 0,
- 0,
- 847.9551236057661,
- 0,
- 200.41586291554975,
- 299.3533966632075,
- 0,
- 0,
- 723.4768229032092,
- 406.0638873849486,
- 1835.305481767689,
- 2518.4275184275184,
- 0,
- 0,
- 0,
- 0,
- 992.8432548711372,
- 549.9317677251156,
- 0,
- 779.6900256727204,
- 2151.1801613385123,
- 934.9827387802071,
- 196.0399921584003,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 4613.126441602013,
- 6251.2603347449085,
- 1640.5338044609898,
- 0,
- 0,
- 0,
- 911.3946561152359,
- 0,
- 0,
- 0,
- 0,
- 3574.573900429985,
- 0,
- 0,
- 0,
- 0,
- 1536.3343063450607,
- 1586.4621893178212,
- 1408.3605402983164,
- 753.9500426145677,
- 0,
- 0,
- 1214.8931608661474,
- 2035.042438080111,
- 0,
- 0,
- 488.20179007323026,
- 0,
- 1363.1022326674502,
- 1673.2901066722445,
- 0,
- 0,
- 0,
- 0,
- 1380.3556445719544,
- 6177.813591189901,
- 3716.062490520249,
- 0,
- 1719.8136868505912,
- 0,
- 0,
- 0,
- 0,
- 1858.952015801092,
- 2047.3562399857576,
- 4287.245444801715,
- 5671.077504725898,
- 626.8211696144203,
- 0,
- 0,
- 1665.4770402093743,
- 933.1622535868424,
- 352.43532811729045,
- 3027.0542977864666,
- 0,
- 0,
- 739.7908857762873,
- 213.2044630800938,
- 1844.532279314888,
- 3134.6495742490874,
- 4231.844630847125,
- 4495.078663876618,
- 648.1406465202949,
- 645.9113809585325,
- 0,
- 0,
- 2022.4394471998844,
- 2055.039313795568,
- 0,
- 0,
- 478.67248165088824,
- 628.3459421419057,
- 4893.196574762398,
- 2916.940129803836,
- 211.79261267366994,
- 410.5300969877354,
- 2899.00493614354,
- 0,
- 440.50437751225155,
- 478.9941123640356,
- 558.7792821835375,
- 3242.0500793267574,
- 1450.560077363204,
- 635.9851988899168,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 376.70864277257556,
- 649.2133949331159,
- 408.4133142740453,
- 0,
- 0,
- 2760.2523659305994,
- 4026.1002360127723,
- 3639.4776279169346,
- 0,
- 748.6295249824917,
- 46.74644727000748,
- 0,
- 0,
- 0,
- 0,
- 1165.9541391371938,
- 907.9613877473,
- 1917.5455417066157,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 2147.496333542845,
- 558.0173970129657,
- 0,
- 1965.6295630686286,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 169.91391028545536,
- 445.9805998439068,
- 2925.858739540055,
- 0,
- 405.71870170015455,
- 303.1374728439347,
- 0,
- 10079.575596816976,
- 4489.983882109142,
- 5789.909015715467,
- 0,
- 469.8059340103357,
- 4773.707885798219,
- 0,
- 0,
- 0,
- 0,
- 0,
- 171.39918871050676,
- 1201.2325690708726,
- 0,
- 0,
- 3745.1089994410286,
- 4258.943781942078,
- 116.95222501608092,
- 526.6237565827969,
- 910.8179144872095,
- 3681.3224977425853,
- 0,
- 0,
- 3709.29209103483,
- 4253.9782574444625,
- 2135.054617676266,
- 0,
- 0,
- 0,
- 5627.666333847689,
- 4357.694053563323,
- 3182.7723979142684,
- 0,
- 0,
- 0,
- 547.4785570898473,
- 0,
- 874.9950284373384,
- 1278.8584505620247,
- 0,
- 902.4049090827054,
- 198.95218515816697,
- 0,
- 0,
- 3327.0389353475407,
- 0,
- 0,
- 458.44794531966323,
- 596.3656774012488,
- 4544.005102040816,
- 0,
- 0,
- 0,
- 0,
- 3429.355281207133,
- 0,
- 0,
- 3696.2131250435878,
- 0,
- 0,
- 1017.0950201463053,
- 0,
- 0,
- 0,
- 3780.5141499243896,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1263.2169926078413,
- 1560.323209807746,
- 8480.993487808571,
- 0,
- 0,
- 2823.108173242443,
- 1394.0861398488516,
- 0,
- 0,
- 1110.370863868532,
- 269.72353337828724,
- 309.59752321981426,
- 0,
- 792.2674694977025,
- 8562.793821356614,
- 5944.369672498879,
- 0,
- 382.1795151779865,
- 269.19349628512975,
- 13089.005235602095,
- 0,
- 0,
- 2841.6010392140943,
- 349.7359493582345,
- 731.0832216400632,
- 0,
- 0,
- 0,
- 5460.114529231589,
- 0,
- 0,
- 0,
- 579.2624058698591,
- 511.770726714432,
- 2503.3974679922753,
- 0,
- 0,
- 0,
- 0,
- 0,
- 669.1449814126394,
- 996.710854181202,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 499.5717956037682,
- 0,
- 0,
- 0,
- 0,
- 0,
- 0,
- 1088.139281828074,
- 0,
- 1030.5736860185505,
- 1168.0382267056011,
- 0,
- 0,
- 0,
- 436.5287235900122,
- 1934.8868511819635,
- 730.8338814587444,
- 1791.900609246207,
- 0,
- 1828.1535648994513
- ],
- "colorbar": {
- "thickness": 20,
- "title": {
- "text": "A"
- }
- },
- "colorscale": [
- [
- 0,
- "#0508b8"
- ],
- [
- 0.08333333333333333,
- "#1910d8"
- ],
- [
- 0.16666666666666666,
- "#3c19f0"
- ],
- [
- 0.25,
- "#6b1cfb"
- ],
- [
- 0.3333333333333333,
- "#981cfd"
- ],
- [
- 0.4166666666666667,
- "#bf1cfd"
- ],
- [
- 0.5,
- "#dd2bfd"
- ],
- [
- 0.5833333333333334,
- "#f246fe"
- ],
- [
- 0.6666666666666666,
- "#fc67fd"
- ],
- [
- 0.75,
- "#fe88fc"
- ],
- [
- 0.8333333333333334,
- "#fea5fd"
- ],
- [
- 0.9166666666666666,
- "#febefe"
- ],
- [
- 1,
- "#fec3fe"
- ]
- ],
- "size": 5
- },
- "mode": "markers",
- "name": "A",
- "type": "scatter3d",
- "x": [
- -2.101682662963867,
- -1.887513518333435,
- -1.7570427656173706,
- -1.8541388511657715,
- 1.8749754428863525,
- 1.80832040309906,
- 2.1825294494628906,
- 2.062222480773926,
- -2.38004469871521,
- -2.3056769371032715,
- -2.2629430294036865,
- -2.0936312675476074,
- -1.9997928142547607,
- -1.7547287940979004,
- -1.6898266077041626,
- -1.6704288721084595,
- 3.5905017852783203,
- 3.2578799724578857,
- 3.160881519317627,
- 3.4964303970336914,
- -0.6913178563117981,
- -1.0443613529205322,
- -0.8108569979667664,
- -0.5850074887275696,
- -0.293684720993042,
- 0.0675533190369606,
- -0.271133154630661,
- 0.018742907792329788,
- 4.4305853843688965,
- 4.508673667907715,
- 4.325611114501953,
- 4.611989498138428,
- 3.4338648319244385,
- 3.488844871520996,
- 3.289395570755005,
- 3.6204428672790527,
- 3.71138858795166,
- 3.857684850692749,
- 3.974630117416382,
- 4.003854274749756,
- -3.9132473468780518,
- -4.0064496994018555,
- -3.8273096084594727,
- -3.709832191467285,
- 2.3001842498779297,
- 2.2914557456970215,
- 2.0052285194396973,
- 2.2628118991851807,
- -1.980513334274292,
- -2.0251479148864746,
- -1.7515032291412354,
- -2.1317431926727295,
- 3.794757843017578,
- 3.3874454498291016,
- 3.7147281169891357,
- 3.586693048477173,
- -2.8868887424468994,
- -3.001088857650757,
- -2.9482247829437256,
- -2.6325371265411377,
- -4.134808540344238,
- -3.772261619567871,
- -4.165527820587158,
- -3.994203805923462,
- -4.163450241088867,
- 3.875136137008667,
- 3.7112133502960205,
- 3.765407085418701,
- -2.4520857334136963,
- -2.657001495361328,
- -2.6662352085113525,
- -2.8774945735931396,
- 3.942436933517456,
- 3.8352348804473877,
- 3.6082088947296143,
- 4.133811950683594,
- -3.171978712081909,
- -3.221795082092285,
- -3.0311388969421387,
- -2.9480156898498535,
- 4.4702277183532715,
- 4.6418352127075195,
- 4.766424655914307,
- 4.669127941131592,
- -3.4734950065612793,
- -3.1584713459014893,
- -3.2440361976623535,
- -3.3585245609283447,
- -2.429314613342285,
- -2.2996301651000977,
- -2.1834332942962646,
- -1.2482850551605225,
- -0.8828672766685486,
- -0.8636268973350525,
- 4.625131607055664,
- 5,
- 4.731442928314209,
- 4.639413356781006,
- 2.726271152496338,
- 2.482100486755371,
- 2.630417823791504,
- 2.613208293914795,
- 2.359410285949707,
- 2.4850215911865234,
- 2.0713677406311035,
- 2.9034955501556396,
- 3.2096197605133057,
- 3.0044784545898438,
- 3.031195640563965,
- 2.8652327060699463,
- 3.303494453430176,
- -0.9179192781448364,
- -1.1669803857803345,
- -1.2644528150558472,
- -1.0285327434539795,
- -0.8682996034622192,
- -1.0111645460128784,
- -1.1425732374191284,
- -0.9068978428840637,
- 1.6444306373596191,
- 1.5535091161727905,
- 1.877994418144226,
- -4.233823299407959,
- -4.286869049072266,
- -4.4695281982421875,
- -4.121842384338379,
- -1.4972978830337524,
- -0.9989351034164429,
- -1.422027349472046,
- -1.2346546649932861,
- -2.2228097915649414,
- -2.000976085662842,
- -2.127882480621338,
- -4.581174373626709,
- -4.083948135375977,
- 2.5844061374664307,
- 2.6696746349334717,
- 2.439190149307251,
- 2.836972236633301,
- 3.768427848815918,
- 3.901214361190796,
- 4.03761625289917,
- 3.712953805923462,
- 3.7559714317321777,
- 3.856983184814453,
- 4.166917324066162,
- -2.2912299633026123,
- -2.089019775390625,
- -1.982771635055542,
- 0.2804890275001526,
- 0.14649292826652527,
- -0.02719704993069172,
- 0.35809698700904846,
- -0.09706947952508926,
- -0.06142881140112877,
- -0.6113005876541138,
- -0.263994425535202,
- 4.316342830657959,
- 4.358631610870361,
- 4.577394962310791,
- 4.1251115798950195,
- 2.637986421585083,
- 2.9547457695007324,
- 2.78865909576416,
- 1.622883915901184,
- 1.6951839923858643,
- 1.6690202951431274,
- 1.4459738731384277,
- 5,
- 1.4305493831634521,
- 1.2514207363128662,
- 1.230926275253296,
- 1.0252352952957153,
- 1.0430431365966797,
- 1.0417221784591675,
- 1.277311086654663,
- 0.8228275179862976,
- -2.6111531257629395,
- -0.8876737952232361,
- -0.6530675888061523,
- -0.8721553087234497,
- -1.1404987573623657,
- -3.7799670696258545,
- -3.7419769763946533,
- -3.7747626304626465,
- -3.765298843383789,
- -1.3552204370498657,
- -1.448533058166504,
- 1.976080060005188,
- 2.3143045902252197,
- 2.006865978240967,
- 4.718459129333496,
- 5,
- 5,
- 5,
- -0.21346406638622284,
- -0.3900603652000427,
- -0.7078602910041809,
- 2.546725273132324,
- 2.2419445514678955,
- 2.62286114692688,
- 2.31475830078125,
- 2.815099000930786,
- 0.17036111652851105,
- 0.35399267077445984,
- 0.22068481147289276,
- 0.5616357326507568,
- 2.168175220489502,
- 2.396758794784546,
- 2.032904624938965,
- 1.9458956718444824,
- 1.672920823097229,
- -1.9237370491027832,
- -1.7913600206375122,
- -2.1189286708831787,
- -4.244471549987793,
- -4.725438117980957,
- -4.62848424911499,
- -4.6635870933532715,
- -4.4014410972595215,
- -0.39015352725982666,
- -3.62326979637146,
- -3.6562275886535645,
- -3.3212900161743164,
- -2.650617837905884,
- -2.9336674213409424,
- -2.5238282680511475,
- -2.854623556137085,
- 3.359579563140869,
- 3.281346321105957,
- 3.4625306129455566,
- -1.6233601570129395,
- -1.4790972471237183,
- 3.500380516052246,
- 4.63165283203125,
- 4.554935932159424,
- 4.720632076263428,
- -0.6211792826652527,
- -0.9868704080581665,
- -0.2744942903518677,
- -0.23266896605491638,
- -0.4965898394584656,
- -0.32649561762809753,
- -1.423138976097107,
- -1.7905021905899048,
- -1.4218405485153198,
- -3.732257604598999,
- -3.5719547271728516,
- -3.941251754760742,
- -3.9911673069000244,
- 2.76228666305542,
- 3.034092664718628,
- 2.5956602096557617,
- 3.0007383823394775,
- -2.4493157863616943,
- 1.5511066913604736,
- 1.313583254814148,
- 0.09208802133798599,
- 0.2716134786605835,
- 0.33897581696510315,
- -2.9448187351226807,
- -3.1763267517089844,
- -2.965965747833252,
- 2.055418014526367,
- 1.7646766901016235,
- 2.0915160179138184,
- 1.9841140508651733,
- 0.7309734225273132,
- 0.8535610437393188,
- 1.1015901565551758,
- 1.1043431758880615,
- -3.231236696243286,
- -3.466428518295288,
- -3.2163987159729004,
- 1.5548237562179565,
- -2.620222806930542,
- -2.8454513549804688,
- -2.381518602371216,
- -1.7730915546417236,
- -2.034778118133545,
- -1.792545199394226,
- 0.23506808280944824,
- 0.15298357605934143,
- -0.12086783349514008,
- -0.0009967255173251033,
- 3.0469939708709717,
- 3.3803346157073975,
- 3.5396389961242676,
- 3.4276304244995117,
- -3.4141626358032227,
- -3.28906512260437,
- -3.1413207054138184,
- -2.9626805782318115,
- -3.5331058502197266,
- -2.7990610599517822,
- -2.5825302600860596,
- 1.0379852056503296,
- 1.3705062866210938,
- 1.090142846107483,
- 1.1630381345748901,
- -0.7285075783729553,
- -0.5913762450218201,
- -0.41392114758491516,
- 0.37851566076278687,
- 0.2083987444639206,
- 0.536102294921875,
- 4.585145950317383,
- 4.314233303070068,
- 4.690446853637695,
- 4.508464336395264,
- 0.5570757389068604,
- 0.7471429109573364,
- 0.8703640103340149,
- 0.735404372215271,
- 1.950286626815796,
- -2.459625482559204,
- -2.3318281173706055,
- -4.318643569946289,
- -2.7759718894958496,
- -2.491568088531494,
- -2.487426280975342,
- 3.034865140914917,
- 1.392642855644226,
- 3.841580390930176,
- -1.7278932332992554,
- -1.9114822149276733,
- -1.5143166780471802,
- -1.7121433019638062,
- 4.3564581871032715,
- 4.085196018218994,
- 4.489546298980713,
- 0.03738686069846153,
- 0.4072064459323883,
- 0.3515777885913849,
- 4.740171909332275,
- 5,
- 5,
- -3.7102108001708984,
- -3.5805227756500244,
- -3.250467300415039,
- -3.6381490230560303,
- -5,
- -4.672852039337158,
- -5,
- -5,
- 3.9007976055145264,
- 4.133395671844482,
- 4.175212860107422,
- 4.236222267150879,
- 1.3414992094039917,
- 1.545016884803772,
- 1.7293202877044678,
- 1.7089415788650513,
- 1.5792618989944458,
- 1.938088297843933,
- -4.447057247161865,
- -4.589023590087891,
- -4.721797943115234,
- -5,
- -4.662319183349609,
- -4.697544574737549,
- -4.536230564117432,
- 5,
- 5,
- 5,
- 2.2066378593444824,
- 1.9319493770599365,
- 2.258507013320923,
- 2.2539353370666504,
- 2.732060194015503,
- -2.9786436557769775,
- -2.8140065670013428,
- -2.7915046215057373,
- -2.627666711807251,
- 0.9115676283836365,
- -0.532065212726593,
- -0.5675407648086548,
- -0.5571060180664062,
- -2.564318895339966,
- -4.4288010597229,
- -4.226881980895996,
- -4.208695411682129,
- -4.0041913986206055,
- -4.3078436851501465,
- -4.320655345916748,
- 2.809098720550537,
- 2.785369634628296,
- 5,
- 4.710524559020996,
- 5,
- 5,
- -4.560494422912598,
- -4.414031982421875,
- -4.710155963897705,
- 0.027450760826468468,
- -0.09511373937129974,
- 0.3111163377761841,
- 4.47791862487793,
- 4.311753749847412,
- 2.278442859649658,
- 2.3220880031585693,
- 1.0773473978042603,
- 0.6730288863182068,
- 1.7689932584762573,
- 1.6555397510528564,
- 1.9800528287887573,
- 2.0714244842529297,
- -0.6446894407272339,
- -0.43192827701568604,
- -3.7548670768737793,
- -3.300417423248291,
- -1.1125221252441406,
- -0.6115882396697998,
- -2.978154420852661,
- -3.3732173442840576,
- -3.242103338241577,
- 1.2596628665924072,
- -3.6130688190460205,
- -3.133923292160034,
- -3.3986732959747314,
- -3.5859854221343994,
- -3.520331621170044,
- -3.851719617843628,
- -3.865055561065674,
- 0.5590431690216064,
- 0.6265019774436951,
- -0.03324676677584648,
- 2.4285573959350586,
- 2.5746889114379883,
- 2.7181601524353027,
- 2.378453016281128,
- 3.447817087173462,
- 2.445730209350586,
- 2.310244083404541,
- 2.6667962074279785,
- -4.695241928100586,
- -5,
- -4.548861980438232,
- -0.33884161710739136,
- -0.5452479720115662,
- -0.44265344738960266,
- -1.2199991941452026,
- -1.154729962348938,
- -0.9447287917137146,
- -0.8053910136222839,
- 3.9948537349700928,
- 3.997985601425171,
- 4.207438945770264,
- 2.2636070251464844,
- 2.816199541091919,
- 3.2298614978790283,
- 3.0754427909851074,
- 3.1898257732391357,
- -2.0362820625305176,
- -1.695935845375061,
- -2.8119935989379883,
- -2.5727436542510986,
- 3.0221409797668457,
- 3.255614995956421,
- 3.368884563446045,
- 3.2635715007781982,
- 4.541206359863281,
- 3.801682472229004,
- 4.062766075134277,
- 3.6565608978271484,
- 2.893397092819214,
- 3.020784378051758,
- 2.637270450592041,
- 2.978060007095337,
- 0.706810474395752,
- 0.7772684097290039,
- 0.8003952503204346,
- -0.22241777181625366,
- -0.1280590295791626,
- -2.9058010578155518,
- -0.3929927349090576,
- -1.6517680883407593,
- 4.374144554138184,
- 4.208742141723633,
- 1.0169200897216797,
- 0.6947392225265503,
- 0.6771532297134399,
- -4.339812278747559,
- 3.8944802284240723,
- 3.9562127590179443,
- 2.033257246017456,
- 1.9155778884887695,
- 1.3438067436218262,
- 1.0825568437576294,
- -1.7339566946029663,
- -1.3611284494400024,
- -1.3337901830673218,
- -1.2508692741394043,
- -2.2653911113739014,
- -2.2419567108154297,
- -3.1367833614349365,
- -1.81843900680542,
- -2.1527793407440186,
- -1.6042685508728027,
- -1.647326946258545,
- 4.628890037536621,
- 4.72548246383667,
- 2.286425828933716,
- 1.9910200834274292,
- 2.3555381298065186,
- 2.0931544303894043,
- 3.7614736557006836,
- 3.912747859954834,
- -4.636204242706299,
- -4.488008499145508,
- 0.4070380926132202,
- -0.13350971043109894,
- 0.19662299752235413,
- 0.13111887872219086,
- -0.7308740019798279,
- -0.5450983643531799,
- -0.6622709035873413,
- 0.003929497674107552,
- 0.24031925201416016,
- -0.22965681552886963,
- -0.0660269558429718,
- -0.17119362950325012,
- -0.18464888632297516,
- -0.0036181053146719933,
- -0.7095974087715149,
- 1.9864104986190796,
- -2.5475826263427734,
- -2.7074756622314453,
- -2.891202926635742,
- -2.509110927581787,
- 2.9578778743743896,
- 3.029849052429199,
- 2.3168818950653076,
- 3.536309242248535,
- 3.2530806064605713,
- -3.741461992263794,
- -2.821955680847168,
- -3.082059383392334,
- -2.9099485874176025,
- -2.7286927700042725,
- -0.6247063279151917,
- -0.3622240722179413,
- -0.4216044247150421,
- 1.6000310182571411,
- 5,
- 5,
- -1.6445059776306152,
- 0.2146318256855011,
- -4.1633453369140625,
- -4.1257829666137695,
- -3.817925214767456,
- -3.784167766571045,
- -1.2936067581176758,
- 1.8930131196975708,
- 1.5624295473098755,
- 1.5452696084976196,
- -1.8079805374145508,
- -1.6008325815200806,
- 1.2422401905059814,
- 1.4802297353744507,
- 1.4433354139328003,
- 1.5805444717407227,
- 0.7913298010826111,
- 2.578340768814087,
- 2.6075079441070557,
- -0.813774585723877,
- -5,
- -5,
- -4.7412261962890625,
- -4.72172212600708,
- 1.3737642765045166,
- 1.2108287811279297,
- 1.3925875425338745,
- 1.4203695058822632,
- 0.5987880825996399,
- -4.71983003616333,
- -5,
- -5,
- -4.692821025848389,
- 1.909011960029602,
- 1.7303102016448975,
- 1.6846473217010498,
- 5,
- -3.5527470111846924,
- 0.37845441699028015,
- -1.9841102361679077,
- 3.145871162414551,
- 1.289706826210022,
- 0.7273845076560974,
- 0.720970630645752,
- 1.0219862461090088,
- 0.8861194849014282,
- -4.596095085144043,
- -4.253779888153076,
- -4.743481159210205,
- -1.5359901189804077,
- 3.121032953262329,
- -4.488008499145508,
- -1.1460216045379639,
- 4.6934332847595215,
- 4.375402450561523,
- 4.680056095123291,
- -4.230134010314941,
- -3.7863848209381104,
- -4.4221673011779785,
- -4.591073989868164,
- 4.1638264656066895,
- 4.340243339538574,
- 4.488320350646973,
- -2.5075998306274414,
- 1.917682409286499,
- 4.661116600036621,
- 4.636397361755371,
- 4.488320350646973,
- 5,
- -3.489121437072754,
- -1.138638973236084,
- -0.7274905443191528,
- -4.574654579162598,
- -4.382515907287598,
- -3.1639509201049805,
- -2.7766637802124023,
- 0.7139411568641663,
- 0.4993683397769928,
- 0.7703021764755249,
- 0.901824951171875,
- -1.5355284214019775,
- -2.1874425411224365,
- -2.3504247665405273,
- -4.327395915985107,
- -2.3662376403808594,
- -3.6765761375427246,
- 1.808962345123291,
- 4.351280689239502,
- 4.706614017486572,
- -3.448230266571045,
- -3.3269059658050537,
- -1.3753197193145752,
- -1.1046783924102783,
- -1.4444420337677002,
- 0.29257264733314514,
- 0.009619895368814468,
- 0.32545214891433716,
- 0.23237977921962738,
- 1.4445356130599976,
- -1.2714718580245972,
- -1.4109042882919312,
- 4.735227108001709,
- -3.157381772994995,
- -5,
- -4.624974727630615,
- 4.58084774017334,
- 4.646906852722168,
- -4.253415107727051,
- -3.6714272499084473,
- -4.048503875732422,
- -3.91367769241333,
- -0.662963330745697,
- -0.45707225799560547,
- -0.3023490607738495,
- -0.10872425138950348,
- -0.40253975987434387,
- -0.7720760107040405,
- -2.228641986846924,
- -2.0955162048339844,
- -1.9311330318450928,
- 4.527668476104736,
- 4.4020185470581055,
- 4.253148078918457,
- 4.159819602966309,
- 0.06420236825942993,
- 4.135446548461914,
- -0.9258043766021729,
- -0.8058002591133118,
- 4.537054061889648,
- 4.744240760803223,
- -0.8789688944816589,
- 0.3651331961154938,
- 0.7293714880943298,
- -0.06956324726343155,
- -0.08140537887811661,
- 1.721306324005127,
- -3.6552634239196777,
- -3.3976213932037354,
- -3.114668607711792,
- -2.9648706912994385,
- -2.7460291385650635,
- 0.9609786868095398,
- 1.0764851570129395,
- -2.625852346420288,
- -2.673210859298706,
- -2.3928139209747314,
- 3.227536678314209,
- 3.531540632247925,
- 3.7912299633026123,
- 3.446416139602661,
- 1.760624647140503,
- 1.2702659368515015,
- 1.4204895496368408,
- 1.1356712579727173,
- 1.1212012767791748,
- -0.7966426014900208,
- -4.596960067749023,
- -2.358410358428955,
- -2.481785297393799,
- -2.317129611968994,
- 2.1517908573150635,
- 1.9424786567687988,
- 4.65165901184082,
- -4.577237129211426,
- 3.162456750869751,
- 3.290433168411255,
- 3.418100118637085,
- -3.9114646911621094,
- 0.9896045327186584,
- -0.19112993776798248,
- 2.6939661502838135,
- 3.0167806148529053,
- 2.893794298171997,
- 3.0206243991851807,
- 1.2407162189483643,
- -0.46050986647605896,
- 5,
- 4.663840293884277,
- 5,
- -3.103480339050293,
- -2.277939558029175,
- -2.125932216644287,
- -1.824216604232788,
- -2.0925588607788086,
- 2.68068528175354,
- -4.7859697341918945,
- -4.575015544891357,
- 2.8520922660827637,
- -3.2595419883728027,
- -4.203586101531982,
- -4.2565202713012695,
- -3.767660140991211,
- -3.32572078704834,
- 0.5733931660652161,
- 0.5859797596931458,
- 0.6658535599708557,
- 4.556863307952881,
- 5,
- 5,
- -2.477255344390869,
- 0.25908347964286804,
- 0.25868678092956543,
- 0.49322885274887085,
- -5,
- -0.1877877414226532,
- -5,
- -5,
- 3.983049154281616,
- -2.6407032012939453,
- 0.5915303230285645,
- 1.0867373943328857,
- -1.214605450630188,
- -1.4895960092544556,
- 2.3244974613189697,
- 1.0752484798431396,
- 3.5134105682373047,
- 3.492990732192993,
- -4.003303050994873,
- -4.055683612823486,
- -4.244694709777832,
- -4.091361999511719,
- 2.220043897628784,
- 2.544774293899536,
- -5,
- 3.5021090507507324,
- 3.226494312286377,
- 1.4538578987121582,
- 0.25620901584625244,
- -4.075596809387207,
- -4.281928539276123,
- -4.1883087158203125,
- -4.555990695953369,
- -4.334146976470947,
- -4.165266990661621,
- 4.628626346588135,
- 4.596282482147217,
- 4.575169086456299,
- -4.123189449310303,
- -3.8626294136047363,
- -3.69762921333313,
- 3.6556200981140137,
- -4.1212477684021,
- -3.785296678543091,
- -1.9285658597946167,
- -3.4919838905334473,
- 5,
- -1.8179099559783936,
- -4.580845355987549,
- -4.697874546051025,
- -4.374136447906494,
- 2.7386975288391113,
- 3.034958839416504,
- 2.8929836750030518,
- 2.8669273853302,
- -5,
- -1.5589079856872559,
- 1.9696201086044312,
- 3.9466171264648438,
- -3.894467353820801,
- -1.4353413581848145,
- 0.6438999772071838,
- -3.559412717819214,
- 2.898449182510376,
- 4.226627349853516,
- -5,
- -5,
- -4.580845355987549,
- -2.0328192710876465,
- 4.1754069328308105,
- 4.199225902557373,
- 4.34015417098999,
- -2.9041290283203125,
- 2.497323513031006,
- -1.7650561332702637,
- -0.5644856095314026,
- -5,
- -5,
- 3.0372588634490967,
- 3.8829185962677,
- 3.6070923805236816,
- 3.8541207313537598,
- 3.8192059993743896,
- -2.6382784843444824,
- -4.700376033782959,
- 2.501884937286377,
- 4.065597057342529,
- 1.0171412229537964,
- 5,
- -4.651655673980713,
- -0.8031032681465149,
- 1.2622673511505127,
- 1.2936519384384155,
- 1.369748592376709,
- 4.189074516296387,
- 4.076688766479492,
- 5,
- 0.7270625233650208,
- 0.995764970779419,
- -0.8975422382354736,
- -1.5903971195220947,
- 3.329392194747925,
- 3.4523019790649414,
- -1.0810967683792114,
- -0.5812257528305054,
- 2.644548177719116,
- 2.6585214138031006,
- 5,
- 3.7732388973236084,
- 0.9950934052467346,
- 0.8841180801391602,
- 3.8183670043945312,
- -0.6460126042366028,
- 2.1103804111480713,
- 2.3608930110931396,
- 1.3835891485214233,
- 3.4795989990234375,
- 1.769286036491394,
- 1.7716087102890015,
- -5,
- -5,
- -5,
- -1.426405906677246,
- -2.7312746047973633,
- -5,
- 0.47139957547187805,
- 3.8471028804779053,
- 0.7896639108657837,
- -1.2268297672271729,
- -4.720064640045166,
- 2.7558088302612305,
- 3.023494243621826,
- 3.7829294204711914,
- -1.891106128692627,
- 3.048088550567627,
- 0.008336871862411499,
- 0.07599930465221405,
- -1.3721232414245605,
- -1.032981276512146,
- -0.6021665930747986,
- 1.735460877418518,
- 1.5383501052856445,
- 2.478435516357422,
- -3.304556131362915,
- -2.378432035446167,
- -0.4857358932495117,
- -2.097623586654663,
- -3.2147445678710938,
- -1.8128300905227661,
- 3.589271306991577,
- 3.373690366744995,
- -3.5193681716918945,
- 3.53788161277771,
- -1.1633410453796387,
- -3.841488838195801,
- -3.562544822692871,
- -5,
- -4.628747463226318,
- -0.3776344060897827,
- -1.9576623439788818,
- -2.3299407958984375,
- -2.3134829998016357,
- 0.5879091620445251,
- 0.39716675877571106,
- 5,
- -4.527527809143066,
- 2.8390586376190186,
- 0.3319953382015228,
- -0.2031165361404419,
- 5,
- 5,
- 5,
- -5,
- 2.2759742736816406,
- 4.30157470703125,
- -0.7995855808258057,
- -0.05464247241616249,
- -1.3260889053344727,
- -1.0919172763824463,
- -1.5666868686676025,
- 0.6270329356193542,
- 2.468057155609131,
- -2.5841712951660156,
- -4.339723110198975,
- 5,
- 5,
- 0.5067524909973145,
- 0.7723978161811829,
- 3.510948657989502,
- 4.363494873046875,
- -3.0252578258514404,
- -1.2719022035598755,
- 4.58084774017334,
- 5,
- 4.526966571807861,
- -5,
- -5,
- -5,
- 5,
- 4.227243900299072,
- 4.085610389709473,
- -4.363025188446045,
- -1.356877088546753,
- -1.0370725393295288,
- 1.1098798513412476,
- -1.7669402360916138,
- 3.0309200286865234,
- 1.8378273248672485,
- -1.0789508819580078,
- 1.8391550779342651,
- 0.4916764497756958,
- -3.601686716079712,
- -0.24966329336166382,
- 4.12544059753418,
- -5,
- -5,
- 1.536503791809082,
- 1.7359037399291992,
- 5,
- -3.840538263320923,
- -5,
- -5,
- -5,
- 4.124938011169434,
- -4.646697998046875,
- -5,
- 4.167131423950195,
- -3.3831329345703125,
- -3.5020036697387695,
- 3.266669988632202,
- -0.9436191916465759,
- -1.5299025774002075,
- -1.982384204864502,
- 3.6774818897247314,
- -2.2120511531829834,
- -0.3448413610458374,
- -3.386986017227173,
- -3.1074790954589844,
- -0.4411892294883728,
- -0.3736647963523865,
- -5,
- -5,
- -1.2011436223983765,
- -1.1121392250061035,
- -2.1613833904266357,
- -2.2924811840057373,
- 3.104656934738159,
- 2.610442638397217,
- 5,
- -5,
- -2.3681676387786865,
- 3.672323226928711,
- 3.7326676845550537,
- 0.1613098382949829,
- 0.2413194328546524,
- 1.3728821277618408,
- 0.4339759051799774,
- 0.35695144534111023,
- -2.493479013442993,
- 2.1896910667419434,
- 4.700502395629883,
- 5,
- -1.016597032546997,
- 0.6210448145866394,
- 0.6637445688247681,
- 5,
- -1.0216628313064575,
- -0.23358485102653503,
- 3.3018922805786133,
- 1.8105369806289673,
- 0.955568790435791,
- -3.7231528759002686,
- -3.9804978370666504,
- -1.2900493144989014,
- 4.1124267578125,
- -3.540820360183716,
- -5,
- -3.8975656032562256,
- 1.2156816720962524,
- 0.7590240836143494,
- 3.5594608783721924,
- -3.283069372177124,
- -5,
- -3.2769768238067627,
- 0.1670776754617691,
- -0.7176233530044556,
- 0.9799598455429077,
- 1.3872452974319458,
- -2.0572428703308105,
- -3.3091535568237305,
- -1.3487980365753174,
- -4.625357627868652,
- -2.012728691101074,
- -5,
- 0.8194661736488342,
- -1.579920768737793,
- -1.5731505155563354,
- -4.639402389526367,
- -1.7494895458221436,
- -3.0217342376708984,
- -1.5556175708770752,
- 2.022423028945923,
- -2.8629543781280518,
- 1.2468470335006714,
- 1.9912384748458862,
- -1.0789836645126343,
- -0.08867280930280685,
- -1.3601857423782349,
- 0.519882321357727,
- 2.222944498062134,
- 0.5680000185966492,
- 2.373995542526245,
- -2.9980807304382324,
- 3.2855708599090576
- ],
- "y": [
- -0.9644528031349182,
- -0.5014916062355042,
- -0.9228641390800476,
- -0.9955595135688782,
- 0.2492223083972931,
- 0.057115908712148666,
- -0.16631139814853668,
- -0.06584170460700989,
- 0.10396039485931396,
- -0.31133314967155457,
- -0.041115161031484604,
- -0.04820563644170761,
- -0.949433445930481,
- -0.8801339268684387,
- -0.5981799364089966,
- -0.9736314415931702,
- -0.43101099133491516,
- -0.4243756830692291,
- -0.4731490910053253,
- -0.6577183604240417,
- 0.2146396040916443,
- 0.5974391102790833,
- 0.2125028818845749,
- 0.43337777256965637,
- 0.4884589910507202,
- 0.6967326402664185,
- 0.6029126048088074,
- 0.23680882155895233,
- 0.6917465329170227,
- 0.4850515127182007,
- 0.18376414477825165,
- 0.48162636160850525,
- -0.6320042610168457,
- -0.7730603814125061,
- -0.9154437184333801,
- -0.9334678649902344,
- -0.937618613243103,
- -0.6324880123138428,
- -0.9645949602127075,
- -0.8584909439086914,
- -0.021662965416908264,
- -0.19917190074920654,
- -0.40617337822914124,
- 0.01375947892665863,
- 0.6443992257118225,
- 0.2646108865737915,
- 0.3110242187976837,
- 0.4987179636955261,
- 0.2822154462337494,
- 0.22283178567886353,
- 0.3027957081794739,
- 0.48568424582481384,
- -0.004136862698942423,
- 0.24444110691547394,
- 0.3975219428539276,
- 0.06679671257734299,
- 0.3392251133918762,
- 0.4178438186645508,
- 0.0005444167763926089,
- 0.26371410489082336,
- 0.6860716342926025,
- 0.5389652252197266,
- 0.2810700237751007,
- 0.29595068097114563,
- -0.0028515858575701714,
- -0.914943516254425,
- -0.8317362070083618,
- -0.5160342454910278,
- 0.1723458170890808,
- -0.24010129272937775,
- 0.11037452518939972,
- -0.04924260079860687,
- 0.9950059056282043,
- 0.5880264043807983,
- 0.590488612651825,
- 0.6281570792198181,
- -0.1020033061504364,
- 0.12514355778694153,
- 0.26880502700805664,
- -0.06841706484556198,
- 0.07446050643920898,
- -0.19104579091072083,
- 0.17392556369304657,
- -0.010952293872833252,
- 0.8551027774810791,
- 0.8424614071846008,
- 0.4966377019882202,
- 0.9818977117538452,
- -0.7847625613212585,
- -0.3964613676071167,
- -0.7274291515350342,
- 0.9931104183197021,
- 0.990178644657135,
- 0.9477092027664185,
- -0.7309668660163879,
- -0.8255475759506226,
- -0.5082603693008423,
- -0.8930004835128784,
- 0.4194926917552948,
- 0.20234280824661255,
- 0.382354199886322,
- 0.04821555316448212,
- -0.22185000777244568,
- -0.2684493958950043,
- -0.2542339563369751,
- -0.6113150715827942,
- -0.749304473400116,
- 0.9967495203018188,
- 0.6226924657821655,
- 0.9509856700897217,
- 0.9614278674125671,
- -0.5285993218421936,
- -0.26093634963035583,
- -0.44633013010025024,
- -0.7162333726882935,
- 0.37243372201919556,
- 0.7037805914878845,
- 0.5981281399726868,
- 0.8595001101493835,
- -0.2422453761100769,
- -0.2717275023460388,
- -0.342314749956131,
- -0.36787569522857666,
- -0.0067490083165466785,
- -0.12062981724739075,
- -0.10932574421167374,
- 0.7730425596237183,
- 0.7197641730308533,
- 0.5498804450035095,
- 0.8838788866996765,
- -0.4682152271270752,
- -0.8429638743400574,
- -0.7152993083000183,
- 0.16587448120117188,
- 0.17635276913642883,
- 0.4282841980457306,
- -0.06333015114068985,
- 0.0034832851961255074,
- 0.09057462960481644,
- -0.7059872150421143,
- -0.3774401545524597,
- -0.6989597082138062,
- -0.5003755688667297,
- 0.7566817402839661,
- 0.44234010577201843,
- 0.45263102650642395,
- 0.5166338682174683,
- 0.16024252772331238,
- 0.5950716137886047,
- -0.18073487281799316,
- 0.0018878098344430327,
- -0.2708609104156494,
- -0.25196877121925354,
- -0.11142797023057938,
- -0.43370550870895386,
- -0.15656259655952454,
- -0.039399806410074234,
- 0.46687936782836914,
- 0.32242169976234436,
- 0.6205798983573914,
- 0.6568413972854614,
- 0.2932124137878418,
- 0.286562442779541,
- 0.5216072797775269,
- -0.9623097777366638,
- -0.9981469511985779,
- -0.6364484429359436,
- -0.9993236660957336,
- -0.07432012259960175,
- 0.42001017928123474,
- 0.34383609890937805,
- -0.08206897974014282,
- 0.17495545744895935,
- -0.6187282204627991,
- -0.17506438493728638,
- -0.16744637489318848,
- -0.3097870349884033,
- -0.4293544590473175,
- -0.34442025423049927,
- -0.08278083801269531,
- 0.040901072323322296,
- -0.20948979258537292,
- -0.8171733617782593,
- -0.6349214315414429,
- -0.63686603307724,
- -0.34542766213417053,
- 0.9818851351737976,
- 0.7231388688087463,
- -0.4980590343475342,
- -0.5276463031768799,
- -0.6645891070365906,
- 0.6138550639152527,
- 0.7307949662208557,
- 0.565581202507019,
- 0.8974766731262207,
- 0.2210589051246643,
- -0.04366305470466614,
- 0.2200208306312561,
- 0.9976720213890076,
- 0.9910743236541748,
- 0.04993176832795143,
- 0.2965986132621765,
- 0.3659362196922302,
- -0.6525683999061584,
- -0.4112653136253357,
- -0.9211462140083313,
- -0.8424838185310364,
- -0.9637735486030579,
- -0.9835269451141357,
- -0.9970294237136841,
- -0.9710226655006409,
- -0.9704429507255554,
- -0.000344896805472672,
- 0.21921929717063904,
- -0.13210053741931915,
- 0.1057116687297821,
- -0.5773980617523193,
- -0.8491992354393005,
- -0.9644528031349182,
- -0.9644528031349182,
- 0.18421055376529694,
- -0.34306600689888,
- -0.6099089980125427,
- -0.522908627986908,
- 0.5520397424697876,
- 0.6777611374855042,
- 0.7900189757347107,
- 0.8836524486541748,
- 0.998988151550293,
- 0.6972864270210266,
- 0.9325829744338989,
- -0.7420949339866638,
- -0.8717162013053894,
- 0.3239639103412628,
- 0.3646659553050995,
- 0.18762114644050598,
- 0.4323038160800934,
- 0.49042609333992004,
- 0.4172574579715729,
- -0.4056946337223053,
- -0.7565715909004211,
- -0.8770694732666016,
- -0.6713137626647949,
- 0.3914759159088135,
- 0.5560338497161865,
- 0.401335746049881,
- 0.6967827081680298,
- 0.5735718011856079,
- 0.9659417867660522,
- 0.4600377678871155,
- -0.7376769781112671,
- -0.7612969279289246,
- -0.8649499416351318,
- -0.9680713415145874,
- -0.07136695086956024,
- 0.08702337741851807,
- -0.0012019457062706351,
- -0.40912172198295593,
- -0.006982382852584124,
- -0.2469279021024704,
- 0.2634161114692688,
- 0.19823867082595825,
- 0.6264614462852478,
- -0.0895332545042038,
- 0.15487948060035706,
- 0.010749834589660168,
- 0.21317049860954285,
- 0.3579390347003937,
- 0.6785242557525635,
- 0.4390743672847748,
- 0.2672802209854126,
- -0.8758218884468079,
- -0.963442862033844,
- -0.9812936782836914,
- 0.47073882818222046,
- 0.4233376085758209,
- 0.6527111530303955,
- 0.6982703804969788,
- 0.6721965670585632,
- 0.9104544520378113,
- 0.8594658970832825,
- 0.9712696671485901,
- 0.7178391218185425,
- 0.9804772734642029,
- 0.9899379014968872,
- -0.272844135761261,
- -0.23376643657684326,
- -0.262163907289505,
- 0.03704443946480751,
- -0.4075758457183838,
- -0.7010478377342224,
- -0.20673303306102753,
- -0.5571584105491638,
- -0.8706849217414856,
- -0.48726165294647217,
- -0.2910931706428528,
- -0.002765015931800008,
- 0.05970108136534691,
- 0.3084672689437866,
- 0.15337669849395752,
- -0.6174674034118652,
- -0.6328142881393433,
- -0.5624826550483704,
- 0.1400715708732605,
- 0.3191937208175659,
- 0.02131892368197441,
- -0.09887219220399857,
- -0.13459566235542297,
- 0.031372569501399994,
- -0.23347316682338715,
- -0.1083475649356842,
- 0.10015857964754105,
- -0.15261906385421753,
- -0.3190996050834656,
- 0.5962103009223938,
- 0.944227933883667,
- 0.6263585686683655,
- -0.03721585124731064,
- -0.14064188301563263,
- -0.12287423759698868,
- 0.1620333045721054,
- 0.051118478178977966,
- 0.025942236185073853,
- 0.9509856700897217,
- 0.07660112529993057,
- -0.2148650735616684,
- -0.2792571783065796,
- -0.3916383981704712,
- -0.5475131869316101,
- -0.3573049306869507,
- -0.5381907820701599,
- 0.5642790794372559,
- 0.39763057231903076,
- 0.4926196038722992,
- 0.6876794695854187,
- 0.9853602051734924,
- 0.9853602051734924,
- 0.2784459888935089,
- 0.33439427614212036,
- 0.3757942020893097,
- 0.5680580735206604,
- -0.202531099319458,
- 0.04602264240384102,
- 0.1253708153963089,
- -0.053822703659534454,
- -0.09523261338472366,
- -0.3647562861442566,
- 0.055967457592487335,
- -0.18043585121631622,
- -0.36183372139930725,
- -0.26616132259368896,
- 0.5843426585197449,
- 0.7874525785446167,
- 0.3204408586025238,
- 0.46942922472953796,
- -0.3549381494522095,
- -0.15470989048480988,
- -0.28662583231925964,
- -0.45677778124809265,
- -0.14482297003269196,
- -0.3699699342250824,
- -0.31996339559555054,
- 0,
- 0.03902474418282509,
- -0.4207833707332611,
- 0.5997176170349121,
- 0.34521904587745667,
- 0.260562002658844,
- 0.301216721534729,
- -0.39678168296813965,
- -0.9933051466941833,
- -0.48806899785995483,
- -0.9801273941993713,
- -0.9932265877723694,
- -0.00268577691167593,
- -0.4860992431640625,
- -0.718903660774231,
- -0.22610677778720856,
- 0.40737977623939514,
- 0.7242735624313354,
- 0.9194390773773193,
- 0.992190957069397,
- 0.5167772769927979,
- -0.8444285988807678,
- -0.6822850704193115,
- 0.6697694063186646,
- 0.9455884695053101,
- -0.563209056854248,
- -0.6827536821365356,
- -0.6466551423072815,
- -1,
- 0.00808846578001976,
- -0.21341004967689514,
- -0.08499597012996674,
- -0.22998903691768646,
- -0.6067743301391602,
- -0.49108201265335083,
- -0.5265984535217285,
- -0.9826362729072571,
- -0.23542766273021698,
- -0.2631172835826874,
- -0.38973894715309143,
- -0.510794460773468,
- 0.614811897277832,
- 0.9284683465957642,
- 0.980880856513977,
- 0.6759928464889526,
- 0.7887943387031555,
- 0.334210067987442,
- 0.8685921430587769,
- 0.9433988928794861,
- 0.3017013370990753,
- 0.322925865650177,
- 0.0030513221863657236,
- -0.08400421589612961,
- 0.1492752730846405,
- 0.15100379288196564,
- 0.2531687021255493,
- 0.22673995792865753,
- 0.08318476378917694,
- -0.09412675350904465,
- -0.10312476009130478,
- 0.00051957240793854,
- 0.1938382387161255,
- -0.429431289434433,
- -0.6668448448181152,
- 0.27889484167099,
- -0.9699349999427795,
- -0.6830593347549438,
- -0.9178845286369324,
- -0.8040575385093689,
- -0.03522491827607155,
- 0.586391270160675,
- 0.9315357804298401,
- 0.7273709177970886,
- 0.23738005757331848,
- 0.16160446405410767,
- 0.196137934923172,
- 0.6648127436637878,
- 0.9904631972312927,
- 0.9321214556694031,
- -0.9826473593711853,
- -0.5793296098709106,
- -0.5139965415000916,
- -0.9829296469688416,
- 0.10490112006664276,
- 0.26333707571029663,
- 0.015549364499747753,
- 0.7950919270515442,
- -0.22844749689102173,
- 0.08410408347845078,
- -0.014554033055901527,
- -0.40973183512687683,
- -0.6088537573814392,
- -0.7200993895530701,
- -0.25975117087364197,
- -0.05376914516091347,
- 0.25696367025375366,
- -0.02727169543504715,
- -0.9200538992881775,
- -0.9851748943328857,
- 0.2039009928703308,
- -0.18674251437187195,
- -0.0373150035738945,
- 0.0003531149122864008,
- 0.7743528485298157,
- 0.49138516187667847,
- 0.8453116416931152,
- 0.8113861680030823,
- -0.2243531048297882,
- 0.17102263867855072,
- 0.13133029639720917,
- -0.8719936609268188,
- -0.7000458240509033,
- -0.5028141736984253,
- 0.5621294975280762,
- -0.48999398946762085,
- 1,
- 0.9576523303985596,
- -0.41538330912590027,
- -0.5296134352684021,
- -0.5272583365440369,
- 0.26668936014175415,
- 0.9760602116584778,
- 0.874788224697113,
- -0.8827227354049683,
- -0.9637153744697571,
- -0.5040878057479858,
- -0.27172648906707764,
- 0.274967223405838,
- -0.01066218875348568,
- 0.29421308636665344,
- 0.1539771407842636,
- 0.15297439694404602,
- 0.35023635625839233,
- -0.21796944737434387,
- 0.8537461161613464,
- 0.9835426211357117,
- 0.9496530294418335,
- 0.9985606074333191,
- -0.2221001833677292,
- 0.4310095012187958,
- 0.6029019355773926,
- 0.7001603841781616,
- 0.8360967636108398,
- 0.519031286239624,
- -0.9936496019363403,
- -0.9828091859817505,
- 0.26668936014175415,
- 0.5236851572990417,
- 0.49962037801742554,
- 0.5692272782325745,
- 0.22008033096790314,
- 0.2918113172054291,
- -0.005608721170574427,
- 0.03870052844285965,
- 0.26892536878585815,
- -0.1814487725496292,
- 0.06543553620576859,
- 0.08210965245962143,
- -0.09493392705917358,
- 0.23452402651309967,
- 0.04021294042468071,
- -0.09652941673994064,
- 0.6716895699501038,
- 0.8282829523086548,
- -0.5790790915489197,
- -0.7159784436225891,
- -0.874889612197876,
- -0.9411375522613525,
- -0.25209754705429077,
- -0.6056337356567383,
- -0.4996890425682068,
- 0.268974632024765,
- 0.4170511066913605,
- 0.2456361949443817,
- 0.17661170661449432,
- -0.6461558938026428,
- -0.8366621732711792,
- -0.9373155832290649,
- 0.6573933362960815,
- 0.764940083026886,
- 0.4581672251224518,
- 0.012059792876243591,
- -0.36481741070747375,
- 0.047285694628953934,
- -0.19150404632091522,
- -0.06492480635643005,
- 0.2849947214126587,
- 0.49767422676086426,
- 0.28277072310447693,
- 0.54390949010849,
- 0.1638433039188385,
- -0.31062552332878113,
- -0.08801092207431793,
- -0.47230759263038635,
- -0.2938145399093628,
- -0.0704847201704979,
- 0.6260424852371216,
- 0.39466437697410583,
- 0.31425905227661133,
- 0.7220942974090576,
- -0.7903173565864563,
- 0.2835279703140259,
- 0.6021785140037537,
- 0.5951641798019409,
- 0.3522506654262543,
- 0.5202761888504028,
- 0.6336329579353333,
- 0.44877156615257263,
- 0.5989428758621216,
- 0.9741127490997314,
- 0.9952908158302307,
- 0.6856418251991272,
- -0.18962796032428741,
- 0.14198823273181915,
- 0.027870045974850655,
- -0.2665543556213379,
- -0.12062981724739075,
- -0.35000452399253845,
- -0.6031556725502014,
- -0.7968862652778625,
- -0.9509775042533875,
- 0.2576938569545746,
- -0.17726917564868927,
- 0.9844260215759277,
- -0.4435259699821472,
- -0.1699523627758026,
- 0.6966899037361145,
- 0.9935153722763062,
- 0.994518518447876,
- 0.9067777991294861,
- -0.9979760646820068,
- -0.9827584624290466,
- -0.01198972761631012,
- 0.004887382499873638,
- 0.9262871146202087,
- -0.011220625601708889,
- 0.20926238596439362,
- 0.08175507932901382,
- 0.13949643075466156,
- 0.24324852228164673,
- 0.2432398945093155,
- -0.03161051869392395,
- 0.41032442450523376,
- 0.5218767523765564,
- -0.1977277398109436,
- 0.07446050643920898,
- -0.20594902336597443,
- -0.3251917064189911,
- -0.6149249076843262,
- 0.4732542634010315,
- 0.07446050643920898,
- 0.3481038212776184,
- 0.22188933193683624,
- 0.2149362415075302,
- -0.24006293714046478,
- -0.2876802384853363,
- 0.41702282428741455,
- 0.19047819077968597,
- -0.2501949965953827,
- -0.15160758793354034,
- 0.43379339575767517,
- 0.0909355953335762,
- 0.451621413230896,
- 0.5065004825592041,
- -0.9908729195594788,
- -0.08206022530794144,
- -0.027877792716026306,
- 0.5542229413986206,
- -0.38842886686325073,
- 0.9741654992103577,
- -0.3724351227283478,
- -0.1986246407032013,
- -0.3232215344905853,
- 0.7665350437164307,
- 0.5796975493431091,
- -0.6754114627838135,
- -0.8743530511856079,
- -0.8580234050750732,
- 0.7657902240753174,
- 0.6770547032356262,
- 0.5566800236701965,
- 0.935212254524231,
- -0.584112286567688,
- 0.017612561583518982,
- -0.36803585290908813,
- -0.5247402191162109,
- 0.4970661997795105,
- -0.6998907327651978,
- -0.5846438407897949,
- 0.9509856700897217,
- 0.8254937529563904,
- 0.6614059805870056,
- 0.5184406042098999,
- -0.5043556690216064,
- -0.8817981481552124,
- -0.6980621218681335,
- -0.3875381350517273,
- -0.9762217998504639,
- -0.9982428550720215,
- 0.2067089080810547,
- 0.11346746981143951,
- 0.01595616154372692,
- -0.2828061878681183,
- 0.014170551672577858,
- 0.6205798983573914,
- -0.8973569869995117,
- -0.7388009428977966,
- -0.5494065880775452,
- -0.8166348338127136,
- 0.5313565731048584,
- -0.004518178757280111,
- 0.48383238911628723,
- -0.4977671205997467,
- -0.11393170058727264,
- -0.1845625638961792,
- -0.3601009249687195,
- -0.314405232667923,
- 0.48286524415016174,
- 0.20714795589447021,
- 0.040663253515958786,
- -0.9531037211418152,
- -0.26953038573265076,
- -0.4040994942188263,
- -0.26528051495552063,
- 0.23274151980876923,
- -0.6318374872207642,
- -0.9665676951408386,
- 0.005913611501455307,
- 0.49386274814605713,
- 0.23279796540737152,
- 0.24144552648067474,
- 0.3414899408817291,
- 0.30328240990638733,
- -0.9941494464874268,
- -0.3179697096347809,
- -0.25289952754974365,
- -0.4826950430870056,
- -0.992070198059082,
- -0.9115789532661438,
- -0.5940829515457153,
- -0.5463100671768188,
- -0.9485341310501099,
- -0.6519872546195984,
- -0.9987034797668457,
- -0.5913269519805908,
- -0.7342608571052551,
- 1,
- 0.45685240626335144,
- -0.0836566612124443,
- -0.5427722334861755,
- -0.2221001833677292,
- -0.9979760646820068,
- -0.7426897883415222,
- 0.4536954462528229,
- -0.5354653596878052,
- -0.5605345368385315,
- -0.24477224051952362,
- -0.31265220046043396,
- -0.8582495450973511,
- -0.2184845358133316,
- -0.8255475759506226,
- -0.8973569869995117,
- -0.9509775042533875,
- 0.7109987735748291,
- -0.3486618995666504,
- -0.5666218400001526,
- 0.0820944681763649,
- 0.28015971183776855,
- -0.9690587520599365,
- -0.6733459830284119,
- -0.929873526096344,
- 0.05627104640007019,
- -0.5349896550178528,
- -0.49556639790534973,
- -0.2316868156194687,
- -0.2666398584842682,
- -0.5846438407897949,
- 0.9041470885276794,
- 0.34881946444511414,
- 0.73880535364151,
- -0.4977671205997467,
- -0.620514452457428,
- 0.3705782890319824,
- -0.3981460928916931,
- -0.7447241544723511,
- -0.5671089291572571,
- -0.7126420140266418,
- 0.3201524019241333,
- -0.9361801147460938,
- -0.021949056535959244,
- 0.26071488857269287,
- 0.11704500019550323,
- -0.09812191873788834,
- -0.6564890742301941,
- 0.5860076546669006,
- 0.23305492103099823,
- 0.1070864275097847,
- 0.02329915389418602,
- -0.2407625913619995,
- 0.3414646089076996,
- 0.6114945411682129,
- 0.0007608749438077211,
- -0.18877489864826202,
- -0.06473154574632645,
- -0.5393319725990295,
- -0.37636464834213257,
- -0.2776724100112915,
- 0.407381534576416,
- 0.5711175799369812,
- 0.10242214798927307,
- -0.5774988532066345,
- 0.5009621977806091,
- 0.7229906320571899,
- 0.5307389497756958,
- 0.8771102428436279,
- -0.6564419269561768,
- -0.41044551134109497,
- -0.6564419269561768,
- -0.7309668660163879,
- -0.9828091859817505,
- -0.9828091859817505,
- -0.31996339559555054,
- 0.02778959460556507,
- -0.18145851790905,
- -0.4760945737361908,
- -0.6159340143203735,
- -0.5961918830871582,
- -0.6848282217979431,
- -0.251895934343338,
- 0.29486724734306335,
- 0.40002304315567017,
- 0.9899379014968872,
- 0.7229412794113159,
- 0.9807852506637573,
- -0.7337335348129272,
- -0.8108888864517212,
- -0.5162743926048279,
- -0.6094732284545898,
- -0.9194790720939636,
- 0.5308945178985596,
- 0.01500244252383709,
- -0.7993972897529602,
- 0.9984241127967834,
- -0.012843931093811989,
- -0.8668404221534729,
- 0.990543007850647,
- 0.0920555591583252,
- -0.31916898488998413,
- 0.9374285340309143,
- 0.7959373593330383,
- 0.8754876255989075,
- -0.8362293243408203,
- -0.6582773923873901,
- -0.9916395545005798,
- -0.8973569869995117,
- 0.061656251549720764,
- 0.5361354351043701,
- 0.36971715092658997,
- -0.4583832919597626,
- -0.46862149238586426,
- -0.9807852506637573,
- -0.9511585831642151,
- -0.27999889850616455,
- 0.038460005074739456,
- 0.1938815712928772,
- 0.19310392439365387,
- 0.5270761847496033,
- 0.5389652252197266,
- -0.5263717770576477,
- 0.31121960282325745,
- 0.13053779304027557,
- 0.2712872624397278,
- 0.9807852506637573,
- -0.97075355052948,
- 0.9580817818641663,
- 0.7310782670974731,
- 0.5388161540031433,
- 0.9519411325454712,
- 0.8434329628944397,
- -0.4833066761493683,
- -0.20707954466342926,
- -0.5099445581436157,
- -0.6608012318611145,
- -0.018839603289961815,
- -0.7309668660163879,
- -0.5254232883453369,
- 0.3551715314388275,
- -0.21630725264549255,
- -0.39276570081710815,
- -0.07621423900127411,
- 0.02646898478269577,
- 0.3646659553050995,
- 0.8563774824142456,
- 0.5865227580070496,
- 0.46233615279197693,
- 0.8343841433525085,
- -0.8973569869995117,
- -0.5947028398513794,
- -0.8064454793930054,
- 0.570570170879364,
- 0.5161767601966858,
- 0.48175233602523804,
- 0.4885003864765167,
- -0.38643592596054077,
- -0.4773034155368805,
- -0.38785600662231445,
- 0.8576608896255493,
- -0.9899351596832275,
- 0.9875081777572632,
- -0.1636705994606018,
- -0.9172571897506714,
- -0.16427050530910492,
- -0.4349454939365387,
- -0.9953550100326538,
- -0.9971668124198914,
- 0.6962160468101501,
- 0.5453452467918396,
- -0.05568347126245499,
- -0.6601232290267944,
- -0.842789351940155,
- -0.2496166080236435,
- -0.8420789837837219,
- -0.8744059801101685,
- -0.834104597568512,
- -0.9026780724525452,
- 0.9523860216140747,
- 0.9934259653091431,
- -0.7173683643341064,
- -0.9974165558815002,
- 0.3086850345134735,
- -0.8398857116699219,
- -0.2520681619644165,
- -0.2881055772304535,
- -0.17640793323516846,
- -0.8340798020362854,
- 0.803859293460846,
- -0.5375675559043884,
- -0.35286054015159607,
- -0.40147092938423157,
- -0.5391048192977905,
- -0.4075758457183838,
- -0.06929513067007065,
- 0.4999752938747406,
- 0.5083998441696167,
- 0.7683452367782593,
- 0.44873738288879395,
- 0.1870150864124298,
- 0.44929590821266174,
- 0.7604588270187378,
- -0.253332257270813,
- 0.7990961074829102,
- -0.4588089883327484,
- -0.36481741070747375,
- -0.2928994297981262,
- -0.620514452457428,
- -0.8754743337631226,
- -0.6474624276161194,
- -0.7147241830825806,
- -0.8206048011779785,
- 0.8667620420455933,
- 0.8917268514633179,
- 0.9518074989318848,
- -0.5455569624900818,
- 0.06518997251987457,
- -0.1746850311756134,
- 0.711083710193634,
- -0.7957763075828552,
- -0.23037903010845184,
- 0.4979412853717804,
- -0.9531556367874146,
- -0.9841888546943665,
- 0.04183444380760193,
- 0.8254937529563904,
- 0.9814017415046692,
- -0.5506122708320618,
- 0.9509856700897217,
- 0.8974766731262207,
- 0.8271036744117737,
- 0.6565945744514465,
- 0.5882179737091064,
- 0.4074084758758545,
- 0.1779918372631073,
- 0.8254937529563904,
- 0.3646659553050995,
- 0.6998251676559448,
- -0.25461456179618835,
- -0.16163697838783264,
- 0.5031144618988037,
- 0.056570108979940414,
- 0.4599801003932953,
- 0.22676178812980652,
- -0.27921000123023987,
- -0.5993555784225464,
- 0.9872598648071289,
- -0.1492013782262802,
- -0.11010982096195221,
- 0.08578278124332428,
- -0.176510289311409,
- 0.12077020108699799,
- -0.08411595970392227,
- 0.9915391802787781,
- 0.7307949662208557,
- 0.8754876255989075,
- -0.2441762387752533,
- -0.14552778005599976,
- -0.2168065309524536,
- -0.4977671205997467,
- 0.6998251676559448,
- 0.5844343304634094,
- -0.4977671205997467,
- -0.5964337587356567,
- 0.16315852105617523,
- 0.7636315226554871,
- 0.265627384185791,
- 0.9430791139602661,
- 0.6161730289459229,
- 0.9977315664291382,
- 0.9039280414581299,
- -0.06703191250562668,
- 0.4994438886642456,
- 0.4858933091163635,
- 0.9834839701652527,
- 0.880670964717865,
- 0.8490715026855469,
- 0.9645264744758606,
- -0.9836878776550293,
- 0.020235415548086166,
- 0.6966110467910767,
- 0.9339800477027893,
- 0.5601944327354431,
- -0.00601609330624342,
- 0.22188933193683624,
- 0.06982731819152832,
- 0.42058631777763367,
- -0.20701900124549866,
- -0.5002540349960327,
- -0.9948720335960388,
- -0.6225435733795166,
- 0.29936158657073975,
- -0.9993430376052856,
- -0.8705465197563171,
- 0.9978688955307007,
- 0.9816693663597107,
- -0.2221001833677292,
- -0.07432012259960175,
- 0.005510379560291767,
- 0.93561190366745,
- 0.769040584564209,
- 0.4979412853717804,
- 0.09552592039108276,
- -0.4952143132686615,
- 0.8628236055374146,
- 0.891992449760437,
- 0.3251786231994629,
- -0.9622695446014404,
- -0.9051315188407898,
- 0.6972473859786987,
- -0.9227719902992249,
- -0.9991018772125244,
- 0.9954250454902649,
- -0.2867448031902313,
- 0.40268635749816895,
- 0.14126500487327576,
- 0.9529435634613037,
- 0.6507450938224792,
- 0.27342158555984497,
- -0.9639715552330017,
- -0.971455454826355,
- 0.9434934258460999,
- 0.7417119145393372,
- 0.922407329082489,
- 0.7960216403007507,
- 0.39301806688308716,
- 0.44151046872138977,
- 0.9164034128189087,
- -0.45337846875190735,
- -0.7604051232337952,
- -0.9881238341331482,
- 0.3329641819000244,
- 0.5564926266670227,
- -0.7899213433265686,
- 0.7021987438201904,
- -0.9409090876579285,
- 0.8222968578338623,
- -0.1262354850769043,
- 0.9899379014968872,
- 0.8101232051849365,
- 0.4139884412288666,
- 0.4850161373615265,
- 0.8455127477645874,
- -0.7117887139320374,
- -0.9599732160568237,
- 0.32545220851898193,
- -0.017274606972932816,
- 0.0917535200715065,
- 0.9274268746376038,
- 0.7069732546806335
- ],
- "z": [
- 0.24893133342266083,
- 0.06961314380168915,
- 0.38458311557769775,
- 0.045085154473781586,
- -0.2524856626987457,
- -0.6164182424545288,
- -0.4557993710041046,
- -0.09390309453010559,
- -0.6660021543502808,
- -0.5890951156616211,
- -0.9959505200386047,
- -0.6060599088668823,
- -0.298443466424942,
- -0.4645257592201233,
- -0.23048292100429535,
- -0.21867342293262482,
- -0.31317806243896484,
- 0.07732536643743515,
- -0.3414348065853119,
- -0.05248579755425453,
- -0.10382933914661407,
- -0.019813725724816322,
- 0.2175561636686325,
- 0.13014905154705048,
- 0.40530869364738464,
- 0.7156205773353577,
- 0.7926167249679565,
- 0.4570474326610565,
- -0.13187628984451294,
- 0.12653519213199615,
- -0.22819986939430237,
- -0.3281902074813843,
- 0.28013405203819275,
- 0.6267420649528503,
- 0.39846572279930115,
- 0.3510749340057373,
- -0.33739176392555237,
- -0.18817365169525146,
- -0.24846261739730835,
- -0.5050169229507446,
- -0.5259588956832886,
- -0.26771974563598633,
- -0.446445107460022,
- -0.248659148812294,
- 0.24804984033107758,
- 0.18279309570789337,
- 0.03786000609397888,
- -0.07831154018640518,
- -0.20537401735782623,
- 0.22865191102027893,
- 0.03590712696313858,
- 0.0510106198489666,
- -0.5112490653991699,
- -0.4819660484790802,
- -0.5647855401039124,
- -0.9934210777282715,
- -0.9370624423027039,
- -0.3811916410923004,
- -0.5316653251647949,
- -0.5263366103172302,
- -0.7243698835372925,
- -0.8403451442718506,
- -0.5899010300636292,
- -0.9501896500587463,
- -0.9997191429138184,
- 0.3994015157222748,
- 0.5550714731216431,
- 0.1366790235042572,
- 0.33598801493644714,
- 0.49225300550460815,
- 0.6483957171440125,
- 0.3165377676486969,
- 0.05070596933364868,
- 0.3658945858478546,
- 0.07349245995283127,
- 0.02135220356285572,
- 0.9899535775184631,
- 0.6588714122772217,
- 0.9584241509437561,
- 0.7039474248886108,
- 0.9926663041114807,
- 0.5769069790840149,
- 0.6764622330665588,
- 0.998921275138855,
- 0.5113556385040283,
- 0.5350059866905212,
- 0.4005412459373474,
- 0.18379539251327515,
- -0.6124829649925232,
- -0.916515052318573,
- -0.6823439002037048,
- 0.06995134800672531,
- -0.09971776604652405,
- 0.30412760376930237,
- -0.678033173084259,
- -0.5627862811088562,
- -0.42405495047569275,
- -0.4404540956020355,
- -0.22640195488929749,
- -0.2587750554084778,
- -0.5708564519882202,
- -0.5173807144165039,
- -0.9726678133010864,
- -0.6065524220466614,
- -0.9628442525863647,
- -0.060457516461610794,
- 0.07383366674184799,
- 0.033002905547618866,
- -0.26771634817123413,
- -0.29332637786865234,
- -0.2589031755924225,
- 0.4012563228607178,
- 0.6697467565536499,
- 0.37911468744277954,
- 0.6959860324859619,
- -0.3439806401729584,
- -0.709836483001709,
- -0.36161622405052185,
- -0.5031288266181946,
- -0.37700721621513367,
- -0.027168434113264084,
- 0.1186046227812767,
- 0.9283714294433594,
- 0.6873116493225098,
- 0.9881190061569214,
- 0.9892323613166809,
- 0.6267638206481934,
- 0.6916837096214294,
- 0.3116864562034607,
- 0.45751941204071045,
- -0.30098357796669006,
- -0.5340659618377686,
- -0.070583276450634,
- 0.9836627840995789,
- 0.9826307892799377,
- 0.2885918915271759,
- 0.23875781893730164,
- -0.0010253038490191102,
- -0.01305148471146822,
- -0.7080255746841431,
- -0.5416524410247803,
- -0.7137928605079651,
- -0.8609718084335327,
- -0.6466995477676392,
- -0.22543102502822876,
- -0.46304792165756226,
- 0.40055951476097107,
- 0.5511629581451416,
- 0.4643996059894562,
- -0.24696844816207886,
- 0.0023746946826577187,
- -0.121971994638443,
- 0.09900698065757751,
- 0.24953289330005646,
- 0.22445939481258392,
- 0.10599268972873688,
- -0.02011456899344921,
- 0.4988115429878235,
- 0.9421597123146057,
- 0.7781175374984741,
- 0.7483584880828857,
- -0.9510202407836914,
- -0.5498870611190796,
- -0.8496232032775879,
- -0.25599583983421326,
- -0.018814457580447197,
- 0.0450722798705101,
- 0.006867034826427698,
- 0.9926801323890686,
- -0.33451950550079346,
- -0.6014363765716553,
- -0.3249167501926422,
- -0.42981573939323425,
- -0.7796371579170227,
- -0.6329610347747803,
- -0.9835079908370972,
- -0.9459924101829529,
- -0.5039926767349243,
- -0.4338308274745941,
- -0.25865885615348816,
- -0.6047350168228149,
- -0.20979124307632446,
- 0.5729902386665344,
- 0.7663477659225464,
- 0.29461243748664856,
- 0.5809187293052673,
- -0.18392319977283478,
- 0.020668039098381996,
- -0.27200955152511597,
- 0.03924412652850151,
- 0.0195060633122921,
- 0.3324436545372009,
- 0.6782426834106445,
- 0.17382746934890747,
- 0.4320796728134155,
- 0.20146599411964417,
- 0.37333109974861145,
- 0.5286331176757812,
- -0.02363656461238861,
- -0.0906238928437233,
- 0.5550857782363892,
- 0.5451454520225525,
- 0.5945549011230469,
- -0.7518652677536011,
- -0.5248426795005798,
- -0.387797087430954,
- -0.5349641442298889,
- -0.25117042660713196,
- 0.1672535389661789,
- -0.030160700902342796,
- 0.2272733896970749,
- 0.22918443381786346,
- 0.0007958645583130419,
- -0.47246626019477844,
- -0.26326435804367065,
- -0.2667330503463745,
- 0.2950707972049713,
- 0.5224003791809082,
- 0.24893133342266083,
- 0.24893133342266083,
- -0.3438313901424408,
- 0.2669813930988312,
- -0.05906572937965393,
- 0.3875717222690582,
- 0.2657814919948578,
- 0.7311900854110718,
- 0.6060779690742493,
- 0.45794302225112915,
- -0.010273333638906479,
- 0.1575591117143631,
- 0.3539920449256897,
- -0.6644736528396606,
- -0.48027414083480835,
- -0.9416919350624084,
- 0.9293450713157654,
- 0.4946977198123932,
- 0.5810832977294922,
- 0.8662898540496826,
- 0.9053993225097656,
- 0.5155513882637024,
- 0.6468337774276733,
- 0.4702588617801666,
- 0.11277738958597183,
- -0.048379454761743546,
- -0.2031347006559372,
- -0.4603961706161499,
- -0.1806602030992508,
- 0.10649269074201584,
- 0.24402277171611786,
- 0.22087182104587555,
- 0.6698569059371948,
- 0.6410759091377258,
- 0.4929329752922058,
- 0.23700262606143951,
- -0.37436285614967346,
- -0.2582411468029022,
- 0.000663433806039393,
- -0.9097479581832886,
- -0.6664299368858337,
- -0.9650605320930481,
- 0.4332942068576813,
- 0.19210495054721832,
- 0.2930695116519928,
- 0.23533089458942413,
- 0.6286520957946777,
- 0.6442918181419373,
- 0.34618571400642395,
- -0.006241363473236561,
- 0.1833106428384781,
- 0.29168185591697693,
- -0.002174111781641841,
- 0.47259294986724854,
- 0.25226056575775146,
- 0.1899283230304718,
- 0.1295872926712036,
- -0.14776815474033356,
- -0.007787336595356464,
- 0.1263086497783661,
- 0.15495635569095612,
- 0.40780001878738403,
- 0.5031928420066833,
- 0.22645917534828186,
- 0.04210563376545906,
- 0.1961057186126709,
- -0.10216209292411804,
- 0.28054866194725037,
- 0.4921416640281677,
- 0.18888798356056213,
- 0.29682838916778564,
- 0.9105742573738098,
- 0.7120792269706726,
- 0.46320977807044983,
- 0.830166220664978,
- 0.48220357298851013,
- -0.8679813146591187,
- -0.9516631364822388,
- 0.47452154755592346,
- 0.7259277701377869,
- 0.6084266901016235,
- 0.9848937392234802,
- -0.23830050230026245,
- -0.76807701587677,
- -0.44848307967185974,
- -0.24442195892333984,
- 0.0057609472423791885,
- 0.04943608120083809,
- -0.038206059485673904,
- -0.20376498997211456,
- -0.33428671956062317,
- -0.4373824894428253,
- -0.42244595289230347,
- -0.6520264744758606,
- -0.36086952686309814,
- -0.6188114285469055,
- 0.1818607598543167,
- -0.31560376286506653,
- -0.2107848972082138,
- -0.6734336614608765,
- 0.9861479997634888,
- 0.9878979325294495,
- 0.9840410947799683,
- 0.34084373712539673,
- -0.6104958653450012,
- 0.29332637786865234,
- 0.6329606175422668,
- 0.4734562635421753,
- 0.6387461423873901,
- 0.9190930128097534,
- -0.34333351254463196,
- -0.19907696545124054,
- -0.007516813464462757,
- 0.35606294870376587,
- 0.5664986968040466,
- 0.2380324900150299,
- 0.02087165042757988,
- 0.1486402451992035,
- -0.1486402451992035,
- -0.5884139537811279,
- -0.24894261360168457,
- -0.5900663137435913,
- -0.4645562767982483,
- 0.22966508567333221,
- 0.30052053928375244,
- 0.25223761796951294,
- 0.4725068509578705,
- 0.9906204342842102,
- 0.53376704454422,
- 0.5839667320251465,
- 0.9822286367416382,
- -0.5414755940437317,
- -0.959226131439209,
- -0.8078566789627075,
- -0.6092051267623901,
- -0.634707510471344,
- -0.5340558290481567,
- 0.20579388737678528,
- 0.5619252324104309,
- 0.020743170753121376,
- -0.8842752575874329,
- -0.9857361912727356,
- -0.5279218554496765,
- -0.9429054260253906,
- 0,
- -0.4684806168079376,
- -0.21044278144836426,
- -0.7952387928962708,
- -0.9352442026138306,
- -0.9609246850013733,
- -0.4732184112071991,
- 0.23765499889850616,
- -0.0679740384221077,
- -0.14824911952018738,
- 0.19725912809371948,
- -0.06877187639474869,
- -0.07851611077785492,
- 0.8686026334762573,
- 0.6927322745323181,
- 0.6234987378120422,
- 0.5488587021827698,
- -0.19145558774471283,
- -0.3909909725189209,
- -0.07928632199764252,
- -0.3109854459762573,
- 0.5313256978988647,
- 0.03555777668952942,
- 0.0490003265440464,
- 0.31111860275268555,
- 0.10442136228084564,
- 0.17511685192584991,
- -0.11836609244346619,
- 0,
- -0.01821127161383629,
- -0.3708040714263916,
- -0.2981916069984436,
- -0.46162664890289307,
- -0.1726837307214737,
- -0.123359814286232,
- 0.4126456081867218,
- 0.17629684507846832,
- 0.43020865321159363,
- -0.16406390070915222,
- -0.29134809970855713,
- -0.3465260863304138,
- -0.1638673096895218,
- -0.36755621433258057,
- -0.19412018358707428,
- -0.2797713577747345,
- 0.6075701713562012,
- 0.654580295085907,
- -0.4861188530921936,
- -0.31833672523498535,
- -0.5780981779098511,
- -0.6000235080718994,
- -0.004480898380279541,
- 0.06860040128231049,
- -0.24482126533985138,
- 0.28688132762908936,
- -0.9631673693656921,
- -0.971184492111206,
- -0.5911328792572021,
- -0.9907293319702148,
- 0.5847785472869873,
- 0.9999487996101379,
- 0.5352766513824463,
- -0.8988922834396362,
- -0.7401489019393921,
- 0.9553634524345398,
- -0.23085886240005493,
- -0.11746350675821304,
- -0.3938993215560913,
- -0.5889719724655151,
- -0.2792058289051056,
- -0.3732108473777771,
- -0.3574441075325012,
- -0.6824148297309875,
- -0.22026440501213074,
- -0.5700737833976746,
- -0.5176344513893127,
- 0.12050525844097137,
- -0.09682867676019669,
- -0.35551348328590393,
- -0.17618408799171448,
- -0.2755252420902252,
- 0.04571164771914482,
- -0.17331843078136444,
- -0.9896681308746338,
- -0.6911693215370178,
- -0.5965977907180786,
- -0.5998966097831726,
- -0.9706664681434631,
- -0.9917164444923401,
- -0.6897068619728088,
- -0.9094218611717224,
- 0.78774094581604,
- 0.6912752389907837,
- 0.0785423144698143,
- 0.016106540337204933,
- -0.22879524528980255,
- 0.013991397805511951,
- -0.38984066247940063,
- -0.15052154660224915,
- -0.5829851031303406,
- -0.23330901563167572,
- 0.059916771948337555,
- 0.0003111835103482008,
- 0.6251672506332397,
- 0.31113284826278687,
- 0.5296736359596252,
- -0.5800420045852661,
- 0.5752048492431641,
- 0.6355389952659607,
- 0.25313037633895874,
- -0.47975510358810425,
- -0.7129015326499939,
- 0.2674548923969269,
- -0.20113208889961243,
- 0.3797936737537384,
- 1.1691379777549558e-15,
- -0.2713494598865509,
- 0.40313920378685,
- 0.845343828201294,
- 0.39367449283599854,
- -0.9590659737586975,
- -0.2106667459011078,
- -0.47452685236930847,
- -0.4596824049949646,
- -0.25136223435401917,
- 0.15601640939712524,
- 0.08271649479866028,
- 0.9565548896789551,
- 0.7303852438926697,
- 0.6288405656814575,
- 0.9848345518112183,
- -0.09036430716514587,
- -0.42064154148101807,
- -0.9738449454307556,
- -0.5138938426971436,
- -0.16709473729133606,
- -0.2977195680141449,
- 0.014614290557801723,
- 0.9725919365882874,
- -0.593136191368103,
- 0.7926254868507385,
- 0.7128075361251831,
- 0.5469134449958801,
- 0.4639262855052948,
- -0.06447644531726837,
- 0.17454104125499725,
- -0.9590659737586975,
- -0.8485125303268433,
- -0.8613754510879517,
- -0.8202615976333618,
- -0.9732046723365784,
- -0.44705015420913696,
- -0.9994475841522217,
- -0.7387363910675049,
- -0.9583876729011536,
- 0.5713192224502563,
- 0.6820598244667053,
- 0.6784961819648743,
- 0.9906498193740845,
- -0.9688231945037842,
- -0.6363033056259155,
- -0.9904927015304565,
- -0.09575266391038895,
- -0.5594531893730164,
- 0.3919374942779541,
- 0.6962965726852417,
- 0.4743371605873108,
- 0.32579144835472107,
- -0.036251384764909744,
- 0.30545035004615784,
- -0.3993871510028839,
- -0.16404372453689575,
- -0.05687348172068596,
- 0.06529530882835388,
- -0.2403002232313156,
- -0.21965867280960083,
- -0.5458555817604065,
- -0.33839061856269836,
- -0.7479055523872375,
- -0.6366367340087891,
- -0.8835325837135315,
- -0.998812198638916,
- 0.9292991161346436,
- 0.5906811952590942,
- 0.1568344235420227,
- 0.329791784286499,
- 0.6214436292648315,
- 0.8624156713485718,
- 0.9541876912117004,
- 0.8377023935317993,
- 0.16098438203334808,
- 0.5198801755905151,
- 0.4614923894405365,
- 0.4828778803348541,
- -0.4090541899204254,
- -0.6571433544158936,
- 0.7736345529556274,
- 0.9174755811691284,
- 0.5050711035728455,
- 0.6888444423675537,
- -0.6057143807411194,
- 0.9539580345153809,
- 0.7932191491127014,
- 0.3558451235294342,
- -0.294318825006485,
- -0.43747037649154663,
- -0.2859049141407013,
- -0.5471164584159851,
- 0.3661544919013977,
- 0.21708662807941437,
- 0.047813039273023605,
- -0.10936380922794342,
- -0.9813233017921448,
- 0.6716124415397644,
- 0.9972550272941589,
- 0.9591069221496582,
- 0.9881190061569214,
- -0.5873571634292603,
- -0.7924172282218933,
- -0.597710132598877,
- -0.2933533787727356,
- 0.6591892242431641,
- 0.982540488243103,
- 0.15812546014785767,
- 0.5574328303337097,
- 0.3088320791721344,
- -0.15484392642974854,
- 0.06583964824676514,
- 0.0556543804705143,
- -0.41467854380607605,
- -0.020549282431602478,
- -0.17505614459514618,
- -0.6844256520271301,
- -0.14388316869735718,
- 0.37474673986434937,
- -0.9988948702812195,
- -0.18562301993370056,
- 0.21414516866207123,
- 0.1545124351978302,
- -0.0718170553445816,
- 0.09742579609155655,
- 0.2770216763019562,
- -0.1361367404460907,
- 0.23760713636875153,
- -0.979985237121582,
- -0.9926663041114807,
- -0.9774913191795349,
- -0.16620796918869019,
- 0.3408176600933075,
- -0.8754684329032898,
- -0.9926663041114807,
- -0.9343691468238831,
- -0.9726558923721313,
- 0.3258844017982483,
- -0.6285980939865112,
- -0.9526984095573425,
- 0.5530601739883423,
- 0.4029441475868225,
- -0.15432234108448029,
- -0.25908252596855164,
- 0.4096115529537201,
- 0.43439316749572754,
- -0.8870314359664917,
- -0.41186952590942383,
- 0.09266889840364456,
- 0.2557157576084137,
- 0.6775721907615662,
- -0.4413914978504181,
- 0.13172948360443115,
- 0.21691279113292694,
- -0.9269883036613464,
- 0.30631664395332336,
- 0.21891158819198608,
- -0.6346932053565979,
- -0.3447767496109009,
- 0.130438894033432,
- 0.47534096240997314,
- 0.5058916211128235,
- -0.6356008052825928,
- -0.24553059041500092,
- -0.17978045344352722,
- -0.34532439708709717,
- -0.2420850694179535,
- -0.4619636535644531,
- -0.4826432168483734,
- 0.5221319198608398,
- 0.029748890548944473,
- -0.7130288481712341,
- -0.8076095581054688,
- 0.29332637786865234,
- 0.5628518462181091,
- 0.06730208545923233,
- 0.4723880887031555,
- -0.12552547454833984,
- -0.4614121615886688,
- 0.08412102609872818,
- -0.13070812821388245,
- -0.2101341336965561,
- 0.01784065179526806,
- 0.9772608280181885,
- 0.9888244271278381,
- 0.998428463935852,
- 0.9541769623756409,
- 0.9986042976379395,
- -0.7781175374984741,
- 0.43230360746383667,
- 0.6684873104095459,
- 0.2304299771785736,
- -0.5736464858055115,
- -0.844412088394165,
- 0.00047851071576587856,
- -0.8698142766952515,
- -0.8623660206794739,
- -0.6524214744567871,
- 0.4876599907875061,
- 0.41059526801109314,
- 0.11519432067871094,
- 0.027569491416215897,
- -0.18464042246341705,
- 0.07333831489086151,
- -0.28634411096572876,
- -0.628840982913971,
- -0.4625285863876343,
- -0.7084884643554688,
- 0.13881811499595642,
- 0.013083233498036861,
- -0.2419593632221222,
- -0.9994175434112549,
- -0.8644529581069946,
- -0.969346821308136,
- 0.6237660050392151,
- 0.3980129659175873,
- 0.07845746725797653,
- 0.059401463717222214,
- 0.9435102343559265,
- 0.6205036044120789,
- 0.8704222440719604,
- 0.0805128887295723,
- 0.40569618344306946,
- 0.7998630404472351,
- -0.15637905895709991,
- -0.30140817165374756,
- -0.10545636713504791,
- 0.013164041563868523,
- -0.8021248579025269,
- -0.674019455909729,
- 1.1381953347961641e-15,
- 0.8842353820800781,
- 0.70960932970047,
- 0.8383103013038635,
- 0.9725919365882874,
- -0.020549282431602478,
- 0.6637487411499023,
- -0.4817539155483246,
- 0.842215895652771,
- 0.827395498752594,
- 0.5711965560913086,
- 0.9451232552528381,
- -0.505468487739563,
- -0.5622516870498657,
- 0.5627862811088562,
- 0.43230360746383667,
- 0.2933533787727356,
- -0.7023643851280212,
- 0.5701262354850769,
- 0.32938721776008606,
- -0.9919143915176392,
- -0.9549797773361206,
- 0.23374751210212708,
- 0.026159776374697685,
- -0.36292386054992676,
- 0.9944577813148499,
- 0.021349981427192688,
- -0.4515495300292969,
- -0.0596543550491333,
- -0.054855652153491974,
- -0.8076095581054688,
- -0.4196002781391144,
- -0.4410720765590668,
- -0.6684819459915161,
- 0.8623660206794739,
- 0.7781712412834167,
- -0.4617902934551239,
- 0.9156145453453064,
- 0.6612699031829834,
- 0.8220000267028809,
- 0.7003620862960815,
- 0.9428480863571167,
- 0.3421337604522705,
- 0.009491427801549435,
- -0.024708475917577744,
- -0.243136465549469,
- -0.6658512353897095,
- 0.05885906517505646,
- -0.12039002776145935,
- -0.9692688584327698,
- -0.9894528985023499,
- -0.712857186794281,
- 0.9669307470321655,
- 0.9363831281661987,
- 0.7855737209320068,
- 0.0020480032544583082,
- 0.48156502842903137,
- 0.23229436576366425,
- 0.2777603268623352,
- 0.9257963299751282,
- 0.6556273102760315,
- -0.9106780886650085,
- -0.3095446527004242,
- 0.9899122714996338,
- -0.8134732842445374,
- 0.8606582283973694,
- 0.6877522468566895,
- 0.4117426872253418,
- 0.4701825976371765,
- 0.7486863732337952,
- 0.544661283493042,
- 0.7486863732337952,
- 0.678033173084259,
- 0.17454104125499725,
- -0.17454104125499725,
- -0.9429054260253906,
- -0.9972629547119141,
- -0.7024728059768677,
- 0.484409362077713,
- -0.7819303274154663,
- -0.7981323003768921,
- -0.7253903150558472,
- -0.28735053539276123,
- 0.36599305272102356,
- -0.9146113395690918,
- -0.10216209292411804,
- 0.01893974095582962,
- 0.19509032368659973,
- -0.6746619939804077,
- -0.580647885799408,
- -0.8524736762046814,
- -0.38539648056030273,
- 0.3909161388874054,
- 0.8446590304374695,
- -0.9985224008560181,
- 0.5946504473686218,
- -0.01600003056228161,
- 0.40821167826652527,
- 0.48939603567123413,
- -0.09601835906505585,
- -0.9909332990646362,
- -0.5974749326705933,
- 0.33801841735839844,
- 0.5988664031028748,
- 0.47321829199790955,
- 0.5466654896736145,
- -0.08516772836446762,
- -0.08488517999649048,
- -0.43230360746383667,
- -0.9939273595809937,
- -0.8418577313423157,
- 0.37960660457611084,
- 0.3056824207305908,
- -0.3595028221607208,
- -0.19509032368659973,
- -0.29275640845298767,
- -0.9550285339355469,
- 0.9962120056152344,
- 0.9809043407440186,
- 0.6006340980529785,
- 0.8467000126838684,
- -0.8403451442718506,
- -0.8470764756202698,
- 0.2801212966442108,
- -0.9871431589126587,
- 0.08321216702461243,
- 0.19509032368659973,
- 0.22816050052642822,
- -0.2699337899684906,
- -0.6778974533081055,
- -0.8404248356819153,
- 0.2901766896247864,
- 0.5331884622573853,
- 0.44227609038352966,
- 0.9771484136581421,
- 0.8558570742607117,
- -0.7451087236404419,
- 0.9981444478034973,
- -0.678033173084259,
- -0.8475834727287292,
- 0.3360883593559265,
- 0.9743492007255554,
- -0.282871812582016,
- -0.22345055639743805,
- 0.3189956545829773,
- -0.9293450713157654,
- 0.5089709162712097,
- 0.8060675263404846,
- 0.8813042640686035,
- -0.5501174926757812,
- 0.43230360746383667,
- 0.399971067905426,
- 0.5860621929168701,
- -0.8191595077514648,
- 0.8525258898735046,
- 0.4839176535606384,
- 0.43716105818748474,
- 0.44707098603248596,
- -0.004523725248873234,
- -0.0728132501244545,
- -0.5065698027610779,
- 0.10219016671180725,
- 0.12683188915252686,
- 0.46737194061279297,
- -0.39507293701171875,
- 0.14336158335208893,
- 0.5697399377822876,
- -0.04716167598962784,
- -0.02876582369208336,
- 0.716044545173645,
- 0.8369349837303162,
- -0.3292773365974426,
- 0.7456651926040649,
- 0.5343924760818481,
- -0.9642449021339417,
- -0.535721480846405,
- -0.4752419590950012,
- 0.5506404638290405,
- 0.42234858870506287,
- 0.2887100875377655,
- -0.06674723327159882,
- 0.6946030259132385,
- 0.02623007260262966,
- 0.946326732635498,
- -0.5398248434066772,
- -0.9635012149810791,
- -0.9525694251060486,
- -0.5915231704711914,
- -0.5506868362426758,
- 0.5892135500907898,
- -0.8410922288894653,
- -0.9329262375831604,
- -0.9138374328613281,
- 0.8402705788612366,
- 0.9105742573738098,
- -0.9931750297546387,
- -0.4777680039405823,
- -0.8566827178001404,
- -0.6324874758720398,
- 0.8885729312896729,
- 0.9815806150436401,
- -0.13777193427085876,
- -0.6420971155166626,
- -0.5806383490562439,
- 0.5950174927711487,
- -0.8831895589828491,
- -0.9292991161346436,
- -0.515745222568512,
- -0.7781712412834167,
- -0.47324317693710327,
- 0.7560555934906006,
- -0.6978248953819275,
- 0.5688090324401855,
- 0.48954278230667114,
- -0.4428369104862213,
- -0.2906172573566437,
- -0.8368217945098877,
- -0.9935793280601501,
- 0.982795000076294,
- -0.7022608518600464,
- -0.5990626811981201,
- 0.4099653661251068,
- 0.8622729182243347,
- -0.286173015832901,
- 0.16053339838981628,
- 0.6610923409461975,
- 0.5628518462181091,
- 0.18883104622364044,
- 0.8341196775436401,
- -0.29332637786865234,
- -0.4320796728134155,
- -0.5608901381492615,
- -0.7485610842704773,
- -0.06010530889034271,
- 0.21931923925876617,
- -0.22103886306285858,
- -0.5628518462181091,
- 0.9293450713157654,
- 0.7130826711654663,
- 0.9627287983894348,
- 0.9840801358222961,
- -0.8595077991485596,
- 0.31655168533325195,
- 0.882563591003418,
- 0.971177875995636,
- -0.9552678465843201,
- 0.7955359220504761,
- -0.12935291230678558,
- 0.9853049516677856,
- -0.33821555972099304,
- 0.9915511608123779,
- -0.9826152324676514,
- -0.9881051778793335,
- 0.9917153120040894,
- 0.08590389788150787,
- -0.6782426834106445,
- 0.47321829199790955,
- -0.17458701133728027,
- -0.445766419172287,
- -0.648909866809845,
- -0.8623660206794739,
- 0.7130826711654663,
- 0.807781457901001,
- 0.8623660206794739,
- -0.31360378861427307,
- 0.9839302897453308,
- 0.6382311582565308,
- -0.9593880772590637,
- 0.3193909227848053,
- -0.7817341685295105,
- 0.023031573742628098,
- -0.4200100302696228,
- 0.9933979511260986,
- -0.8614697456359863,
- -0.8687127232551575,
- 0.16769032180309296,
- 0.46352097392082214,
- -0.5226393938064575,
- -0.24868835508823395,
- 0.16562004387378693,
- 0.3897646963596344,
- 0.7157204151153564,
- 0.3493865430355072,
- -0.8276746273040771,
- -0.9994074702262878,
- 0.9726558923721313,
- -0.2598225772380829,
- 0.9036200046539307,
- 0.9771667718887329,
- 0.8610367178916931,
- -0.05206523463129997,
- 0.20172397792339325,
- -0.9491549134254456,
- 0.006670048926025629,
- 0.48246243596076965,
- 0.02163754589855671,
- 0.1861138790845871,
- -0.9725919365882874,
- -0.9926801323890686,
- -0.9994572997093201,
- 0.34400707483291626,
- 0.6316402554512024,
- -0.8622729182243347,
- 0.6931447386741638,
- 0.8637305498123169,
- -0.49691101908683777,
- 0.4423399865627289,
- 0.9413233995437622,
- 0.2561284601688385,
- 0.4177584648132324,
- -0.7151981592178345,
- 0.3847554624080658,
- 0.00911870226264,
- 0.04645007848739624,
- 0.9529821872711182,
- 0.9131877422332764,
- 0.9860866069793701,
- -0.28687211871147156,
- 0.7533616423606873,
- 0.525320291519165,
- -0.2505177855491638,
- 0.22584663331508636,
- -0.31802502274513245,
- -0.664940357208252,
- 0.3854376971721649,
- -0.5987637042999268,
- 0.9183555841445923,
- -0.8924358487129211,
- -0.39667022228240967,
- -0.8860922455787659,
- 0.642162561416626,
- -0.12058087438344955,
- -0.9389616847038269,
- -0.830712616443634,
- -0.606196939945221,
- -0.7111347317695618,
- -0.3265444338321686,
- -0.56674724817276,
- 0.9875668883323669,
- -0.10216209292411804,
- 0.5815808773040771,
- 0.9071466326713562,
- -0.8691815733909607,
- -0.5292973518371582,
- -0.7014018893241882,
- 0.2636984586715698,
- 0.9412404298782349,
- 0.9982985854148865,
- 0.9909630417823792,
- -0.3709893822669983,
- -0.7072163224220276
- ]
- }
- ],
- "layout": {
- "height": 500,
- "scene": {
- "aspectmode": "data"
- },
- "template": {
- "data": {
- "bar": [
- {
- "error_x": {
- "color": "#2a3f5f"
- },
- "error_y": {
- "color": "#2a3f5f"
- },
- "marker": {
- "line": {
- "color": "#E5ECF6",
- "width": 0.5
- },
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "bar"
- }
- ],
- "barpolar": [
- {
- "marker": {
- "line": {
- "color": "#E5ECF6",
- "width": 0.5
- },
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "barpolar"
- }
- ],
- "carpet": [
- {
- "aaxis": {
- "endlinecolor": "#2a3f5f",
- "gridcolor": "white",
- "linecolor": "white",
- "minorgridcolor": "white",
- "startlinecolor": "#2a3f5f"
- },
- "baxis": {
- "endlinecolor": "#2a3f5f",
- "gridcolor": "white",
- "linecolor": "white",
- "minorgridcolor": "white",
- "startlinecolor": "#2a3f5f"
- },
- "type": "carpet"
- }
- ],
- "choropleth": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "choropleth"
- }
- ],
- "contour": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "contour"
- }
- ],
- "contourcarpet": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "contourcarpet"
- }
- ],
- "heatmap": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "heatmap"
- }
- ],
- "heatmapgl": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "heatmapgl"
- }
- ],
- "histogram": [
- {
- "marker": {
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "histogram"
- }
- ],
- "histogram2d": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "histogram2d"
- }
- ],
- "histogram2dcontour": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "histogram2dcontour"
- }
- ],
- "mesh3d": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "mesh3d"
- }
- ],
- "parcoords": [
- {
- "line": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "parcoords"
- }
- ],
- "pie": [
- {
- "automargin": true,
- "type": "pie"
- }
- ],
- "scatter": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatter"
- }
- ],
- "scatter3d": [
- {
- "line": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatter3d"
- }
- ],
- "scattercarpet": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattercarpet"
- }
- ],
- "scattergeo": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattergeo"
- }
- ],
- "scattergl": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattergl"
- }
- ],
- "scattermapbox": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattermapbox"
- }
- ],
- "scatterpolar": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterpolar"
- }
- ],
- "scatterpolargl": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterpolargl"
- }
- ],
- "scatterternary": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterternary"
- }
- ],
- "surface": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "surface"
- }
- ],
- "table": [
- {
- "cells": {
- "fill": {
- "color": "#EBF0F8"
- },
- "line": {
- "color": "white"
- }
- },
- "header": {
- "fill": {
- "color": "#C8D4E3"
- },
- "line": {
- "color": "white"
- }
- },
- "type": "table"
- }
- ]
- },
- "layout": {
- "annotationdefaults": {
- "arrowcolor": "#2a3f5f",
- "arrowhead": 0,
- "arrowwidth": 1
- },
- "autotypenumbers": "strict",
- "coloraxis": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "colorscale": {
- "diverging": [
- [
- 0,
- "#8e0152"
- ],
- [
- 0.1,
- "#c51b7d"
- ],
- [
- 0.2,
- "#de77ae"
- ],
- [
- 0.3,
- "#f1b6da"
- ],
- [
- 0.4,
- "#fde0ef"
- ],
- [
- 0.5,
- "#f7f7f7"
- ],
- [
- 0.6,
- "#e6f5d0"
- ],
- [
- 0.7,
- "#b8e186"
- ],
- [
- 0.8,
- "#7fbc41"
- ],
- [
- 0.9,
- "#4d9221"
- ],
- [
- 1,
- "#276419"
- ]
- ],
- "sequential": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "sequentialminus": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ]
- },
- "colorway": [
- "#636efa",
- "#EF553B",
- "#00cc96",
- "#ab63fa",
- "#FFA15A",
- "#19d3f3",
- "#FF6692",
- "#B6E880",
- "#FF97FF",
- "#FECB52"
- ],
- "font": {
- "color": "#2a3f5f"
- },
- "geo": {
- "bgcolor": "white",
- "lakecolor": "white",
- "landcolor": "#E5ECF6",
- "showlakes": true,
- "showland": true,
- "subunitcolor": "white"
- },
- "hoverlabel": {
- "align": "left"
- },
- "hovermode": "closest",
- "mapbox": {
- "style": "light"
- },
- "paper_bgcolor": "white",
- "plot_bgcolor": "#E5ECF6",
- "polar": {
- "angularaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "bgcolor": "#E5ECF6",
- "radialaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- }
- },
- "scene": {
- "xaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- },
- "yaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- },
- "zaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- }
- },
- "shapedefaults": {
- "line": {
- "color": "#2a3f5f"
- }
- },
- "ternary": {
- "aaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "baxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "bgcolor": "#E5ECF6",
- "caxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- }
- },
- "title": {
- "x": 0.05
- },
- "xaxis": {
- "automargin": true,
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": "",
- "title": {
- "standoff": 15
- },
- "zerolinecolor": "white",
- "zerolinewidth": 2
- },
- "yaxis": {
- "automargin": true,
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": "",
- "title": {
- "standoff": 15
- },
- "zerolinecolor": "white",
- "zerolinewidth": 2
- }
- }
- },
- "title": {
- "text": "Stochastic Results"
- },
- "width": 500,
- "xaxis": {
- "range": [
- -5,
- 5
- ]
- },
- "yaxis": {
- "range": [
- -1,
- 0.9999999999999999
- ]
- }
- }
- },
- "text/html": [
- " "
- ]
- },
- "metadata": {},
- "output_type": "display_data"
- },
- {
- "data": {
- "text/html": [
- " \n",
- " "
- ]
- },
- "metadata": {},
- "output_type": "display_data"
- },
- {
- "data": {
- "application/vnd.plotly.v1+json": {
- "config": {
- "linkText": "Export to plot.ly",
- "plotlyServerURL": "https://plot.ly",
- "showLink": false
- },
- "data": [
- {
- "marker": {
- "color": [
- 9.564335374870252e+40,
- -1.4454895324466542e+42,
- -8.28529091594078e+41,
- 6.655263051687091e+39,
- -4.167134313102489e+44,
- -2.0651428088049316e+44,
- -3.2690895804201947e+44,
- -3.05829152315126e+44,
- 4.258358405426227e+41,
- -1.1495033915649353e+42,
- 2.6400533798096977e+41,
- -9.374395162499978e+42,
- 2.886258999805707e+41,
- -4.657456031210092e+40,
- -1.8131016645527998e+43,
- -6.795016793342594e+41,
- 1.9287052908618806e+45,
- 1.2832222801248469e+44,
- -9.667627070533012e+44,
- 1.5523794790609484e+44,
- -1.0593165688335335e+44,
- -1.406966187117799e+43,
- -4.940941705389235e+43,
- -2.0584344504460927e+44,
- -1.6574082870105647e+44,
- 2.9008069859190986e+43,
- -2.140293994672546e+41,
- -5.331365124656717e+44,
- 3.011657394675736e+44,
- 4.166342536300793e+45,
- -3.7433917203800574e+46,
- 3.841396175272953e+45,
- 1.821308978493024e+44,
- -4.912291623786151e+42,
- -7.627270159676832e+42,
- 1.3480695090599562e+43,
- -1.7455994372438277e+43,
- 7.558456748233028e+43,
- 1.647655709835341e+43,
- 2.353178888510054e+43,
- 2.48267608817669e+39,
- 7.309179254877736e+39,
- 3.17469028824278e+39,
- -8.924179041106582e+40,
- 1.72396858826551e+43,
- -1.6283778153656201e+43,
- -3.0417997380531657e+44,
- 7.361901210160562e+43,
- 2.0319593089861664e+42,
- 2.901677420880713e+41,
- 1.8873724444299784e+43,
- -9.193071250787455e+42,
- -5.817556954339484e+45,
- 2.7977108038390176e+45,
- -3.635671719825667e+44,
- 8.652175271531545e+43,
- -3.2318861519874297e+40,
- -4.001151962107059e+41,
- -8.757098895774662e+41,
- 1.5782152937580948e+42,
- -5.47265422000069e+38,
- -1.3425452265675508e+39,
- 4.385724103274985e+38,
- 1.3554379290714237e+38,
- 2.8140171006857547e+38,
- 1.157859357050345e+43,
- 5.4795938492988073e+42,
- -1.5901751621865987e+45,
- 4.713165496706625e+42,
- 1.360768223282482e+41,
- -1.9664754501640593e+41,
- -3.0935279210233503e+41,
- -5.39029209210632e+43,
- -1.253683628185929e+44,
- -3.4256786150178646e+43,
- 1.9353425053708486e+45,
- -1.2170078961773314e+39,
- 7.326177978189949e+40,
- 1.9556434920657186e+40,
- -3.6096676516583223e+40,
- 1.7035247921420814e+43,
- 4.681606859748907e+44,
- 9.412175473189375e+42,
- -1.3309501571195523e+42,
- -2.8271704178262976e+39,
- 2.976217070409151e+39,
- 1.140383789524173e+41,
- -4.4423644499897255e+38,
- 8.407215500569274e+40,
- 9.713231598910813e+40,
- -3.5366338966342286e+40,
- -1.3443603998251336e+41,
- 1.4811894102641899e+41,
- 8.737428355137302e+41,
- 1.4241706321929422e+43,
- 39178.998043,
- -3.3149171251907732e+44,
- 1.5907119577925537e+43,
- 1.409416293581588e+43,
- 3.06164722991684e+43,
- 2.8306548904332384e+43,
- 1.4275918605061097e+44,
- 1.7776275200621176e+42,
- 1.8026247658862234e+43,
- 1.139610894201508e+42,
- 6.295980914878367e+43,
- 5.090182433613915e+42,
- -2.0638546657308535e+42,
- -8.485504110066575e+43,
- 8.259360247229732e+42,
- 9.311954702353437e+42,
- -4.144900723681075e+43,
- 1.601144589373076e+43,
- 7.626860620926641e+43,
- 1.7380352580327717e+42,
- 1.251822817986756e+44,
- -1.452727329804208e+42,
- -1.7066742769507752e+43,
- -1.3800192904332498e+42,
- 2.1970750406452966e+45,
- -4.5359929304025176e+45,
- 1.1421790468740873e+45,
- -1.0641329701151342e+38,
- -7.993235286001864e+38,
- 2.8463971544074144e+36,
- 6.433939968255725e+36,
- -1.4341658048968593e+41,
- 8.871853946893403e+41,
- -1.0773785788029425e+43,
- -1.8610762924443435e+42,
- -4.767568674184886e+42,
- 1.2458689095486543e+41,
- 5.423912666528586e+41,
- 3.2825005971949355e+37,
- 2.96761008204409e+37,
- 1.4748263412440772e+44,
- 1.3489787491864136e+44,
- -8.663702131783416e+42,
- 1.824769705108145e+44,
- -7.4271623184253425e+40,
- -2.262341377550644e+44,
- 1.1001644148166116e+43,
- 2.5649570144154863e+43,
- -1.1675572053027592e+44,
- 6.757784679712686e+44,
- 5.175605216815304e+45,
- 3.132245547229214e+41,
- -3.351741595173048e+42,
- -2.349195444900006e+41,
- 1.8392094186744633e+45,
- -6.9050024072857945e+44,
- -1.0375050676347564e+45,
- 9.603750522519297e+45,
- -4.452057725979254e+44,
- -8.712271745721374e+45,
- -7.687817331879186e+42,
- 5.46675804296618e+44,
- -8.854366607270226e+44,
- 3.916756297204354e+43,
- 2.240792825149249e+43,
- 4.194232572686198e+43,
- 5.536925434779725e+42,
- -5.0959759925690945e+44,
- 7.3500382862362e+42,
- 9.98340919868387e+43,
- 2.827668844977951e+43,
- 4.2373948241486146e+44,
- -1.3330613777772656e+43,
- 39178.998043,
- 8.52798448890278e+44,
- 2.9358353079663036e+44,
- -5.273026335167347e+45,
- -2.2831059219686678e+45,
- -2.306480620377954e+44,
- -1.5763111894180687e+45,
- 8.954079285806066e+43,
- 2.232663555621556e+43,
- 1.1740565734735734e+42,
- -3.311030321742244e+42,
- -6.448166064691689e+44,
- 3.2290970151602054e+43,
- 1.2532467845899274e+44,
- 4.310485983453444e+38,
- 9.661220886345965e+38,
- 1.5450384988860207e+39,
- 6.214694120806666e+38,
- 3.382500784081691e+41,
- -3.763219950872245e+41,
- 3.847818118835562e+44,
- -2.204050764381127e+44,
- 3.578888722345277e+43,
- -6.029063012970963e+44,
- 39178.998043,
- 39178.998043,
- 39178.998043,
- 1.8793749472763718e+45,
- 5.909454833677983e+44,
- -2.3650581863073414e+44,
- -1.7261378993169338e+42,
- 3.1081319882352897e+42,
- 1.9213009365216726e+44,
- -1.2985453626259044e+43,
- 8.651996403023845e+43,
- 1.9147279480307568e+43,
- -1.7452826712631575e+45,
- -2.962316314787208e+44,
- -3.404094038469323e+44,
- -1.0952918102270685e+43,
- 3.0304918230999637e+42,
- -5.2297552645168734e+42,
- -1.204636750698826e+43,
- 1.7415278677345026e+43,
- 2.5075388318287354e+43,
- 3.2425339120940594e+43,
- -3.876933568204713e+42,
- 8.401185087040827e+39,
- 1.516515009751044e+38,
- 1.6588586986434912e+37,
- 1.333897426811004e+37,
- -2.899128933369879e+37,
- 2.9531649039366176e+43,
- -2.0924509706735737e+40,
- -1.556335459243086e+40,
- -2.7386434202528606e+40,
- -6.918478106785382e+40,
- 1.9008992126260093e+40,
- -1.4847659191390339e+40,
- 3.3294543218236885e+39,
- 5.287725588273299e+42,
- 9.33594363588744e+43,
- 4.078767531693869e+42,
- -5.127929302011834e+41,
- -2.3184349332462407e+42,
- 7.133754816379477e+42,
- 2.1522958336030716e+43,
- -4.0213707238073955e+44,
- -8.140670238155586e+43,
- 5.3184625956679176e+42,
- 4.521864403650602e+42,
- 1.1110028356850898e+45,
- 5.424054443062773e+43,
- -4.250979862078851e+42,
- 1.1022831587770228e+45,
- -1.1993443399114708e+42,
- 5.341781472762434e+42,
- -9.652516506663115e+42,
- -3.1644491138880768e+38,
- -5.641779949899312e+40,
- 6.263962767522669e+38,
- 2.2623060572917806e+40,
- -4.6339172458956965e+42,
- -3.747802222130256e+42,
- -1.4417350927256363e+42,
- -5.865344317500531e+42,
- 8.096776983975275e+41,
- 1.3444218931627568e+44,
- -8.936515836047544e+44,
- 9.118600103205794e+43,
- 2.476466141353122e+44,
- 5.217255474456338e+43,
- -6.819928610587707e+41,
- 1.1545369567218071e+41,
- -2.6485465948856824e+40,
- -1.3735697419718695e+44,
- 5.140153595902848e+43,
- -5.058430633039506e+42,
- -1.2238084228763777e+44,
- -4.6074202104315155e+45,
- 3.421130057354718e+44,
- -1.5772131359925465e+45,
- -2.7744419849692913e+45,
- 1.0577054013064893e+39,
- 7.23460848078698e+37,
- 3.978157697946791e+39,
- 1.0805058689363693e+45,
- 1.7676434897989414e+42,
- -4.3439585406114895e+41,
- 8.284374907960003e+41,
- -2.254931810198256e+41,
- 6.171376231711321e+40,
- 1.4040551494889661e+41,
- 1.4952725532719714e+43,
- 2.485187392440164e+44,
- -3.716022432647291e+42,
- -1.1579495818468716e+43,
- -1.2447807224678851e+44,
- 2.55251266591185e+44,
- -7.883409147428197e+44,
- 3.3415150106135526e+45,
- -4.275916671252055e+39,
- -8.10541769428962e+38,
- 2.6906630822868477e+41,
- -1.0953310379313462e+39,
- 2.3517662539063114e+38,
- -3.689203992852621e+40,
- 4.436290668192385e+40,
- 2.114652366503814e+45,
- -4.948606314713763e+43,
- -5.294117289227356e+44,
- 3.2698380493167043e+43,
- -1.4264818137708471e+44,
- -1.6010365325063356e+43,
- 1.4704578472464367e+44,
- -5.688210355687085e+44,
- -2.4906404825536348e+45,
- 1.2823628526359352e+46,
- 3.1651114262032164e+45,
- 2.737750739507377e+45,
- 2.6752947614027853e+45,
- 9.465112604426098e+44,
- 1.2244893710869959e+45,
- -4.781481967006476e+44,
- 1.7695116661719382e+45,
- -1.1094946070998386e+45,
- -1.7059832765617288e+44,
- 2.0210968670673977e+40,
- 1.032777756261992e+42,
- -1.026352856632856e+38,
- -7.707792681715387e+39,
- -6.767805508528665e+39,
- -4.540728785228407e+38,
- -1.5084387545854478e+45,
- 5.387256093065528e+44,
- -1.073094686510598e+43,
- -1.5644455593435186e+42,
- 4.117271731570439e+42,
- -8.86759801083276e+42,
- 1.1502186261097951e+41,
- -1.7724448581089028e+44,
- -2.3181805775806062e+45,
- -8.630332168172036e+44,
- 3.2310622914486516e+44,
- -2.3199703986509824e+44,
- -1.2667628499158872e+45,
- -5.451976456829913e+44,
- 39178.998043,
- 39178.998043,
- -2.3274642286345066e+40,
- -4.526737712752115e+40,
- 3.5896113954779104e+40,
- -3.706682010081101e+39,
- 0,
- 1.4690552617011498e+39,
- 0,
- 0,
- 1.0553006254515326e+44,
- 7.750994463466926e+44,
- -4.024505215492102e+44,
- 4.8485659077374e+43,
- -1.2529773448335404e+45,
- 2.707904882275324e+43,
- -7.718435996722826e+42,
- -1.0707066370848503e+43,
- 1.8819038014696732e+43,
- -9.622760770548537e+42,
- -1.6351653563629055e+39,
- 1.9521281433174533e+38,
- 1.6572849840013355e+38,
- 0,
- 9.837933467326836e+36,
- 1.756821326149861e+38,
- 2.6888507174667494e+37,
- 39178.998043,
- 39178.998043,
- 39178.998043,
- -4.216143032708572e+42,
- 2.962194326495376e+42,
- -2.6602497478011887e+42,
- 2.113888987056868e+44,
- 4.59893327789211e+44,
- -2.923961045540547e+39,
- -2.7185795025029546e+41,
- -7.719828080360626e+39,
- -1.7428339449623906e+40,
- 1.7761513599771513e+46,
- -1.0485242319164447e+43,
- -2.4741436508072634e+43,
- 4.4319842953943866e+42,
- -9.855669029146284e+40,
- -1.0099249731953492e+39,
- -7.51555695656406e+38,
- -2.7350968977699495e+38,
- 3.038660273012947e+40,
- -8.632699416535792e+37,
- -7.78800818319108e+38,
- -2.1983400844797442e+43,
- -3.3517812355732386e+42,
- 39178.998043,
- 1.453052340131468e+44,
- 39178.998043,
- 39178.998043,
- -5.765191982376325e+38,
- -1.798872893773805e+39,
- -6.871727087534396e+37,
- -3.112578524404599e+45,
- -9.214202783049836e+44,
- 1.0866683292437415e+46,
- 3.0094954842653167e+44,
- 3.549215045346073e+43,
- -2.8682349516969756e+44,
- -1.023310725829948e+44,
- 1.1036532999132008e+46,
- 5.42233863980987e+45,
- -2.2170477280872404e+44,
- -1.3549744822323542e+43,
- 6.369610911789865e+42,
- 2.7895118082262815e+43,
- 6.15427087641121e+42,
- -4.792451772891727e+43,
- -4.6318430773643636e+38,
- 5.2654652084474243e+39,
- -1.1034557435709688e+43,
- -1.9911496805781103e+43,
- -2.7766861897480915e+41,
- 6.074821477269868e+40,
- 1.850389730421213e+41,
- -2.025199243998884e+45,
- -4.334230485227012e+39,
- 3.716501255460095e+39,
- 1.8033916571000032e+41,
- -3.4479134045449054e+39,
- -4.877249990435865e+40,
- 8.921306641777389e+38,
- 7.159727059365336e+39,
- 8.895974668471712e+42,
- -1.2253592799769057e+44,
- 8.450441676282184e+43,
- 4.030017112906037e+41,
- -8.541893694627705e+42,
- 4.4318250266473015e+42,
- -1.5564067458788274e+42,
- 7.739106140517533e+42,
- -1.7214296122696133e+43,
- -1.3364988372883892e+42,
- 9.426430342965526e+42,
- 6.2326218737390845e+38,
- 0,
- -1.5174654676509694e+39,
- -9.099083944214052e+43,
- 3.9355125957970865e+42,
- 3.857828534536414e+42,
- 6.56123970795974e+42,
- 1.0007235158942443e+44,
- -5.031748418736235e+44,
- -3.288257561342344e+42,
- -1.526906726787092e+44,
- -1.381150866504864e+44,
- 7.682093235777872e+45,
- -3.367287785901581e+42,
- -1.4139529682235332e+42,
- -5.641190740023374e+43,
- -1.2720331402847043e+44,
- -1.526460455871769e+43,
- 2.6438136286842874e+41,
- -5.161507011262781e+41,
- -2.4832921926002836e+41,
- 1.8959772825582015e+42,
- -2.4099754551974725e+44,
- 8.041541516097029e+43,
- -2.274113947019672e+43,
- -2.208779266773304e+42,
- 2.6313301957901298e+45,
- -9.603712752213689e+44,
- 1.6954109616293643e+46,
- -2.1774956699322192e+45,
- -2.1288634889268358e+42,
- -1.0240055282555547e+43,
- -4.4516629460131126e+42,
- 3.7862497432914265e+42,
- 8.180783688616667e+45,
- -2.1163591051413616e+45,
- 1.03220547392013e+46,
- 6.759223137052469e+42,
- 6.167886498619237e+43,
- -1.828837629665172e+41,
- -1.1112719554305036e+44,
- -1.6431712986449835e+43,
- -1.3132353179419065e+44,
- -1.5955620006207044e+44,
- 9.733301922491795e+45,
- -7.223608278241114e+44,
- 1.0310870779336167e+46,
- 4.789311660241936e+37,
- -9.758924181150145e+43,
- -1.9016545336929574e+44,
- -3.34012383944732e+42,
- 6.793800147308952e+42,
- -1.086402896564984e+45,
- 1.3837583702579408e+46,
- 9.78848135930156e+40,
- -3.141443253521662e+41,
- 2.517558595567229e+41,
- -8.761811216636633e+40,
- -3.801105119772983e+42,
- -4.6607514492855715e+42,
- 8.756613446625062e+39,
- -1.2329503032959188e+41,
- 8.521119382482112e+40,
- 2.3183005972086026e+41,
- 1.084630380500978e+41,
- -4.3132341635732205e+42,
- -1.2798229293414894e+44,
- -1.7415518824473214e+41,
- 2.426903889985578e+42,
- -8.005358187434676e+41,
- -2.5692855076847948e+42,
- 1.0001611390737809e+43,
- 4.3280487820783245e+43,
- 3.835737753474035e+37,
- -2.0064611381457837e+36,
- 3.1178159406852406e+43,
- -1.8379499463272402e+43,
- -6.201769878754079e+42,
- 6.0048733192761525e+44,
- -2.4711957666483193e+42,
- -1.7539743614677489e+43,
- -3.505981875537539e+42,
- -1.484769672482479e+45,
- -1.773719398772643e+45,
- 2.7448747469511612e+44,
- 7.059282062466431e+43,
- -2.0418321078427047e+43,
- 5.038240477874394e+44,
- 3.069587440090649e+43,
- 3.7536961930965577e+43,
- 1.977108736806453e+42,
- -1.1718091388689142e+41,
- -5.924835009538062e+39,
- 8.434039392928679e+39,
- -7.256426019315736e+40,
- 8.682580399477658e+43,
- -6.972434115589344e+43,
- -6.00650919322563e+43,
- -1.758624444197081e+45,
- 3.088380503152175e+44,
- -1.2986823609571535e+40,
- -3.781078820944235e+41,
- -2.125582229838644e+40,
- -3.402716050663252e+40,
- -2.155544180021214e+40,
- 4.2597491592183245e+41,
- 5.706295345434609e+41,
- -8.881641583675292e+42,
- -6.313831300076416e+42,
- 39178.998043,
- 39178.998043,
- 4.39885565081432e+42,
- -3.453955155920853e+44,
- -1.794510620007728e+39,
- -3.449009472363694e+37,
- 1.1361883947663213e+38,
- -4.68169166343388e+38,
- -1.537714424309696e+43,
- 2.1601810145144957e+44,
- -4.893199740723064e+44,
- -6.198942619362843e+44,
- 3.84595452820105e+43,
- 2.0756598586164855e+42,
- 4.0255531155473837e+43,
- 9.581501152231202e+42,
- 3.9147230184020496e+44,
- -1.0339390271329386e+43,
- -2.7398541523715664e+44,
- -7.79055946427509e+42,
- -8.085525908446761e+42,
- 5.554361650853185e+43,
- 0,
- 0,
- 3.2113465317219367e+38,
- 1.9336696672944434e+38,
- 2.280421579414336e+44,
- 2.802517433511016e+41,
- -1.3498405176461985e+43,
- -3.5182856854277555e+43,
- 3.295686187069249e+43,
- 3.3237383371387685e+37,
- 0,
- 0,
- 5.2923307577426554e+36,
- -3.676130041480647e+43,
- 1.1101340393735252e+43,
- 8.768898736640267e+43,
- 39178.998043,
- -3.452592681348335e+39,
- -3.205062692812036e+44,
- 3.0593211358171673e+40,
- -9.557974197811087e+43,
- 2.922170858191243e+43,
- 4.603390496990818e+44,
- 8.657324390131202e+42,
- 1.1658072343253066e+43,
- -2.419124929820371e+42,
- 1.0109033204488748e+37,
- -3.9445379571631537e+37,
- 9.057032628700582e+37,
- -1.6768562976326613e+44,
- -4.1011394214489916e+42,
- 2.346346283474583e+36,
- 7.659723508086473e+43,
- 2.6990931593268918e+44,
- 2.0861696761918692e+45,
- 1.752078544594183e+45,
- -1.1861692447295208e+40,
- -1.0958281074324059e+39,
- -4.204168584950205e+39,
- 1.3534881587320286e+39,
- -1.019644211022931e+44,
- -2.1623619312979596e+44,
- -2.3879021017756726e+44,
- 3.1994047709118428e+41,
- 8.996510287563618e+43,
- -9.292701264386159e+43,
- -1.3118876847147809e+44,
- -1.8176714925032752e+44,
- 39178.998043,
- -1.776120889117286e+40,
- 2.4915180843576642e+42,
- -1.1572765653204108e+43,
- 1.4318700347439334e+38,
- -6.459574926073916e+38,
- 1.2492286683073276e+41,
- -2.4409471503314875e+40,
- -1.3404535086036403e+45,
- 1.8844827564216927e+45,
- 6.944970293508661e+43,
- 3.495882784292698e+44,
- -1.5364450472212895e+42,
- -9.334453107204544e+42,
- 4.0945471596591274e+41,
- -3.171514239114648e+39,
- 3.2993933277445707e+41,
- 1.326740510818103e+38,
- -9.736259211358494e+42,
- -3.705768065661258e+45,
- -3.0532456540772044e+44,
- 7.995702664486982e+38,
- 3.3290268622717835e+40,
- 3.900537168361359e+43,
- 5.63783896117159e+42,
- -1.975850992747928e+42,
- -7.436611005455304e+42,
- 7.362574450451047e+43,
- 7.028016463581853e+44,
- -1.4865561187989898e+43,
- -3.012320918546622e+45,
- -6.758681964130903e+42,
- -1.8776250261794915e+43,
- 5.546090854567315e+43,
- 2.164675588205482e+41,
- 0,
- 1.5997618748419353e+37,
- -7.852649263893824e+43,
- -3.608769643800519e+41,
- -3.655263909926057e+39,
- -8.627409801273485e+39,
- 5.195534553808166e+39,
- 1.7991548170267802e+38,
- -2.853827399906305e+43,
- 1.2034164650247717e+45,
- 1.0469513883002384e+43,
- 2.2575203740311467e+43,
- 3.052395787420342e+42,
- 5.0220092017825503e+42,
- 1.8311140765697004e+40,
- 6.180295575975022e+40,
- 1.465790552168772e+41,
- -1.826227823354411e+44,
- 6.783731851649486e+42,
- 6.688475660278705e+42,
- -3.0673583909698315e+44,
- -2.662148617851758e+43,
- -2.7333127848854442e+44,
- 6.487349314194355e+43,
- -8.765682867250218e+41,
- -7.090681591198305e+43,
- -5.100543764319341e+44,
- -1.7523266628166091e+44,
- 1.2695546558532717e+46,
- -1.0374205690752205e+47,
- 1.1259002404147688e+44,
- -3.3733922723771616e+44,
- 1.8723140937580884e+45,
- -3.3126989594884926e+37,
- 3.1520034324957767e+40,
- -2.0188114469605143e+40,
- -5.65841083478548e+40,
- -5.161722413642058e+41,
- 1.0599633441952832e+46,
- -5.085150099600077e+44,
- 1.4759689442931038e+40,
- -1.996625267083334e+40,
- 8.322492668158772e+40,
- -1.8962503044214454e+44,
- -1.4908004106415002e+44,
- -1.9998593597241018e+45,
- 6.30275841209233e+40,
- 4.55099052257533e+43,
- -1.592029372708258e+45,
- 6.287054638132343e+42,
- -4.7091588293640725e+44,
- -5.713662414057076e+44,
- -1.895560455717416e+43,
- -1.6685981611126637e+38,
- 7.950608557290299e+40,
- 8.564215387472349e+41,
- -1.6321019348533044e+39,
- -5.234452096862851e+42,
- -4.033923981896862e+42,
- -4.551064593544007e+43,
- 4.3223346095498975e+37,
- -8.553556407387486e+43,
- -1.524042819507592e+43,
- 1.970445242369171e+42,
- 3.556429480094634e+38,
- -4.589483764833879e+44,
- -4.992141331937442e+43,
- -1.4840636032238238e+42,
- -2.7362908068777673e+41,
- 4.700958983406949e+43,
- 7.206176187768559e+42,
- -2.301541355148592e+44,
- 2.241200726180209e+44,
- 39178.998043,
- -2.051653880218144e+41,
- 39178.998043,
- 1.3292764885333704e+39,
- 2.5074295260740373e+41,
- 1.955696367497783e+42,
- -6.036788348393784e+41,
- -2.2610404309279013e+41,
- -4.357122148744561e+42,
- 7.518328956272759e+37,
- 1.2451531550346656e+37,
- 1.1655865109060048e+43,
- 8.214985800885291e+40,
- -7.643791603866205e+38,
- 4.77609613077037e+38,
- -4.6588399630213995e+39,
- 1.9118822957511886e+39,
- -1.9822789951857437e+41,
- -1.3975746601381792e+45,
- 2.6112283413388205e+43,
- -1.401327177929177e+43,
- 39178.998043,
- 39178.998043,
- -4.123273167817142e+40,
- -1.7608360743912358e+44,
- -5.441442160068687e+44,
- -3.878003284319045e+44,
- 0,
- 1.1730515439487141e+44,
- 0,
- 0,
- 7.374214936966749e+45,
- 5.587110365850732e+41,
- 7.580222715008597e+45,
- 3.00254112953479e+44,
- -2.1450724115292684e+41,
- -1.470196021956162e+41,
- 1.6937827786810985e+43,
- -3.2654271263542916e+44,
- -1.8204707178994323e+43,
- -6.647437862635369e+42,
- 1.8045559698923255e+40,
- 5.388963886463272e+39,
- -1.978059419715823e+39,
- 2.362704019089084e+39,
- 4.484484860389631e+41,
- 2.1075893100880954e+42,
- 0,
- -3.6272923649237036e+44,
- -2.5698853704087996e+42,
- 2.0269251590760277e+43,
- 6.450063683210905e+43,
- -9.634750558409025e+37,
- -1.0844541147982538e+39,
- -1.3908155259159315e+38,
- 1.2339937611746228e+37,
- -8.339308336575533e+38,
- -1.8305490588343504e+38,
- -4.962390067257501e+42,
- 6.185330756890478e+42,
- 4.501387392949879e+43,
- 2.705643843980368e+38,
- -8.620995790086036e+38,
- -1.2538324911984846e+40,
- 8.270013023644542e+44,
- 2.1140791044806817e+35,
- -3.148606235412687e+38,
- -2.0514838330657462e+41,
- -1.4248856595577194e+40,
- 39178.998043,
- -3.288513558753313e+41,
- 9.360169656503599e+37,
- 4.812843065783014e+38,
- -5.992646921601673e+37,
- 6.743531614049926e+42,
- 1.5287193214399258e+43,
- 4.1929824879899294e+42,
- 8.025194967887439e+43,
- 0,
- -2.189698394106856e+41,
- 5.72094551053624e+41,
- 2.6838091420045614e+43,
- 4.3957239632062414e+38,
- -1.1953355671026292e+43,
- -2.2472582976686357e+44,
- -6.365899828215895e+38,
- -1.2513175523757382e+40,
- -2.9595743030516392e+44,
- 0,
- 0,
- 2.4878773818360405e+35,
- 1.7499547540025216e+41,
- 6.657177242350187e+43,
- 1.7169187293438821e+43,
- 2.8416278615780114e+43,
- -1.819245306420406e+40,
- -1.3287192396705139e+42,
- 4.570308312680581e+42,
- 5.263838503346144e+44,
- 0,
- 0,
- 1.3426576036791389e+43,
- 5.487691538399858e+42,
- 8.220737445153357e+42,
- 1.1787475872308156e+43,
- 4.8892107349507854e+44,
- -1.599288627224123e+40,
- 2.3636293296342876e+37,
- -1.595834225244175e+42,
- -1.0255674044154628e+45,
- 1.3060610129076321e+44,
- 39178.998043,
- 2.9587174001252496e+37,
- -1.1183726671610172e+43,
- -3.0745823495380497e+43,
- -4.0486777252534947e+43,
- -8.823827694255485e+42,
- -1.0155442868339115e+44,
- -1.2423713740114476e+42,
- 39178.998043,
- -2.7114814586788782e+44,
- -3.886081939353941e+44,
- -2.6187850533762998e+42,
- -1.000558412011573e+41,
- -2.111887786648245e+43,
- -3.816047851410242e+42,
- 5.160216672036807e+43,
- -1.5289689102408277e+43,
- 4.733075060984353e+43,
- 8.943375157738434e+43,
- 39178.998043,
- -3.3068283300052875e+43,
- 6.955784394372669e+43,
- 7.694549442663598e+43,
- 8.336794938068314e+42,
- 1.3831464295793367e+42,
- -7.969781028044762e+42,
- -4.553240005337418e+43,
- -1.2528887995827837e+44,
- -1.8141724257546486e+43,
- -4.3297529277535384e+42,
- -1.0591521575734324e+44,
- 0,
- 0,
- 0,
- 1.9503460970237816e+43,
- -4.466486108394874e+40,
- 0,
- 2.460776573366117e+43,
- -4.477200133430212e+45,
- -5.066443227423433e+44,
- 7.499327331018496e+43,
- 3.986560398889814e+37,
- -7.068911928549942e+41,
- 5.0184970058956536e+41,
- 1.404046495029229e+43,
- 4.308000631207351e+40,
- -2.5525335891163157e+44,
- -5.433037865026808e+43,
- -9.320173425783983e+43,
- -2.551122821209884e+40,
- 2.5861871566040308e+42,
- -1.0294960946425435e+43,
- 1.2527426779671818e+43,
- 1.287098561476273e+43,
- -1.5936159902046293e+42,
- 4.32697680436258e+39,
- -6.4947455267931415e+40,
- -1.2616056418392115e+43,
- 4.512574106157367e+40,
- 1.0146199782537708e+38,
- -5.975491406604375e+41,
- 5.756064410298624e+43,
- 5.237550707979098e+44,
- 1.9392805699321562e+38,
- 7.993936409104716e+42,
- -1.0513047003419562e+42,
- -3.0833737263062254e+38,
- -9.714363746478723e+38,
- 0,
- 1.3284937399663194e+37,
- -8.295565209787231e+42,
- -3.242555267384807e+42,
- 7.902270481277261e+40,
- 6.204387411778243e+40,
- 6.789448273800443e+43,
- 4.3973412781889025e+43,
- 39178.998043,
- -3.201146991588937e+37,
- 1.5016510510021003e+44,
- 5.645752877471417e+43,
- 7.722291884227824e+43,
- 39178.998043,
- 39178.998043,
- 39178.998043,
- 0,
- 2.183410784194122e+42,
- 6.93353038619768e+42,
- -1.2531280394600736e+43,
- 2.543299528754044e+42,
- 2.6327428510882916e+41,
- -7.784029998413734e+41,
- -4.638444704751045e+41,
- 4.743394055092457e+43,
- -1.8864631261022542e+42,
- 1.554996386320466e+40,
- -2.8348609694406235e+37,
- 39178.998043,
- 39178.998043,
- -4.211634926782804e+44,
- -1.7148408084081898e+44,
- 1.4677472763766223e+44,
- -1.1704044939116792e+43,
- 4.9879748557077615e+39,
- 1.3551238937946354e+41,
- -1.4175181152946981e+44,
- 39178.998043,
- -1.8330701573655583e+44,
- 0,
- 0,
- 0,
- 39178.998043,
- -9.261327898950873e+43,
- 3.0382535125282964e+43,
- -4.2394289996130823e+37,
- -2.401244719884461e+41,
- 4.4987675067292105e+42,
- 1.895037966851609e+43,
- 5.478450654698708e+42,
- 1.4940560692740381e+43,
- -1.460925076973971e+42,
- -3.005890334311539e+41,
- 2.001516198830606e+43,
- 1.0853275666587061e+41,
- -3.5268990381472695e+38,
- 2.9273912989016114e+44,
- 2.691782108987836e+43,
- 0,
- 0,
- 6.000113386880942e+43,
- -1.6175968516225232e+43,
- 39178.998043,
- 4.5838294302679425e+38,
- 0,
- 0,
- 0,
- -2.9613787787692476e+43,
- 4.4115828319447496e+36,
- 0,
- 2.629005265263733e+43,
- -1.1629306708162563e+39,
- -1.412625528512675e+39,
- 3.7617574818745454e+42,
- -3.698687127012522e+41,
- 2.0059471795829555e+41,
- -1.678922762115535e+41,
- -2.0436908075007254e+42,
- 4.650201309045743e+40,
- 6.139896466679185e+42,
- 1.1551078433636346e+39,
- -2.3315685441753476e+38,
- 2.5466896955723816e+42,
- -1.913775302698656e+42,
- 0,
- 0,
- 6.477701097867758e+42,
- 3.293547371008937e+43,
- 2.22813036538002e+40,
- 7.0803185024446515e+40,
- -3.022533870947158e+43,
- -3.048729525870819e+41,
- 39178.998043,
- 0,
- 1.779765565392244e+40,
- 3.466685425742989e+43,
- 6.866363841559475e+43,
- -2.543659794204213e+44,
- 5.000885473309796e+44,
- 7.076148266741163e+42,
- -3.457726310287747e+44,
- -3.358292925728559e+44,
- 1.8976470965026243e+40,
- 5.346676013551e+42,
- -2.0265744163781746e+43,
- 39178.998043,
- -4.878688220186485e+41,
- 5.401347842359418e+43,
- 7.281699808410123e+43,
- 39178.998043,
- 2.9064660927273605e+43,
- 3.769987880906863e+43,
- 1.8360252970209204e+41,
- -1.5915661664606833e+43,
- 1.425430744581399e+43,
- 6.338423440370668e+37,
- 7.636600512635e+37,
- -1.8867507681324835e+40,
- 7.387138844938381e+42,
- -6.056282160052055e+38,
- 0,
- 5.780118028988565e+38,
- 3.166387080075537e+43,
- -3.1889277803854604e+43,
- 1.0825890101844107e+43,
- 2.1326404849765855e+39,
- 0,
- 1.9170251310441534e+39,
- -1.3017028941775778e+44,
- 4.946835029544322e+41,
- 5.94564559674225e+42,
- -4.81927538479358e+42,
- -3.9165285922976503e+40,
- 1.2351290976201609e+39,
- 2.502879823637484e+40,
- 5.304158170070498e+37,
- -3.4496206011710992e+41,
- 0,
- -2.7371535112603864e+44,
- -1.407286134326929e+41,
- 4.614508487874808e+40,
- 1.8896752034941335e+37,
- -2.4437469586043083e+41,
- -1.690229978498245e+39,
- 2.5340399947199107e+41,
- -1.1531625460162024e+42,
- -9.53341748143993e+39,
- 1.3287320656763714e+43,
- 1.345835586141156e+42,
- -3.0722910325586965e+41,
- -1.1558978530932915e+43,
- -1.1890137052002735e+42,
- -2.0091659050776417e+44,
- -2.4391926384951327e+41,
- -1.1580994826947325e+44,
- -2.609812209344232e+42,
- 4.918024361935406e+38,
- -2.900825164343953e+43
- ],
- "colorbar": {
- "thickness": 20,
- "title": {
- "text": "A"
- }
- },
- "colorscale": [
- [
- 0,
- "#0508b8"
- ],
- [
- 0.08333333333333333,
- "#1910d8"
- ],
- [
- 0.16666666666666666,
- "#3c19f0"
- ],
- [
- 0.25,
- "#6b1cfb"
- ],
- [
- 0.3333333333333333,
- "#981cfd"
- ],
- [
- 0.4166666666666667,
- "#bf1cfd"
- ],
- [
- 0.5,
- "#dd2bfd"
- ],
- [
- 0.5833333333333334,
- "#f246fe"
- ],
- [
- 0.6666666666666666,
- "#fc67fd"
- ],
- [
- 0.75,
- "#fe88fc"
- ],
- [
- 0.8333333333333334,
- "#fea5fd"
- ],
- [
- 0.9166666666666666,
- "#febefe"
- ],
- [
- 1,
- "#fec3fe"
- ]
- ],
- "size": 5
- },
- "mode": "markers",
- "name": "A",
- "type": "scatter3d",
- "x": [
- -2.101682662963867,
- -1.887513518333435,
- -1.7570427656173706,
- -1.8541388511657715,
- 1.8749754428863525,
- 1.80832040309906,
- 2.1825294494628906,
- 2.062222480773926,
- -2.38004469871521,
- -2.3056769371032715,
- -2.2629430294036865,
- -2.0936312675476074,
- -1.9997928142547607,
- -1.7547287940979004,
- -1.6898266077041626,
- -1.6704288721084595,
- 3.5905017852783203,
- 3.2578799724578857,
- 3.160881519317627,
- 3.4964303970336914,
- -0.6913178563117981,
- -1.0443613529205322,
- -0.8108569979667664,
- -0.5850074887275696,
- -0.293684720993042,
- 0.0675533190369606,
- -0.271133154630661,
- 0.018742907792329788,
- 4.4305853843688965,
- 4.508673667907715,
- 4.325611114501953,
- 4.611989498138428,
- 3.4338648319244385,
- 3.488844871520996,
- 3.289395570755005,
- 3.6204428672790527,
- 3.71138858795166,
- 3.857684850692749,
- 3.974630117416382,
- 4.003854274749756,
- -3.9132473468780518,
- -4.0064496994018555,
- -3.8273096084594727,
- -3.709832191467285,
- 2.3001842498779297,
- 2.2914557456970215,
- 2.0052285194396973,
- 2.2628118991851807,
- -1.980513334274292,
- -2.0251479148864746,
- -1.7515032291412354,
- -2.1317431926727295,
- 3.794757843017578,
- 3.3874454498291016,
- 3.7147281169891357,
- 3.586693048477173,
- -2.8868887424468994,
- -3.001088857650757,
- -2.9482247829437256,
- -2.6325371265411377,
- -4.134808540344238,
- -3.772261619567871,
- -4.165527820587158,
- -3.994203805923462,
- -4.163450241088867,
- 3.875136137008667,
- 3.7112133502960205,
- 3.765407085418701,
- -2.4520857334136963,
- -2.657001495361328,
- -2.6662352085113525,
- -2.8774945735931396,
- 3.942436933517456,
- 3.8352348804473877,
- 3.6082088947296143,
- 4.133811950683594,
- -3.171978712081909,
- -3.221795082092285,
- -3.0311388969421387,
- -2.9480156898498535,
- 4.4702277183532715,
- 4.6418352127075195,
- 4.766424655914307,
- 4.669127941131592,
- -3.4734950065612793,
- -3.1584713459014893,
- -3.2440361976623535,
- -3.3585245609283447,
- -2.429314613342285,
- -2.2996301651000977,
- -2.1834332942962646,
- -1.2482850551605225,
- -0.8828672766685486,
- -0.8636268973350525,
- 4.625131607055664,
- 5,
- 4.731442928314209,
- 4.639413356781006,
- 2.726271152496338,
- 2.482100486755371,
- 2.630417823791504,
- 2.613208293914795,
- 2.359410285949707,
- 2.4850215911865234,
- 2.0713677406311035,
- 2.9034955501556396,
- 3.2096197605133057,
- 3.0044784545898438,
- 3.031195640563965,
- 2.8652327060699463,
- 3.303494453430176,
- -0.9179192781448364,
- -1.1669803857803345,
- -1.2644528150558472,
- -1.0285327434539795,
- -0.8682996034622192,
- -1.0111645460128784,
- -1.1425732374191284,
- -0.9068978428840637,
- 1.6444306373596191,
- 1.5535091161727905,
- 1.877994418144226,
- -4.233823299407959,
- -4.286869049072266,
- -4.4695281982421875,
- -4.121842384338379,
- -1.4972978830337524,
- -0.9989351034164429,
- -1.422027349472046,
- -1.2346546649932861,
- -2.2228097915649414,
- -2.000976085662842,
- -2.127882480621338,
- -4.581174373626709,
- -4.083948135375977,
- 2.5844061374664307,
- 2.6696746349334717,
- 2.439190149307251,
- 2.836972236633301,
- 3.768427848815918,
- 3.901214361190796,
- 4.03761625289917,
- 3.712953805923462,
- 3.7559714317321777,
- 3.856983184814453,
- 4.166917324066162,
- -2.2912299633026123,
- -2.089019775390625,
- -1.982771635055542,
- 0.2804890275001526,
- 0.14649292826652527,
- -0.02719704993069172,
- 0.35809698700904846,
- -0.09706947952508926,
- -0.06142881140112877,
- -0.6113005876541138,
- -0.263994425535202,
- 4.316342830657959,
- 4.358631610870361,
- 4.577394962310791,
- 4.1251115798950195,
- 2.637986421585083,
- 2.9547457695007324,
- 2.78865909576416,
- 1.622883915901184,
- 1.6951839923858643,
- 1.6690202951431274,
- 1.4459738731384277,
- 5,
- 1.4305493831634521,
- 1.2514207363128662,
- 1.230926275253296,
- 1.0252352952957153,
- 1.0430431365966797,
- 1.0417221784591675,
- 1.277311086654663,
- 0.8228275179862976,
- -2.6111531257629395,
- -0.8876737952232361,
- -0.6530675888061523,
- -0.8721553087234497,
- -1.1404987573623657,
- -3.7799670696258545,
- -3.7419769763946533,
- -3.7747626304626465,
- -3.765298843383789,
- -1.3552204370498657,
- -1.448533058166504,
- 1.976080060005188,
- 2.3143045902252197,
- 2.006865978240967,
- 4.718459129333496,
- 5,
- 5,
- 5,
- -0.21346406638622284,
- -0.3900603652000427,
- -0.7078602910041809,
- 2.546725273132324,
- 2.2419445514678955,
- 2.62286114692688,
- 2.31475830078125,
- 2.815099000930786,
- 0.17036111652851105,
- 0.35399267077445984,
- 0.22068481147289276,
- 0.5616357326507568,
- 2.168175220489502,
- 2.396758794784546,
- 2.032904624938965,
- 1.9458956718444824,
- 1.672920823097229,
- -1.9237370491027832,
- -1.7913600206375122,
- -2.1189286708831787,
- -4.244471549987793,
- -4.725438117980957,
- -4.62848424911499,
- -4.6635870933532715,
- -4.4014410972595215,
- -0.39015352725982666,
- -3.62326979637146,
- -3.6562275886535645,
- -3.3212900161743164,
- -2.650617837905884,
- -2.9336674213409424,
- -2.5238282680511475,
- -2.854623556137085,
- 3.359579563140869,
- 3.281346321105957,
- 3.4625306129455566,
- -1.6233601570129395,
- -1.4790972471237183,
- 3.500380516052246,
- 4.63165283203125,
- 4.554935932159424,
- 4.720632076263428,
- -0.6211792826652527,
- -0.9868704080581665,
- -0.2744942903518677,
- -0.23266896605491638,
- -0.4965898394584656,
- -0.32649561762809753,
- -1.423138976097107,
- -1.7905021905899048,
- -1.4218405485153198,
- -3.732257604598999,
- -3.5719547271728516,
- -3.941251754760742,
- -3.9911673069000244,
- 2.76228666305542,
- 3.034092664718628,
- 2.5956602096557617,
- 3.0007383823394775,
- -2.4493157863616943,
- 1.5511066913604736,
- 1.313583254814148,
- 0.09208802133798599,
- 0.2716134786605835,
- 0.33897581696510315,
- -2.9448187351226807,
- -3.1763267517089844,
- -2.965965747833252,
- 2.055418014526367,
- 1.7646766901016235,
- 2.0915160179138184,
- 1.9841140508651733,
- 0.7309734225273132,
- 0.8535610437393188,
- 1.1015901565551758,
- 1.1043431758880615,
- -3.231236696243286,
- -3.466428518295288,
- -3.2163987159729004,
- 1.5548237562179565,
- -2.620222806930542,
- -2.8454513549804688,
- -2.381518602371216,
- -1.7730915546417236,
- -2.034778118133545,
- -1.792545199394226,
- 0.23506808280944824,
- 0.15298357605934143,
- -0.12086783349514008,
- -0.0009967255173251033,
- 3.0469939708709717,
- 3.3803346157073975,
- 3.5396389961242676,
- 3.4276304244995117,
- -3.4141626358032227,
- -3.28906512260437,
- -3.1413207054138184,
- -2.9626805782318115,
- -3.5331058502197266,
- -2.7990610599517822,
- -2.5825302600860596,
- 1.0379852056503296,
- 1.3705062866210938,
- 1.090142846107483,
- 1.1630381345748901,
- -0.7285075783729553,
- -0.5913762450218201,
- -0.41392114758491516,
- 0.37851566076278687,
- 0.2083987444639206,
- 0.536102294921875,
- 4.585145950317383,
- 4.314233303070068,
- 4.690446853637695,
- 4.508464336395264,
- 0.5570757389068604,
- 0.7471429109573364,
- 0.8703640103340149,
- 0.735404372215271,
- 1.950286626815796,
- -2.459625482559204,
- -2.3318281173706055,
- -4.318643569946289,
- -2.7759718894958496,
- -2.491568088531494,
- -2.487426280975342,
- 3.034865140914917,
- 1.392642855644226,
- 3.841580390930176,
- -1.7278932332992554,
- -1.9114822149276733,
- -1.5143166780471802,
- -1.7121433019638062,
- 4.3564581871032715,
- 4.085196018218994,
- 4.489546298980713,
- 0.03738686069846153,
- 0.4072064459323883,
- 0.3515777885913849,
- 4.740171909332275,
- 5,
- 5,
- -3.7102108001708984,
- -3.5805227756500244,
- -3.250467300415039,
- -3.6381490230560303,
- -5,
- -4.672852039337158,
- -5,
- -5,
- 3.9007976055145264,
- 4.133395671844482,
- 4.175212860107422,
- 4.236222267150879,
- 1.3414992094039917,
- 1.545016884803772,
- 1.7293202877044678,
- 1.7089415788650513,
- 1.5792618989944458,
- 1.938088297843933,
- -4.447057247161865,
- -4.589023590087891,
- -4.721797943115234,
- -5,
- -4.662319183349609,
- -4.697544574737549,
- -4.536230564117432,
- 5,
- 5,
- 5,
- 2.2066378593444824,
- 1.9319493770599365,
- 2.258507013320923,
- 2.2539353370666504,
- 2.732060194015503,
- -2.9786436557769775,
- -2.8140065670013428,
- -2.7915046215057373,
- -2.627666711807251,
- 0.9115676283836365,
- -0.532065212726593,
- -0.5675407648086548,
- -0.5571060180664062,
- -2.564318895339966,
- -4.4288010597229,
- -4.226881980895996,
- -4.208695411682129,
- -4.0041913986206055,
- -4.3078436851501465,
- -4.320655345916748,
- 2.809098720550537,
- 2.785369634628296,
- 5,
- 4.710524559020996,
- 5,
- 5,
- -4.560494422912598,
- -4.414031982421875,
- -4.710155963897705,
- 0.027450760826468468,
- -0.09511373937129974,
- 0.3111163377761841,
- 4.47791862487793,
- 4.311753749847412,
- 2.278442859649658,
- 2.3220880031585693,
- 1.0773473978042603,
- 0.6730288863182068,
- 1.7689932584762573,
- 1.6555397510528564,
- 1.9800528287887573,
- 2.0714244842529297,
- -0.6446894407272339,
- -0.43192827701568604,
- -3.7548670768737793,
- -3.300417423248291,
- -1.1125221252441406,
- -0.6115882396697998,
- -2.978154420852661,
- -3.3732173442840576,
- -3.242103338241577,
- 1.2596628665924072,
- -3.6130688190460205,
- -3.133923292160034,
- -3.3986732959747314,
- -3.5859854221343994,
- -3.520331621170044,
- -3.851719617843628,
- -3.865055561065674,
- 0.5590431690216064,
- 0.6265019774436951,
- -0.03324676677584648,
- 2.4285573959350586,
- 2.5746889114379883,
- 2.7181601524353027,
- 2.378453016281128,
- 3.447817087173462,
- 2.445730209350586,
- 2.310244083404541,
- 2.6667962074279785,
- -4.695241928100586,
- -5,
- -4.548861980438232,
- -0.33884161710739136,
- -0.5452479720115662,
- -0.44265344738960266,
- -1.2199991941452026,
- -1.154729962348938,
- -0.9447287917137146,
- -0.8053910136222839,
- 3.9948537349700928,
- 3.997985601425171,
- 4.207438945770264,
- 2.2636070251464844,
- 2.816199541091919,
- 3.2298614978790283,
- 3.0754427909851074,
- 3.1898257732391357,
- -2.0362820625305176,
- -1.695935845375061,
- -2.8119935989379883,
- -2.5727436542510986,
- 3.0221409797668457,
- 3.255614995956421,
- 3.368884563446045,
- 3.2635715007781982,
- 4.541206359863281,
- 3.801682472229004,
- 4.062766075134277,
- 3.6565608978271484,
- 2.893397092819214,
- 3.020784378051758,
- 2.637270450592041,
- 2.978060007095337,
- 0.706810474395752,
- 0.7772684097290039,
- 0.8003952503204346,
- -0.22241777181625366,
- -0.1280590295791626,
- -2.9058010578155518,
- -0.3929927349090576,
- -1.6517680883407593,
- 4.374144554138184,
- 4.208742141723633,
- 1.0169200897216797,
- 0.6947392225265503,
- 0.6771532297134399,
- -4.339812278747559,
- 3.8944802284240723,
- 3.9562127590179443,
- 2.033257246017456,
- 1.9155778884887695,
- 1.3438067436218262,
- 1.0825568437576294,
- -1.7339566946029663,
- -1.3611284494400024,
- -1.3337901830673218,
- -1.2508692741394043,
- -2.2653911113739014,
- -2.2419567108154297,
- -3.1367833614349365,
- -1.81843900680542,
- -2.1527793407440186,
- -1.6042685508728027,
- -1.647326946258545,
- 4.628890037536621,
- 4.72548246383667,
- 2.286425828933716,
- 1.9910200834274292,
- 2.3555381298065186,
- 2.0931544303894043,
- 3.7614736557006836,
- 3.912747859954834,
- -4.636204242706299,
- -4.488008499145508,
- 0.4070380926132202,
- -0.13350971043109894,
- 0.19662299752235413,
- 0.13111887872219086,
- -0.7308740019798279,
- -0.5450983643531799,
- -0.6622709035873413,
- 0.003929497674107552,
- 0.24031925201416016,
- -0.22965681552886963,
- -0.0660269558429718,
- -0.17119362950325012,
- -0.18464888632297516,
- -0.0036181053146719933,
- -0.7095974087715149,
- 1.9864104986190796,
- -2.5475826263427734,
- -2.7074756622314453,
- -2.891202926635742,
- -2.509110927581787,
- 2.9578778743743896,
- 3.029849052429199,
- 2.3168818950653076,
- 3.536309242248535,
- 3.2530806064605713,
- -3.741461992263794,
- -2.821955680847168,
- -3.082059383392334,
- -2.9099485874176025,
- -2.7286927700042725,
- -0.6247063279151917,
- -0.3622240722179413,
- -0.4216044247150421,
- 1.6000310182571411,
- 5,
- 5,
- -1.6445059776306152,
- 0.2146318256855011,
- -4.1633453369140625,
- -4.1257829666137695,
- -3.817925214767456,
- -3.784167766571045,
- -1.2936067581176758,
- 1.8930131196975708,
- 1.5624295473098755,
- 1.5452696084976196,
- -1.8079805374145508,
- -1.6008325815200806,
- 1.2422401905059814,
- 1.4802297353744507,
- 1.4433354139328003,
- 1.5805444717407227,
- 0.7913298010826111,
- 2.578340768814087,
- 2.6075079441070557,
- -0.813774585723877,
- -5,
- -5,
- -4.7412261962890625,
- -4.72172212600708,
- 1.3737642765045166,
- 1.2108287811279297,
- 1.3925875425338745,
- 1.4203695058822632,
- 0.5987880825996399,
- -4.71983003616333,
- -5,
- -5,
- -4.692821025848389,
- 1.909011960029602,
- 1.7303102016448975,
- 1.6846473217010498,
- 5,
- -3.5527470111846924,
- 0.37845441699028015,
- -1.9841102361679077,
- 3.145871162414551,
- 1.289706826210022,
- 0.7273845076560974,
- 0.720970630645752,
- 1.0219862461090088,
- 0.8861194849014282,
- -4.596095085144043,
- -4.253779888153076,
- -4.743481159210205,
- -1.5359901189804077,
- 3.121032953262329,
- -4.488008499145508,
- -1.1460216045379639,
- 4.6934332847595215,
- 4.375402450561523,
- 4.680056095123291,
- -4.230134010314941,
- -3.7863848209381104,
- -4.4221673011779785,
- -4.591073989868164,
- 4.1638264656066895,
- 4.340243339538574,
- 4.488320350646973,
- -2.5075998306274414,
- 1.917682409286499,
- 4.661116600036621,
- 4.636397361755371,
- 4.488320350646973,
- 5,
- -3.489121437072754,
- -1.138638973236084,
- -0.7274905443191528,
- -4.574654579162598,
- -4.382515907287598,
- -3.1639509201049805,
- -2.7766637802124023,
- 0.7139411568641663,
- 0.4993683397769928,
- 0.7703021764755249,
- 0.901824951171875,
- -1.5355284214019775,
- -2.1874425411224365,
- -2.3504247665405273,
- -4.327395915985107,
- -2.3662376403808594,
- -3.6765761375427246,
- 1.808962345123291,
- 4.351280689239502,
- 4.706614017486572,
- -3.448230266571045,
- -3.3269059658050537,
- -1.3753197193145752,
- -1.1046783924102783,
- -1.4444420337677002,
- 0.29257264733314514,
- 0.009619895368814468,
- 0.32545214891433716,
- 0.23237977921962738,
- 1.4445356130599976,
- -1.2714718580245972,
- -1.4109042882919312,
- 4.735227108001709,
- -3.157381772994995,
- -5,
- -4.624974727630615,
- 4.58084774017334,
- 4.646906852722168,
- -4.253415107727051,
- -3.6714272499084473,
- -4.048503875732422,
- -3.91367769241333,
- -0.662963330745697,
- -0.45707225799560547,
- -0.3023490607738495,
- -0.10872425138950348,
- -0.40253975987434387,
- -0.7720760107040405,
- -2.228641986846924,
- -2.0955162048339844,
- -1.9311330318450928,
- 4.527668476104736,
- 4.4020185470581055,
- 4.253148078918457,
- 4.159819602966309,
- 0.06420236825942993,
- 4.135446548461914,
- -0.9258043766021729,
- -0.8058002591133118,
- 4.537054061889648,
- 4.744240760803223,
- -0.8789688944816589,
- 0.3651331961154938,
- 0.7293714880943298,
- -0.06956324726343155,
- -0.08140537887811661,
- 1.721306324005127,
- -3.6552634239196777,
- -3.3976213932037354,
- -3.114668607711792,
- -2.9648706912994385,
- -2.7460291385650635,
- 0.9609786868095398,
- 1.0764851570129395,
- -2.625852346420288,
- -2.673210859298706,
- -2.3928139209747314,
- 3.227536678314209,
- 3.531540632247925,
- 3.7912299633026123,
- 3.446416139602661,
- 1.760624647140503,
- 1.2702659368515015,
- 1.4204895496368408,
- 1.1356712579727173,
- 1.1212012767791748,
- -0.7966426014900208,
- -4.596960067749023,
- -2.358410358428955,
- -2.481785297393799,
- -2.317129611968994,
- 2.1517908573150635,
- 1.9424786567687988,
- 4.65165901184082,
- -4.577237129211426,
- 3.162456750869751,
- 3.290433168411255,
- 3.418100118637085,
- -3.9114646911621094,
- 0.9896045327186584,
- -0.19112993776798248,
- 2.6939661502838135,
- 3.0167806148529053,
- 2.893794298171997,
- 3.0206243991851807,
- 1.2407162189483643,
- -0.46050986647605896,
- 5,
- 4.663840293884277,
- 5,
- -3.103480339050293,
- -2.277939558029175,
- -2.125932216644287,
- -1.824216604232788,
- -2.0925588607788086,
- 2.68068528175354,
- -4.7859697341918945,
- -4.575015544891357,
- 2.8520922660827637,
- -3.2595419883728027,
- -4.203586101531982,
- -4.2565202713012695,
- -3.767660140991211,
- -3.32572078704834,
- 0.5733931660652161,
- 0.5859797596931458,
- 0.6658535599708557,
- 4.556863307952881,
- 5,
- 5,
- -2.477255344390869,
- 0.25908347964286804,
- 0.25868678092956543,
- 0.49322885274887085,
- -5,
- -0.1877877414226532,
- -5,
- -5,
- 3.983049154281616,
- -2.6407032012939453,
- 0.5915303230285645,
- 1.0867373943328857,
- -1.214605450630188,
- -1.4895960092544556,
- 2.3244974613189697,
- 1.0752484798431396,
- 3.5134105682373047,
- 3.492990732192993,
- -4.003303050994873,
- -4.055683612823486,
- -4.244694709777832,
- -4.091361999511719,
- 2.220043897628784,
- 2.544774293899536,
- -5,
- 3.5021090507507324,
- 3.226494312286377,
- 1.4538578987121582,
- 0.25620901584625244,
- -4.075596809387207,
- -4.281928539276123,
- -4.1883087158203125,
- -4.555990695953369,
- -4.334146976470947,
- -4.165266990661621,
- 4.628626346588135,
- 4.596282482147217,
- 4.575169086456299,
- -4.123189449310303,
- -3.8626294136047363,
- -3.69762921333313,
- 3.6556200981140137,
- -4.1212477684021,
- -3.785296678543091,
- -1.9285658597946167,
- -3.4919838905334473,
- 5,
- -1.8179099559783936,
- -4.580845355987549,
- -4.697874546051025,
- -4.374136447906494,
- 2.7386975288391113,
- 3.034958839416504,
- 2.8929836750030518,
- 2.8669273853302,
- -5,
- -1.5589079856872559,
- 1.9696201086044312,
- 3.9466171264648438,
- -3.894467353820801,
- -1.4353413581848145,
- 0.6438999772071838,
- -3.559412717819214,
- 2.898449182510376,
- 4.226627349853516,
- -5,
- -5,
- -4.580845355987549,
- -2.0328192710876465,
- 4.1754069328308105,
- 4.199225902557373,
- 4.34015417098999,
- -2.9041290283203125,
- 2.497323513031006,
- -1.7650561332702637,
- -0.5644856095314026,
- -5,
- -5,
- 3.0372588634490967,
- 3.8829185962677,
- 3.6070923805236816,
- 3.8541207313537598,
- 3.8192059993743896,
- -2.6382784843444824,
- -4.700376033782959,
- 2.501884937286377,
- 4.065597057342529,
- 1.0171412229537964,
- 5,
- -4.651655673980713,
- -0.8031032681465149,
- 1.2622673511505127,
- 1.2936519384384155,
- 1.369748592376709,
- 4.189074516296387,
- 4.076688766479492,
- 5,
- 0.7270625233650208,
- 0.995764970779419,
- -0.8975422382354736,
- -1.5903971195220947,
- 3.329392194747925,
- 3.4523019790649414,
- -1.0810967683792114,
- -0.5812257528305054,
- 2.644548177719116,
- 2.6585214138031006,
- 5,
- 3.7732388973236084,
- 0.9950934052467346,
- 0.8841180801391602,
- 3.8183670043945312,
- -0.6460126042366028,
- 2.1103804111480713,
- 2.3608930110931396,
- 1.3835891485214233,
- 3.4795989990234375,
- 1.769286036491394,
- 1.7716087102890015,
- -5,
- -5,
- -5,
- -1.426405906677246,
- -2.7312746047973633,
- -5,
- 0.47139957547187805,
- 3.8471028804779053,
- 0.7896639108657837,
- -1.2268297672271729,
- -4.720064640045166,
- 2.7558088302612305,
- 3.023494243621826,
- 3.7829294204711914,
- -1.891106128692627,
- 3.048088550567627,
- 0.008336871862411499,
- 0.07599930465221405,
- -1.3721232414245605,
- -1.032981276512146,
- -0.6021665930747986,
- 1.735460877418518,
- 1.5383501052856445,
- 2.478435516357422,
- -3.304556131362915,
- -2.378432035446167,
- -0.4857358932495117,
- -2.097623586654663,
- -3.2147445678710938,
- -1.8128300905227661,
- 3.589271306991577,
- 3.373690366744995,
- -3.5193681716918945,
- 3.53788161277771,
- -1.1633410453796387,
- -3.841488838195801,
- -3.562544822692871,
- -5,
- -4.628747463226318,
- -0.3776344060897827,
- -1.9576623439788818,
- -2.3299407958984375,
- -2.3134829998016357,
- 0.5879091620445251,
- 0.39716675877571106,
- 5,
- -4.527527809143066,
- 2.8390586376190186,
- 0.3319953382015228,
- -0.2031165361404419,
- 5,
- 5,
- 5,
- -5,
- 2.2759742736816406,
- 4.30157470703125,
- -0.7995855808258057,
- -0.05464247241616249,
- -1.3260889053344727,
- -1.0919172763824463,
- -1.5666868686676025,
- 0.6270329356193542,
- 2.468057155609131,
- -2.5841712951660156,
- -4.339723110198975,
- 5,
- 5,
- 0.5067524909973145,
- 0.7723978161811829,
- 3.510948657989502,
- 4.363494873046875,
- -3.0252578258514404,
- -1.2719022035598755,
- 4.58084774017334,
- 5,
- 4.526966571807861,
- -5,
- -5,
- -5,
- 5,
- 4.227243900299072,
- 4.085610389709473,
- -4.363025188446045,
- -1.356877088546753,
- -1.0370725393295288,
- 1.1098798513412476,
- -1.7669402360916138,
- 3.0309200286865234,
- 1.8378273248672485,
- -1.0789508819580078,
- 1.8391550779342651,
- 0.4916764497756958,
- -3.601686716079712,
- -0.24966329336166382,
- 4.12544059753418,
- -5,
- -5,
- 1.536503791809082,
- 1.7359037399291992,
- 5,
- -3.840538263320923,
- -5,
- -5,
- -5,
- 4.124938011169434,
- -4.646697998046875,
- -5,
- 4.167131423950195,
- -3.3831329345703125,
- -3.5020036697387695,
- 3.266669988632202,
- -0.9436191916465759,
- -1.5299025774002075,
- -1.982384204864502,
- 3.6774818897247314,
- -2.2120511531829834,
- -0.3448413610458374,
- -3.386986017227173,
- -3.1074790954589844,
- -0.4411892294883728,
- -0.3736647963523865,
- -5,
- -5,
- -1.2011436223983765,
- -1.1121392250061035,
- -2.1613833904266357,
- -2.2924811840057373,
- 3.104656934738159,
- 2.610442638397217,
- 5,
- -5,
- -2.3681676387786865,
- 3.672323226928711,
- 3.7326676845550537,
- 0.1613098382949829,
- 0.2413194328546524,
- 1.3728821277618408,
- 0.4339759051799774,
- 0.35695144534111023,
- -2.493479013442993,
- 2.1896910667419434,
- 4.700502395629883,
- 5,
- -1.016597032546997,
- 0.6210448145866394,
- 0.6637445688247681,
- 5,
- -1.0216628313064575,
- -0.23358485102653503,
- 3.3018922805786133,
- 1.8105369806289673,
- 0.955568790435791,
- -3.7231528759002686,
- -3.9804978370666504,
- -1.2900493144989014,
- 4.1124267578125,
- -3.540820360183716,
- -5,
- -3.8975656032562256,
- 1.2156816720962524,
- 0.7590240836143494,
- 3.5594608783721924,
- -3.283069372177124,
- -5,
- -3.2769768238067627,
- 0.1670776754617691,
- -0.7176233530044556,
- 0.9799598455429077,
- 1.3872452974319458,
- -2.0572428703308105,
- -3.3091535568237305,
- -1.3487980365753174,
- -4.625357627868652,
- -2.012728691101074,
- -5,
- 0.8194661736488342,
- -1.579920768737793,
- -1.5731505155563354,
- -4.639402389526367,
- -1.7494895458221436,
- -3.0217342376708984,
- -1.5556175708770752,
- 2.022423028945923,
- -2.8629543781280518,
- 1.2468470335006714,
- 1.9912384748458862,
- -1.0789836645126343,
- -0.08867280930280685,
- -1.3601857423782349,
- 0.519882321357727,
- 2.222944498062134,
- 0.5680000185966492,
- 2.373995542526245,
- -2.9980807304382324,
- 3.2855708599090576
- ],
- "y": [
- -0.9644528031349182,
- -0.5014916062355042,
- -0.9228641390800476,
- -0.9955595135688782,
- 0.2492223083972931,
- 0.057115908712148666,
- -0.16631139814853668,
- -0.06584170460700989,
- 0.10396039485931396,
- -0.31133314967155457,
- -0.041115161031484604,
- -0.04820563644170761,
- -0.949433445930481,
- -0.8801339268684387,
- -0.5981799364089966,
- -0.9736314415931702,
- -0.43101099133491516,
- -0.4243756830692291,
- -0.4731490910053253,
- -0.6577183604240417,
- 0.2146396040916443,
- 0.5974391102790833,
- 0.2125028818845749,
- 0.43337777256965637,
- 0.4884589910507202,
- 0.6967326402664185,
- 0.6029126048088074,
- 0.23680882155895233,
- 0.6917465329170227,
- 0.4850515127182007,
- 0.18376414477825165,
- 0.48162636160850525,
- -0.6320042610168457,
- -0.7730603814125061,
- -0.9154437184333801,
- -0.9334678649902344,
- -0.937618613243103,
- -0.6324880123138428,
- -0.9645949602127075,
- -0.8584909439086914,
- -0.021662965416908264,
- -0.19917190074920654,
- -0.40617337822914124,
- 0.01375947892665863,
- 0.6443992257118225,
- 0.2646108865737915,
- 0.3110242187976837,
- 0.4987179636955261,
- 0.2822154462337494,
- 0.22283178567886353,
- 0.3027957081794739,
- 0.48568424582481384,
- -0.004136862698942423,
- 0.24444110691547394,
- 0.3975219428539276,
- 0.06679671257734299,
- 0.3392251133918762,
- 0.4178438186645508,
- 0.0005444167763926089,
- 0.26371410489082336,
- 0.6860716342926025,
- 0.5389652252197266,
- 0.2810700237751007,
- 0.29595068097114563,
- -0.0028515858575701714,
- -0.914943516254425,
- -0.8317362070083618,
- -0.5160342454910278,
- 0.1723458170890808,
- -0.24010129272937775,
- 0.11037452518939972,
- -0.04924260079860687,
- 0.9950059056282043,
- 0.5880264043807983,
- 0.590488612651825,
- 0.6281570792198181,
- -0.1020033061504364,
- 0.12514355778694153,
- 0.26880502700805664,
- -0.06841706484556198,
- 0.07446050643920898,
- -0.19104579091072083,
- 0.17392556369304657,
- -0.010952293872833252,
- 0.8551027774810791,
- 0.8424614071846008,
- 0.4966377019882202,
- 0.9818977117538452,
- -0.7847625613212585,
- -0.3964613676071167,
- -0.7274291515350342,
- 0.9931104183197021,
- 0.990178644657135,
- 0.9477092027664185,
- -0.7309668660163879,
- -0.8255475759506226,
- -0.5082603693008423,
- -0.8930004835128784,
- 0.4194926917552948,
- 0.20234280824661255,
- 0.382354199886322,
- 0.04821555316448212,
- -0.22185000777244568,
- -0.2684493958950043,
- -0.2542339563369751,
- -0.6113150715827942,
- -0.749304473400116,
- 0.9967495203018188,
- 0.6226924657821655,
- 0.9509856700897217,
- 0.9614278674125671,
- -0.5285993218421936,
- -0.26093634963035583,
- -0.44633013010025024,
- -0.7162333726882935,
- 0.37243372201919556,
- 0.7037805914878845,
- 0.5981281399726868,
- 0.8595001101493835,
- -0.2422453761100769,
- -0.2717275023460388,
- -0.342314749956131,
- -0.36787569522857666,
- -0.0067490083165466785,
- -0.12062981724739075,
- -0.10932574421167374,
- 0.7730425596237183,
- 0.7197641730308533,
- 0.5498804450035095,
- 0.8838788866996765,
- -0.4682152271270752,
- -0.8429638743400574,
- -0.7152993083000183,
- 0.16587448120117188,
- 0.17635276913642883,
- 0.4282841980457306,
- -0.06333015114068985,
- 0.0034832851961255074,
- 0.09057462960481644,
- -0.7059872150421143,
- -0.3774401545524597,
- -0.6989597082138062,
- -0.5003755688667297,
- 0.7566817402839661,
- 0.44234010577201843,
- 0.45263102650642395,
- 0.5166338682174683,
- 0.16024252772331238,
- 0.5950716137886047,
- -0.18073487281799316,
- 0.0018878098344430327,
- -0.2708609104156494,
- -0.25196877121925354,
- -0.11142797023057938,
- -0.43370550870895386,
- -0.15656259655952454,
- -0.039399806410074234,
- 0.46687936782836914,
- 0.32242169976234436,
- 0.6205798983573914,
- 0.6568413972854614,
- 0.2932124137878418,
- 0.286562442779541,
- 0.5216072797775269,
- -0.9623097777366638,
- -0.9981469511985779,
- -0.6364484429359436,
- -0.9993236660957336,
- -0.07432012259960175,
- 0.42001017928123474,
- 0.34383609890937805,
- -0.08206897974014282,
- 0.17495545744895935,
- -0.6187282204627991,
- -0.17506438493728638,
- -0.16744637489318848,
- -0.3097870349884033,
- -0.4293544590473175,
- -0.34442025423049927,
- -0.08278083801269531,
- 0.040901072323322296,
- -0.20948979258537292,
- -0.8171733617782593,
- -0.6349214315414429,
- -0.63686603307724,
- -0.34542766213417053,
- 0.9818851351737976,
- 0.7231388688087463,
- -0.4980590343475342,
- -0.5276463031768799,
- -0.6645891070365906,
- 0.6138550639152527,
- 0.7307949662208557,
- 0.565581202507019,
- 0.8974766731262207,
- 0.2210589051246643,
- -0.04366305470466614,
- 0.2200208306312561,
- 0.9976720213890076,
- 0.9910743236541748,
- 0.04993176832795143,
- 0.2965986132621765,
- 0.3659362196922302,
- -0.6525683999061584,
- -0.4112653136253357,
- -0.9211462140083313,
- -0.8424838185310364,
- -0.9637735486030579,
- -0.9835269451141357,
- -0.9970294237136841,
- -0.9710226655006409,
- -0.9704429507255554,
- -0.000344896805472672,
- 0.21921929717063904,
- -0.13210053741931915,
- 0.1057116687297821,
- -0.5773980617523193,
- -0.8491992354393005,
- -0.9644528031349182,
- -0.9644528031349182,
- 0.18421055376529694,
- -0.34306600689888,
- -0.6099089980125427,
- -0.522908627986908,
- 0.5520397424697876,
- 0.6777611374855042,
- 0.7900189757347107,
- 0.8836524486541748,
- 0.998988151550293,
- 0.6972864270210266,
- 0.9325829744338989,
- -0.7420949339866638,
- -0.8717162013053894,
- 0.3239639103412628,
- 0.3646659553050995,
- 0.18762114644050598,
- 0.4323038160800934,
- 0.49042609333992004,
- 0.4172574579715729,
- -0.4056946337223053,
- -0.7565715909004211,
- -0.8770694732666016,
- -0.6713137626647949,
- 0.3914759159088135,
- 0.5560338497161865,
- 0.401335746049881,
- 0.6967827081680298,
- 0.5735718011856079,
- 0.9659417867660522,
- 0.4600377678871155,
- -0.7376769781112671,
- -0.7612969279289246,
- -0.8649499416351318,
- -0.9680713415145874,
- -0.07136695086956024,
- 0.08702337741851807,
- -0.0012019457062706351,
- -0.40912172198295593,
- -0.006982382852584124,
- -0.2469279021024704,
- 0.2634161114692688,
- 0.19823867082595825,
- 0.6264614462852478,
- -0.0895332545042038,
- 0.15487948060035706,
- 0.010749834589660168,
- 0.21317049860954285,
- 0.3579390347003937,
- 0.6785242557525635,
- 0.4390743672847748,
- 0.2672802209854126,
- -0.8758218884468079,
- -0.963442862033844,
- -0.9812936782836914,
- 0.47073882818222046,
- 0.4233376085758209,
- 0.6527111530303955,
- 0.6982703804969788,
- 0.6721965670585632,
- 0.9104544520378113,
- 0.8594658970832825,
- 0.9712696671485901,
- 0.7178391218185425,
- 0.9804772734642029,
- 0.9899379014968872,
- -0.272844135761261,
- -0.23376643657684326,
- -0.262163907289505,
- 0.03704443946480751,
- -0.4075758457183838,
- -0.7010478377342224,
- -0.20673303306102753,
- -0.5571584105491638,
- -0.8706849217414856,
- -0.48726165294647217,
- -0.2910931706428528,
- -0.002765015931800008,
- 0.05970108136534691,
- 0.3084672689437866,
- 0.15337669849395752,
- -0.6174674034118652,
- -0.6328142881393433,
- -0.5624826550483704,
- 0.1400715708732605,
- 0.3191937208175659,
- 0.02131892368197441,
- -0.09887219220399857,
- -0.13459566235542297,
- 0.031372569501399994,
- -0.23347316682338715,
- -0.1083475649356842,
- 0.10015857964754105,
- -0.15261906385421753,
- -0.3190996050834656,
- 0.5962103009223938,
- 0.944227933883667,
- 0.6263585686683655,
- -0.03721585124731064,
- -0.14064188301563263,
- -0.12287423759698868,
- 0.1620333045721054,
- 0.051118478178977966,
- 0.025942236185073853,
- 0.9509856700897217,
- 0.07660112529993057,
- -0.2148650735616684,
- -0.2792571783065796,
- -0.3916383981704712,
- -0.5475131869316101,
- -0.3573049306869507,
- -0.5381907820701599,
- 0.5642790794372559,
- 0.39763057231903076,
- 0.4926196038722992,
- 0.6876794695854187,
- 0.9853602051734924,
- 0.9853602051734924,
- 0.2784459888935089,
- 0.33439427614212036,
- 0.3757942020893097,
- 0.5680580735206604,
- -0.202531099319458,
- 0.04602264240384102,
- 0.1253708153963089,
- -0.053822703659534454,
- -0.09523261338472366,
- -0.3647562861442566,
- 0.055967457592487335,
- -0.18043585121631622,
- -0.36183372139930725,
- -0.26616132259368896,
- 0.5843426585197449,
- 0.7874525785446167,
- 0.3204408586025238,
- 0.46942922472953796,
- -0.3549381494522095,
- -0.15470989048480988,
- -0.28662583231925964,
- -0.45677778124809265,
- -0.14482297003269196,
- -0.3699699342250824,
- -0.31996339559555054,
- 0,
- 0.03902474418282509,
- -0.4207833707332611,
- 0.5997176170349121,
- 0.34521904587745667,
- 0.260562002658844,
- 0.301216721534729,
- -0.39678168296813965,
- -0.9933051466941833,
- -0.48806899785995483,
- -0.9801273941993713,
- -0.9932265877723694,
- -0.00268577691167593,
- -0.4860992431640625,
- -0.718903660774231,
- -0.22610677778720856,
- 0.40737977623939514,
- 0.7242735624313354,
- 0.9194390773773193,
- 0.992190957069397,
- 0.5167772769927979,
- -0.8444285988807678,
- -0.6822850704193115,
- 0.6697694063186646,
- 0.9455884695053101,
- -0.563209056854248,
- -0.6827536821365356,
- -0.6466551423072815,
- -1,
- 0.00808846578001976,
- -0.21341004967689514,
- -0.08499597012996674,
- -0.22998903691768646,
- -0.6067743301391602,
- -0.49108201265335083,
- -0.5265984535217285,
- -0.9826362729072571,
- -0.23542766273021698,
- -0.2631172835826874,
- -0.38973894715309143,
- -0.510794460773468,
- 0.614811897277832,
- 0.9284683465957642,
- 0.980880856513977,
- 0.6759928464889526,
- 0.7887943387031555,
- 0.334210067987442,
- 0.8685921430587769,
- 0.9433988928794861,
- 0.3017013370990753,
- 0.322925865650177,
- 0.0030513221863657236,
- -0.08400421589612961,
- 0.1492752730846405,
- 0.15100379288196564,
- 0.2531687021255493,
- 0.22673995792865753,
- 0.08318476378917694,
- -0.09412675350904465,
- -0.10312476009130478,
- 0.00051957240793854,
- 0.1938382387161255,
- -0.429431289434433,
- -0.6668448448181152,
- 0.27889484167099,
- -0.9699349999427795,
- -0.6830593347549438,
- -0.9178845286369324,
- -0.8040575385093689,
- -0.03522491827607155,
- 0.586391270160675,
- 0.9315357804298401,
- 0.7273709177970886,
- 0.23738005757331848,
- 0.16160446405410767,
- 0.196137934923172,
- 0.6648127436637878,
- 0.9904631972312927,
- 0.9321214556694031,
- -0.9826473593711853,
- -0.5793296098709106,
- -0.5139965415000916,
- -0.9829296469688416,
- 0.10490112006664276,
- 0.26333707571029663,
- 0.015549364499747753,
- 0.7950919270515442,
- -0.22844749689102173,
- 0.08410408347845078,
- -0.014554033055901527,
- -0.40973183512687683,
- -0.6088537573814392,
- -0.7200993895530701,
- -0.25975117087364197,
- -0.05376914516091347,
- 0.25696367025375366,
- -0.02727169543504715,
- -0.9200538992881775,
- -0.9851748943328857,
- 0.2039009928703308,
- -0.18674251437187195,
- -0.0373150035738945,
- 0.0003531149122864008,
- 0.7743528485298157,
- 0.49138516187667847,
- 0.8453116416931152,
- 0.8113861680030823,
- -0.2243531048297882,
- 0.17102263867855072,
- 0.13133029639720917,
- -0.8719936609268188,
- -0.7000458240509033,
- -0.5028141736984253,
- 0.5621294975280762,
- -0.48999398946762085,
- 1,
- 0.9576523303985596,
- -0.41538330912590027,
- -0.5296134352684021,
- -0.5272583365440369,
- 0.26668936014175415,
- 0.9760602116584778,
- 0.874788224697113,
- -0.8827227354049683,
- -0.9637153744697571,
- -0.5040878057479858,
- -0.27172648906707764,
- 0.274967223405838,
- -0.01066218875348568,
- 0.29421308636665344,
- 0.1539771407842636,
- 0.15297439694404602,
- 0.35023635625839233,
- -0.21796944737434387,
- 0.8537461161613464,
- 0.9835426211357117,
- 0.9496530294418335,
- 0.9985606074333191,
- -0.2221001833677292,
- 0.4310095012187958,
- 0.6029019355773926,
- 0.7001603841781616,
- 0.8360967636108398,
- 0.519031286239624,
- -0.9936496019363403,
- -0.9828091859817505,
- 0.26668936014175415,
- 0.5236851572990417,
- 0.49962037801742554,
- 0.5692272782325745,
- 0.22008033096790314,
- 0.2918113172054291,
- -0.005608721170574427,
- 0.03870052844285965,
- 0.26892536878585815,
- -0.1814487725496292,
- 0.06543553620576859,
- 0.08210965245962143,
- -0.09493392705917358,
- 0.23452402651309967,
- 0.04021294042468071,
- -0.09652941673994064,
- 0.6716895699501038,
- 0.8282829523086548,
- -0.5790790915489197,
- -0.7159784436225891,
- -0.874889612197876,
- -0.9411375522613525,
- -0.25209754705429077,
- -0.6056337356567383,
- -0.4996890425682068,
- 0.268974632024765,
- 0.4170511066913605,
- 0.2456361949443817,
- 0.17661170661449432,
- -0.6461558938026428,
- -0.8366621732711792,
- -0.9373155832290649,
- 0.6573933362960815,
- 0.764940083026886,
- 0.4581672251224518,
- 0.012059792876243591,
- -0.36481741070747375,
- 0.047285694628953934,
- -0.19150404632091522,
- -0.06492480635643005,
- 0.2849947214126587,
- 0.49767422676086426,
- 0.28277072310447693,
- 0.54390949010849,
- 0.1638433039188385,
- -0.31062552332878113,
- -0.08801092207431793,
- -0.47230759263038635,
- -0.2938145399093628,
- -0.0704847201704979,
- 0.6260424852371216,
- 0.39466437697410583,
- 0.31425905227661133,
- 0.7220942974090576,
- -0.7903173565864563,
- 0.2835279703140259,
- 0.6021785140037537,
- 0.5951641798019409,
- 0.3522506654262543,
- 0.5202761888504028,
- 0.6336329579353333,
- 0.44877156615257263,
- 0.5989428758621216,
- 0.9741127490997314,
- 0.9952908158302307,
- 0.6856418251991272,
- -0.18962796032428741,
- 0.14198823273181915,
- 0.027870045974850655,
- -0.2665543556213379,
- -0.12062981724739075,
- -0.35000452399253845,
- -0.6031556725502014,
- -0.7968862652778625,
- -0.9509775042533875,
- 0.2576938569545746,
- -0.17726917564868927,
- 0.9844260215759277,
- -0.4435259699821472,
- -0.1699523627758026,
- 0.6966899037361145,
- 0.9935153722763062,
- 0.994518518447876,
- 0.9067777991294861,
- -0.9979760646820068,
- -0.9827584624290466,
- -0.01198972761631012,
- 0.004887382499873638,
- 0.9262871146202087,
- -0.011220625601708889,
- 0.20926238596439362,
- 0.08175507932901382,
- 0.13949643075466156,
- 0.24324852228164673,
- 0.2432398945093155,
- -0.03161051869392395,
- 0.41032442450523376,
- 0.5218767523765564,
- -0.1977277398109436,
- 0.07446050643920898,
- -0.20594902336597443,
- -0.3251917064189911,
- -0.6149249076843262,
- 0.4732542634010315,
- 0.07446050643920898,
- 0.3481038212776184,
- 0.22188933193683624,
- 0.2149362415075302,
- -0.24006293714046478,
- -0.2876802384853363,
- 0.41702282428741455,
- 0.19047819077968597,
- -0.2501949965953827,
- -0.15160758793354034,
- 0.43379339575767517,
- 0.0909355953335762,
- 0.451621413230896,
- 0.5065004825592041,
- -0.9908729195594788,
- -0.08206022530794144,
- -0.027877792716026306,
- 0.5542229413986206,
- -0.38842886686325073,
- 0.9741654992103577,
- -0.3724351227283478,
- -0.1986246407032013,
- -0.3232215344905853,
- 0.7665350437164307,
- 0.5796975493431091,
- -0.6754114627838135,
- -0.8743530511856079,
- -0.8580234050750732,
- 0.7657902240753174,
- 0.6770547032356262,
- 0.5566800236701965,
- 0.935212254524231,
- -0.584112286567688,
- 0.017612561583518982,
- -0.36803585290908813,
- -0.5247402191162109,
- 0.4970661997795105,
- -0.6998907327651978,
- -0.5846438407897949,
- 0.9509856700897217,
- 0.8254937529563904,
- 0.6614059805870056,
- 0.5184406042098999,
- -0.5043556690216064,
- -0.8817981481552124,
- -0.6980621218681335,
- -0.3875381350517273,
- -0.9762217998504639,
- -0.9982428550720215,
- 0.2067089080810547,
- 0.11346746981143951,
- 0.01595616154372692,
- -0.2828061878681183,
- 0.014170551672577858,
- 0.6205798983573914,
- -0.8973569869995117,
- -0.7388009428977966,
- -0.5494065880775452,
- -0.8166348338127136,
- 0.5313565731048584,
- -0.004518178757280111,
- 0.48383238911628723,
- -0.4977671205997467,
- -0.11393170058727264,
- -0.1845625638961792,
- -0.3601009249687195,
- -0.314405232667923,
- 0.48286524415016174,
- 0.20714795589447021,
- 0.040663253515958786,
- -0.9531037211418152,
- -0.26953038573265076,
- -0.4040994942188263,
- -0.26528051495552063,
- 0.23274151980876923,
- -0.6318374872207642,
- -0.9665676951408386,
- 0.005913611501455307,
- 0.49386274814605713,
- 0.23279796540737152,
- 0.24144552648067474,
- 0.3414899408817291,
- 0.30328240990638733,
- -0.9941494464874268,
- -0.3179697096347809,
- -0.25289952754974365,
- -0.4826950430870056,
- -0.992070198059082,
- -0.9115789532661438,
- -0.5940829515457153,
- -0.5463100671768188,
- -0.9485341310501099,
- -0.6519872546195984,
- -0.9987034797668457,
- -0.5913269519805908,
- -0.7342608571052551,
- 1,
- 0.45685240626335144,
- -0.0836566612124443,
- -0.5427722334861755,
- -0.2221001833677292,
- -0.9979760646820068,
- -0.7426897883415222,
- 0.4536954462528229,
- -0.5354653596878052,
- -0.5605345368385315,
- -0.24477224051952362,
- -0.31265220046043396,
- -0.8582495450973511,
- -0.2184845358133316,
- -0.8255475759506226,
- -0.8973569869995117,
- -0.9509775042533875,
- 0.7109987735748291,
- -0.3486618995666504,
- -0.5666218400001526,
- 0.0820944681763649,
- 0.28015971183776855,
- -0.9690587520599365,
- -0.6733459830284119,
- -0.929873526096344,
- 0.05627104640007019,
- -0.5349896550178528,
- -0.49556639790534973,
- -0.2316868156194687,
- -0.2666398584842682,
- -0.5846438407897949,
- 0.9041470885276794,
- 0.34881946444511414,
- 0.73880535364151,
- -0.4977671205997467,
- -0.620514452457428,
- 0.3705782890319824,
- -0.3981460928916931,
- -0.7447241544723511,
- -0.5671089291572571,
- -0.7126420140266418,
- 0.3201524019241333,
- -0.9361801147460938,
- -0.021949056535959244,
- 0.26071488857269287,
- 0.11704500019550323,
- -0.09812191873788834,
- -0.6564890742301941,
- 0.5860076546669006,
- 0.23305492103099823,
- 0.1070864275097847,
- 0.02329915389418602,
- -0.2407625913619995,
- 0.3414646089076996,
- 0.6114945411682129,
- 0.0007608749438077211,
- -0.18877489864826202,
- -0.06473154574632645,
- -0.5393319725990295,
- -0.37636464834213257,
- -0.2776724100112915,
- 0.407381534576416,
- 0.5711175799369812,
- 0.10242214798927307,
- -0.5774988532066345,
- 0.5009621977806091,
- 0.7229906320571899,
- 0.5307389497756958,
- 0.8771102428436279,
- -0.6564419269561768,
- -0.41044551134109497,
- -0.6564419269561768,
- -0.7309668660163879,
- -0.9828091859817505,
- -0.9828091859817505,
- -0.31996339559555054,
- 0.02778959460556507,
- -0.18145851790905,
- -0.4760945737361908,
- -0.6159340143203735,
- -0.5961918830871582,
- -0.6848282217979431,
- -0.251895934343338,
- 0.29486724734306335,
- 0.40002304315567017,
- 0.9899379014968872,
- 0.7229412794113159,
- 0.9807852506637573,
- -0.7337335348129272,
- -0.8108888864517212,
- -0.5162743926048279,
- -0.6094732284545898,
- -0.9194790720939636,
- 0.5308945178985596,
- 0.01500244252383709,
- -0.7993972897529602,
- 0.9984241127967834,
- -0.012843931093811989,
- -0.8668404221534729,
- 0.990543007850647,
- 0.0920555591583252,
- -0.31916898488998413,
- 0.9374285340309143,
- 0.7959373593330383,
- 0.8754876255989075,
- -0.8362293243408203,
- -0.6582773923873901,
- -0.9916395545005798,
- -0.8973569869995117,
- 0.061656251549720764,
- 0.5361354351043701,
- 0.36971715092658997,
- -0.4583832919597626,
- -0.46862149238586426,
- -0.9807852506637573,
- -0.9511585831642151,
- -0.27999889850616455,
- 0.038460005074739456,
- 0.1938815712928772,
- 0.19310392439365387,
- 0.5270761847496033,
- 0.5389652252197266,
- -0.5263717770576477,
- 0.31121960282325745,
- 0.13053779304027557,
- 0.2712872624397278,
- 0.9807852506637573,
- -0.97075355052948,
- 0.9580817818641663,
- 0.7310782670974731,
- 0.5388161540031433,
- 0.9519411325454712,
- 0.8434329628944397,
- -0.4833066761493683,
- -0.20707954466342926,
- -0.5099445581436157,
- -0.6608012318611145,
- -0.018839603289961815,
- -0.7309668660163879,
- -0.5254232883453369,
- 0.3551715314388275,
- -0.21630725264549255,
- -0.39276570081710815,
- -0.07621423900127411,
- 0.02646898478269577,
- 0.3646659553050995,
- 0.8563774824142456,
- 0.5865227580070496,
- 0.46233615279197693,
- 0.8343841433525085,
- -0.8973569869995117,
- -0.5947028398513794,
- -0.8064454793930054,
- 0.570570170879364,
- 0.5161767601966858,
- 0.48175233602523804,
- 0.4885003864765167,
- -0.38643592596054077,
- -0.4773034155368805,
- -0.38785600662231445,
- 0.8576608896255493,
- -0.9899351596832275,
- 0.9875081777572632,
- -0.1636705994606018,
- -0.9172571897506714,
- -0.16427050530910492,
- -0.4349454939365387,
- -0.9953550100326538,
- -0.9971668124198914,
- 0.6962160468101501,
- 0.5453452467918396,
- -0.05568347126245499,
- -0.6601232290267944,
- -0.842789351940155,
- -0.2496166080236435,
- -0.8420789837837219,
- -0.8744059801101685,
- -0.834104597568512,
- -0.9026780724525452,
- 0.9523860216140747,
- 0.9934259653091431,
- -0.7173683643341064,
- -0.9974165558815002,
- 0.3086850345134735,
- -0.8398857116699219,
- -0.2520681619644165,
- -0.2881055772304535,
- -0.17640793323516846,
- -0.8340798020362854,
- 0.803859293460846,
- -0.5375675559043884,
- -0.35286054015159607,
- -0.40147092938423157,
- -0.5391048192977905,
- -0.4075758457183838,
- -0.06929513067007065,
- 0.4999752938747406,
- 0.5083998441696167,
- 0.7683452367782593,
- 0.44873738288879395,
- 0.1870150864124298,
- 0.44929590821266174,
- 0.7604588270187378,
- -0.253332257270813,
- 0.7990961074829102,
- -0.4588089883327484,
- -0.36481741070747375,
- -0.2928994297981262,
- -0.620514452457428,
- -0.8754743337631226,
- -0.6474624276161194,
- -0.7147241830825806,
- -0.8206048011779785,
- 0.8667620420455933,
- 0.8917268514633179,
- 0.9518074989318848,
- -0.5455569624900818,
- 0.06518997251987457,
- -0.1746850311756134,
- 0.711083710193634,
- -0.7957763075828552,
- -0.23037903010845184,
- 0.4979412853717804,
- -0.9531556367874146,
- -0.9841888546943665,
- 0.04183444380760193,
- 0.8254937529563904,
- 0.9814017415046692,
- -0.5506122708320618,
- 0.9509856700897217,
- 0.8974766731262207,
- 0.8271036744117737,
- 0.6565945744514465,
- 0.5882179737091064,
- 0.4074084758758545,
- 0.1779918372631073,
- 0.8254937529563904,
- 0.3646659553050995,
- 0.6998251676559448,
- -0.25461456179618835,
- -0.16163697838783264,
- 0.5031144618988037,
- 0.056570108979940414,
- 0.4599801003932953,
- 0.22676178812980652,
- -0.27921000123023987,
- -0.5993555784225464,
- 0.9872598648071289,
- -0.1492013782262802,
- -0.11010982096195221,
- 0.08578278124332428,
- -0.176510289311409,
- 0.12077020108699799,
- -0.08411595970392227,
- 0.9915391802787781,
- 0.7307949662208557,
- 0.8754876255989075,
- -0.2441762387752533,
- -0.14552778005599976,
- -0.2168065309524536,
- -0.4977671205997467,
- 0.6998251676559448,
- 0.5844343304634094,
- -0.4977671205997467,
- -0.5964337587356567,
- 0.16315852105617523,
- 0.7636315226554871,
- 0.265627384185791,
- 0.9430791139602661,
- 0.6161730289459229,
- 0.9977315664291382,
- 0.9039280414581299,
- -0.06703191250562668,
- 0.4994438886642456,
- 0.4858933091163635,
- 0.9834839701652527,
- 0.880670964717865,
- 0.8490715026855469,
- 0.9645264744758606,
- -0.9836878776550293,
- 0.020235415548086166,
- 0.6966110467910767,
- 0.9339800477027893,
- 0.5601944327354431,
- -0.00601609330624342,
- 0.22188933193683624,
- 0.06982731819152832,
- 0.42058631777763367,
- -0.20701900124549866,
- -0.5002540349960327,
- -0.9948720335960388,
- -0.6225435733795166,
- 0.29936158657073975,
- -0.9993430376052856,
- -0.8705465197563171,
- 0.9978688955307007,
- 0.9816693663597107,
- -0.2221001833677292,
- -0.07432012259960175,
- 0.005510379560291767,
- 0.93561190366745,
- 0.769040584564209,
- 0.4979412853717804,
- 0.09552592039108276,
- -0.4952143132686615,
- 0.8628236055374146,
- 0.891992449760437,
- 0.3251786231994629,
- -0.9622695446014404,
- -0.9051315188407898,
- 0.6972473859786987,
- -0.9227719902992249,
- -0.9991018772125244,
- 0.9954250454902649,
- -0.2867448031902313,
- 0.40268635749816895,
- 0.14126500487327576,
- 0.9529435634613037,
- 0.6507450938224792,
- 0.27342158555984497,
- -0.9639715552330017,
- -0.971455454826355,
- 0.9434934258460999,
- 0.7417119145393372,
- 0.922407329082489,
- 0.7960216403007507,
- 0.39301806688308716,
- 0.44151046872138977,
- 0.9164034128189087,
- -0.45337846875190735,
- -0.7604051232337952,
- -0.9881238341331482,
- 0.3329641819000244,
- 0.5564926266670227,
- -0.7899213433265686,
- 0.7021987438201904,
- -0.9409090876579285,
- 0.8222968578338623,
- -0.1262354850769043,
- 0.9899379014968872,
- 0.8101232051849365,
- 0.4139884412288666,
- 0.4850161373615265,
- 0.8455127477645874,
- -0.7117887139320374,
- -0.9599732160568237,
- 0.32545220851898193,
- -0.017274606972932816,
- 0.0917535200715065,
- 0.9274268746376038,
- 0.7069732546806335
- ],
- "z": [
- 0.24893133342266083,
- 0.06961314380168915,
- 0.38458311557769775,
- 0.045085154473781586,
- -0.2524856626987457,
- -0.6164182424545288,
- -0.4557993710041046,
- -0.09390309453010559,
- -0.6660021543502808,
- -0.5890951156616211,
- -0.9959505200386047,
- -0.6060599088668823,
- -0.298443466424942,
- -0.4645257592201233,
- -0.23048292100429535,
- -0.21867342293262482,
- -0.31317806243896484,
- 0.07732536643743515,
- -0.3414348065853119,
- -0.05248579755425453,
- -0.10382933914661407,
- -0.019813725724816322,
- 0.2175561636686325,
- 0.13014905154705048,
- 0.40530869364738464,
- 0.7156205773353577,
- 0.7926167249679565,
- 0.4570474326610565,
- -0.13187628984451294,
- 0.12653519213199615,
- -0.22819986939430237,
- -0.3281902074813843,
- 0.28013405203819275,
- 0.6267420649528503,
- 0.39846572279930115,
- 0.3510749340057373,
- -0.33739176392555237,
- -0.18817365169525146,
- -0.24846261739730835,
- -0.5050169229507446,
- -0.5259588956832886,
- -0.26771974563598633,
- -0.446445107460022,
- -0.248659148812294,
- 0.24804984033107758,
- 0.18279309570789337,
- 0.03786000609397888,
- -0.07831154018640518,
- -0.20537401735782623,
- 0.22865191102027893,
- 0.03590712696313858,
- 0.0510106198489666,
- -0.5112490653991699,
- -0.4819660484790802,
- -0.5647855401039124,
- -0.9934210777282715,
- -0.9370624423027039,
- -0.3811916410923004,
- -0.5316653251647949,
- -0.5263366103172302,
- -0.7243698835372925,
- -0.8403451442718506,
- -0.5899010300636292,
- -0.9501896500587463,
- -0.9997191429138184,
- 0.3994015157222748,
- 0.5550714731216431,
- 0.1366790235042572,
- 0.33598801493644714,
- 0.49225300550460815,
- 0.6483957171440125,
- 0.3165377676486969,
- 0.05070596933364868,
- 0.3658945858478546,
- 0.07349245995283127,
- 0.02135220356285572,
- 0.9899535775184631,
- 0.6588714122772217,
- 0.9584241509437561,
- 0.7039474248886108,
- 0.9926663041114807,
- 0.5769069790840149,
- 0.6764622330665588,
- 0.998921275138855,
- 0.5113556385040283,
- 0.5350059866905212,
- 0.4005412459373474,
- 0.18379539251327515,
- -0.6124829649925232,
- -0.916515052318573,
- -0.6823439002037048,
- 0.06995134800672531,
- -0.09971776604652405,
- 0.30412760376930237,
- -0.678033173084259,
- -0.5627862811088562,
- -0.42405495047569275,
- -0.4404540956020355,
- -0.22640195488929749,
- -0.2587750554084778,
- -0.5708564519882202,
- -0.5173807144165039,
- -0.9726678133010864,
- -0.6065524220466614,
- -0.9628442525863647,
- -0.060457516461610794,
- 0.07383366674184799,
- 0.033002905547618866,
- -0.26771634817123413,
- -0.29332637786865234,
- -0.2589031755924225,
- 0.4012563228607178,
- 0.6697467565536499,
- 0.37911468744277954,
- 0.6959860324859619,
- -0.3439806401729584,
- -0.709836483001709,
- -0.36161622405052185,
- -0.5031288266181946,
- -0.37700721621513367,
- -0.027168434113264084,
- 0.1186046227812767,
- 0.9283714294433594,
- 0.6873116493225098,
- 0.9881190061569214,
- 0.9892323613166809,
- 0.6267638206481934,
- 0.6916837096214294,
- 0.3116864562034607,
- 0.45751941204071045,
- -0.30098357796669006,
- -0.5340659618377686,
- -0.070583276450634,
- 0.9836627840995789,
- 0.9826307892799377,
- 0.2885918915271759,
- 0.23875781893730164,
- -0.0010253038490191102,
- -0.01305148471146822,
- -0.7080255746841431,
- -0.5416524410247803,
- -0.7137928605079651,
- -0.8609718084335327,
- -0.6466995477676392,
- -0.22543102502822876,
- -0.46304792165756226,
- 0.40055951476097107,
- 0.5511629581451416,
- 0.4643996059894562,
- -0.24696844816207886,
- 0.0023746946826577187,
- -0.121971994638443,
- 0.09900698065757751,
- 0.24953289330005646,
- 0.22445939481258392,
- 0.10599268972873688,
- -0.02011456899344921,
- 0.4988115429878235,
- 0.9421597123146057,
- 0.7781175374984741,
- 0.7483584880828857,
- -0.9510202407836914,
- -0.5498870611190796,
- -0.8496232032775879,
- -0.25599583983421326,
- -0.018814457580447197,
- 0.0450722798705101,
- 0.006867034826427698,
- 0.9926801323890686,
- -0.33451950550079346,
- -0.6014363765716553,
- -0.3249167501926422,
- -0.42981573939323425,
- -0.7796371579170227,
- -0.6329610347747803,
- -0.9835079908370972,
- -0.9459924101829529,
- -0.5039926767349243,
- -0.4338308274745941,
- -0.25865885615348816,
- -0.6047350168228149,
- -0.20979124307632446,
- 0.5729902386665344,
- 0.7663477659225464,
- 0.29461243748664856,
- 0.5809187293052673,
- -0.18392319977283478,
- 0.020668039098381996,
- -0.27200955152511597,
- 0.03924412652850151,
- 0.0195060633122921,
- 0.3324436545372009,
- 0.6782426834106445,
- 0.17382746934890747,
- 0.4320796728134155,
- 0.20146599411964417,
- 0.37333109974861145,
- 0.5286331176757812,
- -0.02363656461238861,
- -0.0906238928437233,
- 0.5550857782363892,
- 0.5451454520225525,
- 0.5945549011230469,
- -0.7518652677536011,
- -0.5248426795005798,
- -0.387797087430954,
- -0.5349641442298889,
- -0.25117042660713196,
- 0.1672535389661789,
- -0.030160700902342796,
- 0.2272733896970749,
- 0.22918443381786346,
- 0.0007958645583130419,
- -0.47246626019477844,
- -0.26326435804367065,
- -0.2667330503463745,
- 0.2950707972049713,
- 0.5224003791809082,
- 0.24893133342266083,
- 0.24893133342266083,
- -0.3438313901424408,
- 0.2669813930988312,
- -0.05906572937965393,
- 0.3875717222690582,
- 0.2657814919948578,
- 0.7311900854110718,
- 0.6060779690742493,
- 0.45794302225112915,
- -0.010273333638906479,
- 0.1575591117143631,
- 0.3539920449256897,
- -0.6644736528396606,
- -0.48027414083480835,
- -0.9416919350624084,
- 0.9293450713157654,
- 0.4946977198123932,
- 0.5810832977294922,
- 0.8662898540496826,
- 0.9053993225097656,
- 0.5155513882637024,
- 0.6468337774276733,
- 0.4702588617801666,
- 0.11277738958597183,
- -0.048379454761743546,
- -0.2031347006559372,
- -0.4603961706161499,
- -0.1806602030992508,
- 0.10649269074201584,
- 0.24402277171611786,
- 0.22087182104587555,
- 0.6698569059371948,
- 0.6410759091377258,
- 0.4929329752922058,
- 0.23700262606143951,
- -0.37436285614967346,
- -0.2582411468029022,
- 0.000663433806039393,
- -0.9097479581832886,
- -0.6664299368858337,
- -0.9650605320930481,
- 0.4332942068576813,
- 0.19210495054721832,
- 0.2930695116519928,
- 0.23533089458942413,
- 0.6286520957946777,
- 0.6442918181419373,
- 0.34618571400642395,
- -0.006241363473236561,
- 0.1833106428384781,
- 0.29168185591697693,
- -0.002174111781641841,
- 0.47259294986724854,
- 0.25226056575775146,
- 0.1899283230304718,
- 0.1295872926712036,
- -0.14776815474033356,
- -0.007787336595356464,
- 0.1263086497783661,
- 0.15495635569095612,
- 0.40780001878738403,
- 0.5031928420066833,
- 0.22645917534828186,
- 0.04210563376545906,
- 0.1961057186126709,
- -0.10216209292411804,
- 0.28054866194725037,
- 0.4921416640281677,
- 0.18888798356056213,
- 0.29682838916778564,
- 0.9105742573738098,
- 0.7120792269706726,
- 0.46320977807044983,
- 0.830166220664978,
- 0.48220357298851013,
- -0.8679813146591187,
- -0.9516631364822388,
- 0.47452154755592346,
- 0.7259277701377869,
- 0.6084266901016235,
- 0.9848937392234802,
- -0.23830050230026245,
- -0.76807701587677,
- -0.44848307967185974,
- -0.24442195892333984,
- 0.0057609472423791885,
- 0.04943608120083809,
- -0.038206059485673904,
- -0.20376498997211456,
- -0.33428671956062317,
- -0.4373824894428253,
- -0.42244595289230347,
- -0.6520264744758606,
- -0.36086952686309814,
- -0.6188114285469055,
- 0.1818607598543167,
- -0.31560376286506653,
- -0.2107848972082138,
- -0.6734336614608765,
- 0.9861479997634888,
- 0.9878979325294495,
- 0.9840410947799683,
- 0.34084373712539673,
- -0.6104958653450012,
- 0.29332637786865234,
- 0.6329606175422668,
- 0.4734562635421753,
- 0.6387461423873901,
- 0.9190930128097534,
- -0.34333351254463196,
- -0.19907696545124054,
- -0.007516813464462757,
- 0.35606294870376587,
- 0.5664986968040466,
- 0.2380324900150299,
- 0.02087165042757988,
- 0.1486402451992035,
- -0.1486402451992035,
- -0.5884139537811279,
- -0.24894261360168457,
- -0.5900663137435913,
- -0.4645562767982483,
- 0.22966508567333221,
- 0.30052053928375244,
- 0.25223761796951294,
- 0.4725068509578705,
- 0.9906204342842102,
- 0.53376704454422,
- 0.5839667320251465,
- 0.9822286367416382,
- -0.5414755940437317,
- -0.959226131439209,
- -0.8078566789627075,
- -0.6092051267623901,
- -0.634707510471344,
- -0.5340558290481567,
- 0.20579388737678528,
- 0.5619252324104309,
- 0.020743170753121376,
- -0.8842752575874329,
- -0.9857361912727356,
- -0.5279218554496765,
- -0.9429054260253906,
- 0,
- -0.4684806168079376,
- -0.21044278144836426,
- -0.7952387928962708,
- -0.9352442026138306,
- -0.9609246850013733,
- -0.4732184112071991,
- 0.23765499889850616,
- -0.0679740384221077,
- -0.14824911952018738,
- 0.19725912809371948,
- -0.06877187639474869,
- -0.07851611077785492,
- 0.8686026334762573,
- 0.6927322745323181,
- 0.6234987378120422,
- 0.5488587021827698,
- -0.19145558774471283,
- -0.3909909725189209,
- -0.07928632199764252,
- -0.3109854459762573,
- 0.5313256978988647,
- 0.03555777668952942,
- 0.0490003265440464,
- 0.31111860275268555,
- 0.10442136228084564,
- 0.17511685192584991,
- -0.11836609244346619,
- 0,
- -0.01821127161383629,
- -0.3708040714263916,
- -0.2981916069984436,
- -0.46162664890289307,
- -0.1726837307214737,
- -0.123359814286232,
- 0.4126456081867218,
- 0.17629684507846832,
- 0.43020865321159363,
- -0.16406390070915222,
- -0.29134809970855713,
- -0.3465260863304138,
- -0.1638673096895218,
- -0.36755621433258057,
- -0.19412018358707428,
- -0.2797713577747345,
- 0.6075701713562012,
- 0.654580295085907,
- -0.4861188530921936,
- -0.31833672523498535,
- -0.5780981779098511,
- -0.6000235080718994,
- -0.004480898380279541,
- 0.06860040128231049,
- -0.24482126533985138,
- 0.28688132762908936,
- -0.9631673693656921,
- -0.971184492111206,
- -0.5911328792572021,
- -0.9907293319702148,
- 0.5847785472869873,
- 0.9999487996101379,
- 0.5352766513824463,
- -0.8988922834396362,
- -0.7401489019393921,
- 0.9553634524345398,
- -0.23085886240005493,
- -0.11746350675821304,
- -0.3938993215560913,
- -0.5889719724655151,
- -0.2792058289051056,
- -0.3732108473777771,
- -0.3574441075325012,
- -0.6824148297309875,
- -0.22026440501213074,
- -0.5700737833976746,
- -0.5176344513893127,
- 0.12050525844097137,
- -0.09682867676019669,
- -0.35551348328590393,
- -0.17618408799171448,
- -0.2755252420902252,
- 0.04571164771914482,
- -0.17331843078136444,
- -0.9896681308746338,
- -0.6911693215370178,
- -0.5965977907180786,
- -0.5998966097831726,
- -0.9706664681434631,
- -0.9917164444923401,
- -0.6897068619728088,
- -0.9094218611717224,
- 0.78774094581604,
- 0.6912752389907837,
- 0.0785423144698143,
- 0.016106540337204933,
- -0.22879524528980255,
- 0.013991397805511951,
- -0.38984066247940063,
- -0.15052154660224915,
- -0.5829851031303406,
- -0.23330901563167572,
- 0.059916771948337555,
- 0.0003111835103482008,
- 0.6251672506332397,
- 0.31113284826278687,
- 0.5296736359596252,
- -0.5800420045852661,
- 0.5752048492431641,
- 0.6355389952659607,
- 0.25313037633895874,
- -0.47975510358810425,
- -0.7129015326499939,
- 0.2674548923969269,
- -0.20113208889961243,
- 0.3797936737537384,
- 1.1691379777549558e-15,
- -0.2713494598865509,
- 0.40313920378685,
- 0.845343828201294,
- 0.39367449283599854,
- -0.9590659737586975,
- -0.2106667459011078,
- -0.47452685236930847,
- -0.4596824049949646,
- -0.25136223435401917,
- 0.15601640939712524,
- 0.08271649479866028,
- 0.9565548896789551,
- 0.7303852438926697,
- 0.6288405656814575,
- 0.9848345518112183,
- -0.09036430716514587,
- -0.42064154148101807,
- -0.9738449454307556,
- -0.5138938426971436,
- -0.16709473729133606,
- -0.2977195680141449,
- 0.014614290557801723,
- 0.9725919365882874,
- -0.593136191368103,
- 0.7926254868507385,
- 0.7128075361251831,
- 0.5469134449958801,
- 0.4639262855052948,
- -0.06447644531726837,
- 0.17454104125499725,
- -0.9590659737586975,
- -0.8485125303268433,
- -0.8613754510879517,
- -0.8202615976333618,
- -0.9732046723365784,
- -0.44705015420913696,
- -0.9994475841522217,
- -0.7387363910675049,
- -0.9583876729011536,
- 0.5713192224502563,
- 0.6820598244667053,
- 0.6784961819648743,
- 0.9906498193740845,
- -0.9688231945037842,
- -0.6363033056259155,
- -0.9904927015304565,
- -0.09575266391038895,
- -0.5594531893730164,
- 0.3919374942779541,
- 0.6962965726852417,
- 0.4743371605873108,
- 0.32579144835472107,
- -0.036251384764909744,
- 0.30545035004615784,
- -0.3993871510028839,
- -0.16404372453689575,
- -0.05687348172068596,
- 0.06529530882835388,
- -0.2403002232313156,
- -0.21965867280960083,
- -0.5458555817604065,
- -0.33839061856269836,
- -0.7479055523872375,
- -0.6366367340087891,
- -0.8835325837135315,
- -0.998812198638916,
- 0.9292991161346436,
- 0.5906811952590942,
- 0.1568344235420227,
- 0.329791784286499,
- 0.6214436292648315,
- 0.8624156713485718,
- 0.9541876912117004,
- 0.8377023935317993,
- 0.16098438203334808,
- 0.5198801755905151,
- 0.4614923894405365,
- 0.4828778803348541,
- -0.4090541899204254,
- -0.6571433544158936,
- 0.7736345529556274,
- 0.9174755811691284,
- 0.5050711035728455,
- 0.6888444423675537,
- -0.6057143807411194,
- 0.9539580345153809,
- 0.7932191491127014,
- 0.3558451235294342,
- -0.294318825006485,
- -0.43747037649154663,
- -0.2859049141407013,
- -0.5471164584159851,
- 0.3661544919013977,
- 0.21708662807941437,
- 0.047813039273023605,
- -0.10936380922794342,
- -0.9813233017921448,
- 0.6716124415397644,
- 0.9972550272941589,
- 0.9591069221496582,
- 0.9881190061569214,
- -0.5873571634292603,
- -0.7924172282218933,
- -0.597710132598877,
- -0.2933533787727356,
- 0.6591892242431641,
- 0.982540488243103,
- 0.15812546014785767,
- 0.5574328303337097,
- 0.3088320791721344,
- -0.15484392642974854,
- 0.06583964824676514,
- 0.0556543804705143,
- -0.41467854380607605,
- -0.020549282431602478,
- -0.17505614459514618,
- -0.6844256520271301,
- -0.14388316869735718,
- 0.37474673986434937,
- -0.9988948702812195,
- -0.18562301993370056,
- 0.21414516866207123,
- 0.1545124351978302,
- -0.0718170553445816,
- 0.09742579609155655,
- 0.2770216763019562,
- -0.1361367404460907,
- 0.23760713636875153,
- -0.979985237121582,
- -0.9926663041114807,
- -0.9774913191795349,
- -0.16620796918869019,
- 0.3408176600933075,
- -0.8754684329032898,
- -0.9926663041114807,
- -0.9343691468238831,
- -0.9726558923721313,
- 0.3258844017982483,
- -0.6285980939865112,
- -0.9526984095573425,
- 0.5530601739883423,
- 0.4029441475868225,
- -0.15432234108448029,
- -0.25908252596855164,
- 0.4096115529537201,
- 0.43439316749572754,
- -0.8870314359664917,
- -0.41186952590942383,
- 0.09266889840364456,
- 0.2557157576084137,
- 0.6775721907615662,
- -0.4413914978504181,
- 0.13172948360443115,
- 0.21691279113292694,
- -0.9269883036613464,
- 0.30631664395332336,
- 0.21891158819198608,
- -0.6346932053565979,
- -0.3447767496109009,
- 0.130438894033432,
- 0.47534096240997314,
- 0.5058916211128235,
- -0.6356008052825928,
- -0.24553059041500092,
- -0.17978045344352722,
- -0.34532439708709717,
- -0.2420850694179535,
- -0.4619636535644531,
- -0.4826432168483734,
- 0.5221319198608398,
- 0.029748890548944473,
- -0.7130288481712341,
- -0.8076095581054688,
- 0.29332637786865234,
- 0.5628518462181091,
- 0.06730208545923233,
- 0.4723880887031555,
- -0.12552547454833984,
- -0.4614121615886688,
- 0.08412102609872818,
- -0.13070812821388245,
- -0.2101341336965561,
- 0.01784065179526806,
- 0.9772608280181885,
- 0.9888244271278381,
- 0.998428463935852,
- 0.9541769623756409,
- 0.9986042976379395,
- -0.7781175374984741,
- 0.43230360746383667,
- 0.6684873104095459,
- 0.2304299771785736,
- -0.5736464858055115,
- -0.844412088394165,
- 0.00047851071576587856,
- -0.8698142766952515,
- -0.8623660206794739,
- -0.6524214744567871,
- 0.4876599907875061,
- 0.41059526801109314,
- 0.11519432067871094,
- 0.027569491416215897,
- -0.18464042246341705,
- 0.07333831489086151,
- -0.28634411096572876,
- -0.628840982913971,
- -0.4625285863876343,
- -0.7084884643554688,
- 0.13881811499595642,
- 0.013083233498036861,
- -0.2419593632221222,
- -0.9994175434112549,
- -0.8644529581069946,
- -0.969346821308136,
- 0.6237660050392151,
- 0.3980129659175873,
- 0.07845746725797653,
- 0.059401463717222214,
- 0.9435102343559265,
- 0.6205036044120789,
- 0.8704222440719604,
- 0.0805128887295723,
- 0.40569618344306946,
- 0.7998630404472351,
- -0.15637905895709991,
- -0.30140817165374756,
- -0.10545636713504791,
- 0.013164041563868523,
- -0.8021248579025269,
- -0.674019455909729,
- 1.1381953347961641e-15,
- 0.8842353820800781,
- 0.70960932970047,
- 0.8383103013038635,
- 0.9725919365882874,
- -0.020549282431602478,
- 0.6637487411499023,
- -0.4817539155483246,
- 0.842215895652771,
- 0.827395498752594,
- 0.5711965560913086,
- 0.9451232552528381,
- -0.505468487739563,
- -0.5622516870498657,
- 0.5627862811088562,
- 0.43230360746383667,
- 0.2933533787727356,
- -0.7023643851280212,
- 0.5701262354850769,
- 0.32938721776008606,
- -0.9919143915176392,
- -0.9549797773361206,
- 0.23374751210212708,
- 0.026159776374697685,
- -0.36292386054992676,
- 0.9944577813148499,
- 0.021349981427192688,
- -0.4515495300292969,
- -0.0596543550491333,
- -0.054855652153491974,
- -0.8076095581054688,
- -0.4196002781391144,
- -0.4410720765590668,
- -0.6684819459915161,
- 0.8623660206794739,
- 0.7781712412834167,
- -0.4617902934551239,
- 0.9156145453453064,
- 0.6612699031829834,
- 0.8220000267028809,
- 0.7003620862960815,
- 0.9428480863571167,
- 0.3421337604522705,
- 0.009491427801549435,
- -0.024708475917577744,
- -0.243136465549469,
- -0.6658512353897095,
- 0.05885906517505646,
- -0.12039002776145935,
- -0.9692688584327698,
- -0.9894528985023499,
- -0.712857186794281,
- 0.9669307470321655,
- 0.9363831281661987,
- 0.7855737209320068,
- 0.0020480032544583082,
- 0.48156502842903137,
- 0.23229436576366425,
- 0.2777603268623352,
- 0.9257963299751282,
- 0.6556273102760315,
- -0.9106780886650085,
- -0.3095446527004242,
- 0.9899122714996338,
- -0.8134732842445374,
- 0.8606582283973694,
- 0.6877522468566895,
- 0.4117426872253418,
- 0.4701825976371765,
- 0.7486863732337952,
- 0.544661283493042,
- 0.7486863732337952,
- 0.678033173084259,
- 0.17454104125499725,
- -0.17454104125499725,
- -0.9429054260253906,
- -0.9972629547119141,
- -0.7024728059768677,
- 0.484409362077713,
- -0.7819303274154663,
- -0.7981323003768921,
- -0.7253903150558472,
- -0.28735053539276123,
- 0.36599305272102356,
- -0.9146113395690918,
- -0.10216209292411804,
- 0.01893974095582962,
- 0.19509032368659973,
- -0.6746619939804077,
- -0.580647885799408,
- -0.8524736762046814,
- -0.38539648056030273,
- 0.3909161388874054,
- 0.8446590304374695,
- -0.9985224008560181,
- 0.5946504473686218,
- -0.01600003056228161,
- 0.40821167826652527,
- 0.48939603567123413,
- -0.09601835906505585,
- -0.9909332990646362,
- -0.5974749326705933,
- 0.33801841735839844,
- 0.5988664031028748,
- 0.47321829199790955,
- 0.5466654896736145,
- -0.08516772836446762,
- -0.08488517999649048,
- -0.43230360746383667,
- -0.9939273595809937,
- -0.8418577313423157,
- 0.37960660457611084,
- 0.3056824207305908,
- -0.3595028221607208,
- -0.19509032368659973,
- -0.29275640845298767,
- -0.9550285339355469,
- 0.9962120056152344,
- 0.9809043407440186,
- 0.6006340980529785,
- 0.8467000126838684,
- -0.8403451442718506,
- -0.8470764756202698,
- 0.2801212966442108,
- -0.9871431589126587,
- 0.08321216702461243,
- 0.19509032368659973,
- 0.22816050052642822,
- -0.2699337899684906,
- -0.6778974533081055,
- -0.8404248356819153,
- 0.2901766896247864,
- 0.5331884622573853,
- 0.44227609038352966,
- 0.9771484136581421,
- 0.8558570742607117,
- -0.7451087236404419,
- 0.9981444478034973,
- -0.678033173084259,
- -0.8475834727287292,
- 0.3360883593559265,
- 0.9743492007255554,
- -0.282871812582016,
- -0.22345055639743805,
- 0.3189956545829773,
- -0.9293450713157654,
- 0.5089709162712097,
- 0.8060675263404846,
- 0.8813042640686035,
- -0.5501174926757812,
- 0.43230360746383667,
- 0.399971067905426,
- 0.5860621929168701,
- -0.8191595077514648,
- 0.8525258898735046,
- 0.4839176535606384,
- 0.43716105818748474,
- 0.44707098603248596,
- -0.004523725248873234,
- -0.0728132501244545,
- -0.5065698027610779,
- 0.10219016671180725,
- 0.12683188915252686,
- 0.46737194061279297,
- -0.39507293701171875,
- 0.14336158335208893,
- 0.5697399377822876,
- -0.04716167598962784,
- -0.02876582369208336,
- 0.716044545173645,
- 0.8369349837303162,
- -0.3292773365974426,
- 0.7456651926040649,
- 0.5343924760818481,
- -0.9642449021339417,
- -0.535721480846405,
- -0.4752419590950012,
- 0.5506404638290405,
- 0.42234858870506287,
- 0.2887100875377655,
- -0.06674723327159882,
- 0.6946030259132385,
- 0.02623007260262966,
- 0.946326732635498,
- -0.5398248434066772,
- -0.9635012149810791,
- -0.9525694251060486,
- -0.5915231704711914,
- -0.5506868362426758,
- 0.5892135500907898,
- -0.8410922288894653,
- -0.9329262375831604,
- -0.9138374328613281,
- 0.8402705788612366,
- 0.9105742573738098,
- -0.9931750297546387,
- -0.4777680039405823,
- -0.8566827178001404,
- -0.6324874758720398,
- 0.8885729312896729,
- 0.9815806150436401,
- -0.13777193427085876,
- -0.6420971155166626,
- -0.5806383490562439,
- 0.5950174927711487,
- -0.8831895589828491,
- -0.9292991161346436,
- -0.515745222568512,
- -0.7781712412834167,
- -0.47324317693710327,
- 0.7560555934906006,
- -0.6978248953819275,
- 0.5688090324401855,
- 0.48954278230667114,
- -0.4428369104862213,
- -0.2906172573566437,
- -0.8368217945098877,
- -0.9935793280601501,
- 0.982795000076294,
- -0.7022608518600464,
- -0.5990626811981201,
- 0.4099653661251068,
- 0.8622729182243347,
- -0.286173015832901,
- 0.16053339838981628,
- 0.6610923409461975,
- 0.5628518462181091,
- 0.18883104622364044,
- 0.8341196775436401,
- -0.29332637786865234,
- -0.4320796728134155,
- -0.5608901381492615,
- -0.7485610842704773,
- -0.06010530889034271,
- 0.21931923925876617,
- -0.22103886306285858,
- -0.5628518462181091,
- 0.9293450713157654,
- 0.7130826711654663,
- 0.9627287983894348,
- 0.9840801358222961,
- -0.8595077991485596,
- 0.31655168533325195,
- 0.882563591003418,
- 0.971177875995636,
- -0.9552678465843201,
- 0.7955359220504761,
- -0.12935291230678558,
- 0.9853049516677856,
- -0.33821555972099304,
- 0.9915511608123779,
- -0.9826152324676514,
- -0.9881051778793335,
- 0.9917153120040894,
- 0.08590389788150787,
- -0.6782426834106445,
- 0.47321829199790955,
- -0.17458701133728027,
- -0.445766419172287,
- -0.648909866809845,
- -0.8623660206794739,
- 0.7130826711654663,
- 0.807781457901001,
- 0.8623660206794739,
- -0.31360378861427307,
- 0.9839302897453308,
- 0.6382311582565308,
- -0.9593880772590637,
- 0.3193909227848053,
- -0.7817341685295105,
- 0.023031573742628098,
- -0.4200100302696228,
- 0.9933979511260986,
- -0.8614697456359863,
- -0.8687127232551575,
- 0.16769032180309296,
- 0.46352097392082214,
- -0.5226393938064575,
- -0.24868835508823395,
- 0.16562004387378693,
- 0.3897646963596344,
- 0.7157204151153564,
- 0.3493865430355072,
- -0.8276746273040771,
- -0.9994074702262878,
- 0.9726558923721313,
- -0.2598225772380829,
- 0.9036200046539307,
- 0.9771667718887329,
- 0.8610367178916931,
- -0.05206523463129997,
- 0.20172397792339325,
- -0.9491549134254456,
- 0.006670048926025629,
- 0.48246243596076965,
- 0.02163754589855671,
- 0.1861138790845871,
- -0.9725919365882874,
- -0.9926801323890686,
- -0.9994572997093201,
- 0.34400707483291626,
- 0.6316402554512024,
- -0.8622729182243347,
- 0.6931447386741638,
- 0.8637305498123169,
- -0.49691101908683777,
- 0.4423399865627289,
- 0.9413233995437622,
- 0.2561284601688385,
- 0.4177584648132324,
- -0.7151981592178345,
- 0.3847554624080658,
- 0.00911870226264,
- 0.04645007848739624,
- 0.9529821872711182,
- 0.9131877422332764,
- 0.9860866069793701,
- -0.28687211871147156,
- 0.7533616423606873,
- 0.525320291519165,
- -0.2505177855491638,
- 0.22584663331508636,
- -0.31802502274513245,
- -0.664940357208252,
- 0.3854376971721649,
- -0.5987637042999268,
- 0.9183555841445923,
- -0.8924358487129211,
- -0.39667022228240967,
- -0.8860922455787659,
- 0.642162561416626,
- -0.12058087438344955,
- -0.9389616847038269,
- -0.830712616443634,
- -0.606196939945221,
- -0.7111347317695618,
- -0.3265444338321686,
- -0.56674724817276,
- 0.9875668883323669,
- -0.10216209292411804,
- 0.5815808773040771,
- 0.9071466326713562,
- -0.8691815733909607,
- -0.5292973518371582,
- -0.7014018893241882,
- 0.2636984586715698,
- 0.9412404298782349,
- 0.9982985854148865,
- 0.9909630417823792,
- -0.3709893822669983,
- -0.7072163224220276
- ]
- }
- ],
- "layout": {
- "height": 500,
- "scene": {
- "aspectmode": "data"
- },
- "template": {
- "data": {
- "bar": [
- {
- "error_x": {
- "color": "#2a3f5f"
- },
- "error_y": {
- "color": "#2a3f5f"
- },
- "marker": {
- "line": {
- "color": "#E5ECF6",
- "width": 0.5
- },
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "bar"
- }
- ],
- "barpolar": [
- {
- "marker": {
- "line": {
- "color": "#E5ECF6",
- "width": 0.5
- },
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "barpolar"
- }
- ],
- "carpet": [
- {
- "aaxis": {
- "endlinecolor": "#2a3f5f",
- "gridcolor": "white",
- "linecolor": "white",
- "minorgridcolor": "white",
- "startlinecolor": "#2a3f5f"
- },
- "baxis": {
- "endlinecolor": "#2a3f5f",
- "gridcolor": "white",
- "linecolor": "white",
- "minorgridcolor": "white",
- "startlinecolor": "#2a3f5f"
- },
- "type": "carpet"
- }
- ],
- "choropleth": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "choropleth"
- }
- ],
- "contour": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "contour"
- }
- ],
- "contourcarpet": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "contourcarpet"
- }
- ],
- "heatmap": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "heatmap"
- }
- ],
- "heatmapgl": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "heatmapgl"
- }
- ],
- "histogram": [
- {
- "marker": {
- "pattern": {
- "fillmode": "overlay",
- "size": 10,
- "solidity": 0.2
- }
- },
- "type": "histogram"
- }
- ],
- "histogram2d": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "histogram2d"
- }
- ],
- "histogram2dcontour": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "histogram2dcontour"
- }
- ],
- "mesh3d": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "type": "mesh3d"
- }
- ],
- "parcoords": [
- {
- "line": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "parcoords"
- }
- ],
- "pie": [
- {
- "automargin": true,
- "type": "pie"
- }
- ],
- "scatter": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatter"
- }
- ],
- "scatter3d": [
- {
- "line": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatter3d"
- }
- ],
- "scattercarpet": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattercarpet"
- }
- ],
- "scattergeo": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattergeo"
- }
- ],
- "scattergl": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattergl"
- }
- ],
- "scattermapbox": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scattermapbox"
- }
- ],
- "scatterpolar": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterpolar"
- }
- ],
- "scatterpolargl": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterpolargl"
- }
- ],
- "scatterternary": [
- {
- "marker": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "type": "scatterternary"
- }
- ],
- "surface": [
- {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- },
- "colorscale": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "type": "surface"
- }
- ],
- "table": [
- {
- "cells": {
- "fill": {
- "color": "#EBF0F8"
- },
- "line": {
- "color": "white"
- }
- },
- "header": {
- "fill": {
- "color": "#C8D4E3"
- },
- "line": {
- "color": "white"
- }
- },
- "type": "table"
- }
- ]
- },
- "layout": {
- "annotationdefaults": {
- "arrowcolor": "#2a3f5f",
- "arrowhead": 0,
- "arrowwidth": 1
- },
- "autotypenumbers": "strict",
- "coloraxis": {
- "colorbar": {
- "outlinewidth": 0,
- "ticks": ""
- }
- },
- "colorscale": {
- "diverging": [
- [
- 0,
- "#8e0152"
- ],
- [
- 0.1,
- "#c51b7d"
- ],
- [
- 0.2,
- "#de77ae"
- ],
- [
- 0.3,
- "#f1b6da"
- ],
- [
- 0.4,
- "#fde0ef"
- ],
- [
- 0.5,
- "#f7f7f7"
- ],
- [
- 0.6,
- "#e6f5d0"
- ],
- [
- 0.7,
- "#b8e186"
- ],
- [
- 0.8,
- "#7fbc41"
- ],
- [
- 0.9,
- "#4d9221"
- ],
- [
- 1,
- "#276419"
- ]
- ],
- "sequential": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ],
- "sequentialminus": [
- [
- 0,
- "#0d0887"
- ],
- [
- 0.1111111111111111,
- "#46039f"
- ],
- [
- 0.2222222222222222,
- "#7201a8"
- ],
- [
- 0.3333333333333333,
- "#9c179e"
- ],
- [
- 0.4444444444444444,
- "#bd3786"
- ],
- [
- 0.5555555555555556,
- "#d8576b"
- ],
- [
- 0.6666666666666666,
- "#ed7953"
- ],
- [
- 0.7777777777777778,
- "#fb9f3a"
- ],
- [
- 0.8888888888888888,
- "#fdca26"
- ],
- [
- 1,
- "#f0f921"
- ]
- ]
- },
- "colorway": [
- "#636efa",
- "#EF553B",
- "#00cc96",
- "#ab63fa",
- "#FFA15A",
- "#19d3f3",
- "#FF6692",
- "#B6E880",
- "#FF97FF",
- "#FECB52"
- ],
- "font": {
- "color": "#2a3f5f"
- },
- "geo": {
- "bgcolor": "white",
- "lakecolor": "white",
- "landcolor": "#E5ECF6",
- "showlakes": true,
- "showland": true,
- "subunitcolor": "white"
- },
- "hoverlabel": {
- "align": "left"
- },
- "hovermode": "closest",
- "mapbox": {
- "style": "light"
- },
- "paper_bgcolor": "white",
- "plot_bgcolor": "#E5ECF6",
- "polar": {
- "angularaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "bgcolor": "#E5ECF6",
- "radialaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- }
- },
- "scene": {
- "xaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- },
- "yaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- },
- "zaxis": {
- "backgroundcolor": "#E5ECF6",
- "gridcolor": "white",
- "gridwidth": 2,
- "linecolor": "white",
- "showbackground": true,
- "ticks": "",
- "zerolinecolor": "white"
- }
- },
- "shapedefaults": {
- "line": {
- "color": "#2a3f5f"
- }
- },
- "ternary": {
- "aaxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "baxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- },
- "bgcolor": "#E5ECF6",
- "caxis": {
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": ""
- }
- },
- "title": {
- "x": 0.05
- },
- "xaxis": {
- "automargin": true,
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": "",
- "title": {
- "standoff": 15
- },
- "zerolinecolor": "white",
- "zerolinewidth": 2
- },
- "yaxis": {
- "automargin": true,
- "gridcolor": "white",
- "linecolor": "white",
- "ticks": "",
- "title": {
- "standoff": 15
- },
- "zerolinecolor": "white",
- "zerolinewidth": 2
- }
- }
- },
- "title": {
- "text": "Deterministic Results"
- },
- "width": 500,
- "xaxis": {
- "range": [
- -5,
- 5
- ]
- },
- "yaxis": {
- "range": [
- -1,
- 0.9999999999999999
- ]
- }
- }
- },
- "text/html": [
- " "
- ]
- },
- "metadata": {},
- "output_type": "display_data"
- }
- ],
+ "outputs": [],
"source": [
"results2.plot_species('A', t_ndx=200, width=None, height=None, title=\"Raw Stochastic Results\")\n",
"results2.plot_species('A', t_ndx=200, concentration=True, width=None, height=None, title=\"Stochastic Results\")\n",
diff --git a/spatialpy/core/boundarycondition.py b/spatialpy/core/boundarycondition.py
index 55fb0bd0..c66579d2 100644
--- a/spatialpy/core/boundarycondition.py
+++ b/spatialpy/core/boundarycondition.py
@@ -31,7 +31,7 @@ class BoundaryCondition():
- type_id: type (subdomain) of the partciles
Targets (one of the following must be set):
property: (str), 'nu', 'rho','v'
- species: (str) name of a chemical species.
+ species: (str) name of a chemical species. \
Must also set deterministic=True/False flag.
:param xmin: x-axis coordinate lower bound of **condition**
@@ -59,7 +59,7 @@ class BoundaryCondition():
and applies to deterministic simulation. **BoundaryCondition not yet implemeneted for Stochastic Species**.
:type deterministic: bool
- :param target: Set **target** to properties, can be 'nu' 'rho' or 'v' or species name
+ :param target: Set **target** to properties, can be 'nu' 'rho' or 'v' or species name \
If species name, determinstic must also be set to True/False.
:type target: str
@@ -67,7 +67,7 @@ class BoundaryCondition():
:type value: float or float[3]
:param model: Target model of boundary condition
- :type model: spatialpy.Model.Model
+ :type model: spatialpy.core.model.Model
"""
def __init__(self, xmin=None, xmax=None, ymin=None, ymax=None, zmin=None, zmax=None,
diff --git a/spatialpy/core/datafunction.py b/spatialpy/core/datafunction.py
index f63b375f..a926fc5d 100644
--- a/spatialpy/core/datafunction.py
+++ b/spatialpy/core/datafunction.py
@@ -23,6 +23,8 @@ class DataFunction():
:param name: Name of the Data Function.
:type name: str
+
+ :raises DataFunctionError: If a name is not provided.
"""
def __init__(self, name=None):
@@ -35,11 +37,11 @@ def map(self, point):
"""
This method must be overridden by the DataFunction subclass.
- NOTE: The spatial location is evaulated at t=0 and is not
- reevaluated as the fluid domain moves over time.
+ NOTE: The spatial location is evaulated at t=0 and is not \
+ re-evaluated as the fluid domain moves over time.
- :param point: The x,y,z position
- :type point: vector of 3 doubles
+ :param point: The x, y, z position.
+ :type point: float[3]
:returns: Value of function at this spatial location.
:rtype: float
diff --git a/spatialpy/core/domain.py b/spatialpy/core/domain.py
index 27e6445a..b6c763de 100644
--- a/spatialpy/core/domain.py
+++ b/spatialpy/core/domain.py
@@ -37,13 +37,13 @@ class Domain():
:type numpoints: int
:param xlim: Range of domain along x-axis
- :type xlim: tuple(float)
+ :type xlim: float(2)
:param ylim: Range of domain along y-axis
- :type ylim: tuple(float)
+ :type ylim: float(2)
:param zlim: Range of domain along z-axis
- :type zlim: tuple(float)
+ :type zlim: float(2)
:param rho: Background density for the system
:type rho: float
@@ -55,7 +55,7 @@ class Domain():
:type P0: float
:param gravity: Acceleration of gravity for the system.
- :type species: float
+ :type gravity: float[3]
"""
def __init__(self, numpoints, xlim, ylim, zlim, rho0=1.0, c0=10, P0=None, gravity=None):
self.vertices = numpy.zeros((numpoints, 3), dtype=float)
@@ -132,10 +132,10 @@ def get_type_def(self, type_id):
def compile_prep(self):
"""
- Generate the domain list of type ids and check for invalid type_ids and rho values
+ Generate the domains list of type ids and check for invalid type_ids and rho values
in preperation of compiling the simulation files.
- :raises DomainError: If a type_id is not set or rh for a particle is 0.
+ :raises DomainError: If a type_id is not set or rho=0 for a particle.
"""
if self.type_id.tolist().count(None) > 0:
raise DomainError(f"Particles must be assigned a type_id.")
@@ -150,7 +150,7 @@ def add_point(self, point, vol=0, mass=0, type_id=1, nu=0, fixed=False, rho=None
Add a single point particle to the domain space.
:param point: Spatial coordinate vertices of point to be added
- :type point: tuple(float, float, float) or tuple(float, float)
+ :type point: float(3)
:param vol: Default volume of particle to be added
:type vol: float
@@ -158,19 +158,19 @@ def add_point(self, point, vol=0, mass=0, type_id=1, nu=0, fixed=False, rho=None
:param mass: Default mass of particle to be added
:type mass: float
- :param type_id: Particle type ID of particle to be created
+ :param type_id: Particle type ID of particle to be craddedeated
:type type_id: str | int
- :param nu: Default viscosity of particle to be created
+ :param nu: Default viscosity of particle to be added
:type nu: float
:param fixed: True if particle is spatially fixed, else False
:type fixed: bool
- :param c: Default artificial speed of sound of particle to be created
+ :param c: Default artificial speed of sound of particle to be added
:type c: float
- :param rho: Default density of particle to be created
+ :param rho: Default density of particle to be added
:type rho: float
:raises DomainError: Type_id is 0 or type_id contains an invalid character.
@@ -204,9 +204,9 @@ def set_properties(self, geometry_ivar, type_id, vol=None, mass=None, nu=None, r
"""
Add a type definition to the domain. By default, all regions are set to type 0.
- :param geometry_ivar: an instance of a 'spatialpy.Geometry' subclass. The 'inside()' method
+ :param geometry_ivar: an instance of a :py:class:`spatialpy.core.geometry.Geometry` subclass. The 'inside()' method
of this object will be used to assign properties to points.
- :type geometry_ivar: spatialpy.Geometry.Geometry
+ :type geometry_ivar: spatialpy.core.geometry.Geometry
:param type_id: The identifier for this type.
:type type_id: str | int
@@ -270,9 +270,9 @@ def fill_with_particles(self, geometry_ivar, deltax, deltay=None, deltaz=None, x
"""
Fill a geometric shape with particles.
- :param geometry_ivar: an instance of a 'spatialpy.Geometry' subclass. The 'inside()' method
+ :param geometry_ivar: an instance of a :py:class:`spatialpy.core.geometry.Geometry` subclass. The 'inside()' method
of this object will be used to create add the particles.
- :type geometry_ivar: spatialpy.geometry.Geometry
+ :type geometry_ivar: spatialpy.core.geometry.Geometry
:param deltax: Distance between particles on the x-axis.
:type deltax: float
@@ -301,8 +301,7 @@ def fill_with_particles(self, geometry_ivar, deltax, deltay=None, deltaz=None, x
:param zmax: Maximum z value of the bounding box (defaults to Domain.zlim[1]).
:type zmax: float
- :param kwargs: Key word arguments for Domain.add_point.
- :type kwargs: dict
+ :param \**kwargs: Additional keyword arguments passed to :py:meth:`Domain.add_point`.
:returns: The number of particles that were created within this geometry.
:rtype: int
@@ -416,10 +415,10 @@ def distance_between_2_vertices(self, start, end):
Get distance between 2 domain vertices.
:param start: Starting point
- :type start: tuple(float, float, float) or tuple(float, float)
+ :type start: float(3)
:param end: Ending point
- :type end: tuple(float, float, float) or tuple(float, float)
+ :type end: float(2)
:returns: a distance measurement between start and end point
:rtype: float
@@ -431,10 +430,10 @@ def closest_vertex(self, point):
Find the nearest vertex of a given point in the domain.
:param point: Target source point
- :type point: tuple(float, float, float) or tuple(float, float)
+ :type point: float(3)
:returns: The coordinates of the nearest vertex to the source point.
- :rtype: tuple(float, float, float) or tuple(float, float)
+ :rtype: float(3)
"""
min_dist = None
min_vtx = None
@@ -652,7 +651,7 @@ def read_xml_mesh(cls, filename):
:type filename: str
:returns: SpatialPy Domain object created from xml mesh.
- :rtype: spatialpy.Domain.Domain
+ :rtype: spatialpy.core.domain.Domain
"""
root = ET.parse(filename).getroot()
if not root.tag == 'dolfin':
@@ -705,7 +704,7 @@ def import_meshio_object(cls, mesh_obj):
:type mesh_obj: meshio.Mesh
:returns: SpatialPy Domain object created from the meshio object
- :rtype: spatialpy.Domain.Domain
+ :rtype: spatialpy.core.domain.Domain
"""
# create domain object
xlim = (min(mesh_obj.points[:, 0]), max(mesh_obj.points[:, 0]))
@@ -742,7 +741,7 @@ def read_msh_file(cls, filename):
:type filename: str
:returns: SpatialPy Domain object created from the mesh file.
- :rtype: spatialpy.Domain.Domain
+ :rtype: spatialpy.core.domain.Domain
"""
try:
import meshio # pylint: disable=import-outside-toplevel
@@ -789,7 +788,7 @@ def read_stochss_domain(cls, filename):
:type filename: str
:returns: SpatialPy Domain object created from StochSS domain.
- :rtype: spatialpy.Domain.Domain
+ :rtype: spatialpy.core.domain.Domain
"""
try:
with open(filename, "r", encoding="utf-8") as domain_file:
@@ -825,13 +824,13 @@ def create_3D_domain(cls, xlim, ylim, zlim, nx, ny, nz, type_id=1, mass=1.0,
Create a filled 3D domain
:param xlim: highest and lowest coordinate in the x dimension
- :type xlim: tuple(float, float)
+ :type xlim: float(2)
:param ylim: highest and lowest coordinate in the y dimension
- :type ylim: tuple(float, float)
+ :type ylim: float(2)
:param zlim: highest and lowest coordinate in the z dimension
- :type zlim: tuple(float, float)
+ :type zlim: float(2)
:param nx: number of particle spacing in the x dimension
:type nx: int
@@ -855,22 +854,15 @@ def create_3D_domain(cls, xlim, ylim, zlim, nx, ny, nz, type_id=1, mass=1.0,
:type c: float
:param rho: default density of particles to be created.
- :type rho:
+ :type rho: float
:param fixed: spatially fixed flag of particles to be created. Defaults to false.
:type fixed: bool
- :param rho0: background density for the system. Defaults to 1.0
- :type rho0: float
-
- :param c0: speed of sound for the system. Defaults to 10
- :type c0: float
-
- :param P0: background pressure for the system. Defaults to 10
- :type P0: float
-
+ :param \**kwargs: Additional keyword arguments passed to :py:class:`Domain`.
+
:returns: Uniform 3D SpatialPy Domain object.
- :rtype: spatialpy.Domain.Domain
+ :rtype: spatialpy.core.domain.Domain
"""
# Create domain object
numberparticles = nx * ny * nz
@@ -897,10 +889,10 @@ def create_2D_domain(cls, xlim, ylim, nx, ny, type_id=1, mass=1.0,
Create a filled 2D domain
:param xlim: highest and lowest coordinate in the x dimension
- :type xlim: tuple(float, float)
+ :type xlim: float(2)
:param ylim: highest and lowest coordinate in the y dimension
- :type ylim: tuple(float, float)
+ :type ylim: float(2)
:param nx: number of particle spacing in the x dimension
:type nx: int
@@ -921,22 +913,15 @@ def create_2D_domain(cls, xlim, ylim, nx, ny, type_id=1, mass=1.0,
:type c: float
:param rho: default density of particles to be created.
- :type rho:
+ :type rho: float
:param fixed: spatially fixed flag of particles to be created. Defaults to false.
:type fixed: bool
- :param rho0: background density for the system. Defaults to 1.0
- :type rho0: float
-
- :param c0: speed of sound for the system. Defaults to 10
- :type c0: float
-
- :param P0: background pressure for the system. Defaults to 10
- :type P0: float
+ :param \**kwargs: Additional keyword arguments passed to :py:class:`Domain`.
:returns: Uniform 2D SpatialPy Domain object.
- :rtype: spatialpy.Domain.Domain
+ :rtype: spatialpy.core.domain.Domain
"""
# Create domain object
numberparticles = nx * ny
diff --git a/spatialpy/core/geometry.py b/spatialpy/core/geometry.py
index b94a9ace..ee3e7aa5 100644
--- a/spatialpy/core/geometry.py
+++ b/spatialpy/core/geometry.py
@@ -57,7 +57,7 @@ def inside(self, point, on_boundary):
class GeometryExterior(Geometry):
"""
Mark particles that are on the edge of the domain.
- only works for meshes that define triangles and tetrahedrons.
+ only works for domains that define triangles and tetrahedrons.
"""
def inside(self, point, on_boundary):
"""
@@ -75,7 +75,7 @@ def inside(self, point, on_boundary):
class GeometryInterior(Geometry):
"""
Mark particles that are not on the edge of the domain.
- Only works for meshes that define triangles and tetrahedrons.
+ Only works for domains that define triangles and tetrahedrons.
"""
def inside(self, point, on_boundary):
"""
diff --git a/spatialpy/core/initialcondition.py b/spatialpy/core/initialcondition.py
index 40b1cc67..f3cb505d 100644
--- a/spatialpy/core/initialcondition.py
+++ b/spatialpy/core/initialcondition.py
@@ -23,11 +23,14 @@ class InitialCondition():
"""
Class used to defined initial conditions in SpatialPy.
SubClasses must implement the 'apply(model)' method, which
- direction modifies the model.u0[species,voxel] matrix.
+ direction modifies the model.u0[species, voxel] matrix.
"""
def apply(self, model):
"""
Set the initial condition of the species to the count.
+
+ :param model: Model contianing the target species.
+ :type model: spatialpy.core.model.Model
"""
raise InitialConditionError("spatialpy.InitialCondition subclasses must implement apply()")
@@ -36,7 +39,7 @@ class PlaceInitialCondition(InitialCondition):
Class used to defined the place initial condition in SpatialPy.
:param species: The species to set the initial condition.
- :type species: spayialpy.species.Species
+ :type species: spatialpy.core.species.Species
:param count: The initial condition for the target species.
:type count: int
@@ -58,7 +61,7 @@ def apply(self, model):
Set the initial condition of the species to the count at the location.
:param model: Model contianing the target species.
- :type model: spatialpy.model.Model
+ :type model: spatialpy.core.model.Model
"""
spec_name = self.species.name
spec_ndx = None
@@ -74,7 +77,7 @@ class UniformInitialCondition(InitialCondition):
Class used to defined the uniform initial condition in SpatialPy.
:param species: The species to set the initial condition.
- :type species: spayialpy.species.Species
+ :type species: spatialpy.core.species.Species
:param count: The initial condition for the target species.
:type count: int
@@ -101,7 +104,7 @@ def apply(self, model):
Set 'count' of 'species' in over the list of types (all types if None).
:param model: Model contianing the target species.
- :type model: spatialpy.model.Model
+ :type model: spatialpy.core.model.Model
"""
spec_name = self.species.name
spec_ndx = None
@@ -126,7 +129,7 @@ class ScatterInitialCondition(InitialCondition):
Class used to defined the scatter initial condition in SpatialPy.
:param species: The species to set the initial condition.
- :type species: spayialpy.species.Species
+ :type species: spatialpy.core.species.Species
:param count: The initial condition for the target species.
:type count: int
@@ -153,7 +156,7 @@ def apply(self, model):
Scatter 'count' of 'species' randomly over the list of types (all types if None).
:param model: Model contianing the target species.
- :type model: spatialpy.model.Model
+ :type model: spatialpy.core.model.Model
"""
spec_name = self.species.name
spec_ndx = None
diff --git a/spatialpy/core/model.py b/spatialpy/core/model.py
index f605dcd9..68b74b03 100644
--- a/spatialpy/core/model.py
+++ b/spatialpy/core/model.py
@@ -32,8 +32,8 @@ def export_StochSS(spatialpy_model, filename=None, return_stochss_model=False):
"""
SpatialPy model to StochSS converter
- :param spatailpy_model: SpatialPy model to be converted to StochSS
- :type spatialpy_model: spatialpy.Model
+ :param spatialpy_model: SpatialPy model to be converted to StochSS
+ :type spatialpy_model: spatialpy.core.model.Model
:param filename: Path to the exported stochss model
:type filename: str
@@ -329,12 +329,12 @@ def add_species(self, obj):
Adds a species, or list of species to the model. Will return the added object upon success.
:param obj: The species or list of species to be added to the model object.
- :type obj: spatialpy.Model.Species | list(spatialpy.Model.Species
+ :type obj: spatialpy.core.species.Species | list(spatialpy.core.species.Species
:returns: Species object which was added to the model.
- :rtype: spatialpy.Species | list(spatialpy.Species)
+ :rtype: spatialpy.core.species.Species | list(spatialpy.core.species.Species)
- :raises ModelError: If obj is not a spatialpy.Species
+ :raises ModelError: If obj is not a spatialpy.core.species.Species
"""
from spatialpy.core.species import Species # pylint: disable=import-outside-toplevel
if isinstance(obj, list):
@@ -359,7 +359,7 @@ def delete_species(self, obj):
Remove a Species from model.listOfSpecies.
:param obj: Species object to be removed
- :type obj: spatialpy.Model.Species
+ :type obj: spatialpy.core.species.Species
"""
self.listOfSpecies.pop(obj) # raises key error if param is missing
@@ -389,7 +389,7 @@ def get_species(self, sname):
:type sname: str
:returns: The Species objected represented by given 'sname'
- :rtype: spatialpy.Model.Species
+ :rtype: spatialpy.core.species.Species
:raises ModelError: if the model does not contain the requested species
"""
@@ -417,12 +417,12 @@ def add_parameter(self,params):
Parameter object or a list of Parameter objects.
:param params: Parameter object or list of Parameters to be added.
- :type params: spatialpy.Model.Parameter | list(spatialpy.Model.Parameter)
+ :type params: spatialpy.core.parameter.Parameter | list(spatialpy.core.parameter.Parameter)
:returns: Parameter object which has been added to the model.
- :rtype: spatialpy.Parameter | list(spatialpy.Parameter)
+ :rtype: spatialpy.core.parameter.Parameter | list(spatialpy.core.parameter.Parameter)
- :raises ModelError: if obj is not a spatialpy.Parameter
+ :raises ModelError: if obj is not a spatialpy.core.parameter.Parameter
"""
from spatialpy.core.parameter import Parameter # pylint: disable=import-outside-toplevel
if isinstance(params,list):
@@ -449,7 +449,7 @@ def delete_parameter(self, obj):
Remove a Parameter from model.listOfParameters.
:param obj: Parameter object to be removed
- :type obj: spatialpy.Model.Parameter
+ :type obj: spatialpy.core.parameter.Parameter
"""
self.listOfParameters.pop(obj)
@@ -466,11 +466,11 @@ def get_parameter(self, pname):
"""
Return the Parameter object from model associated with 'pname'
- :param pname: Name of parameter to be removed
- :type pname: spatialpy.Model.Parameter
+ :param pname: Name of parameter to be returned
+ :type pname: str
:returns: The Parameter object represented in the model by 'pname'
- :rtype: Spatialpy.Model.Parameter
+ :rtype: Spatialpy.core.parameter.Parameter
:raises ModelError: No parameter named {pname}
"""
@@ -499,12 +499,12 @@ def add_reaction(self, reacs):
or a dict with name, instance pairs.
:param reacs: Reaction or list of Reactions to be added.
- :type reacs: spatialpy.Model.Reaction | list(spatialpy.Model.Reaction)
+ :type reacs: spatialpy.core.reaction.Reaction | list(spatialpy.core.reaction.Reaction)
:returns: The Reaction object(s) added to the model
- :rtype: spatialpy.Model.Reaction
+ :rtype: spatialpy.core.reaction.Reaction | list(spatialpy.core.reaction.Reaction)
- :raises ModelError: Invalid input/reaction to add_reaction()
+ :raises ModelError: if obj is not a spatialpy.core.reaction.Reaction
"""
from spatialpy.core.reaction import Reaction # pylint: disable=import-outside-toplevel
if isinstance(reacs, list):
@@ -529,7 +529,7 @@ def delete_reaction(self, obj):
Remove reaction from model.listOfReactions
:param obj: Reaction to be removed.
- :type obj: spatialpy.Model.Reaction
+ :type obj: spatialpy.core.reaction.Reaction
"""
self.listOfReactions.pop(obj)
@@ -555,11 +555,11 @@ def get_reaction(self, rname):
"""
Retrieve a reaction object from the model by name
- :param rname: name of Reaction to retrieve
+ :param rname: name of the reaction to be returned
:type rname: str
:returns: The Reaction Object in the model represented by 'rname'
- :rtype: spatialpy.Model.Reaction
+ :rtype: spatialpy.core.reaction.Reaction
:raises ModelError: Could not find reaction
"""
@@ -596,7 +596,7 @@ def run(self, number_of_trajectories=1, seed=None, timeout=None,
:type profile: bool
:returns: A SpatialPy Result object containing simulation data.
- :rtype: spatialpy.Result.Result
+ :rtype: spatialpy.core.result.Result
"""
from spatialpy.solvers.solver import Solver # pylint: disable=import-outside-toplevel
@@ -608,7 +608,7 @@ def run(self, number_of_trajectories=1, seed=None, timeout=None,
def set_timesteps(self, output_interval, num_steps, timestep_size=None):
- """"
+ """
Set the simlation time span parameters.
:param output_interval: size of each output timestep in seconds
@@ -668,7 +668,7 @@ def add_domain(self, domain):
Add a spatial domain to the model
:param domain: The Domain object to be added to the model
- :type domain: spatialpy.Domain.Domain
+ :type domain: spatialpy.core.domain.Domain
:raises ModelError: Invalid Domain object
"""
@@ -681,15 +681,15 @@ def add_domain(self, domain):
def add_data_function(self, data_function):
"""
Add a scalar spatial function to the simulation. This is useful if you have a
- spatially varying in put to your model. Argument is a instances of subclass of the
- spatialpy.DataFunction class. It must implement a function 'map(x)' which takes a
- the spatial positon 'x' as an array, and it returns a float value.
+ spatially varying input to your model. Argument is a instances of subclass of the
+ spatialpy.DataFunction class. It must implement a function 'map(point)' which takes a
+ the spatial positon 'point' as an array, and it returns a float value.
:param data_function: Data function to be added.
:type data_function: spatialpy.DataFunction
:returns: DataFunction object(s) added tothe model.
- :rtype: spatialpy.DataFunction | list(spatialpy.DataFunction)
+ :rtype: spatialpy.core.datafunction.DataFunction | list(spatialpy.core.datafunction.DataFunction)
:raises ModelError: Invalid DataFunction
"""
@@ -711,16 +711,16 @@ def add_initial_condition(self, init_cond):
Add an initial condition object to the initialization of the model.
:param init_cond: Initial condition to be added
- :type init_cond: spatialpy.InitialCondition.InitialCondition
+ :type init_cond: spatialpy.core.initialcondition.InitialCondition
"""
self.listOfInitialConditions.append(init_cond)
def add_boundary_condition(self, bound_cond):
"""
- Add an BoundaryCondition object to the model.
+ Add an boundary condition object to the model.
:param bound_cond: Boundary condition to be added
- :type bound_cond: spatialpy.BoundaryCondition
+ :type bound_cond: spatialpy.core.boundarycondition.BoundaryCondition
"""
bound_cond.model = self
self.listOfBoundaryConditions.append(bound_cond)
diff --git a/spatialpy/core/reaction.py b/spatialpy/core/reaction.py
index f72c4054..988f0823 100644
--- a/spatialpy/core/reaction.py
+++ b/spatialpy/core/reaction.py
@@ -42,7 +42,7 @@ class Reaction():
:type propensity_function: str
:param rate: if mass action, rate is a reference to a parameter instance.
- :type rate: spatialpy.model.Parameter
+ :type rate: spatialpy.core.parameter.Parameter
:param annotation: Description of the reaction (meta)
:type annotation: str
@@ -177,8 +177,8 @@ def add_product(self, species, stoichiometry):
"""
Add a product to this reaction
- :param S: Species object to be produced by the reaction
- :type S: spatialpy.Model.Species
+ :param species: Species object to be produced by the reaction
+ :type species: spatialpy.core.species.Species
:param stoichiometry: Stoichiometry of this product.
:type stoichiometry: int
@@ -195,7 +195,7 @@ def add_reactant(self, species, stoichiometry):
Add a reactant to this reaction
:param species: reactant Species object
- :type species: spatialpy.Model.Species
+ :type species: spatialpy.core.species.Species
:param stoichiometry: Stoichiometry of this participant reactant
:type stoichiometry: int
@@ -223,7 +223,7 @@ def initialize(self, model):
Deferred object initialization, called by model.add_reaction().
:param model: Target SpatialPy Model for annotation.
- :type model: spatialpy.Model
+ :type model: spatialpy.core.model.Model
"""
self.ode_propensity_function = self.propensity_function
diff --git a/spatialpy/core/result.py b/spatialpy/core/result.py
index fbc06f5f..a8408d8f 100644
--- a/spatialpy/core/result.py
+++ b/spatialpy/core/result.py
@@ -312,25 +312,25 @@ def get_species(self, species, timepoints=None, concentration=False, determinist
one or all timepoints. Returns a numpy array containing the species population/concentration values.
:param species: A species in string or dictionary form to retreive information about
- :type species: str | dict
+ :type species: str | spatialpy.core.species.Species
:param timepoints: A time point where the information should be retreived from.
If 'timepoints' is None (default), a matrix of dimension:
(number of timepoints) x (number of voxels) is returned.
If an integer value is given, that value is used to index into the timespan, and that time point is returned
- as a 1D array with size (number of voxel).
- :type timepoints: int (default None)
+ as a 1D array with size (number of voxel). Defaults to None
+ :type timepoints: int
:param concentration: Whether or not the species is a concentration (True) or population (False)
If concentration is False (default), the integer, raw, trajectory data is returned.
- If set to True, the concentration (=copy_number/volume) is returned.
- :type concentration: bool (default False)
+ If set to True, the concentration (=copy_number/volume) is returned. Defaults to False
+ :type concentration: bool
- :param deterministic: Whether or not the species is deterministic (True) or stochastic (False)
- :type deterministic: bool (default False)
+ :param deterministic: Whether or not the species is deterministic (True) or stochastic (False). Defaults to False
+ :type deterministic: bool
- :param debug: Whether or not debug information should be printed
- :type debug: bool (default False)
+ :param debug: Whether or not debug information should be printed. Defaults to False
+ :type debug: bool
:returns: A numpy array containing population/concentration values for target species across specified
timepoints. Defaults to all timepoints.
@@ -340,7 +340,7 @@ def get_species(self, species, timepoints=None, concentration=False, determinist
"""
num_voxel = self.model.domain.get_num_voxels()
- if isinstance(species,str):
+ if isinstance(species, str):
spec_name = species
else:
spec_name = species.name
@@ -404,11 +404,13 @@ def plot_species(self, species, t_ndx=None, t_val=None, concentration=False,
:param deterministic: Whether or not to plot the data as deterministic
:type deterministic: bool
- :param width: Width in pixels of output plot box
- :type width: int (default 500)
+ :param width: Width in pixels of output plot box or for matplotlib inches of output plot box. \
+ Defaults to 500 (Plotly) or 6.4 (MatPlotLib)
+ :type width: int
- :param height: Height in pixels of output plot box
- :type height: int (default 500)
+ :param height: Height in pixels of output plot box or for matplotlib inches of output plot box. \
+ Defaults to 500 (Plotly) or 4.8 (MatPlotLib)
+ :type height: int
:param colormap: colormap to use. Plotly specification, valid values: "Plotly3","Jet","Blues","YlOrRd",
"PuRd","BuGn","YlOrBr","PuBuGn","BuPu","YlGnBu", "PuBu","GnBu","YlGn","Greens","Reds",
@@ -450,7 +452,7 @@ def plot_species(self, species, t_ndx=None, t_val=None, concentration=False,
:returns: A dictionary containing data for a plotly figure of species output trajectory
:rtype: dict
- :raises ResultsError: unable to plot species for given time
+ :raises ResultError: unable to plot species for given time
"""
time_index_list = self.get_timespan()
@@ -578,7 +580,14 @@ def get_property(self, property_name, timepoints=None):
given, that value is used to index into the timespan, and that time point is returned \
as a 1D array with size (number of voxel).
- :param property_name: A string describing the property to be returned.
+ :param property_name: A string describing the property to be returned. Can be one of: {
+ 'v' : velocity,
+ 'rho': density,
+ 'mass': mass,
+ 'id': type_id,
+ 'type': type as str,
+ 'bvf_phi': boundary volume fraction,
+ 'nu': viscosity}
:type property_name: str
:param timepoints: timespan index to be returned. Default is None
@@ -587,7 +596,7 @@ def get_property(self, property_name, timepoints=None):
:returns: a numpy array of target property values across timepoints, defaults to all timepoints.
:rtype: numpy.ndarray
- :raises ResultsError: Could not get data for given timepoints.
+ :raises ResultError: Could not get data for given timepoints.
"""
l_time = len(self.get_timespan()) - 1
@@ -639,11 +648,13 @@ def plot_property(self, property_name, t_ndx=None, t_val=None, p_ndx=0, width=No
:param p_ndx: The property index of the results to be plotted
:type p_ndx: int
- :param width: Width in pixels of output plot box or for matplotlib inches of output plot box
- :type width: int (default 500)
+ :param width: Width in pixels of output plot box or for matplotlib inches of output plot box. \
+ Defaults to 500 (Plotly) or 6.4 (MatPlotLib)
+ :type width: int
- :param height: Height in pixels of output plot box or for matplotlib inches of output plot box
- :type height: int (default 500)
+ :param height: Height in pixels of output plot box or for matplotlib inches of output plot box. \
+ Defaults to 500 (Plotly) or 4.8 (MatPlotLib)
+ :type height: int
:param colormap: colormap to use. Plotly specification, valid values: "Plotly3","Jet","Blues","YlOrRd",
"PuRd","BuGn","YlOrBr","PuBuGn","BuPu","YlGnBu", "PuBu","GnBu","YlGn","Greens","Reds",
@@ -835,9 +846,9 @@ def export_to_csv(self, folder_name=None):
The columns of modelname_mesh.csv are: 'Voxel ID', 'X', 'Y', 'Z', 'Type', 'Volume', 'Mass', 'Viscosity'
The columns of modelname_species_S.csv: 'Time', 'Voxel 0', Voxel 1', ... 'Voxel N'.
- :type folder_name: str (default current working directory)
- :param folder_name: A path where the vtk files will be written, created if non-existant.
- If no path is provided current working directory is used.
+ :type folder_name: str
+ :param folder_name: A path where the vtk files will be written, created if non-existant. \
+ Defaults current working directory
"""
if not folder_name:
folder_name = os.path.abspath(os.getcwd())
@@ -866,7 +877,7 @@ def export_to_csv(self, folder_name=None):
for voxel in range(num_vox):
writer.writerow([voxel] + data[:,voxel].tolist())
- def export_to_vtk(self, timespan, folder_name=None):
+ def __export_to_vtk(self, timespan, folder_name=None):
"""
Write the trajectory to a collection of vtk files.
The exported data is #molecules/volume, where the volume unit is implicit from the mesh dimension.
diff --git a/spatialpy/core/species.py b/spatialpy/core/species.py
index 11a63b53..c1f03142 100644
--- a/spatialpy/core/species.py
+++ b/spatialpy/core/species.py
@@ -28,7 +28,7 @@ class Species():
:param diffusion_coefficient: Non-constant coefficient of diffusion for Species.
:type diffusion_coefficient: float
- :param restrict_to: Set the diffusion coefficient to zero for 'species' in all types not in 'listOfTypes'.
+ :param restrict_to: Set the diffusion coefficient to zero for 'species' in all types not in 'listOfTypes'. \
This effectively restricts the movement of 'species' to the types specified in 'listOfTypes'.
:type restrict_to: int, str, list of ints or list of strs
"""
@@ -71,7 +71,7 @@ def set_diffusion_coefficient(self, diffusion_coefficient):
:param diffusion_coefficient: Non-constant coefficient of diffusion for Species.
:type diffusion_coefficient: float
- :raises SpeciesError: If diffusion_coefficient is negative.
+ :raises SpeciesError: If diffusion_coefficient is negative or not a valid type.
"""
if not (isinstance(diffusion_coefficient, (Parameter, float, int)) or \
type(diffusion_coefficient).__name__ == 'Parameter'):
diff --git a/spatialpy/solvers/c_base/ssa_sdpd-c-simulation-engine/build/Makefile b/spatialpy/solvers/c_base/ssa_sdpd-c-simulation-engine/build/Makefile
index 25324c19..0d61c901 100644
--- a/spatialpy/solvers/c_base/ssa_sdpd-c-simulation-engine/build/Makefile
+++ b/spatialpy/solvers/c_base/ssa_sdpd-c-simulation-engine/build/Makefile
@@ -2,21 +2,24 @@ CC = g++
CFLAGS = -c -std=c++14 -Wall -O3
SIMFLAGS = -l. -std=c++14 -Wall -O3
LFLAGS = -pthread -lm
-INCDIR = $(ROOTINC)/include/ $(ROOTINC)/external/ $(ROOTINC)/external/ANN/include/
-INCDIRPARAMS = $(INCDIR:%=-I%)
+#INCDIR = "$(ROOTINC)/include/" "$(ROOTINC)/external/" "$(ROOTINC)/external/ANN/include/"
+#INCDIRPARAMS = $(INCDIR:%=-I%)
+INCDIRPARAMS = -I$(ROOTINC)/include/ -I$(ROOTINC)/external/ -I$(ROOTINC)/external/ANN/include/
OBJ = NRMConstant_v5.o particle.o simulate.o count_cores.o output.o simulate_rdme.o simulate_threads.o model.o pthread_barrier.o
ANNOBJECTS = ANN.o brute.o kd_tree.o kd_util.o kd_split.o \
kd_dump.o kd_search.o kd_pr_search.o kd_fix_rad_search.o \
bd_tree.o bd_search.o bd_pr_search.o bd_fix_rad_search.o \
perf.o
+
.PHONY: all
all: ssa_sdpd
CORE: $(OBJ)
- make -f $(ROOTINC)/external/ANN/src/Makefile.spatialpy ROOTINC=$(ROOTINC)
+#this is now called directly, before this make command, in solver.py
+# make -d -f $(ROOTINC_ESC)/external/ANN/src/Makefile.spatialpy ROOTINC=$(ROOTINC_ESC)
main.o:
$(CC) -c $(GPROFFLAG) $(GDB_FLAG) -o main.o $(MODEL) $(INCDIRPARAMS) $(CFLAGS)
diff --git a/spatialpy/solvers/solver.py b/spatialpy/solvers/solver.py
index 6f30f0c6..ea622ba0 100644
--- a/spatialpy/solvers/solver.py
+++ b/spatialpy/solvers/solver.py
@@ -49,7 +49,7 @@ class Solver:
SpatialPy solver object.
:param model: Target model of solver simulation.
- :type model: spatialpy.Model.Model
+ :type model: spatialpy.core.model.Model
:param debug_level: Target level of debugging.
:type debug_level: int
@@ -474,7 +474,12 @@ def compile(self, debug=False, profile=False):
# Build the solver
makefile = self.spatialpy_rootdir+'/build/Makefile'
- cmd_list = ['cd', self.core_dir, '&&', 'make', 'CORE', '-f', makefile,
+ makefile_ann = self.spatialpy_rootdir+'/external/ANN/src/Makefile.spatialpy'
+ cmd_list = ['cd', self.core_dir, '&&',
+ 'make', '-f' , makefile_ann,
+ 'ROOTINC="' + self.spatialpy_rootinc+'"',
+ '&&',
+ 'make', 'CORE', '-f', makefile,
'ROOT="' + self.spatialpy_rootparam+'"',
'ROOTINC="' + self.spatialpy_rootinc+'"',
'BUILD='+self.core_dir, '&&'
diff --git a/spatialpy/stochss/stochss_export.py b/spatialpy/stochss/stochss_export.py
index 3bd47f6c..02ecc484 100644
--- a/spatialpy/stochss/stochss_export.py
+++ b/spatialpy/stochss/stochss_export.py
@@ -200,13 +200,17 @@ def export(model, path=None, return_stochss_model=False):
"""
SpatialPy model to StochSS converter
- Args:
- spatialpy_model : spatialpy.Model
- SpatialPy model to be converted to StochSS
- filename : str
- Path to the exported stochss model
- return_stochss_model : bool
- Whether or not to return the model
+ :param model: SpatialPy model to be converted to StochSS.
+ :type model: spatialpy.core.model.Model
+
+ :param filename: Path to the exported stochss model.
+ :type filename: str
+
+ :param return_stochss_model: Whether or not to return the model.
+ :type return_stochss_model: bool
+
+ :returns: StochSS model dict if return_stochss_model is True else path to StochSS model file.
+ :rtype: dict | str
"""
_ = model.compile_prep()
if path is None:
diff --git a/test/run_tests.py b/test/run_integration_tests.py
old mode 100755
new mode 100644
similarity index 92%
rename from test/run_tests.py
rename to test/run_integration_tests.py
index 8f9b5d21..a2b547e3
--- a/test/run_tests.py
+++ b/test/run_integration_tests.py
@@ -30,17 +30,11 @@
print('Running tests in develop mode. Appending repository directory to system path.')
sys.path.append(os.path.join(os.path.dirname(__file__), '..'))
- import test_species
- import test_parameter
- import test_reaction
import test_model
import test_solver
#import test_mincde
modules = [
- test_species,
- test_parameter,
- test_reaction,
test_model,
test_solver,
#test_mincde,
diff --git a/test/run_unit_tests.py b/test/run_unit_tests.py
new file mode 100755
index 00000000..b35fb3f3
--- /dev/null
+++ b/test/run_unit_tests.py
@@ -0,0 +1,51 @@
+#!/usr/bin/env python3
+'''
+SpatialPy is a Python 3 package for simulation of
+spatial deterministic/stochastic reaction-diffusion-advection problems
+Copyright (C) 2019 - 2022 SpatialPy developers.
+
+This program is free software: you can redistribute it and/or modify
+it under the terms of the GNU GENERAL PUBLIC LICENSE Version 3 as
+published by the Free Software Foundation.
+
+This program is distributed in the hope that it will be useful,
+but WITHOUT ANY WARRANTY; without even the implied warranty of
+MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
+GNU GENERAL PUBLIC LICENSE Version 3 for more details.
+
+You should have received a copy of the GNU General Public License
+along with this program. If not, see .
+'''
+
+import unittest, sys, os
+import argparse
+
+parser = argparse.ArgumentParser()
+parser.add_argument('-m', '--mode', default='develop', choices=['develop', 'release'],
+ help='Run unit tests in develop mode or release mode.')
+
+if __name__ == '__main__':
+ args = parser.parse_args()
+ if args.mode == 'develop':
+ print('Running unit tests in develop mode. Appending repository directory to system path.')
+ sys.path.append(os.path.join(os.path.dirname(__file__), '..'))
+
+ import test_species
+ import test_parameter
+ import test_reaction
+
+ modules = [
+ test_species,
+ test_parameter,
+ test_reaction
+ ]
+
+ for module in modules:
+ suite = unittest.TestLoader().loadTestsFromModule(module)
+ runner = unittest.TextTestRunner(failfast=args.mode == 'develop')
+
+ print("Executing: {}".format(module))
+ result = runner.run(suite)
+ print('=' * 70)
+ if not result.wasSuccessful():
+ sys.exit(not result.wasSuccessful())