From 0173c3d85181943e2fe034409eb742d5526d31f9 Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Thu, 24 Mar 2022 13:43:10 -0700 Subject: [PATCH 01/26] Add VAlueAtPoints and OneOf to types enum. --- include/world_builder/types/interface.h | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/include/world_builder/types/interface.h b/include/world_builder/types/interface.h index 70cbe4afb..3c8494184 100644 --- a/include/world_builder/types/interface.h +++ b/include/world_builder/types/interface.h @@ -37,7 +37,7 @@ namespace WorldBuilder enum class type { - None,Bool,String,Double,Int,UnsignedInt,Array,Object,List,Point2D,Point3D,CoordinateSystem,PluginSystem,Segment,ConstantLayer + None,Bool,String,Double,Int,UnsignedInt,Array,Object,List,Point2D,Point3D,CoordinateSystem,PluginSystem,Segment,ConstantLayer,ValueAtPoints,OneOf }; class Interface From 9e6f3322721f722872f4485120c9ef7a163de591 Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Thu, 24 Mar 2022 13:37:04 -0700 Subject: [PATCH 02/26] Add oneOf type. --- include/world_builder/types/one_of.h | 89 ++++++++++++++++++++++++++++ source/types/one_of.cc | 77 ++++++++++++++++++++++++ 2 files changed, 166 insertions(+) create mode 100644 include/world_builder/types/one_of.h create mode 100644 source/types/one_of.cc diff --git a/include/world_builder/types/one_of.h b/include/world_builder/types/one_of.h new file mode 100644 index 000000000..f15878f65 --- /dev/null +++ b/include/world_builder/types/one_of.h @@ -0,0 +1,89 @@ +/* + Copyright (C) 2018 - 2021 by the authors of the World Builder code. + + This file is part of the World Builder. + + This program is free software: you can redistribute it and/or modify + it under the terms of the GNU Lesser General Public License as published + by the Free Software Foundation, either version 2 of the License, or + (at your option) any later version. + + 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 Lesser General Public License for more details. + + You should have received a copy of the GNU Lesser General Public License + along with this program. If not, see . +*/ + +#ifndef WORLD_BUILDER_TYPES_ONE_OF_H +#define WORLD_BUILDER_TYPES_ONE_OF_H + + +#include "world_builder/types/interface.h" +#include + + +namespace WorldBuilder +{ + class Parameters; + + namespace Types + { + /** + * This class represents an a single choice between options (one of). + */ + class OneOf final: public Interface + { + public: + /** + * Constructor for the declaration + */ + OneOf(const Interface &type_1, + const Interface &type_2); + + /** + * Constructor for cloning an array. + */ + OneOf(OneOf const &other); + + + /** + * Destructor + */ + ~OneOf() override final; + + /** + * Write schema + */ + void write_schema(Parameters &prm, + const std::string &name, + const std::string &documentation) const override final; + /** + * An enum of the type which this class points to + * @see Types::type + */ + Types::type inner_type; + + /** + * This class is sometimes responsible for the object it points to, but + * sometimes it is not responsible for the object is points to. + * When it is responsible the unique_inner_type points to it and the + * inner_type should have size zero. When it is not responsible, + * unique_inner_type should point to the nullptr and inner_type should + * have a size larger then zero. + * @see inner_type_index + */ + std::vector> inner_types_ptr; + + protected: + OneOf *clone_impl() const override final + { + return new OneOf(*this); + }; + }; + } // namespace Types +} // namespace WorldBuilder + +#endif diff --git a/source/types/one_of.cc b/source/types/one_of.cc new file mode 100644 index 000000000..20cd4672b --- /dev/null +++ b/source/types/one_of.cc @@ -0,0 +1,77 @@ +/* + Copyright (C) 2018 - 2021 by the authors of the World Builder code. + + This file is part of the World Builder. + + This program is free software: you can redistribute it and/or modify + it under the terms of the GNU Lesser General Public License as published + by the Free Software Foundation, either version 2 of the License, or + (at your option) any later version. + + 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 Lesser General Public License for more details. + + You should have received a copy of the GNU Lesser General Public License + along with this program. If not, see . +*/ +#include "world_builder/types/one_of.h" + +#include "world_builder/parameters.h" + +namespace WorldBuilder +{ + namespace Types + { + OneOf::OneOf(const Interface &type_1, + const Interface &type_2) + { + this->type_name = Types::type::OneOf; + inner_types_ptr.emplace_back(type_1.clone()); + inner_types_ptr.emplace_back(type_2.clone()); + + } + + OneOf::OneOf(OneOf const &other) + { + this->type_name = Types::type::OneOf; + for (size_t i = 0; i < other.inner_types_ptr.size(); i++) + { + inner_types_ptr.emplace_back(other.inner_types_ptr[i]->clone()); + } + } + + OneOf::~OneOf () + = default; + + + void + OneOf::write_schema(Parameters &prm, + const std::string &name, + const std::string &documentation) const + { + using namespace rapidjson; + Document &declarations = prm.declarations; + const std::string &base = prm.get_full_json_path() + "/" + name; + + prm.enter_subsection(name); + { + Pointer((base + "/documentation").c_str()).Set(declarations,documentation.c_str()); + prm.enter_subsection("oneOf"); + { + for (size_t i = 0; i < inner_types_ptr.size(); i++) + { + WBAssertThrow(inner_types_ptr[i] != nullptr, "Internal error, inner pointer is NULL."); + inner_types_ptr[i]->write_schema(prm, std::to_string(i), ""); + } + } + prm.leave_subsection(); + } + prm.leave_subsection(); + + + } + } // namespace Types +} // namespace WorldBuilder + From edddadaeef62eb07ef90701611ebbd52a45f5c6d Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Thu, 24 Mar 2022 13:37:26 -0700 Subject: [PATCH 03/26] Add value at points type. --- include/world_builder/types/value_at_points.h | 78 +++++++++++++++ source/types/value_at_points.cc | 94 +++++++++++++++++++ 2 files changed, 172 insertions(+) create mode 100644 include/world_builder/types/value_at_points.h create mode 100644 source/types/value_at_points.cc diff --git a/include/world_builder/types/value_at_points.h b/include/world_builder/types/value_at_points.h new file mode 100644 index 000000000..e55139ac7 --- /dev/null +++ b/include/world_builder/types/value_at_points.h @@ -0,0 +1,78 @@ +/* + Copyright (C) 2018 - 2021 by the authors of the World Builder code. + + This file is part of the World Builder. + + This program is free software: you can redistribute it and/or modify + it under the terms of the GNU Lesser General Public License as published + by the Free Software Foundation, either version 2 of the License, or + (at your option) any later version. + + 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 Lesser General Public License for more details. + + You should have received a copy of the GNU Lesser General Public License + along with this program. If not, see . +*/ + +#ifndef WORLD_BUILDER_TYPES_VALUE_AT_POINTS_H +#define WORLD_BUILDER_TYPES_VALUE_AT_POINTS_H + +#include "world_builder/types/point.h" +#include + + +namespace WorldBuilder +{ + class Parameters; + + namespace Types + { + /** + * This class represents a depth surface value with documentation + */ + class ValueAtPoints : public Interface + { + public: + /** + * A constructor + */ + ValueAtPoints(const double default_value, + std::vector> default_points_ = std::vector>()); + + /** + * Copy constructor + */ + ValueAtPoints(ValueAtPoints const &other); + + + /** + * Destructor + */ + ~ValueAtPoints() override; + + /** + * Write schema + */ + void write_schema(Parameters &prm, + const std::string &name, + const std::string &documentation) const override final; + + double default_value; + std::vector > default_points; + + protected: + ValueAtPoints *clone_impl() const override final + { + return new ValueAtPoints(*this); + }; + private: + + }; + } // namespace Types + +} // namespace WorldBuilder + +#endif diff --git a/source/types/value_at_points.cc b/source/types/value_at_points.cc new file mode 100644 index 000000000..d3870ca12 --- /dev/null +++ b/source/types/value_at_points.cc @@ -0,0 +1,94 @@ +/* + Copyright (C) 2018 - 2021 by the authors of the World Builder code. + + This file is part of the World Builder. + + This program is free software: you can redistribute it and/or modify + it under the terms of the GNU Lesser General Public License as published + by the Free Software Foundation, either version 2 of the License, or + (at your option) any later version. + + 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 Lesser General Public License for more details. + + You should have received a copy of the GNU Lesser General Public License + along with this program. If not, see . +*/ +#include + +#include "world_builder/types/value_at_points.h" + +#include "world_builder/parameters.h" + + +namespace WorldBuilder +{ + namespace Types + { + + ValueAtPoints::ValueAtPoints(const double default_value_, + std::vector> default_points_) + : + default_value(default_value_), + default_points(default_points_) + { + this->type_name = Types::type::ValueAtPoints; + + WBAssert(default_points_.size() == 0, "default points are not implemented."); + } + + ValueAtPoints::ValueAtPoints(ValueAtPoints const &other) + : + default_value(other.default_value), + default_points(other.default_points) + { + this->type_name = Types::type::ValueAtPoints; + } + + + ValueAtPoints::~ValueAtPoints () + = default; + + + + void + ValueAtPoints::write_schema(Parameters &prm, + const std::string &name, + const std::string &documentation) const + { + using namespace rapidjson; + prm.enter_subsection(name); + { + Document &declarations = prm.declarations; + std::string base = prm.get_full_json_path(); + + Pointer((base + "/type").c_str()).Set(declarations,"array"); + Pointer((base + "/additionalProperties").c_str()).Set(declarations,false); + Pointer((base + "/minItems").c_str()).Set(declarations,1); + Pointer((base + "/maxItems").c_str()).Set(declarations,2); + Pointer((base + "/documentation").c_str()).Set(declarations,documentation.c_str()); + + { + Pointer((base + "/items/anyOf/0/type").c_str()).Set(declarations,"number"); + Pointer((base + "/items/anyOf/0/default value").c_str()).Set(declarations,default_value); + + Pointer((base + "/items/anyOf/1/type").c_str()).Set(declarations,"array"); + Pointer((base + "/items/anyOf/1/minItems").c_str()).Set(declarations,1); + Pointer((base + "/items/anyOf/1/maxItems").c_str()).Set(declarations,std::numeric_limits::max()); + + Pointer((base + "/items/anyOf/1/items/type").c_str()).Set(declarations,"array"); + Pointer((base + "/items/anyOf/1/items/minItems").c_str()).Set(declarations,1); + Pointer((base + "/items/anyOf/1/items/maxItems").c_str()).Set(declarations,2); + + Pointer((base + "/items/anyOf/1/items/items/type").c_str()).Set(declarations,"number"); + } + } + prm.leave_subsection(); + } + + } // namespace Types +} // namespace WorldBuilder + + From 88111fe4da163463004c8b0b909673203bb72ebd Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Thu, 24 Mar 2022 13:39:54 -0700 Subject: [PATCH 04/26] Add new folder for objects and add surface as an object. --- include/world_builder/objects/surface.h | 90 +++++++++++ source/objects/surface.cc | 191 ++++++++++++++++++++++++ 2 files changed, 281 insertions(+) create mode 100644 include/world_builder/objects/surface.h create mode 100644 source/objects/surface.cc diff --git a/include/world_builder/objects/surface.h b/include/world_builder/objects/surface.h new file mode 100644 index 000000000..5e79cd3f9 --- /dev/null +++ b/include/world_builder/objects/surface.h @@ -0,0 +1,90 @@ + + +/* +Copyright (C) 2018 - 2021 by the authors of the World Builder code. + +This file is part of the World Builder. + + This program is free software: you can redistribute it and/or modify + it under the terms of the GNU Lesser General Public License as published + by the Free Software Foundation, either version 2 of the License, or + (at your option) any later version. + + 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 Lesser General Public License for more details. + + You should have received a copy of the GNU Lesser General Public License + along with this program. If not, see . +*/ + +#ifndef WORLD_BUILDER_OBJECTSS_SURFACE_H +#define WORLD_BUILDER_OBJECTSS_SURFACE_H + +#include "world_builder/utilities.h" + +#include "world_builder/kd_tree.h" + +namespace WorldBuilder +{ + namespace Objects + { + class Surface + { + public: + /** + * Constructor to create an empty surface. + */ + Surface(); + + /** + * Constructor to create a surface from value at points object output. + */ + Surface(std::pair,std::vector> values_at_points); + + /** + * Returns the value of the surface at the check point. + */ + double local_value(const Point<2> check_point) const; + + /** + * Wether the surface is a constant value or not. This is used for optimalization. + */ + bool constant_value; + + /** + * The minimum value of all provided points. + */ + double minimum; + + /** + * The maximum value of all provided points. + */ + double maximum; + + /** + * The KD tree which stores the centroids of all triangles and an index to the triangle points + * and values stored in the triangles member variable. + */ + KDTree::KDTree tree; + + /** + * Stores the triangles as a list of three points. + */ + std::vector,3> > triangles; + + private: + /** + * Test whether a point is in a triangle. If that is the case is stores the interpolated + * value of the tirangle into `interpolated_value` and returns true. + */ + bool in_triangle(const std::array,3> &points, + const Point<2> check_point, + double &interpolate_value) const; + }; + } + +} + +#endif \ No newline at end of file diff --git a/source/objects/surface.cc b/source/objects/surface.cc new file mode 100644 index 000000000..62cb710aa --- /dev/null +++ b/source/objects/surface.cc @@ -0,0 +1,191 @@ +/* + Copyright (C) 2018 - 2021 by the authors of the World Builder code. + + This file is part of the World Builder. + + This program is free software: you can redistribute it and/or modify + it under the terms of the GNU Lesser General Public License as published + by the Free Software Foundation, either version 2 of the License, or + (at your option) any later version. + + 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 Lesser General Public License for more details. + + You should have received a copy of the GNU Lesser General Public License + along with this program. If not, see . +*/ +#include "world_builder/objects/surface.h" +#include "world_builder/assert.h" +#include "world_builder/utilities.h" + +#include "delaunator-cpp/delaunator.hpp" + + +namespace WorldBuilder +{ + namespace Objects + { + Surface::Surface() + {} + + + Surface::Surface(std::pair,std::vector> values_at_points) + { + // first find the min and max. This need always to be done; + WBAssertThrow(values_at_points.first.size() > 0, "internal error: no values in values_at_points.first."); + minimum = values_at_points.first[0]; + maximum = values_at_points.first[0]; + + for (const auto &value: values_at_points.first) + { + if (value < minimum) + { + minimum = value; + } + if (value > maximum) + { + maximum = value; + } + } + + // if there are points defined there is not a constant value, + // if there are no points defined there is a constant value. + if (values_at_points.second.size() > 0) + { + constant_value = false; + + // Next make the triangulation and the kd-tree. + // Feed the delaunator + delaunator::Delaunator triangulation(values_at_points.second); + + // now loop over all the triangles and add them to the correct vectors + triangles.resize(triangulation.triangles.size()/3); + std::vector node_list; + for (std::size_t i = 0; i < triangulation.triangles.size(); i+=3) + { + delaunator::Delaunator &t = triangulation; + // 1. We need to create a triangle list where each entry contains the coordinates + // and value of the points of the triangle: + // [[[x0,y0,v0],[x1,y1,v1],[x2,y2,v2]],[[x1,y1,v1],[x0,y0,v0],[x3,y3,v3]],...] + // 2. we need to compute the centeroid locations and add those to the KD-tree + // with the index stored on the triangle list + triangles[i/3][0][0] = t.coords[2 * t.triangles[i]]; // tx0 + triangles[i/3][0][1] = t.coords[2 * t.triangles[i]+1]; // ty0 + triangles[i/3][0][2] = values_at_points.first[t.triangles[i]]; // v0 + triangles[i/3][1][0] = t.coords[2 * t.triangles[i+1]]; // tx1 + triangles[i/3][1][1] = t.coords[2 * t.triangles[i+1]+1]; // ty1 + triangles[i/3][1][2] = values_at_points.first[t.triangles[i+1]]; // v1 + triangles[i/3][2][0] = t.coords[2 * t.triangles[i+2]]; // tx2 + triangles[i/3][2][1] = t.coords[2 * t.triangles[i+2]+1]; // ty2 + triangles[i/3][2][2] = values_at_points.first[t.triangles[i+2]]; // v2 + + node_list.emplace_back(KDTree::Node(i/3, + (t.coords[2*t.triangles[i]]+t.coords[2*t.triangles[i+1]]+t.coords[2*t.triangles[i+2]])/3., + (t.coords[2*t.triangles[i]+1]+t.coords[2*t.triangles[i+1]+1]+t.coords[2*t.triangles[i+2]+1])/3.)); + + } + // now feed and create the KD-tree + tree = KDTree::KDTree(node_list); + tree.create_tree(0, node_list.size()-1, false); + } + else + { + constant_value = true; + } + } + + bool Surface::in_triangle(const std::array,3> &points, + const Point<2> check_point, + double &interpolate_value) const + { + double factor = 20.; + // based on https://stackoverflow.com/questions/2049582/how-to-determine-if-a-point-is-in-a-2d-triangle + // compute s, t and area + const double s_no_area = -(points[0][1]*points[2][0] - points[0][0]*points[2][1] + (points[2][1] - points[0][1])*check_point[0] + (points[0][0] - points[2][0])*check_point[1]); + const double t_no_area = -(points[0][0]*points[1][1] - points[0][1]*points[1][0] + (points[0][1] - points[1][1])*check_point[0] + (points[1][0] - points[0][0])*check_point[1]); + const double two_times_area = -(-points[1][1]*points[2][0] + points[0][1]*(-points[1][0] + points[2][0]) + points[0][0]*(points[1][1] - points[2][1]) + points[1][0]*points[2][1]); + + if (s_no_area >= -factor*std::numeric_limits::epsilon() && t_no_area >= -factor*std::numeric_limits::epsilon() && s_no_area+t_no_area-two_times_area<=two_times_area*factor*std::numeric_limits::epsilon()) + { + // point is in this triangle + const double one_over_two_times_area = 1./two_times_area; + const double s = one_over_two_times_area*s_no_area; + const double t = one_over_two_times_area*t_no_area; + interpolate_value = points[0][2]*(1-s-t)+points[1][2]*s+points[2][2]*t; + return true; + } + return false; + } + + double Surface::local_value(const Point<2> check_point) const + { + if (constant_value) + { + // just min and max are the same since it is constant. Just return min. + return minimum; + } + // first find the closest centeroids + const KDTree::IndexDistances index_distances = tree.find_closest_points(check_point); + + Point<2> other_point = check_point; + KDTree::IndexDistances index_distances_other; + bool spherical = false; + if (check_point.get_coordinate_system() == CoordinateSystem::spherical) + { + spherical = true; + other_point[0] += check_point[0] < 0 ? 2.0 * WorldBuilder::Utilities::const_pi : -2.0 * WorldBuilder::Utilities::const_pi; + index_distances_other = tree.find_closest_points(other_point); + } + // try triangle of the closest centroid + double interpolated_value = 0; + + if (in_triangle(triangles[tree.get_nodes()[index_distances.min_index].index],check_point,interpolated_value)) + { + return interpolated_value; + } + else if (spherical && in_triangle(triangles[tree.get_nodes()[index_distances_other.min_index].index],other_point,interpolated_value)) + { + return interpolated_value; + } + else + { + // if not found go to closets nodes + // Todo: could remove the cosest node, because it was already tested. Could also sort based no distance. + for (auto &index_distance: index_distances.vector) + { + if (in_triangle(triangles[tree.get_nodes()[index_distance.index].index],check_point,interpolated_value)) + { + return interpolated_value; + } + else if (spherical && in_triangle(triangles[tree.get_nodes()[index_distance.index].index],other_point,interpolated_value)) + { + // This is probably non-optimal, but it seems to work better than expected + return interpolated_value; + } + } + + // if still not found, go through all nodes + // Todo: Although this shouldonly very rearly happen, could remove already tested nodes. + for (const auto &nodes: tree.get_nodes()) + { + if (in_triangle(triangles[nodes.index],check_point,interpolated_value)) + { + return interpolated_value; + } + else if (spherical && in_triangle(triangles[nodes.index],other_point,interpolated_value)) + { + return interpolated_value; + } + } + WBAssertThrow(false, "Internal error: The requested point was not in any triangle. " + << "This could be due to rounding errors if the difference between the check point and triangle points are small, " + << "or you are requesting a point ouside the bounderies defined by the additional points. The check point was " + << check_point[0] << ":" << check_point[1] << "."); + } + return 0; + } + } // namespace Objects +} // namespace WorldBuilder + From 602230ada40eb091b78a4dd00794ef44d942df80 Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Thu, 24 Mar 2022 13:39:17 -0700 Subject: [PATCH 05/26] Add delaunator as a header only library. --- include/delaunator-cpp/delaunator.hpp | 615 ++++++++++++++++++++++++++ 1 file changed, 615 insertions(+) create mode 100644 include/delaunator-cpp/delaunator.hpp diff --git a/include/delaunator-cpp/delaunator.hpp b/include/delaunator-cpp/delaunator.hpp new file mode 100644 index 000000000..cc928e2f2 --- /dev/null +++ b/include/delaunator-cpp/delaunator.hpp @@ -0,0 +1,615 @@ +/** + * MIT License + * + * Copyright (c) 2018 Volodymyr Bilonenko + * + * Permission is hereby granted, free of charge, to any person obtaining a copy + * of this software and associated documentation files (the "Software"), to deal + * in the Software without restriction, including without limitation the rights + * to use, copy, modify, merge, publish, distribute, sublicense, and/or sell + * copies of the Software, and to permit persons to whom the Software is + * furnished to do so, subject to the following conditions: + * + * The above copyright notice and this permission notice shall be included in all + * copies or substantial portions of the Software. + * + * THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR + * IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, + * FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE + * AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER + * LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, + * OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN THE + * SOFTWARE. + */ + +#ifndef WORLD_BUILDER_DELAUNATOR_CPP_DELAUNATOR_HPP +#define WORLD_BUILDER_DELAUNATOR_CPP_DELAUNATOR_HPP + + +#include +#include +#include +#include +#include +#include +#include +#include +namespace WorldBuilder +{ + namespace delaunator { + + //@see https://stackoverflow.com/questions/33333363/built-in-mod-vs-custom-mod-function-improve-the-performance-of-modulus-op/33333636#33333636 + inline size_t fast_mod(const size_t i, const size_t c) { + return i >= c ? i % c : i; + } + + // Kahan and Babuska summation, Neumaier variant; accumulates less FP error + inline double sum(const std::vector& x) { + double sum = x[0]; + double err = 0.0; + + for (size_t i = 1; i < x.size(); i++) { + const double k = x[i]; + const double m = sum + k; + err += std::fabs(sum) >= std::fabs(k) ? sum - m + k : k - m + sum; + sum = m; + } + return sum + err; + } + + inline double dist( + const double ax, + const double ay, + const double bx, + const double by) { + const double dx = ax - bx; + const double dy = ay - by; + return dx * dx + dy * dy; + } + + inline double circumradius( + const double ax, + const double ay, + const double bx, + const double by, + const double cx, + const double cy) { + const double dx = bx - ax; + const double dy = by - ay; + const double ex = cx - ax; + const double ey = cy - ay; + + const double bl = dx * dx + dy * dy; + const double cl = ex * ex + ey * ey; + const double d = dx * ey - dy * ex; + + const double x = (ey * bl - dy * cl) * 0.5 / d; + const double y = (dx * cl - ex * bl) * 0.5 / d; + + if ((bl > 0.0 || bl < 0.0) && (cl > 0.0 || cl < 0.0) && (d > 0.0 || d < 0.0)) { + return x * x + y * y; + } else { + return std::numeric_limits::max(); + } + } + + inline bool orient( + const double px, + const double py, + const double qx, + const double qy, + const double rx, + const double ry) { + return (qy - py) * (rx - qx) - (qx - px) * (ry - qy) < 0.0; + } + + inline std::pair circumcenter( + const double ax, + const double ay, + const double bx, + const double by, + const double cx, + const double cy) { + const double dx = bx - ax; + const double dy = by - ay; + const double ex = cx - ax; + const double ey = cy - ay; + + const double bl = dx * dx + dy * dy; + const double cl = ex * ex + ey * ey; + const double d = dx * ey - dy * ex; + + const double x = ax + (ey * bl - dy * cl) * 0.5 / d; + const double y = ay + (dx * cl - ex * bl) * 0.5 / d; + + return std::make_pair(x, y); + } + + struct compare { + + std::vector const& coords; + double cx; + double cy; + + bool operator()(std::size_t i, std::size_t j) { + const double d1 = dist(coords[2 * i], coords[2 * i + 1], cx, cy); + const double d2 = dist(coords[2 * j], coords[2 * j + 1], cx, cy); + const double diff1 = d1 - d2; + const double diff2 = coords[2 * i] - coords[2 * j]; + const double diff3 = coords[2 * i + 1] - coords[2 * j + 1]; + + if (diff1 > 0.0 || diff1 < 0.0) { + return diff1 < 0; + } else if (diff2 > 0.0 || diff2 < 0.0) { + return diff2 < 0; + } else { + return diff3 < 0; + } + } + }; + + inline bool in_circle( + const double ax, + const double ay, + const double bx, + const double by, + const double cx, + const double cy, + const double px, + const double py) { + const double dx = ax - px; + const double dy = ay - py; + const double ex = bx - px; + const double ey = by - py; + const double fx = cx - px; + const double fy = cy - py; + + const double ap = dx * dx + dy * dy; + const double bp = ex * ex + ey * ey; + const double cp = fx * fx + fy * fy; + + return (dx * (ey * cp - bp * fy) - + dy * (ex * cp - bp * fx) + + ap * (ex * fy - ey * fx)) < 0.0; + } + + constexpr double EPSILON = std::numeric_limits::epsilon(); + constexpr std::size_t INVALID_INDEX = std::numeric_limits::max(); + + inline bool check_pts_equal(double x1, double y1, double x2, double y2) { + return std::fabs(x1 - x2) <= EPSILON && + std::fabs(y1 - y2) <= EPSILON; + } + + // monotonically increases with real angle, but doesn't need expensive trigonometry + inline double pseudo_angle(const double dx, const double dy) { + const double p = dx / (std::abs(dx) + std::abs(dy)); + return (dy > 0.0 ? 3.0 - p : 1.0 + p) / 4.0; // [0..1) + } + + struct DelaunatorPoint { + std::size_t i; + double x; + double y; + std::size_t t; + std::size_t prev; + std::size_t next; + bool removed; + }; + + class Delaunator { + + public: + std::vector const& coords; + std::vector triangles; + std::vector halfedges; + std::vector hull_prev; + std::vector hull_next; + std::vector hull_tri; + std::size_t hull_start; + + Delaunator(std::vector const& in_coords); + + double get_hull_area(); + + private: + std::vector m_hash; + double m_center_x; + double m_center_y; + std::size_t m_hash_size; + std::vector m_edge_stack; + + std::size_t legalize(std::size_t a); + std::size_t hash_key(double x, double y) const; + std::size_t add_triangle( + std::size_t i0, + std::size_t i1, + std::size_t i2, + std::size_t a, + std::size_t b, + std::size_t c); + void link(std::size_t a, std::size_t b); + }; + + Delaunator::Delaunator(std::vector const& in_coords) + : coords(in_coords), + triangles(), + halfedges(), + hull_prev(), + hull_next(), + hull_tri(), + hull_start(), + m_hash(), + m_center_x(), + m_center_y(), + m_hash_size(), + m_edge_stack() { + std::size_t n = coords.size() >> 1; + + double max_x = std::numeric_limits::min(); + double max_y = std::numeric_limits::min(); + double min_x = std::numeric_limits::max(); + double min_y = std::numeric_limits::max(); + std::vector ids; + ids.reserve(n); + + for (std::size_t i = 0; i < n; i++) { + const double x = coords[2 * i]; + const double y = coords[2 * i + 1]; + + if (x < min_x) min_x = x; + if (y < min_y) min_y = y; + if (x > max_x) max_x = x; + if (y > max_y) max_y = y; + + ids.push_back(i); + } + const double cx = (min_x + max_x) / 2; + const double cy = (min_y + max_y) / 2; + double min_dist = std::numeric_limits::max(); + + std::size_t i0 = INVALID_INDEX; + std::size_t i1 = INVALID_INDEX; + std::size_t i2 = INVALID_INDEX; + + // pick a seed point close to the centroid + for (std::size_t i = 0; i < n; i++) { + const double d = dist(cx, cy, coords[2 * i], coords[2 * i + 1]); + if (d < min_dist) { + i0 = i; + min_dist = d; + } + } + + const double i0x = coords[2 * i0]; + const double i0y = coords[2 * i0 + 1]; + + min_dist = std::numeric_limits::max(); + + // find the point closest to the seed + for (std::size_t i = 0; i < n; i++) { + if (i == i0) continue; + const double d = dist(i0x, i0y, coords[2 * i], coords[2 * i + 1]); + if (d < min_dist && d > 0.0) { + i1 = i; + min_dist = d; + } + } + + double i1x = coords[2 * i1]; + double i1y = coords[2 * i1 + 1]; + + double min_radius = std::numeric_limits::max(); + + // find the third point which forms the smallest circumcircle with the first two + for (std::size_t i = 0; i < n; i++) { + if (i == i0 || i == i1) continue; + + const double r = circumradius( + i0x, i0y, i1x, i1y, coords[2 * i], coords[2 * i + 1]); + + if (r < min_radius) { + i2 = i; + min_radius = r; + } + } + + if (!(min_radius < std::numeric_limits::max())) { + throw std::runtime_error("not triangulation"); + } + + double i2x = coords[2 * i2]; + double i2y = coords[2 * i2 + 1]; + + if (orient(i0x, i0y, i1x, i1y, i2x, i2y)) { + std::swap(i1, i2); + std::swap(i1x, i2x); + std::swap(i1y, i2y); + } + + std::tie(m_center_x, m_center_y) = circumcenter(i0x, i0y, i1x, i1y, i2x, i2y); + + // sort the points by distance from the seed triangle circumcenter + std::sort(ids.begin(), ids.end(), compare{ coords, m_center_x, m_center_y }); + + // initialize a hash table for storing edges of the advancing convex hull + m_hash_size = static_cast(std::llround(std::ceil(std::sqrt(n)))); + m_hash.resize(m_hash_size); + std::fill(m_hash.begin(), m_hash.end(), INVALID_INDEX); + + // initialize arrays for tracking the edges of the advancing convex hull + hull_prev.resize(n); + hull_next.resize(n); + hull_tri.resize(n); + + hull_start = i0; + + size_t hull_size = 3; + + hull_next[i0] = hull_prev[i2] = i1; + hull_next[i1] = hull_prev[i0] = i2; + hull_next[i2] = hull_prev[i1] = i0; + + hull_tri[i0] = 0; + hull_tri[i1] = 1; + hull_tri[i2] = 2; + + m_hash[hash_key(i0x, i0y)] = i0; + m_hash[hash_key(i1x, i1y)] = i1; + m_hash[hash_key(i2x, i2y)] = i2; + + std::size_t max_triangles = n < 3 ? 1 : 2 * n - 5; + triangles.reserve(max_triangles * 3); + halfedges.reserve(max_triangles * 3); + add_triangle(i0, i1, i2, INVALID_INDEX, INVALID_INDEX, INVALID_INDEX); + double xp = std::numeric_limits::quiet_NaN(); + double yp = std::numeric_limits::quiet_NaN(); + for (std::size_t k = 0; k < n; k++) { + const std::size_t i = ids[k]; + const double x = coords[2 * i]; + const double y = coords[2 * i + 1]; + + // skip near-duplicate points + if (k > 0 && check_pts_equal(x, y, xp, yp)) continue; + xp = x; + yp = y; + + // skip seed triangle points + if ( + check_pts_equal(x, y, i0x, i0y) || + check_pts_equal(x, y, i1x, i1y) || + check_pts_equal(x, y, i2x, i2y)) continue; + + // find a visible edge on the convex hull using edge hash + std::size_t start = 0; + + size_t key = hash_key(x, y); + for (size_t j = 0; j < m_hash_size; j++) { + start = m_hash[fast_mod(key + j, m_hash_size)]; + if (start != INVALID_INDEX && start != hull_next[start]) break; + } + + start = hull_prev[start]; + size_t e = start; + size_t q; + + while (q = hull_next[e], !orient(x, y, coords[2 * e], coords[2 * e + 1], coords[2 * q], coords[2 * q + 1])) { //TODO: does it works in a same way as in JS + e = q; + if (e == start) { + e = INVALID_INDEX; + break; + } + } + + if (e == INVALID_INDEX) continue; // likely a near-duplicate point; skip it + + // add the first triangle from the point + std::size_t t = add_triangle( + e, + i, + hull_next[e], + INVALID_INDEX, + INVALID_INDEX, + hull_tri[e]); + + hull_tri[i] = legalize(t + 2); + hull_tri[e] = t; + hull_size++; + + // walk forward through the hull, adding more triangles and flipping recursively + std::size_t next = hull_next[e]; + while ( + q = hull_next[next], + orient(x, y, coords[2 * next], coords[2 * next + 1], coords[2 * q], coords[2 * q + 1])) { + t = add_triangle(next, i, q, hull_tri[i], INVALID_INDEX, hull_tri[next]); + hull_tri[i] = legalize(t + 2); + hull_next[next] = next; // mark as removed + hull_size--; + next = q; + } + + // walk backward from the other side, adding more triangles and flipping + if (e == start) { + while ( + q = hull_prev[e], + orient(x, y, coords[2 * q], coords[2 * q + 1], coords[2 * e], coords[2 * e + 1])) { + t = add_triangle(q, i, e, INVALID_INDEX, hull_tri[e], hull_tri[q]); + legalize(t + 2); + hull_tri[q] = t; + hull_next[e] = e; // mark as removed + hull_size--; + e = q; + } + } + + // update the hull indices + hull_prev[i] = e; + hull_start = e; + hull_prev[next] = i; + hull_next[e] = i; + hull_next[i] = next; + + m_hash[hash_key(x, y)] = i; + m_hash[hash_key(coords[2 * e], coords[2 * e + 1])] = e; + } + } + + double Delaunator::get_hull_area() { + std::vector hull_area; + size_t e = hull_start; + do { + hull_area.push_back((coords[2 * e] - coords[2 * hull_prev[e]]) * (coords[2 * e + 1] + coords[2 * hull_prev[e] + 1])); + e = hull_next[e]; + } while (e != hull_start); + return sum(hull_area); + } + + std::size_t Delaunator::legalize(std::size_t a) { + std::size_t i = 0; + std::size_t ar = 0; + m_edge_stack.clear(); + + // recursion eliminated with a fixed-size stack + while (true) { + const size_t b = halfedges[a]; + + /* if the pair of triangles doesn't satisfy the Delaunay condition + * (p1 is inside the circumcircle of [p0, pl, pr]), flip them, + * then do the same check/flip recursively for the new pair of triangles + * + * pl pl + * /||\ / \ + * al/ || \bl al/ \a + * / || \ / \ + * / a||b \ flip /___ar___\ + * p0\ || /p1 => p0\---bl---/p1 + * \ || / \ / + * ar\ || /br b\ /br + * \||/ \ / + * pr pr + */ + const size_t a0 = 3 * (a / 3); + ar = a0 + (a + 2) % 3; + + if (b == INVALID_INDEX) { + if (i > 0) { + i--; + a = m_edge_stack[i]; + continue; + } else { + //i = INVALID_INDEX; + break; + } + } + + const size_t b0 = 3 * (b / 3); + const size_t al = a0 + (a + 1) % 3; + const size_t bl = b0 + (b + 2) % 3; + + const std::size_t p0 = triangles[ar]; + const std::size_t pr = triangles[a]; + const std::size_t pl = triangles[al]; + const std::size_t p1 = triangles[bl]; + + const bool illegal = in_circle( + coords[2 * p0], + coords[2 * p0 + 1], + coords[2 * pr], + coords[2 * pr + 1], + coords[2 * pl], + coords[2 * pl + 1], + coords[2 * p1], + coords[2 * p1 + 1]); + + if (illegal) { + triangles[a] = p1; + triangles[b] = p0; + + auto hbl = halfedges[bl]; + + // edge swapped on the other side of the hull (rare); fix the halfedge reference + if (hbl == INVALID_INDEX) { + std::size_t e = hull_start; + do { + if (hull_tri[e] == bl) { + hull_tri[e] = a; + break; + } + e = hull_next[e]; + } while (e != hull_start); + } + link(a, hbl); + link(b, halfedges[ar]); + link(ar, bl); + std::size_t br = b0 + (b + 1) % 3; + + if (i < m_edge_stack.size()) { + m_edge_stack[i] = br; + } else { + m_edge_stack.push_back(br); + } + i++; + + } else { + if (i > 0) { + i--; + a = m_edge_stack[i]; + continue; + } else { + break; + } + } + } + return ar; + } + + inline std::size_t Delaunator::hash_key(const double x, const double y) const { + const double dx = x - m_center_x; + const double dy = y - m_center_y; + return fast_mod( + static_cast(std::llround(std::floor(pseudo_angle(dx, dy) * static_cast(m_hash_size)))), + m_hash_size); + } + + std::size_t Delaunator::add_triangle( + std::size_t i0, + std::size_t i1, + std::size_t i2, + std::size_t a, + std::size_t b, + std::size_t c) { + std::size_t t = triangles.size(); + triangles.push_back(i0); + triangles.push_back(i1); + triangles.push_back(i2); + link(t, a); + link(t + 1, b); + link(t + 2, c); + return t; + } + + void Delaunator::link(const std::size_t a, const std::size_t b) { + std::size_t s = halfedges.size(); + if (a == s) { + halfedges.push_back(b); + } else if (a < s) { + halfedges[a] = b; + } else { + throw std::runtime_error("Cannot link edge"); + } + if (b != INVALID_INDEX) { + std::size_t s2 = halfedges.size(); + if (b == s2) { + halfedges.push_back(a); + } else if (b < s2) { + halfedges[b] = a; + } else { + throw std::runtime_error("Cannot link edge"); + } + } + } + + } //namespace delaunator +} //namespace WorldBuilder + +#endif \ No newline at end of file From ed86f3208d445c8e4dead7a612a271e864557a03 Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Thu, 24 Mar 2022 13:20:03 -0700 Subject: [PATCH 06/26] Update rapidjson mystwriter --- include/rapidjson/mystwriter.h | 76 +++++++++++++++++++++++++++------- 1 file changed, 62 insertions(+), 14 deletions(-) diff --git a/include/rapidjson/mystwriter.h b/include/rapidjson/mystwriter.h index c0207bae5..eba4857bb 100644 --- a/include/rapidjson/mystwriter.h +++ b/include/rapidjson/mystwriter.h @@ -17,6 +17,9 @@ #include "writer.h" +#include "assert.h" + +#include #include #include #include @@ -33,6 +36,7 @@ RAPIDJSON_DIAG_OFF(c++98-compat) RAPIDJSON_NAMESPACE_BEGIN +#define MAX_PATH_LEVEL 25 //! Writer with indentation and spacing. /*! @@ -173,7 +177,7 @@ class MySTWriter : public Writer 0 && (level_type.back() != 3 || level_type.size() == 0)) level_type.push_back(0); } Base::WriteString(begin.c_str(), static_cast(begin.size()), false); + Base::os_->Put('\n'); if (level_type.size() == 0 && !make_open) { @@ -238,7 +261,7 @@ class MySTWriter : public Writer(name.size()), false); Base::os_->Put('\n'); Base::os_->Put('\n'); @@ -269,7 +292,17 @@ class MySTWriter : public Writer 0 && (level_type.back() == 1)) + else if (key == "enum" || key == "required" ) + { + level_type.push_back(4); + item += "- **" + std::string(str) + "**:"; + } + else if (key == "anyOf") + { + level_type.push_back(5); + path.push_back(key); + } + else if (level_type.size() > 0 && (level_type.back() == 1 || level_type.back() == 2 || level_type.back() == 5)) { // the level just below properties, these are the sections // add to the path @@ -277,7 +310,7 @@ class MySTWriter : public Writer(item.length()), false); @@ -304,15 +337,19 @@ class MySTWriter : public Writer(name.size()), false); Base::os_->Put('\n'); Base::os_->Put('\n'); } } - return true; } bool EndArray(SizeType /*memberCount = 0*/) { std::string end = ""; - if (level_type.size() != 0 && level_type.back() == 2) + if (level_type.size() != 0 && (level_type.back() == 1 || level_type.back() == 2 || level_type.back() == 3 || level_type.back() == 5)) { array_number.pop_back(); level_type.pop_back(); @@ -389,8 +427,15 @@ class MySTWriter : public Writer 0 && (level_type.back() == 4))// || level_type.back() == 0)) + { + level_type.pop_back(); + } } Base::WriteString(end.c_str(), static_cast(end.size()), false); @@ -450,6 +495,9 @@ class MySTWriter : public Writer Date: Thu, 24 Mar 2022 13:22:16 -0700 Subject: [PATCH 07/26] Add option to the world builder app to convert 3D spherical coordintes in the input to cartesian automatically. --- app/main.cc | 16 ++++++++++++---- 1 file changed, 12 insertions(+), 4 deletions(-) diff --git a/app/main.cc b/app/main.cc index 7731567ae..2b50413ee 100644 --- a/app/main.cc +++ b/app/main.cc @@ -23,6 +23,7 @@ #include "world_builder/assert.h" #include "world_builder/utilities.h" #include "world_builder/world.h" +#include "world_builder/point.h" #ifdef WB_WITH_MPI #include @@ -52,6 +53,7 @@ int main(int argc, char **argv) unsigned int compositions = 0; unsigned int grain_compositions = 0; size_t number_of_grains = 0; + bool convert_spherical = false; if (find_command_line_option(argv, argv+argc, "-h") || find_command_line_option(argv, argv+argc, "--help")) { @@ -157,11 +159,14 @@ int main(int argc, char **argv) if (!line_i.empty() && line_i[0] == "#" && line_i[1] == "number" && line_i[2] == "of" && line_i[3] == "grains" && line_i[4] == "=") number_of_grains = string_to_unsigned_int(line_i[5]); + if (!line_i.empty() && line_i[0] == "#" && line_i[1] == "convert" && line_i[2] == "spherical" && line_i[3] == "=" && line_i[4] == "true") + convert_spherical = true; } switch (dim) { case 2: + WBAssertThrow(!convert_spherical, "Converting to spherical values is only available in 3D."); // set the header std::cout << "# x z d g T "; @@ -184,7 +189,6 @@ int main(int argc, char **argv) WBAssertThrow(data[i].size() == dim + 2, "The file needs to contain dim + 2 entries, but contains " << data[i].size() << " entries " " on line " << i+1 << " of the data file. Dim is " << dim << '.'); - std::array coords = {{ string_to_double(data[i][0]), string_to_double(data[i][1]) @@ -236,12 +240,16 @@ int main(int argc, char **argv) WBAssertThrow(data[i].size() == dim + 2, "The file needs to contain dim + 2 entries, but contains " << data[i].size() << " entries " " on line " << i+1 << " of the data file. Dim is " << dim << '.'); std::array coords = {{ - string_to_double(data[i][0]), - string_to_double(data[i][1]), - string_to_double(data[i][2]) + string_to_double(data[i][0]), // x or R + string_to_double(data[i][1]) *(convert_spherical ? (const_pi/180.): 1.), // y or long + string_to_double(data[i][2]) *(convert_spherical ? (const_pi/180.): 1.) // z or lat } }; + if (convert_spherical) + { + coords = spherical_to_cartesian_coordinates(coords).get_array(); + } std::cout << data[i][0] << ' ' << data[i][1] << ' ' << data[i][2] << ' ' << data[i][3] << ' ' << data[i][4] << ' '; std::cout << world->temperature(coords, string_to_double(data[i][3]), string_to_double(data[i][4])) << ' '; From 2326bbf73b73308cac0a6dc7590027d2ed5eacab Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Thu, 24 Mar 2022 13:31:00 -0700 Subject: [PATCH 08/26] Update KD Tree implementation. --- include/world_builder/kd_tree.h | 6 +++++- source/kd_tree.cc | 4 ++-- 2 files changed, 7 insertions(+), 3 deletions(-) diff --git a/include/world_builder/kd_tree.h b/include/world_builder/kd_tree.h index 0b7d87a5e..922917d62 100644 --- a/include/world_builder/kd_tree.h +++ b/include/world_builder/kd_tree.h @@ -86,6 +86,10 @@ namespace WorldBuilder class KDTree { public: + /** + * Constructor. + */ + KDTree() {}; /** * Constructor. Requires a list of Nodes. */ @@ -102,7 +106,7 @@ namespace WorldBuilder /** * Retun a reference to the vector containing the nodes. */ - std::vector &get_nodes(); + const std::vector &get_nodes() const; /** * Returns the index of the closest point and the distance diff --git a/source/kd_tree.cc b/source/kd_tree.cc index ff44fd237..a4f005e87 100644 --- a/source/kd_tree.cc +++ b/source/kd_tree.cc @@ -48,8 +48,8 @@ namespace WorldBuilder } - std::vector & - KDTree::get_nodes() + const std::vector & + KDTree::get_nodes() const { return nodes; } From efe4f120127ccd6588d75227409934fa57458b99 Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Thu, 24 Mar 2022 13:34:22 -0700 Subject: [PATCH 09/26] Add to paramters a get function to retrieve value at points. --- include/world_builder/parameters.h | 9 ++ source/parameters.cc | 205 +++++++++++++++++++++++++++++ 2 files changed, 214 insertions(+) diff --git a/include/world_builder/parameters.h b/include/world_builder/parameters.h index 61d70c747..ca1a4faed 100644 --- a/include/world_builder/parameters.h +++ b/include/world_builder/parameters.h @@ -108,6 +108,15 @@ namespace WorldBuilder template std::vector get_vector(const std::string &name); + /** + * A specialized verions of get which can retun a value at points type. + * \param name The name of the entry to retrieved + * \param name additional points to be added to the list at either the default value or at the value of a single value array in the list + */ + std::pair,std::vector> + get(const std::string &name, + const std::vector > &addition_points = {}); + /** * A specialized verions of get which can retun vecors/arrays. * This version is designed for the plugin system. diff --git a/source/parameters.cc b/source/parameters.cc index 2c1f06daa..b394283d9 100644 --- a/source/parameters.cc +++ b/source/parameters.cc @@ -30,6 +30,7 @@ #include "world_builder/features/oceanic_plate_models/temperature/interface.h" #include "world_builder/features/subducting_plate.h" #include "world_builder/types/object.h" +#include "world_builder/utilities.h" #include "rapidjson/error/en.h" #include "rapidjson/istreamwrapper.h" @@ -448,6 +449,210 @@ namespace WorldBuilder return vector; } + + std::pair,std::vector> + Parameters::get(const std::string &name, + const std::vector > &addition_points) + { + // There are four cases: + // 1. No value provided: use the default value everywhere. Return first with one value and second with size 0. + // 2. One double provided: use the default value everywhere. Return first with one value and second with size 0. + // 3. One value in a double array and no points provided: use that value everywhere. Return first with one value and second with size 0. + // 4. Other: fill the vectors with the default value and addition points and then add new point. + // If a value without points is encountered, the additional points are used. + std::pair,std::vector> result; + + const std::string strict_base = this->get_full_json_path(); + + // start with adding the additional points with the default value + // to do this we need the default value + double default_value = 0; + bool is_array = true; + if (Pointer((strict_base + "/" + name).c_str()).Get(parameters) != nullptr && Pointer((strict_base + "/" + name).c_str()).Get(parameters)->IsArray()) + { + std::string value_def_path = get_full_json_schema_path() + "/" + name + "/oneOf/1/items/items/anyOf/0/default value"; + Value *value_def = Pointer(value_def_path.c_str()).Get(declarations); + WBAssertThrow(value_def != nullptr, + "internal error: could not retrieve the default value at: " + << value_def_path); + + // Since the default value is set in the code, if it fails it is an internal error, not a user error. + // So no try/catch needed. + default_value = value_def->GetDouble(); + } + else + { + is_array = false; + Value *value_def = Pointer((get_full_json_schema_path() + "/" + name + "/oneOf/0/default value").c_str()).Get(declarations); + WBAssertThrow(value_def != nullptr, + "internal error: could not retrieve the default value at: " + <GetDouble(); + } + + + // check if there is a user defined value + if (Pointer((strict_base + "/" + name).c_str()).Get(parameters) != nullptr) + { + // there is a user defined value, so either case 2, 3 or 4. + if (is_array) + { + Value *array = Pointer((strict_base + "/" + name).c_str()).Get(parameters); + + if (array->Size() == 1 + && Pointer((strict_base + "/" + name + "/0/1").c_str()).Get(parameters) == nullptr) + { + // case 2: Return first with one value and second with size 0. + double value = 0; + try + { + value = Pointer((strict_base + "/" + name + "/0/0").c_str()).Get(parameters)->GetDouble(); + } + catch (...) + { + WBAssertThrow(false, "Could not convert values of " << strict_base << "/" << name << "/0/0 into a double. " + << "The provided value was \"" << Pointer((strict_base + "/" + name + "/0/0").c_str()).Get(parameters)->GetString() << "\"."); + } + result.first.emplace_back(value); + } + else + { + // case 3: fill the vectors with the default value and addition points and then add new point. + // If a value without points is encountered, the additional points are used. + + // first fill with additional points at default value + for (unsigned int addition_point_i = 0; addition_point_i < addition_points.size(); ++addition_point_i) + { + result.first.emplace_back(default_value); + result.second.emplace_back(addition_points[addition_point_i][0]); + result.second.emplace_back(addition_points[addition_point_i][1]); + } + + // second, go through all the points in order + for (size_t i = 0; i < array->Size(); ++i ) + { + // now parse a single value_at_point. + const std::string base = (strict_base + "/").append(name).append("/").append(std::to_string(i)); + // Let's assume that the file is correct, because it has been checked with the json schema. + // So there are exactly two values, the first value is a double, the second an array of 2d arrays (points). + + // Get the double + double value; + Value *value_pointer = Pointer((base + "/0").c_str()).Get(parameters); + + WBAssertThrow(value_pointer != nullptr, "internal error: this should not happen."); + + try + { + value = value_pointer->GetDouble(); + } + catch (...) + { + WBAssertThrow(false, "Could not convert values of " << base << "/0 into doubles. " + << "The provided value was \"" << Pointer((base + "/0").c_str()).Get(parameters)->GetString() << "\"."); + } + + // now get the array of points. + Value *coordinates_array = Pointer((base + "/1").c_str()).Get(parameters); + if (coordinates_array != nullptr) + { + for (size_t coordinate_i = 0; coordinate_i < coordinates_array->Size(); ++coordinate_i ) + { + // Let's assume that the file is correct, because it has been checked with the json schema. + // That means that there are exactly two values per item + double coordinate_0; + double coordinate_1; + try + { + coordinate_0 = Pointer((base + "/1/" + std::to_string(coordinate_i) + "/0").c_str()).Get(parameters)->GetDouble(); + } + catch (...) + { + WBAssertThrow(false, "Could not convert values of " << base + "/1/" + std::to_string(coordinate_i) + "/0" + << " into a Point<2> array, because it could not convert the 1st sub-elements into doubles. " + << "The provided value was \"" + << Pointer((base + "/1/" + std::to_string(coordinate_i) + "/0").c_str()).Get(parameters)->GetString() + << "\"."); + } + try + { + coordinate_1 = Pointer((base + "/1/" + std::to_string(coordinate_i) + "/1").c_str()).Get(parameters)->GetDouble(); + } + catch (...) + { + WBAssertThrow(false, "Could not convert values of " << base + "/1/" + std::to_string(coordinate_i) + "/1" + << " into a Point<2> array, because it could not convert the 2nd sub-elements into doubles. " + << "The provided value was \"" + << Pointer((base + "/1/" + std::to_string(coordinate_i) + "/1").c_str()).Get(parameters)->GetString() + << "\"."); + } + bool found_same_point = false; + unsigned int coordinate_pair_i = 0; + for (; coordinate_pair_i < result.second.size(); coordinate_pair_i+=2) + { + if (Utilities::approx(result.second[coordinate_pair_i],coordinate_0) && Utilities::approx(result.second[coordinate_pair_i+1],coordinate_1)) + { + found_same_point = true; + break; + } + } + if (found_same_point) + { + // set the value to the new value + result.first[coordinate_pair_i/2] = value; + } + else + { + // add a new point + result.first.emplace_back(value); + result.second.emplace_back(coordinate_0 * (coordinate_system->natural_coordinate_system() == CoordinateSystem::spherical ? Utilities::const_pi / 180.0 : 1.)); + result.second.emplace_back(coordinate_1 * (coordinate_system->natural_coordinate_system() == CoordinateSystem::spherical ? Utilities::const_pi / 180.0 : 1.)); + } + } + + } + else + { + // no points are provided, so use the value to fill put in the additional points + // at that value. Since we know that all the additional points are at the start + // we can easily overwrite the values. + for (unsigned int addition_point_i = 0; addition_point_i < addition_points.size(); ++addition_point_i) + { + result.first[addition_point_i] = value; + } + } + } + } + } + else + { + // case 2: there one value, not an array + double value = 0; + try + { + value = Pointer((strict_base + "/" + name).c_str()).Get(parameters)->GetDouble(); + } + catch (...) + { + WBAssertThrow(false, "Could not convert values of " << strict_base << "/" << name << " into a double. " + << "The provided value was \"" << Pointer((strict_base + "/" + name).c_str()).Get(parameters)->GetString() << "\"."); + } + result.first.emplace_back(value); + } + } + else + { + // there is no user defined value. Case one: return the default value and no points + result.first.emplace_back(default_value); + } + + return result; + } + template<> std::vector > Parameters::get_vector(const std::string &name) From c860abb2737f9d611ac840ffa2b221647eddce16 Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Thu, 24 Mar 2022 13:36:32 -0700 Subject: [PATCH 10/26] Add approx function to utilities.h and add get_surface_point function to NaturalCoordinate class. --- include/world_builder/utilities.h | 18 ++++++++++++++++++ source/utilities.cc | 28 ++++++++++++++++++++++++++++ 2 files changed, 46 insertions(+) diff --git a/include/world_builder/utilities.h b/include/world_builder/utilities.h index f376049a8..51cc32b7b 100644 --- a/include/world_builder/utilities.h +++ b/include/world_builder/utilities.h @@ -39,6 +39,18 @@ namespace WorldBuilder // the safest option. constexpr double const_pi = 3.141592653589793238462643383279502884; + /** + * provide a short way to test if two doubles are equal. + * Based on https://stackoverflow.com/a/4010279. + * Removed a==b test since it triggers warnings. If used in + * performance critical parts where this could matter, a fast + * version could be added. + */ + inline bool approx(double a, double b, double error_factor=1.0) + { + return std::abs(a-b)::epsilon()* + error_factor; + } /** * Given a 2d point and a list of points which form a polygon, computes if * the point falls within the polygon. For spherical coordinates it will @@ -98,6 +110,12 @@ namespace WorldBuilder */ std::array get_surface_coordinates() const; + /** + * The coordinate that represents the 'surface' directions in the + * chosen coordinate system. + */ + Point<2> get_surface_point() const; + /** * The coordinate that represents the 'depth' direction in the chosen * coordinate system. diff --git a/source/utilities.cc b/source/utilities.cc index 7e914d80e..9557127ef 100644 --- a/source/utilities.cc +++ b/source/utilities.cc @@ -19,6 +19,7 @@ #include #include +#include #include "world_builder/nan.h" #include "world_builder/utilities.h" @@ -77,6 +78,9 @@ namespace WorldBuilder // edge from V[i] to V[i+1] if (point_list[j][1] <= point[1]) { + // first check if a point is directly on a line (within epsilon) + if (approx(point_list[i][0],point[0]) && approx(point_list[i][1],point[1])) + return true; // start y <= P.y if (point_list[i][1] >= point[1]) // an upward crossing { @@ -277,6 +281,30 @@ namespace WorldBuilder } + Point<2> NaturalCoordinate::get_surface_point() const + { + Point<2> coordinate(0,0,coordinate_system); + + switch (coordinate_system) + { + case CoordinateSystem::cartesian: + coordinate[0] = coordinates[0]; + coordinate[1] = coordinates[1]; + break; + + case CoordinateSystem::spherical: + coordinate[0] = coordinates[1]; + coordinate[1] = coordinates[2]; + break; + + default: + WBAssertThrow (false, "Coordinate system not implemented."); + } + + return coordinate; + } + + CoordinateSystem NaturalCoordinate::get_coordinate_system() const { From 5ad62aad589a2d4e7b2bc4d9fcff9fc093257d8a Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Thu, 24 Mar 2022 13:41:29 -0700 Subject: [PATCH 11/26] Add operator== for points which compares points with an epsilon. --- include/world_builder/point.h | 23 +++++++++++++++++++++++ 1 file changed, 23 insertions(+) diff --git a/include/world_builder/point.h b/include/world_builder/point.h index 9b0cf650a..fde81c7af 100644 --- a/include/world_builder/point.h +++ b/include/world_builder/point.h @@ -22,6 +22,7 @@ #define _USE_MATH_DEFINES #include #include +#include #include "world_builder/assert.h" #include "world_builder/coordinate_system.h" @@ -217,6 +218,28 @@ namespace WorldBuilder return *this; } + /** + * Check if all values are the same. + * + * Note: compares floating points with an epsilon + */ + inline + bool operator==(const Point &point_) const + { + if (coordinate_system != point_.coordinate_system) + return false; + WorldBuilder::Point point_tmp(point,coordinate_system); + point_tmp -= point_; + if (std::fabs(point_tmp[0]) > std::numeric_limits::epsilon()) + return false; + if (std::fabs(point_tmp[1]) > std::numeric_limits::epsilon()) + return false; + if (dim == 3 && std::fabs(point_tmp[2]) > std::numeric_limits::epsilon()) + return false; + + return true; + } + /** * substract two points */ From e825756588796fa77639db2cef659923318fd4ac Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Thu, 24 Mar 2022 13:43:34 -0700 Subject: [PATCH 12/26] remove unneeded line from plugin system. --- source/types/plugin_system.cc | 1 - 1 file changed, 1 deletion(-) diff --git a/source/types/plugin_system.cc b/source/types/plugin_system.cc index cfb31f17c..76acfe136 100644 --- a/source/types/plugin_system.cc +++ b/source/types/plugin_system.cc @@ -82,7 +82,6 @@ namespace WorldBuilder { Pointer((path + "/type").c_str()).Set(prm.declarations,"object"); - //std::cout << "-------use pluginsystem with name " << name << ", and pointer = " << declare_entries<< " and reqruied entires.size() = " << required_entries.size() << std::endl; WBAssert(this->declare_entries != nullptr, "No declare entries given."); this->declare_entries(prm, name, required_entries); From eeed2c1b2ebbe444f4cec334c104d04a2e2e839b Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Thu, 24 Mar 2022 13:45:40 -0700 Subject: [PATCH 13/26] Add min an max surfaces to continental plates. --- .../features/continental_plate.h | 3 + .../composition/interface.h | 4 +- .../composition/uniform.h | 7 +- .../grains/interface.h | 4 +- .../grains/random_uniform_distribution.h | 9 +- .../continental_plate_models/grains/uniform.h | 9 +- .../temperature/adiabatic.h | 6 +- .../temperature/interface.h | 4 +- .../temperature/linear.h | 6 +- .../temperature/uniform.h | 7 +- source/features/continental_plate.cc | 122 +++++++----- .../composition/uniform.cc | 39 ++-- .../grains/random_uniform_distribution.cc | 177 ++++++++++-------- .../grains/uniform.cc | 34 ++-- .../temperature/adiabatic.cc | 61 +++--- .../temperature/linear.cc | 70 ++++--- .../temperature/uniform.cc | 32 ++-- 17 files changed, 366 insertions(+), 228 deletions(-) diff --git a/include/world_builder/features/continental_plate.h b/include/world_builder/features/continental_plate.h index 1098146c4..8b672ac33 100644 --- a/include/world_builder/features/continental_plate.h +++ b/include/world_builder/features/continental_plate.h @@ -22,6 +22,7 @@ #include "world_builder/features/interface.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder @@ -145,7 +146,9 @@ namespace WorldBuilder double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; }; diff --git a/include/world_builder/features/continental_plate_models/composition/interface.h b/include/world_builder/features/continental_plate_models/composition/interface.h index 325e17ebf..7f49ab976 100644 --- a/include/world_builder/features/continental_plate_models/composition/interface.h +++ b/include/world_builder/features/continental_plate_models/composition/interface.h @@ -22,6 +22,7 @@ #include "world_builder/parameters.h" +#include "world_builder/utilities.h" namespace WorldBuilder @@ -66,7 +67,7 @@ namespace WorldBuilder * declare and read in the world builder file into the parameters class */ virtual - void parse_entries(Parameters &prm) = 0; + void parse_entries(Parameters &prm, const std::vector> &coordinates) = 0; /** @@ -74,6 +75,7 @@ namespace WorldBuilder */ virtual double get_composition(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const unsigned int composition_number, double composition, diff --git a/include/world_builder/features/continental_plate_models/composition/uniform.h b/include/world_builder/features/continental_plate_models/composition/uniform.h index 98dbc0812..b8e53065e 100644 --- a/include/world_builder/features/continental_plate_models/composition/uniform.h +++ b/include/world_builder/features/continental_plate_models/composition/uniform.h @@ -22,6 +22,7 @@ #include "world_builder/features/continental_plate_models/composition/interface.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder @@ -60,7 +61,7 @@ namespace WorldBuilder /** * declare and read in the world builder file into the parameters class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** @@ -68,6 +69,7 @@ namespace WorldBuilder * gravity and current composition. */ double get_composition(const Point<3> &position, + const Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const unsigned int composition_number, double composition, @@ -77,8 +79,11 @@ namespace WorldBuilder private: // uniform composition submodule parameters + double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; std::vector compositions; std::vector fractions; std::string operation; diff --git a/include/world_builder/features/continental_plate_models/grains/interface.h b/include/world_builder/features/continental_plate_models/grains/interface.h index c4e09c2ec..dad724a2a 100644 --- a/include/world_builder/features/continental_plate_models/grains/interface.h +++ b/include/world_builder/features/continental_plate_models/grains/interface.h @@ -23,6 +23,7 @@ #include "world_builder/grains.h" #include "world_builder/parameters.h" +#include "world_builder/utilities.h" namespace WorldBuilder @@ -70,7 +71,7 @@ namespace WorldBuilder * declare and read in the world builder file into the parameters class */ virtual - void parse_entries(Parameters &prm) = 0; + void parse_entries(Parameters &prm, const std::vector> &coordinates) = 0; /** @@ -79,6 +80,7 @@ namespace WorldBuilder virtual WorldBuilder::grains get_grains(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const unsigned int composition_number, WorldBuilder::grains grains, diff --git a/include/world_builder/features/continental_plate_models/grains/random_uniform_distribution.h b/include/world_builder/features/continental_plate_models/grains/random_uniform_distribution.h index 8b7242da2..c1869eef1 100644 --- a/include/world_builder/features/continental_plate_models/grains/random_uniform_distribution.h +++ b/include/world_builder/features/continental_plate_models/grains/random_uniform_distribution.h @@ -22,6 +22,7 @@ #include "world_builder/features/continental_plate_models/grains/interface.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder { @@ -79,14 +80,16 @@ namespace WorldBuilder * declare and read in the world builder file into the parameters * class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** * Returns a grains based on the given position, composition (e.g. * olivine and/or enstatite)depth in the model, gravity and current grains. */ WorldBuilder::grains - get_grains(const Point<3> &position, const double depth, + get_grains(const Point<3> &position, + const Utilities::NaturalCoordinate &position_in_natural_coordinates, + const double depth, const unsigned int composition_number, WorldBuilder::grains grains, const double feature_min_depth, @@ -95,7 +98,9 @@ namespace WorldBuilder private: // uniform grains submodule parameters double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; std::vector grains; std::vector compositions; std::string operation; diff --git a/include/world_builder/features/continental_plate_models/grains/uniform.h b/include/world_builder/features/continental_plate_models/grains/uniform.h index eb069bdda..e3c8035b4 100644 --- a/include/world_builder/features/continental_plate_models/grains/uniform.h +++ b/include/world_builder/features/continental_plate_models/grains/uniform.h @@ -22,6 +22,7 @@ #include "world_builder/features/continental_plate_models/grains/interface.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder { @@ -77,14 +78,16 @@ namespace WorldBuilder * declare and read in the world builder file into the parameters * class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** * Returns a grains based on the given position, composition (e.g. * olivine and/or enstatite)depth in the model, gravity and current grains. */ WorldBuilder::grains - get_grains(const Point<3> &position, const double depth, + get_grains(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, + const double depth, const unsigned int composition_number, WorldBuilder::grains grains, const double feature_min_depth, @@ -93,7 +96,9 @@ namespace WorldBuilder private: // uniform grains submodule parameters double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; std::vector grains; std::vector compositions; std::string operation; diff --git a/include/world_builder/features/continental_plate_models/temperature/adiabatic.h b/include/world_builder/features/continental_plate_models/temperature/adiabatic.h index 86beba5ee..49c5e4d82 100644 --- a/include/world_builder/features/continental_plate_models/temperature/adiabatic.h +++ b/include/world_builder/features/continental_plate_models/temperature/adiabatic.h @@ -23,6 +23,7 @@ #include "world_builder/features/continental_plate_models/temperature/interface.h" #include "world_builder/features/utilities.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder @@ -62,7 +63,7 @@ namespace WorldBuilder /** * declare and read in the world builder file into the parameters class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** @@ -70,6 +71,7 @@ namespace WorldBuilder * gravity and current temperature. */ double get_temperature(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity, double temperature, @@ -80,7 +82,9 @@ namespace WorldBuilder private: // adiabatic temperature submodule parameters double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; /** * Todo */ diff --git a/include/world_builder/features/continental_plate_models/temperature/interface.h b/include/world_builder/features/continental_plate_models/temperature/interface.h index 45eeb66ad..65815a6f2 100644 --- a/include/world_builder/features/continental_plate_models/temperature/interface.h +++ b/include/world_builder/features/continental_plate_models/temperature/interface.h @@ -22,6 +22,7 @@ #include "world_builder/parameters.h" +#include "world_builder/utilities.h" namespace WorldBuilder @@ -69,7 +70,7 @@ namespace WorldBuilder * declare and read in the world builder file into the parameters class */ virtual - void parse_entries(Parameters &prm) = 0; + void parse_entries(Parameters &prm, const std::vector> &coordinates) = 0; /** @@ -77,6 +78,7 @@ namespace WorldBuilder */ virtual double get_temperature(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity, double temperature, diff --git a/include/world_builder/features/continental_plate_models/temperature/linear.h b/include/world_builder/features/continental_plate_models/temperature/linear.h index 84daf17cb..bdb8a444c 100644 --- a/include/world_builder/features/continental_plate_models/temperature/linear.h +++ b/include/world_builder/features/continental_plate_models/temperature/linear.h @@ -23,6 +23,7 @@ #include "world_builder/features/continental_plate_models/temperature/interface.h" #include "world_builder/features/utilities.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder @@ -62,7 +63,7 @@ namespace WorldBuilder /** * declare and read in the world builder file into the parameters class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** @@ -70,6 +71,7 @@ namespace WorldBuilder * gravity and current temperature. */ double get_temperature(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity, double temperature, @@ -80,7 +82,9 @@ namespace WorldBuilder private: // linear temperature submodule parameters double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; double top_temperature; double bottom_temperature; Utilities::Operations operation; diff --git a/include/world_builder/features/continental_plate_models/temperature/uniform.h b/include/world_builder/features/continental_plate_models/temperature/uniform.h index b6abe5931..7c899bf3a 100644 --- a/include/world_builder/features/continental_plate_models/temperature/uniform.h +++ b/include/world_builder/features/continental_plate_models/temperature/uniform.h @@ -23,6 +23,8 @@ #include "world_builder/features/continental_plate_models/temperature/interface.h" #include "world_builder/features/utilities.h" +#include "world_builder/objects/surface.h" +#include "world_builder/utilities.h" namespace WorldBuilder @@ -62,7 +64,7 @@ namespace WorldBuilder /** * declare and read in the world builder file into the parameters class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** @@ -70,6 +72,7 @@ namespace WorldBuilder * gravity and current temperature. */ double get_temperature(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity, double temperature, @@ -80,7 +83,9 @@ namespace WorldBuilder private: // uniform temperature submodule parameters double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; double temperature; Utilities::Operations operation; diff --git a/source/features/continental_plate.cc b/source/features/continental_plate.cc index aa8450164..3e6cf637c 100644 --- a/source/features/continental_plate.cc +++ b/source/features/continental_plate.cc @@ -26,9 +26,16 @@ #include "world_builder/nan.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/array.h" +#include "world_builder/types/one_of.h" +#include "world_builder/types/value_at_points.h" #include "world_builder/types/plugin_system.h" #include "world_builder/world.h" +#include "world_builder/kd_tree.h" + +#include + namespace WorldBuilder { @@ -56,9 +63,9 @@ namespace WorldBuilder { prm.declare_entry("", Types::Object(required_entries), "continental plate object"); - prm.declare_entry("min depth", Types::Double(0), - "The depth to which this feature is present"); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), + "The depth from which this feature is present"); + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth to which this feature is present"); prm.declare_entry("temperature models", Types::PluginSystem("", Features::ContinentalPlateModels::Temperature::Interface::declare_entries, {"model"}), @@ -79,8 +86,11 @@ namespace WorldBuilder this->name = prm.get("name"); this->get_coordinates("coordinates", prm, coordinate_system); - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; prm.get_unique_pointers("temperature models", temperature_models); @@ -91,7 +101,7 @@ namespace WorldBuilder { prm.enter_subsection(std::to_string(i)); { - temperature_models[i]->parse_entries(prm); + temperature_models[i]->parse_entries(prm,coordinates); } prm.leave_subsection(); } @@ -107,7 +117,7 @@ namespace WorldBuilder { prm.enter_subsection(std::to_string(i)); { - composition_models[i]->parse_entries(prm); + composition_models[i]->parse_entries(prm, coordinates); } prm.leave_subsection(); } @@ -123,7 +133,7 @@ namespace WorldBuilder { prm.enter_subsection(std::to_string(i)); { - grains_models[i]->parse_entries(prm); + grains_models[i]->parse_entries(prm,coordinates); } prm.leave_subsection(); } @@ -144,20 +154,26 @@ namespace WorldBuilder Utilities::polygon_contains_point(coordinates, Point<2>(position_in_natural_coordinates.get_surface_coordinates(), world->parameters.coordinate_system->natural_coordinate_system()))) { - for (const auto &temperature_model: temperature_models) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - temperature = temperature_model->get_temperature(position_in_cartesian_coordinates, - depth, - gravity_norm, - temperature, - min_depth, - max_depth); - - WBAssert(!std::isnan(temperature), "Temparture is not a number: " << temperature - << ", based on a temperature model with the name " << temperature_model->get_name()); - WBAssert(std::isfinite(temperature), "Temparture is not a finite: " << temperature - << ", based on a temperature model with the name " << temperature_model->get_name()); - + for (const auto &temperature_model: temperature_models) + { + temperature = temperature_model->get_temperature(position_in_cartesian_coordinates, + position_in_natural_coordinates, + depth, + gravity_norm, + temperature, + min_depth_local, + max_depth_local); + + WBAssert(!std::isnan(temperature), "Temparture is not a number: " << temperature + << ", based on a temperature model with the name " << temperature_model->get_name()); + WBAssert(std::isfinite(temperature), "Temparture is not a finite: " << temperature + << ", based on a temperature model with the name " << temperature_model->get_name()); + + } } } @@ -176,20 +192,26 @@ namespace WorldBuilder Utilities::polygon_contains_point(coordinates, Point<2>(position_in_natural_coordinates.get_surface_coordinates(), world->parameters.coordinate_system->natural_coordinate_system()))) { - for (const auto &composition_model: composition_models) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - composition = composition_model->get_composition(position_in_cartesian_coordinates, - depth, - composition_number, - composition, - min_depth, - max_depth); - - WBAssert(!std::isnan(composition), "Composition is not a number: " << composition - << ", based on a temperature model with the name " << composition_model->get_name()); - WBAssert(std::isfinite(composition), "Composition is not a finite: " << composition - << ", based on a temperature model with the name " << composition_model->get_name()); - + for (const auto &composition_model: composition_models) + { + composition = composition_model->get_composition(position_in_cartesian_coordinates, + position_in_natural_coordinates, + depth, + composition_number, + composition, + min_depth_local, + max_depth_local); + + WBAssert(!std::isnan(composition), "Composition is not a number: " << composition + << ", based on a temperature model with the name " << composition_model->get_name()); + WBAssert(std::isfinite(composition), "Composition is not a finite: " << composition + << ", based on a temperature model with the name " << composition_model->get_name()); + + } } } @@ -208,20 +230,26 @@ namespace WorldBuilder Utilities::polygon_contains_point(coordinates, Point<2>(position_in_natural_coordinates.get_surface_coordinates(), world->parameters.coordinate_system->natural_coordinate_system()))) { - for (const auto &grains_model: grains_models) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - grains = grains_model->get_grains(position_in_cartesian_coordinates, - depth, - composition_number, - grains, - min_depth, - max_depth); - - /*WBAssert(!std::isnan(composition), "Composition is not a number: " << composition - << ", based on a temperature model with the name " << composition_model->get_name()); - WBAssert(std::isfinite(composition), "Composition is not a finite: " << composition - << ", based on a temperature model with the name " << composition_model->get_name());*/ - + for (const auto &grains_model: grains_models) + { + grains = grains_model->get_grains(position_in_cartesian_coordinates, + position_in_natural_coordinates, + depth, + composition_number, + grains, + min_depth_local, + max_depth_local); + + /*WBAssert(!std::isnan(composition), "Composition is not a number: " << composition + << ", based on a temperature model with the name " << composition_model->get_name()); + WBAssert(std::isfinite(composition), "Composition is not a finite: " << composition + << ", based on a temperature model with the name " << composition_model->get_name());*/ + + } } } diff --git a/source/features/continental_plate_models/composition/uniform.cc b/source/features/continental_plate_models/composition/uniform.cc index 92d85c955..efaf5d10a 100644 --- a/source/features/continental_plate_models/composition/uniform.cc +++ b/source/features/continental_plate_models/composition/uniform.cc @@ -24,9 +24,13 @@ #include "world_builder/types/array.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" +#include "world_builder/types/value_at_points.h" #include "world_builder/types/unsigned_int.h" #include "world_builder/utilities.h" +#include "world_builder/kd_tree.h" + namespace WorldBuilder { @@ -61,14 +65,18 @@ namespace WorldBuilder "Uniform compositional model. Sets constant compositional field."); // Declare entries of this plugin - prm.declare_entry("min depth", Types::Double(0), + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), "The depth in meters from which the composition of this feature is present."); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), + + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth in meters to which the composition of this feature is present."); + prm.declare_entry("compositions", Types::Array(Types::UnsignedInt(),0), "A list with the labels of the composition which are present there."); + prm.declare_entry("fractions", Types::Array(Types::Double(1.0),1), "TA list of compositional fractions corresponding to the compositions list."); + prm.declare_entry("operation", Types::String("replace",std::vector {"replace"}), "Whether the value should replace any value previously defined at this location (replace) or " "add the value to the previously define value (add, not implemented). Replacing implies that all values not " @@ -77,10 +85,13 @@ namespace WorldBuilder } void - Uniform::parse_entries(Parameters &prm) + Uniform::parse_entries(Parameters &prm, const std::vector> &coordinates) { - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; + compositions = prm.get_vector("compositions"); fractions = prm.get_vector("fractions"); operation = prm.get("operation"); @@ -92,6 +103,7 @@ namespace WorldBuilder double Uniform::get_composition(const Point<3> & /*position_in_cartesian_coordinates*/, + const NaturalCoordinate &position_in_natural_coordinates, const double depth, const unsigned int composition_number, double composition_, @@ -101,16 +113,21 @@ namespace WorldBuilder double composition = composition_; if (depth <= max_depth && depth >= min_depth) { - for (unsigned int i =0; i < compositions.size(); ++i) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - if (compositions[i] == composition_number) + for (unsigned int i =0; i < compositions.size(); ++i) { - return fractions[i]; + if (compositions[i] == composition_number) + { + return fractions[i]; + } } - } - if (operation == "replace") - return 0.0; + if (operation == "replace") + return 0.0; + } } return composition; } diff --git a/source/features/continental_plate_models/grains/random_uniform_distribution.cc b/source/features/continental_plate_models/grains/random_uniform_distribution.cc index 2090cbc32..e0c2c6b0a 100644 --- a/source/features/continental_plate_models/grains/random_uniform_distribution.cc +++ b/source/features/continental_plate_models/grains/random_uniform_distribution.cc @@ -26,10 +26,13 @@ #include "world_builder/types/bool.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" #include "world_builder/types/unsigned_int.h" +#include "world_builder/types/value_at_points.h" #include "world_builder/utilities.h" #include "world_builder/world.h" +#include "world_builder/kd_tree.h" namespace WorldBuilder { @@ -64,9 +67,9 @@ namespace WorldBuilder "to a single value or to a random distribution."); // Declare entries of this plugin - prm.declare_entry("min depth", Types::Double(0), + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), "The depth in meters from which the composition of this feature is present."); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth in meters to which the composition of this feature is present."); prm.declare_entry("compositions", Types::Array(Types::UnsignedInt(),0), @@ -90,10 +93,12 @@ namespace WorldBuilder } void - RandomUniformDistribution::parse_entries(Parameters &prm) + RandomUniformDistribution::parse_entries(Parameters &prm, const std::vector> &coordinates) { - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; compositions = prm.get_vector("compositions"); operation = prm.get("orientation operation"); @@ -112,6 +117,7 @@ namespace WorldBuilder WorldBuilder::grains RandomUniformDistribution::get_grains(const Point<3> & /*position_in_cartesian_coordinates*/, + const NaturalCoordinate &position_in_natural_coordinates, const double depth, const unsigned int composition_number, WorldBuilder::grains grains_, @@ -121,88 +127,93 @@ namespace WorldBuilder WorldBuilder::grains grains_local = grains_; if (depth <= max_depth && depth >= min_depth) { - for (unsigned int i =0; i < compositions.size(); ++i) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - if (compositions[i] == composition_number) + for (unsigned int i =0; i < compositions.size(); ++i) { - std::uniform_real_distribution<> dist(0.0,1.0); - for (auto &&it_rotation_matrices : grains_local.rotation_matrices) + if (compositions[i] == composition_number) { - // set a uniform random a_cosine_matrix per grain - // This function is based on an article in Graphic Gems III, written by James Arvo, Cornell University (p 116-120). - // The original code can be found on http://www.realtimerendering.com/resources/GraphicsGems/gemsiii/rand_rotation.c - // and is licenend accourding to this website with the following licence: - // - // "The Graphics Gems code is copyright-protected. In other words, you cannot claim the text of the code as your own and - // resell it. Using the code is permitted in any program, product, or library, non-commercial or commercial. Giving credit - // is not required, though is a nice gesture. The code comes as-is, and if there are any flaws or problems with any Gems - // code, nobody involved with Gems - authors, editors, publishers, or webmasters - are to be held responsible. Basically, - // don't be a jerk, and remember that anything free comes with no guarantee."" - // - // The book saids in the preface the following: "As in the first two volumes, all of the C and C++ code in this book is in - // the public domain, and is yours to study, modify, and use." - - // first generate three random numbers between 0 and 1 and multiply them with 2 PI or 2 for z. Note that these are not the same as phi_1, theta and phi_2. - double one = dist(world->get_random_number_engine()); - double two = dist(world->get_random_number_engine()); - double three = dist(world->get_random_number_engine()); - - double theta = 2.0 * const_pi * one; // Rotation about the pole (Z) - double phi = 2.0 * const_pi * two; // For direction of pole deflection. - double z = 2.0* three; //For magnitude of pole deflection. - - // Compute a vector V used for distributing points over the sphere - // via the reflection I - V Transpose(V). This formulation of V - // will guarantee that if x[1] and x[2] are uniformly distributed, - // the reflected points will be uniform on the sphere. Note that V - // has length sqrt(2) to eliminate the 2 in the Householder matrix. - - double r = std::sqrt( z ); - double Vx = std::sin( phi ) * r; - double Vy = std::cos( phi ) * r; - double Vz = std::sqrt( 2.F - z ); - - // Compute the row vector S = Transpose(V) * R, where R is a simple - // rotation by theta about the z-axis. No need to compute Sz since - // it's just Vz. - - double st = std::sin( theta ); - double ct = std::cos( theta ); - double Sx = Vx * ct - Vy * st; - double Sy = Vx * st + Vy * ct; - - // Construct the rotation matrix ( V Transpose(V) - I ) R, which - // is equivalent to V S - R. - - it_rotation_matrices[0][0] = Vx * Sx - ct; - it_rotation_matrices[0][1] = Vx * Sy - st; - it_rotation_matrices[0][2] = Vx * Vz; - - it_rotation_matrices[1][0] = Vy * Sx + st; - it_rotation_matrices[1][1] = Vy * Sy - ct; - it_rotation_matrices[1][2] = Vy * Vz; - - it_rotation_matrices[2][0] = Vz * Sx; - it_rotation_matrices[2][1] = Vz * Sy; - it_rotation_matrices[2][2] = 1.0 - z; // This equals Vz * Vz - 1.0 + std::uniform_real_distribution<> dist(0.0,1.0); + for (auto &&it_rotation_matrices : grains_local.rotation_matrices) + { + // set a uniform random a_cosine_matrix per grain + // This function is based on an article in Graphic Gems III, written by James Arvo, Cornell University (p 116-120). + // The original code can be found on http://www.realtimerendering.com/resources/GraphicsGems/gemsiii/rand_rotation.c + // and is licenend accourding to this website with the following licence: + // + // "The Graphics Gems code is copyright-protected. In other words, you cannot claim the text of the code as your own and + // resell it. Using the code is permitted in any program, product, or library, non-commercial or commercial. Giving credit + // is not required, though is a nice gesture. The code comes as-is, and if there are any flaws or problems with any Gems + // code, nobody involved with Gems - authors, editors, publishers, or webmasters - are to be held responsible. Basically, + // don't be a jerk, and remember that anything free comes with no guarantee."" + // + // The book saids in the preface the following: "As in the first two volumes, all of the C and C++ code in this book is in + // the public domain, and is yours to study, modify, and use." + + // first generate three random numbers between 0 and 1 and multiply them with 2 PI or 2 for z. Note that these are not the same as phi_1, theta and phi_2. + double one = dist(world->get_random_number_engine()); + double two = dist(world->get_random_number_engine()); + double three = dist(world->get_random_number_engine()); + + double theta = 2.0 * const_pi * one; // Rotation about the pole (Z) + double phi = 2.0 * const_pi * two; // For direction of pole deflection. + double z = 2.0* three; //For magnitude of pole deflection. + + // Compute a vector V used for distributing points over the sphere + // via the reflection I - V Transpose(V). This formulation of V + // will guarantee that if x[1] and x[2] are uniformly distributed, + // the reflected points will be uniform on the sphere. Note that V + // has length sqrt(2) to eliminate the 2 in the Householder matrix. + + double r = std::sqrt( z ); + double Vx = std::sin( phi ) * r; + double Vy = std::cos( phi ) * r; + double Vz = std::sqrt( 2.F - z ); + + // Compute the row vector S = Transpose(V) * R, where R is a simple + // rotation by theta about the z-axis. No need to compute Sz since + // it's just Vz. + + double st = std::sin( theta ); + double ct = std::cos( theta ); + double Sx = Vx * ct - Vy * st; + double Sy = Vx * st + Vy * ct; + + // Construct the rotation matrix ( V Transpose(V) - I ) R, which + // is equivalent to V S - R. + + it_rotation_matrices[0][0] = Vx * Sx - ct; + it_rotation_matrices[0][1] = Vx * Sy - st; + it_rotation_matrices[0][2] = Vx * Vz; + + it_rotation_matrices[1][0] = Vy * Sx + st; + it_rotation_matrices[1][1] = Vy * Sy - ct; + it_rotation_matrices[1][2] = Vy * Vz; + + it_rotation_matrices[2][0] = Vz * Sx; + it_rotation_matrices[2][1] = Vz * Sy; + it_rotation_matrices[2][2] = 1.0 - z; // This equals Vz * Vz - 1.0 + } + + double total_size = 0; + for (auto &&it_sizes : grains_local.sizes) + { + it_sizes = grain_sizes[i] < 0 ? dist(world->get_random_number_engine()) : grain_sizes[i]; + total_size += it_sizes; + } + + if (normalize_grain_sizes[i]) + { + const double one_over_total_size = 1/total_size; + std::transform(grains_local.sizes.begin(), grains_local.sizes.end(), grains_local.sizes.begin(), + [one_over_total_size](double sizes) -> double { return sizes *one_over_total_size; }); + } + + + return grains_local; } - - double total_size = 0; - for (auto &&it_sizes : grains_local.sizes) - { - it_sizes = grain_sizes[i] < 0 ? dist(world->get_random_number_engine()) : grain_sizes[i]; - total_size += it_sizes; - } - - if (normalize_grain_sizes[i]) - { - const double one_over_total_size = 1/total_size; - std::transform(grains_local.sizes.begin(), grains_local.sizes.end(), grains_local.sizes.begin(), - [one_over_total_size](double sizes) -> double { return sizes *one_over_total_size; }); - } - - - return grains_local; } } } diff --git a/source/features/continental_plate_models/grains/uniform.cc b/source/features/continental_plate_models/grains/uniform.cc index d8cac9ac6..e3ecffe09 100644 --- a/source/features/continental_plate_models/grains/uniform.cc +++ b/source/features/continental_plate_models/grains/uniform.cc @@ -24,9 +24,12 @@ #include "world_builder/types/array.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" #include "world_builder/types/unsigned_int.h" +#include "world_builder/types/value_at_points.h" #include "world_builder/utilities.h" +#include "world_builder/kd_tree.h" namespace WorldBuilder { @@ -61,9 +64,10 @@ namespace WorldBuilder "Uniform grains model. All grains start exactly the same."); // Declare entries of this plugin - prm.declare_entry("min depth", Types::Double(0), + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), "The depth in meters from which the composition of this feature is present."); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), + + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth in meters to which the composition of this feature is present."); prm.declare_entry("compositions", Types::Array(Types::UnsignedInt(),0), @@ -88,10 +92,12 @@ namespace WorldBuilder } void - Uniform::parse_entries(Parameters &prm) + Uniform::parse_entries(Parameters &prm, const std::vector> &coordinates) { - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; compositions = prm.get_vector("compositions"); const bool set_euler_angles = prm.check_entry("Euler angles z-x-z"); @@ -134,6 +140,7 @@ namespace WorldBuilder WorldBuilder::grains Uniform::get_grains(const Point<3> & /*position_in_cartesian_coordinates*/, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const unsigned int composition_number, WorldBuilder::grains grains_, @@ -143,16 +150,21 @@ namespace WorldBuilder WorldBuilder::grains grains_local = grains_; if (depth <= max_depth && depth >= min_depth) { - for (unsigned int i =0; i < compositions.size(); ++i) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - if (compositions[i] == composition_number) + for (unsigned int i =0; i < compositions.size(); ++i) { - std::fill(grains_local.rotation_matrices.begin(),grains_local.rotation_matrices.end(),rotation_matrices[i]); + if (compositions[i] == composition_number) + { + std::fill(grains_local.rotation_matrices.begin(),grains_local.rotation_matrices.end(),rotation_matrices[i]); - const double size = grain_sizes[i] < 0 ? 1.0/static_cast(grains_local.sizes.size()) : grain_sizes[i]; - std::fill(grains_local.sizes.begin(),grains_local.sizes.end(),size); + const double size = grain_sizes[i] < 0 ? 1.0/static_cast(grains_local.sizes.size()) : grain_sizes[i]; + std::fill(grains_local.sizes.begin(),grains_local.sizes.end(),size); - return grains_local; + return grains_local; + } } } } diff --git a/source/features/continental_plate_models/temperature/adiabatic.cc b/source/features/continental_plate_models/temperature/adiabatic.cc index 7c66b261e..5720f1b52 100644 --- a/source/features/continental_plate_models/temperature/adiabatic.cc +++ b/source/features/continental_plate_models/temperature/adiabatic.cc @@ -21,11 +21,15 @@ #include "world_builder/nan.h" +#include "world_builder/types/array.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" +#include "world_builder/types/value_at_points.h" #include "world_builder/utilities.h" #include "world_builder/world.h" +#include "world_builder/kd_tree.h" namespace WorldBuilder { @@ -61,11 +65,11 @@ namespace WorldBuilder "Adiabatic temperature model. Uses global values by default."); // Declare entries of this plugin - prm.declare_entry("min depth", Types::Double(0), - "The depth in meters from which the temperature of this feature is present."); + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), + "The depth in meters from which the composition of this feature is present."); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), - "The depth in meters to which the temperature of this feature is present."); + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), + "The depth in meters to which the composition of this feature is present."); prm.declare_entry("potential mantle temperature", Types::Double(-1), "The potential temperature of the mantle at the surface in Kelvin. " @@ -82,11 +86,13 @@ namespace WorldBuilder } void - Adiabatic::parse_entries(Parameters &prm) + Adiabatic::parse_entries(Parameters &prm, const std::vector> &coordinates) { - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; operation = Utilities::string_operations_to_enum(prm.get("operation")); potential_mantle_temperature = prm.get("potential mantle temperature"); @@ -123,6 +129,7 @@ namespace WorldBuilder double Adiabatic::get_temperature(const Point<3> & /*position_in_cartesian_coordinates*/, + const NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity_norm, double temperature_, @@ -132,25 +139,29 @@ namespace WorldBuilder if (depth <= max_depth && depth >= min_depth) { - const double adabatic_temperature = potential_mantle_temperature * - std::exp(((thermal_expansion_coefficient * gravity_norm) / - specific_heat) * depth); - - - WBAssert(!std::isnan(adabatic_temperature), - "adabatic_temperature is not a number: " << adabatic_temperature << ". " - <<"Parameters: potential_mantle_temperature = " << potential_mantle_temperature - <<", thermal_expansion_coefficient = " << thermal_expansion_coefficient - << ", gravity_norm = " << gravity_norm - << ", specific_heat = " << specific_heat - << ", depth = " << depth); - - WBAssert(std::isfinite(adabatic_temperature), - "adabatic_temperature is not a finite: " << adabatic_temperature << '.'); - - return Utilities::apply_operation(operation,temperature_,adabatic_temperature); + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) + { + const double adabatic_temperature = potential_mantle_temperature * + std::exp(((thermal_expansion_coefficient * gravity_norm) / + specific_heat) * depth); + + + WBAssert(!std::isnan(adabatic_temperature), + "adabatic_temperature is not a number: " << adabatic_temperature << ". " + <<"Parameters: potential_mantle_temperature = " << potential_mantle_temperature + <<", thermal_expansion_coefficient = " << thermal_expansion_coefficient + << ", gravity_norm = " << gravity_norm + << ", specific_heat = " << specific_heat + << ", depth = " << depth); + + WBAssert(std::isfinite(adabatic_temperature), + "adabatic_temperature is not a finite: " << adabatic_temperature << '.'); + + return Utilities::apply_operation(operation,temperature_,adabatic_temperature); + } } - return temperature_; } diff --git a/source/features/continental_plate_models/temperature/linear.cc b/source/features/continental_plate_models/temperature/linear.cc index 01b66fb65..1168b0543 100644 --- a/source/features/continental_plate_models/temperature/linear.cc +++ b/source/features/continental_plate_models/temperature/linear.cc @@ -21,11 +21,15 @@ #include "world_builder/nan.h" +#include "world_builder/types/array.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" +#include "world_builder/types/value_at_points.h" #include "world_builder/utilities.h" #include "world_builder/world.h" +#include "world_builder/kd_tree.h" namespace WorldBuilder { @@ -61,11 +65,11 @@ namespace WorldBuilder "Linear temperature model. Can be set to use an adiabatic temperature at the boundaries."); // Declare entries of this plugin - prm.declare_entry("min depth", Types::Double(0), - "The depth in meters from which the temperature of this feature is present."); + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), + "The depth in meters from which the composition of this feature is present."); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), - "The depth in meters to which the temperature of this feature is present."); + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), + "The depth in meters to which the composition of this feature is present."); prm.declare_entry("top temperature", Types::Double(293.15), "The temperature at the top in degree Kelvin of this feature." @@ -78,10 +82,12 @@ namespace WorldBuilder } void - Linear::parse_entries(Parameters &prm) + Linear::parse_entries(Parameters &prm, const std::vector> &coordinates) { - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; WBAssert(max_depth >= min_depth, "max depth needs to be larger or equal to min depth."); operation = Utilities::string_operations_to_enum(prm.get("operation")); top_temperature = prm.get("top temperature"); @@ -91,6 +97,7 @@ namespace WorldBuilder double Linear::get_temperature(const Point<3> & /*position_in_cartesian_coordinates*/, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity_norm, double temperature_, @@ -99,30 +106,35 @@ namespace WorldBuilder { if (depth <= max_depth && depth >= min_depth) { - const double min_depth_local = std::max(feature_min_depth, min_depth); - const double max_depth_local = std::min(feature_max_depth, max_depth); - - double top_temperature_local = top_temperature; - if (top_temperature_local < 0) - { - top_temperature_local = this->world->potential_mantle_temperature * - std::exp(((this->world->thermal_expansion_coefficient * gravity_norm) / - this->world->specific_heat) * min_depth_local); - } - - double bottom_temperature_local = bottom_temperature; - if (bottom_temperature_local < 0) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - bottom_temperature_local = this->world->potential_mantle_temperature * - std::exp(((this->world->thermal_expansion_coefficient * gravity_norm) / - this->world->specific_heat) * max_depth_local); + const double min_depth_local_local = std::max(feature_min_depth, min_depth_local); + const double max_depth_local_local = std::min(feature_max_depth, max_depth_local); + + double top_temperature_local = top_temperature; + if (top_temperature_local < 0) + { + top_temperature_local = this->world->potential_mantle_temperature * + std::exp(((this->world->thermal_expansion_coefficient * gravity_norm) / + this->world->specific_heat) * min_depth_local_local); + } + + double bottom_temperature_local = bottom_temperature; + if (bottom_temperature_local < 0) + { + bottom_temperature_local = this->world->potential_mantle_temperature * + std::exp(((this->world->thermal_expansion_coefficient * gravity_norm) / + this->world->specific_heat) * max_depth_local_local); + } + + const double new_temperature = top_temperature_local + + (depth - min_depth_local) * + ((bottom_temperature_local - top_temperature_local) / (max_depth_local_local - min_depth_local_local)); + + return Utilities::apply_operation(operation,temperature_,new_temperature); } - - const double new_temperature = top_temperature_local + - (depth - min_depth_local) * - ((bottom_temperature_local - top_temperature_local) / (max_depth_local - min_depth_local)); - - return Utilities::apply_operation(operation,temperature_,new_temperature); } diff --git a/source/features/continental_plate_models/temperature/uniform.cc b/source/features/continental_plate_models/temperature/uniform.cc index dce9da58f..41445ed49 100644 --- a/source/features/continental_plate_models/temperature/uniform.cc +++ b/source/features/continental_plate_models/temperature/uniform.cc @@ -21,10 +21,14 @@ #include "world_builder/nan.h" +#include "world_builder/types/array.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" +#include "world_builder/types/value_at_points.h" #include "world_builder/utilities.h" +#include "world_builder/kd_tree.h" namespace WorldBuilder { @@ -60,11 +64,11 @@ namespace WorldBuilder "Uniform temperature model. Set the temperature to a constan value."); // Declare entries of this plugin - prm.declare_entry("min depth", Types::Double(0), - "The depth in meters from which the temperature of this feature is present."); + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), + "The depth in meters from which the composition of this feature is present."); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), - "The depth in meters to which the temperature of this feature is present."); + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), + "The depth in meters to which the composition of this feature is present."); prm.declare_entry("temperature", Types::Double(293.15), "The temperature in degree Kelvin which this feature should have"); @@ -72,11 +76,13 @@ namespace WorldBuilder } void - Uniform::parse_entries(Parameters &prm) + Uniform::parse_entries(Parameters &prm, const std::vector> &coordinates) { - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; operation = Utilities::string_operations_to_enum(prm.get("operation")); temperature = prm.get("temperature"); } @@ -84,18 +90,22 @@ namespace WorldBuilder double Uniform::get_temperature(const Point<3> & /*position_in_cartesian_coordinates*/, + const NaturalCoordinate &position_in_natural_coordinates, const double depth, const double /*gravity*/, double temperature_, const double /*feature_min_depth*/, const double /*feature_max_depth*/) const { - - if (depth <= max_depth && depth >= min_depth) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - return Utilities::apply_operation(operation,temperature_,temperature); + if (depth <= max_depth && depth >= min_depth) + { + return Utilities::apply_operation(operation,temperature_,temperature); + } } - return temperature_; } From ca41a2161f34fbc116938870e095ee08d0a4a1e0 Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Thu, 24 Mar 2022 13:50:36 -0700 Subject: [PATCH 14/26] update markdown declarations. --- tests/app/world_buider_declarations_closed.md | 13862 +++++++++------- tests/app/world_buider_declarations_open.md | 13648 ++++++++------- 2 files changed, 14763 insertions(+), 12747 deletions(-) diff --git a/tests/app/world_buider_declarations_closed.md b/tests/app/world_buider_declarations_closed.md index b3b9f1e1c..80474afe0 100644 --- a/tests/app/world_buider_declarations_closed.md +++ b/tests/app/world_buider_declarations_closed.md @@ -1,1285 +1,1330 @@ -::::::::::::::::::::{dropdown} / +:::::::::::::::::::::::::{dropdown} / :open: -:name: closed__ +:name: closed_ -- **type**: object -- **documentation**: Root object -- **additionalProperties**: false -- **required**: [version, features] +- **type**:object +- **documentation**:Root object +- **additionalProperties**:false +- **required**:[version, features] -:::::::::::::::::::{dropdown} /version -:name: closed__version +::::::::::::::::::::::::{dropdown} /version +:name: closed_version -- **default value**: -- **type**: string -- **documentation**: The major and minor version number for which the input file was written. -::::::::::::::::::: - -:::::::::::::::::::{dropdown} /cross section -:name: closed__cross section - -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **uniqueItems**: false -- **documentation**: This is an array of two points along where the cross section is taken -::::::::::::::::::{dropdown} /cross section/items -:name: closed__cross section_items - -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -:::::::::::::::::{dropdown} /cross section/items/items -:name: closed__cross section_items_items - -- **type**: number -::::::::::::::::: - -:::::::::::::::::: - -::::::::::::::::::: - -:::::::::::::::::::{dropdown} /potential mantle temperature -:name: closed__potential mantle temperature +- **default value**: +- **type**:string +- **documentation**:The major and minor version number for which the input file was written. +:::::::::::::::::::::::: -- **default value**: 1600.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. -::::::::::::::::::: +::::::::::::::::::::::::{dropdown} /cross section +:name: closed_cross-section -:::::::::::::::::::{dropdown} /surface temperature -:name: closed__surface temperature +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **uniqueItems**:false +- **documentation**:This is an array of two points along where the cross section is taken +:::::::::::::::::::::::{dropdown} /cross section/items +:name: closed_cross-section_items -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the surface in Kelvin. -::::::::::::::::::: +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +::::::::::::::::::::::{dropdown} /cross section/items/items +:name: closed_cross-section_items_items -:::::::::::::::::::{dropdown} /force surface temperature -:name: closed__force surface temperature +- **type**:number +:::::::::::::::::::::: -- **default value**: false -- **type**: boolean -- **documentation**: Force the provided surface temperature to be set at the surface -::::::::::::::::::: +::::::::::::::::::::::: -:::::::::::::::::::{dropdown} /thermal expansion coefficient -:name: closed__thermal expansion coefficient +:::::::::::::::::::::::: -- **default value**: 0.000035 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. -::::::::::::::::::: +::::::::::::::::::::::::{dropdown} /potential mantle temperature +:name: closed_potential-mantle-temperature -:::::::::::::::::::{dropdown} /specific heat -:name: closed__specific heat +- **default value**:1600.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. +:::::::::::::::::::::::: -- **default value**: 1250.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}.$ -::::::::::::::::::: +::::::::::::::::::::::::{dropdown} /surface temperature +:name: closed_surface-temperature -:::::::::::::::::::{dropdown} /thermal diffusivity -:name: closed__thermal diffusivity +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the surface in Kelvin. +:::::::::::::::::::::::: -- **default value**: 8.04e-7 -- **type**: number -- **documentation**: The thermal diffusivity in $m^{2} s^{-1}$. -::::::::::::::::::: +::::::::::::::::::::::::{dropdown} /force surface temperature +:name: closed_force-surface-temperature -:::::::::::::::::::{dropdown} /maximum distance between coordinates -:name: closed__maximum distance between coordinates +- **default value**:false +- **type**:boolean +- **documentation**:Force the provided surface temperature to be set at the surface +:::::::::::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: This enforces a maximum distance (in degree for spherical coordinates or meter in cartesian coordinates) between coordinates in the model. If the distance is larger, extra points are added by interpolation. Requires interpolation to be not 'none'. -::::::::::::::::::: +::::::::::::::::::::::::{dropdown} /thermal expansion coefficient +:name: closed_thermal-expansion-coefficient -:::::::::::::::::::{dropdown} /interpolation -:name: closed__interpolation +- **default value**:0.000035 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. +:::::::::::::::::::::::: -- **default value**: none -- **type**: string -- **documentation**: What type of interpolation should be used to enforce the minimum points per distance parameter. Options are none, linear, monotone spline and continuous monotone spline interpolation. -::::::::::::::::::: +::::::::::::::::::::::::{dropdown} /specific heat +:name: closed_specific-heat -:::::::::::::::::::{dropdown} /coordinate system -:name: closed__coordinate system +- **default value**:1250.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}.$ +:::::::::::::::::::::::: -- **documentation**: A coordinate system. Cartesian or spherical. -- **default value**: cartesian -- **type**: object -::::::::::::::::::{dropdown} /coordinate system/oneOf -:name: closed__coordinate system_oneOf +::::::::::::::::::::::::{dropdown} /thermal diffusivity +:name: closed_thermal-diffusivity -:::::::::::::::::{dropdown} /coordinate system/oneOf/1 -:name: closed__coordinate system_oneOf_1 +- **default value**:8.04e-7 +- **type**:number +- **documentation**:The thermal diffusivity in $m^{2} s^{-1}$. +:::::::::::::::::::::::: -- **type**: object -- **documentation**: A Cartesian coordinate sytem. Coordinates are (x,y,z) and extend infintly in all directions. -- **additionalProperties**: false -- **required**: [model] +::::::::::::::::::::::::{dropdown} /maximum distance between coordinates +:name: closed_maximum-distance-between-coordinates -::::::::::::::::{dropdown} /coordinate system/oneOf/1/model -:name: closed__coordinate system_oneOf_1_model +- **default value**:0.0 +- **type**:number +- **documentation**:This enforces a maximum distance (in degree for spherical coordinates or meter in cartesian coordinates) between coordinates in the model. If the distance is larger, extra points are added by interpolation. Requires interpolation to be not 'none'. +:::::::::::::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -- **enum**: [cartesian] -:::::::::::::::: +::::::::::::::::::::::::{dropdown} /interpolation +:name: closed_interpolation +- **default value**:none +- **type**:string +- **documentation**:What type of interpolation should be used to enforce the minimum points per distance parameter. Options are none, linear, monotone spline and continuous monotone spline interpolation. +:::::::::::::::::::::::: +::::::::::::::::::::::::{dropdown} /coordinate system +:name: closed_coordinate-system -::::::::::::::::: +- **documentation**:A coordinate system. Cartesian or spherical. +- **default value**:cartesian +- **type**:object +:::::::::::::::::::::::{dropdown} /coordinate system/oneOf +:name: closed_coordinate-system_oneOf -:::::::::::::::::{dropdown} /coordinate system/oneOf/2 -:name: closed__coordinate system_oneOf_2 +::::::::::::::::::::::{dropdown} /coordinate system/oneOf/1 +:name: closed_coordinate-system_oneOf_1 -- **type**: object -- **documentation**: A spherical coordinate system. The coordinates are (radius, longitude, latitude). The radius is set in this plugin, the longitude extends at least from -360 to 360 degrees, and the latitude extends from -90 to 90. It is required to choose a depth method. Please see the manual for more information. -- **additionalProperties**: false -- **required**: [model, depth method] +- **type**:object +- **documentation**:A Cartesian coordinate sytem. Coordinates are (x,y,z) and extend infintly in all directions. +- **additionalProperties**:false +- **required**:[model] -::::::::::::::::{dropdown} /coordinate system/oneOf/2/model -:name: closed__coordinate system_oneOf_2_model +:::::::::::::::::::::{dropdown} /coordinate system/oneOf/1/model +:name: closed_coordinate-system_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -- **enum**: [spherical] -:::::::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +- **enum**:[cartesian] +::::::::::::::::::::: -::::::::::::::::{dropdown} /coordinate system/oneOf/2/depth method -:name: closed__coordinate system_oneOf_2_depth method -- **default value**: -- **type**: string -- **documentation**: Which depth method to use in the spherical case. The available options are 'starting point', 'begin segment' and 'begin at end segment'. See the manual section on coordinate systems for more info. -- **enum**: [starting point, begin segment, begin at end segment, continuous] -:::::::::::::::: -::::::::::::::::{dropdown} /coordinate system/oneOf/2/radius -:name: closed__coordinate system_oneOf_2_radius +:::::::::::::::::::::: -- **default value**: 6371000.0 -- **type**: number -- **documentation**: The radius of the sphere. -:::::::::::::::: +::::::::::::::::::::::{dropdown} /coordinate system/oneOf/2 +:name: closed_coordinate-system_oneOf_2 +- **type**:object +- **documentation**:A spherical coordinate system. The coordinates are (radius, longitude, latitude). The radius is set in this plugin, the longitude extends at least from -360 to 360 degrees, and the latitude extends from -90 to 90. It is required to choose a depth method. Please see the manual for more information. +- **additionalProperties**:false +- **required**:[model, depth method] +:::::::::::::::::::::{dropdown} /coordinate system/oneOf/2/model +:name: closed_coordinate-system_oneOf_2_model -::::::::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +- **enum**:[spherical] +::::::::::::::::::::: +:::::::::::::::::::::{dropdown} /coordinate system/oneOf/2/depth method +:name: closed_coordinate-system_oneOf_2_depth-method -::::::::::::::::::: +- **default value**: +- **type**:string +- **documentation**:Which depth method to use in the spherical case. The available options are 'starting point', 'begin segment' and 'begin at end segment'. See the manual section on coordinate systems for more info. +- **enum**:[starting point, begin segment, begin at end segment, continuous] +::::::::::::::::::::: -:::::::::::::::::::{dropdown} /features -:name: closed__features +:::::::::::::::::::::{dropdown} /coordinate system/oneOf/2/radius +:name: closed_coordinate-system_oneOf_2_radius -- **documentation**: A list of features. -- **default value**: -- **type**: array -::::::::::::::::::{dropdown} /features/items -:name: closed__features_items +- **default value**:6371000.0 +- **type**:number +- **documentation**:The radius of the sphere. +::::::::::::::::::::: -:::::::::::::::::{dropdown} /features/items/oneOf -:name: closed__features_items_oneOf -::::::::::::::::{dropdown} /features/items/oneOf/1 -:name: closed__features_items_oneOf_1 -- **type**: object -- **documentation**: continental plate object -- **additionalProperties**: false -- **required**: [model, coordinates] +:::::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/1/model -:name: closed__features_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -- **enum**: [continental plate] -::::::::::::::: +:::::::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/1/name -:name: closed__features_items_oneOf_1_name +::::::::::::::::::::::::{dropdown} /features +:name: closed_features -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -::::::::::::::: +- **documentation**:A list of features. +- **default value**: +- **type**:array +:::::::::::::::::::::::{dropdown} /features/items +:name: closed_features_items -:::::::::::::::{dropdown} /features/items/oneOf/1/coordinates -:name: closed__features_items_oneOf_1_coordinates - -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An array of 2d Points representing an array of coordinates where the feature is located. -::::::::::::::{dropdown} /features/items/oneOf/1/coordinates/items -:name: closed__features_items_oneOf_1_coordinates_items - -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -:::::::::::::{dropdown} /features/items/oneOf/1/coordinates/items/items -:name: closed__features_items_oneOf_1_coordinates_items_items - -- **type**: number -::::::::::::: +::::::::::::::::::::::{dropdown} /features/items/oneOf +:name: closed_features_items_oneOf -:::::::::::::: +:::::::::::::::::::::{dropdown} /features/items/oneOf/1 +:name: closed_features_items_oneOf_1 -::::::::::::::: +- **type**:object +- **documentation**:continental plate object +- **additionalProperties**:false +- **required**:[model, coordinates] -:::::::::::::::{dropdown} /features/items/oneOf/1/interpolation -:name: closed__features_items_oneOf_1_interpolation +::::::::::::::::::::{dropdown} /features/items/oneOf/1/model +:name: closed_features_items_oneOf_1_model -- **default value**: global -- **type**: string -- **documentation**: What type of interpolation should be used to enforce the minimum points per distance parameter. Options are global, none, linear, monotone spline and continuous monotone spline interpolation. If this value is set to global, the global value for interpolation is used. -::::::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +- **enum**:[continental plate] +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/1/min depth -:name: closed__features_items_oneOf_1_min depth +::::::::::::::::::::{dropdown} /features/items/oneOf/1/name +:name: closed_features_items_oneOf_1_name -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/1/max depth -:name: closed__features_items_oneOf_1_max depth +::::::::::::::::::::{dropdown} /features/items/oneOf/1/coordinates +:name: closed_features_items_oneOf_1_coordinates -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An array of 2d Points representing an array of coordinates where the feature is located. +:::::::::::::::::::{dropdown} /features/items/oneOf/1/coordinates/items +:name: closed_features_items_oneOf_1_coordinates_items -:::::::::::::::{dropdown} /features/items/oneOf/1/temperature models -:name: closed__features_items_oneOf_1_temperature models +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +::::::::::::::::::{dropdown} /features/items/oneOf/1/coordinates/items/items +:name: closed_features_items_oneOf_1_coordinates_items_items -- **documentation**: A list of temperature models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items -:name: closed__features_items_oneOf_1_temperature models_items +- **type**:number +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf -:name: closed__features_items_oneOf_1_temperature models_items_oneOf +::::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1 -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_1 +:::::::::::::::::::: -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +::::::::::::::::::::{dropdown} /features/items/oneOf/1/interpolation +:name: closed_features_items_oneOf_1_interpolation -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/model -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_1_model +- **default value**:global +- **type**:string +- **documentation**:What type of interpolation should be used to enforce the minimum points per distance parameter. Options are global, none, linear, monotone spline and continuous monotone spline interpolation. If this value is set to global, the global value for interpolation is used. +:::::::::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/1/min depth +:name: closed_features_items_oneOf_1_min-depth -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/operation -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_1_operation +:::::::::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf +:name: closed_features_items_oneOf_1_min-depth_oneOf -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf/1 +:name: closed_features_items_oneOf_1_min-depth_oneOf_1 -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_1_min depth +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf/2 +:name: closed_features_items_oneOf_1_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf/2/items +:name: closed_features_items_oneOf_1_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_1_min-depth_oneOf_2_items_items + +:::::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf + +::::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_1_max depth +::::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2 -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/potential mantle temperature -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_1_potential mantle temperature +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items_items -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::::::: +- **type**:number +:::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/thermal expansion coefficient -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_1_thermal expansion coefficient +::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::::::: +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/specific heat -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_1_specific heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::::::: +:::::::::::::::: +::::::::::::::::: +:::::::::::::::::: -:::::::::::: -::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2 -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_2 +:::::::::::::::::::: -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max depth] +::::::::::::::::::::{dropdown} /features/items/oneOf/1/max depth +:name: closed_features_items_oneOf_1_max-depth -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/model -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_2_model +:::::::::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf +:name: closed_features_items_oneOf_1_max-depth_oneOf -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf/1 +:name: closed_features_items_oneOf_1_max-depth_oneOf_1 -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/operation -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_2_operation +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf/2 +:name: closed_features_items_oneOf_1_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf/2/items +:name: closed_features_items_oneOf_1_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_1_max-depth_oneOf_2_items_items + +:::::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf + +::::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_2_min depth +::::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2 -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_2_max depth +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items_items -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: +- **type**:number +:::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/top temperature -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_2_top temperature +::::::::::::: -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. -::::::::::: +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/bottom temperature -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_2_bottom temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the top in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. -::::::::::: +:::::::::::::::: +::::::::::::::::: +:::::::::::::::::: -:::::::::::: -::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3 -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_3 +:::::::::::::::::::: -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] +::::::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models +:name: closed_features_items_oneOf_1_temperature-models -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/model -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_3_model +- **documentation**:A list of temperature models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items +:name: closed_features_items_oneOf_1_temperature-models_items -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/operation -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_3_operation +:::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1 -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_3_min depth +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/model +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_model -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_3_max depth +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/operation +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_operation -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/temperature -:name: closed__features_items_oneOf_1_temperature models_items_oneOf_3_temperature +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf/1 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf_1 +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: -:::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf/2 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf/2/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2 -:::::::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items -::::::::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items_items -:::::::::::::::{dropdown} /features/items/oneOf/1/composition models -:name: closed__features_items_oneOf_1_composition models +- **type**:number +:::::::: -- **documentation**: A list of composition models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items -:name: closed__features_items_oneOf_1_composition models_items +::::::::: -:::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf -:name: closed__features_items_oneOf_1_composition models_items_oneOf +:::::::::: -::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1 -:name: closed__features_items_oneOf_1_composition models_items_oneOf_1 -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +:::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/model -:name: closed__features_items_oneOf_1_composition models_items_oneOf_1_model +::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::::::: +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth -:name: closed__features_items_oneOf_1_composition models_items_oneOf_1_min depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the composition of this feature is present. -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth -:name: closed__features_items_oneOf_1_composition models_items_oneOf_1_max depth +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the composition of this feature is present. -::::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf -:::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_1_composition models_items_oneOf_1_compositions +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf/1 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf_1 -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_1_composition models_items_oneOf_1_compositions_items +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::: -- **default value**: 0 -- **type**: integer -- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf/2 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf/2/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 :::::::::: -::::::::::: - -:::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/fractions -:name: closed__features_items_oneOf_1_composition models_items_oneOf_1_fractions - -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/fractions/items -:name: closed__features_items_oneOf_1_composition models_items_oneOf_1_fractions_items +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2 -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items -::::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items_items -:::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/operation -:name: closed__features_items_oneOf_1_composition models_items_oneOf_1_operation +- **type**:number +:::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +::::::::: +:::::::::: :::::::::::: +::::::::::::: :::::::::::::: -::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/1/grains models -:name: closed__features_items_oneOf_1_grains models +:::::::::::::::: -- **documentation**: A list of grains models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items -:name: closed__features_items_oneOf_1_grains models_items +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/potential mantle temperature +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_potential-mantle-temperature -:::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf -:name: closed__features_items_oneOf_1_grains models_items_oneOf +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1 -:name: closed__features_items_oneOf_1_grains models_items_oneOf_1 +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/thermal expansion coefficient +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_thermal-expansion-coefficient -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/model -:name: closed__features_items_oneOf_1_grains models_items_oneOf_1_model +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/specific heat +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_specific-heat -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth -:name: closed__features_items_oneOf_1_grains models_items_oneOf_1_min depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the composition of this feature is present. -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth -:name: closed__features_items_oneOf_1_grains models_items_oneOf_1_max depth +::::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the composition of this feature is present. -::::::::::: +:::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2 -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_1_grains models_items_oneOf_1_compositions +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max depth] -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_1_grains models_items_oneOf_1_compositions_items +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/model +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_model -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::::::: -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/operation +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_operation + +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/orientation operation -:name: closed__features_items_oneOf_1_grains models_items_oneOf_1_orientation operation +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/grain sizes -:name: closed__features_items_oneOf_1_grains models_items_oneOf_1_grain sizes +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf/1 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf_1 -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/grain sizes/items -:name: closed__features_items_oneOf_1_grains models_items_oneOf_1_grain sizes_items +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: -- **default value**: 1.0 -- **type**: number -- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf/2 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf/2/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 :::::::::: -::::::::::: +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2 -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/normalize grain sizes -:name: closed__features_items_oneOf_1_grains models_items_oneOf_1_normalize grain sizes +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/normalize grain sizes/items -:name: closed__features_items_oneOf_1_grains models_items_oneOf_1_normalize grain sizes_items +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items_items -- **default value**: true -- **type**: boolean -- **documentation**: -:::::::::: +- **type**:number +:::::::: -::::::::::: +::::::::: +:::::::::: :::::::::::: -::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2 -:name: closed__features_items_oneOf_1_grains models_items_oneOf_2 +::::::::::::: -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/model -:name: closed__features_items_oneOf_1_grains models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth -:name: closed__features_items_oneOf_1_grains models_items_oneOf_2_min depth +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the composition of this feature is present. -::::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth -:name: closed__features_items_oneOf_1_grains models_items_oneOf_2_max depth +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf/1 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf_1 -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the composition of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/compositions -:name: closed__features_items_oneOf_1_grains models_items_oneOf_2_compositions +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf/2 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf/2/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/compositions/items -:name: closed__features_items_oneOf_1_grains models_items_oneOf_2_compositions_items +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2 -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items -::::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items_items -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/rotation matrices -:name: closed__features_items_oneOf_1_grains models_items_oneOf_2_rotation matrices - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the rotation matrices of the grains which are present there for each compositions. -::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/rotation matrices/items -:name: closed__features_items_oneOf_1_grains models_items_oneOf_2_rotation matrices_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/rotation matrices/items/items -:name: closed__features_items_oneOf_1_grains models_items_oneOf_2_rotation matrices_items_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/rotation matrices/items/items/items -:name: closed__features_items_oneOf_1_grains models_items_oneOf_2_rotation matrices_items_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: +- **type**:number :::::::: ::::::::: :::::::::: -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/Euler angles z-x-z -:name: closed__features_items_oneOf_1_grains models_items_oneOf_2_Euler angles z-x-z - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/Euler angles z-x-z/items -:name: closed__features_items_oneOf_1_grains models_items_oneOf_2_Euler angles z-x-z_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/Euler angles z-x-z/items/items -:name: closed__features_items_oneOf_1_grains models_items_oneOf_2_Euler angles z-x-z_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::::::: +:::::::::::: -:::::::::: +::::::::::::: -::::::::::: +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/orientation operation -:name: closed__features_items_oneOf_1_grains models_items_oneOf_2_orientation operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace, multiply] -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/grain sizes -:name: closed__features_items_oneOf_1_grains models_items_oneOf_2_grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/top temperature +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_top-temperature -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/grain sizes/items -:name: closed__features_items_oneOf_1_grains models_items_oneOf_2_grain sizes_items +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. +:::::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: -:::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/bottom temperature +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_bottom-temperature -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the top in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. +:::::::::::::::: -:::::::::::: +::::::::::::::::: +:::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3 -:::::::::::::: +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] -::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/model +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_model +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/operation +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_operation +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] :::::::::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/2 -:name: closed__features_items_oneOf_2 +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth -- **type**: object -- **documentation**: Fault object -- **additionalProperties**: false -- **required**: [model, coordinates] +:::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf -:::::::::::::::{dropdown} /features/items/oneOf/2/model -:name: closed__features_items_oneOf_2_model +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf/1 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf_1 -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -- **enum**: [fault] -::::::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/2/name -:name: closed__features_items_oneOf_2_name +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf/2 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf/2/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -::::::::::::::: +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2 -:::::::::::::::{dropdown} /features/items/oneOf/2/coordinates -:name: closed__features_items_oneOf_2_coordinates - -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An array of 2d Points representing an array of coordinates where the feature is located. -::::::::::::::{dropdown} /features/items/oneOf/2/coordinates/items -:name: closed__features_items_oneOf_2_coordinates_items - -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -:::::::::::::{dropdown} /features/items/oneOf/2/coordinates/items/items -:name: closed__features_items_oneOf_2_coordinates_items_items - -- **type**: number -::::::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2_items -:::::::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2_items_items -::::::::::::::: +- **type**:number +:::::::: -:::::::::::::::{dropdown} /features/items/oneOf/2/interpolation -:name: closed__features_items_oneOf_2_interpolation +::::::::: -- **default value**: global -- **type**: string -- **documentation**: What type of interpolation should be used to enforce the minimum points per distance parameter. Options are global, none, linear, monotone spline and continuous monotone spline interpolation. If this value is set to global, the global value for interpolation is used. -::::::::::::::: +:::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/2/min depth -:name: closed__features_items_oneOf_2_min depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::::: +:::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/2/max depth -:name: closed__features_items_oneOf_2_max depth +::::::::::::: + +:::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/2/dip point -:name: closed__features_items_oneOf_2_dip point +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: The depth to which this feature is present -::::::::::::::{dropdown} /features/items/oneOf/2/dip point/items -:name: closed__features_items_oneOf_2_dip point_items +:::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf -- **type**: number +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf/1 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf_1 + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: :::::::::::::: -::::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf/2 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf/2/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/2/segments -:name: closed__features_items_oneOf_2_segments +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2 -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: The depth to which this feature is present -::::::::::::::{dropdown} /features/items/oneOf/2/segments/items -:name: closed__features_items_oneOf_2_segments_items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2_items -- **type**: object -- **additionalProperties**: false -- **documentation**: -- **required**: [length, thickness, angle] +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2_items_items -:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/length -:name: closed__features_items_oneOf_2_segments_items_length +- **type**:number +:::::::: -- **type**: number -::::::::::::: +::::::::: -:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/thickness -:name: closed__features_items_oneOf_2_segments_items_thickness +:::::::::: -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::::{dropdown} /features/items/oneOf/2/segments/items/thickness/items -:name: closed__features_items_oneOf_2_segments_items_thickness_items -- **type**: number :::::::::::: ::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/top truncation -:name: closed__features_items_oneOf_2_segments_items_top truncation - -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::::{dropdown} /features/items/oneOf/2/segments/items/top truncation/items -:name: closed__features_items_oneOf_2_segments_items_top truncation_items +:::::::::::::: -- **type**: number -:::::::::::: -::::::::::::: +:::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/angle -:name: closed__features_items_oneOf_2_segments_items_angle +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/temperature +:name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_temperature -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::::{dropdown} /features/items/oneOf/2/segments/items/angle/items -:name: closed__features_items_oneOf_2_segments_items_angle_items +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::::: -- **type**: number -:::::::::::: -::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models -:name: closed__features_items_oneOf_2_segments_items_temperature models +::::::::::::::::: -- **documentation**: -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items -:name: closed__features_items_oneOf_2_segments_items_temperature models_items -:::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf +::::::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1 -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_1 +:::::::::::::::::::: -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +::::::::::::::::::::{dropdown} /features/items/oneOf/1/composition models +:name: closed_features_items_oneOf_1_composition-models -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/model -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_1_model +- **documentation**:A list of composition models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items +:name: closed_features_items_oneOf_1_composition-models_items -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf +:name: closed_features_items_oneOf_1_composition-models_items_oneOf -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/operation -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_1_operation +:::::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1 +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1 -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/min distance fault center -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_1_min distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/model +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_model -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/max distance fault center -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_1_max distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/potential mantle temperature -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_1_potential mantle temperature +::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf/1 +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf_1 -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/thermal expansion coefficient -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_1_thermal expansion coefficient +::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf/2 +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf/2/items +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::::: +::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2 -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/specific heat -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_1_specific heat +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items_items +- **type**:number +:::::::: +::::::::: :::::::::: -::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2 -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_2 -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max distance fault center] +:::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/model -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_2_model +::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/operation -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_2_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/min distance fault center -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_2_min distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The minimum distance to the center of the fault. This determines where the linear temperature starts. -::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/max distance fault center -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_2_max distance fault center +::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf/1 +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf_1 -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The minimum distance to the center of the fault. This determines where the linear temperature end. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/center temperature -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_2_center temperature +::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf/2 +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf/2/items +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the center of this feature in degree Kelvin.If the value is below zero, the an adiabatic temperature is used. -::::::::: +::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2 -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/side temperature -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_2_side temperature +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the sides of this feature in degree Kelvin. If the value is below zero, an adiabatic temperature is used. -::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items_items +- **type**:number +:::::::: +::::::::: :::::::::: -::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3 -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_3 -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] +:::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3/model -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_3_model +::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3/operation -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_3_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3/min distance fault center -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_3_min distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_compositions -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from which the composition of this feature is present. -::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_compositions_items -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3/max distance fault center -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_3_max distance fault center +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters to which the composition of this feature is present. -::::::::: +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3/temperature -:name: closed__features_items_oneOf_2_segments_items_temperature models_items_oneOf_3_temperature +::::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/fractions +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_fractions -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/fractions/items +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_fractions_items +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::::: +:::::::::::::::: -:::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/operation +:name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_operation +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -:::::::::::: -::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models -:name: closed__features_items_oneOf_2_segments_items_composition models +::::::::::::::::: -- **documentation**: -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items -:name: closed__features_items_oneOf_2_segments_items_composition models_items -:::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf -:name: closed__features_items_oneOf_2_segments_items_composition models_items_oneOf +::::::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1 -:name: closed__features_items_oneOf_2_segments_items_composition models_items_oneOf_1 +:::::::::::::::::::: -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +::::::::::::::::::::{dropdown} /features/items/oneOf/1/grains models +:name: closed_features_items_oneOf_1_grains-models -:::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/model -:name: closed__features_items_oneOf_2_segments_items_composition models_items_oneOf_1_model +- **documentation**:A list of grains models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items +:name: closed_features_items_oneOf_1_grains-models_items -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf +:name: closed_features_items_oneOf_1_grains-models_items_oneOf -:::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/min distance fault center -:name: closed__features_items_oneOf_2_segments_items_composition models_items_oneOf_1_min distance fault center +:::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1 +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1 -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from which the composition of this feature is present. -::::::::: +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/max distance fault center -:name: closed__features_items_oneOf_2_segments_items_composition models_items_oneOf_1_max distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/model +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_model -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters to which the composition of this feature is present. -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_2_segments_items_composition models_items_oneOf_1_compositions +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_2_segments_items_composition models_items_oneOf_1_compositions_items +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf/1 +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf_1 -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/fractions -:name: closed__features_items_oneOf_2_segments_items_composition models_items_oneOf_1_fractions +::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf/2 +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf/2/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/fractions/items -:name: closed__features_items_oneOf_2_segments_items_composition models_items_oneOf_1_fractions_items +::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2 -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items -::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items_items -:::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/operation -:name: closed__features_items_oneOf_2_segments_items_composition models_items_oneOf_1_operation +- **type**:number +:::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] ::::::::: - - :::::::::: @@ -1287,264 +1332,233 @@ ::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models -:name: closed__features_items_oneOf_2_segments_items_grains models - -- **documentation**: -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items -:name: closed__features_items_oneOf_2_segments_items_grains models_items - -:::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf +:::::::::::::: -::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1 -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_1 -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/model -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_1_model +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/min distance fault center -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_1_min distance fault center +::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf/1 +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf_1 -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the fault center in meters from which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/max distance fault center -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_1_max distance fault center +::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf/2 +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf/2/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the fault in meters to which the composition of this feature is present. -::::::::: +::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2 -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_1_compositions +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_1_compositions_items +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items_items -- **default value**: 0 -- **type**: integer -- **documentation**: +- **type**:number :::::::: ::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/orientation operation -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_1_orientation operation +:::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/grain sizes -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_1_grain sizes +:::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/grain sizes/items -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_1_grain sizes_items +::::::::::::: -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::: +:::::::::::::: -::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/normalize grain sizes -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_1_normalize grain sizes +:::::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/normalize grain sizes/items -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_1_normalize grain sizes_items +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_compositions -- **default value**: true -- **type**: boolean -- **documentation**: -:::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_compositions_items -::::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/orientation operation +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_orientation-operation -:::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2 -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_2 +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/grain sizes +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_grain-sizes -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/grain sizes/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_grain-sizes_items -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/model -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_2_model +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::::: +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/min distance fault center -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_2_min distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/normalize grain sizes +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_normalize-grain-sizes -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the fault center in meters from which the composition of this feature is present. -::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/normalize grain sizes/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_normalize-grain-sizes_items -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/max distance fault center -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_2_max distance fault center +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the fault in meters to which the composition of this feature is present. -::::::::: +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/compositions -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_2_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/compositions/items -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_2_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +::::::::::::::::: -::::::::: +:::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2 +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2 -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/rotation matrices -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_2_rotation matrices - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the grains which are present there for each compositions. -::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/rotation matrices/items -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_2_rotation matrices_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/rotation matrices/items/items -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_2_rotation matrices_items_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/rotation matrices/items/items/items -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_2_rotation matrices_items_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -:::::: - -::::::: +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::: +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/model +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_model -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/Euler angles z-x-z -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_2_Euler angles z-x-z - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_2_Euler angles z-x-z_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_2_Euler angles z-x-z_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::::: +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth -:::::::: +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf/1 +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf_1 + +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/orientation operation -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_2_orientation operation +::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf/2 +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf/2/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2 -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/grain sizes -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_2_grain sizes +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/grain sizes/items -:name: closed__features_items_oneOf_2_segments_items_grains models_items_oneOf_2_grain sizes_items +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items_items -- **default value**: -1.0 -- **type**: number -- **documentation**: +- **type**:number :::::::: ::::::::: - - :::::::::: @@ -1552,7067 +1566,7991 @@ ::::::::::::: - - :::::::::::::: -::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/2/temperature models -:name: closed__features_items_oneOf_2_temperature models +:::::::::::::::: -- **documentation**: A list of temperature models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items -:name: closed__features_items_oneOf_2_temperature models_items +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth -:::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf -:name: closed__features_items_oneOf_2_temperature models_items_oneOf +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf -::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1 -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_1 +::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf/1 +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf_1 -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/model -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_1_model +::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf/2 +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf/2/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::::::: +::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2 -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/operation -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_1_operation +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items_items -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/min distance fault center -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_1_min distance fault center +- **type**:number +:::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::::: +::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/max distance fault center -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_1_max distance fault center +:::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/potential mantle temperature -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_1_potential mantle temperature +:::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::::::: +::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/thermal expansion coefficient -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_1_thermal expansion coefficient +:::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/specific heat -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_1_specific heat +:::::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/compositions +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_compositions +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/compositions/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_compositions_items +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: -:::::::::::: +:::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2 -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_2 +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/rotation matrices +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_rotation-matrices + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the rotation matrices of the grains which are present there for each compositions. +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/rotation matrices/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_rotation-matrices_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/rotation matrices/items/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_rotation-matrices_items_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/rotation matrices/items/items/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_rotation-matrices_items_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::::::: -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max distance fault center] +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/model -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_2_model +::::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/operation -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_2_operation +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/Euler angles z-x-z +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_Euler-angles-z-x-z + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/Euler angles z-x-z/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_Euler-angles-z-x-z_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/Euler angles z-x-z/items/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/min distance fault center -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_2_min distance fault center +:::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The minimum distance to the center of the fault. This determines where the linear temperature starts. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/orientation operation +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_orientation-operation -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/max distance fault center -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_2_max distance fault center +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace, multiply] +:::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The minimum distance to the center of the fault. This determines where the linear temperature end. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/grain sizes +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_grain-sizes -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/center temperature -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_2_center temperature +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/grain sizes/items +:name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_grain-sizes_items -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the center of this feature in degree Kelvin.If the value is below zero, the an adiabatic temperature is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/side temperature -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_2_side temperature +:::::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the sides of this feature in degree Kelvin. If the value is below zero, an adiabatic temperature is used. -::::::::::: +::::::::::::::::: -:::::::::::: -::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3 -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_3 +::::::::::::::::::: -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] +:::::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3/model -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_3_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3/operation -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_3_operation +::::::::::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +:::::::::::::::::::::{dropdown} /features/items/oneOf/2 +:name: closed_features_items_oneOf_2 -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3/min distance fault center -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_3_min distance fault center +- **type**:object +- **documentation**:Fault object +- **additionalProperties**:false +- **required**:[model, coordinates] -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from which the composition of this feature is present. -::::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/2/model +:name: closed_features_items_oneOf_2_model -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3/max distance fault center -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_3_max distance fault center +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +- **enum**:[fault] +:::::::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters to which the composition of this feature is present. -::::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/2/name +:name: closed_features_items_oneOf_2_name -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3/temperature -:name: closed__features_items_oneOf_2_temperature models_items_oneOf_3_temperature +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +:::::::::::::::::::: -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/2/coordinates +:name: closed_features_items_oneOf_2_coordinates +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An array of 2d Points representing an array of coordinates where the feature is located. +:::::::::::::::::::{dropdown} /features/items/oneOf/2/coordinates/items +:name: closed_features_items_oneOf_2_coordinates_items +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +::::::::::::::::::{dropdown} /features/items/oneOf/2/coordinates/items/items +:name: closed_features_items_oneOf_2_coordinates_items_items -:::::::::::: +- **type**:number +:::::::::::::::::: +::::::::::::::::::: -:::::::::::::: +:::::::::::::::::::: -::::::::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/2/interpolation +:name: closed_features_items_oneOf_2_interpolation -:::::::::::::::{dropdown} /features/items/oneOf/2/composition models -:name: closed__features_items_oneOf_2_composition models +- **default value**:global +- **type**:string +- **documentation**:What type of interpolation should be used to enforce the minimum points per distance parameter. Options are global, none, linear, monotone spline and continuous monotone spline interpolation. If this value is set to global, the global value for interpolation is used. +:::::::::::::::::::: -- **documentation**: A list of composition models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items -:name: closed__features_items_oneOf_2_composition models_items +::::::::::::::::::::{dropdown} /features/items/oneOf/2/min depth +:name: closed_features_items_oneOf_2_min-depth -:::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf -:name: closed__features_items_oneOf_2_composition models_items_oneOf +- **default value**:0.0 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1 -:name: closed__features_items_oneOf_2_composition models_items_oneOf_1 +::::::::::::::::::::{dropdown} /features/items/oneOf/2/max depth +:name: closed_features_items_oneOf_2_max-depth -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/model -:name: closed__features_items_oneOf_2_composition models_items_oneOf_1_model +::::::::::::::::::::{dropdown} /features/items/oneOf/2/dip point +:name: closed_features_items_oneOf_2_dip-point -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::::::: +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**:The depth to which this feature is present +:::::::::::::::::::{dropdown} /features/items/oneOf/2/dip point/items +:name: closed_features_items_oneOf_2_dip-point_items -:::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/min distance fault center -:name: closed__features_items_oneOf_2_composition models_items_oneOf_1_min distance fault center +- **type**:number +::::::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from which the composition of this feature is present. -::::::::::: +:::::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/max distance fault center -:name: closed__features_items_oneOf_2_composition models_items_oneOf_1_max distance fault center +::::::::::::::::::::{dropdown} /features/items/oneOf/2/segments +:name: closed_features_items_oneOf_2_segments -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters to which the composition of this feature is present. -::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:The depth to which this feature is present +:::::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items +:name: closed_features_items_oneOf_2_segments_items -:::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_2_composition models_items_oneOf_1_compositions +- **type**:object +- **additionalProperties**:false +- **documentation**: +- **required**:[length, thickness, angle] -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_2_composition models_items_oneOf_1_compositions_items +::::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/length +:name: closed_features_items_oneOf_2_segments_items_length -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **type**:number +:::::::::::::::::: -::::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/thickness +:name: closed_features_items_oneOf_2_segments_items_thickness -:::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/fractions -:name: closed__features_items_oneOf_2_composition models_items_oneOf_1_fractions +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/thickness/items +:name: closed_features_items_oneOf_2_segments_items_thickness_items -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/fractions/items -:name: closed__features_items_oneOf_2_composition models_items_oneOf_1_fractions_items +- **type**:number +::::::::::::::::: -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::::: +:::::::::::::::::: -::::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/top truncation +:name: closed_features_items_oneOf_2_segments_items_top-truncation -:::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/operation -:name: closed__features_items_oneOf_2_composition models_items_oneOf_1_operation +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/top truncation/items +:name: closed_features_items_oneOf_2_segments_items_top-truncation_items -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +- **type**:number +::::::::::::::::: +:::::::::::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/angle +:name: closed_features_items_oneOf_2_segments_items_angle -:::::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/angle/items +:name: closed_features_items_oneOf_2_segments_items_angle_items +- **type**:number +::::::::::::::::: -:::::::::::::: +:::::::::::::::::: -::::::::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models +:name: closed_features_items_oneOf_2_segments_items_temperature-models -:::::::::::::::{dropdown} /features/items/oneOf/2/grains models -:name: closed__features_items_oneOf_2_grains models +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items -- **documentation**: A list of grains models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items -:name: closed__features_items_oneOf_2_grains models_items +::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf -:::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf -:name: closed__features_items_oneOf_2_grains models_items_oneOf +:::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1 +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_1 -::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1 -:name: closed__features_items_oneOf_2_grains models_items_oneOf_1 +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/model +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_1_model -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/model -:name: closed__features_items_oneOf_2_grains models_items_oneOf_1_model +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/operation +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_1_operation -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/min distance fault center -:name: closed__features_items_oneOf_2_grains models_items_oneOf_1_min distance fault center +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the fault center in meters from which the composition of this feature is present. -::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/min distance fault center +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_1_min-distance-fault-center -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/max distance fault center -:name: closed__features_items_oneOf_2_grains models_items_oneOf_1_max distance fault center +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the fault in meters to which the composition of this feature is present. -::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/max distance fault center +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_1_max-distance-fault-center -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_2_grains models_items_oneOf_1_compositions +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_2_grains models_items_oneOf_1_compositions_items +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/potential mantle temperature +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_1_potential-mantle-temperature -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::::: -::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/thermal expansion coefficient +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_1_thermal-expansion-coefficient -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/orientation operation -:name: closed__features_items_oneOf_2_grains models_items_oneOf_1_orientation operation +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/specific heat +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_1_specific-heat -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/grain sizes -:name: closed__features_items_oneOf_2_grains models_items_oneOf_1_grain sizes +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/grain sizes/items -:name: closed__features_items_oneOf_2_grains models_items_oneOf_1_grain sizes_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::::: -::::::::::: +::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/normalize grain sizes -:name: closed__features_items_oneOf_2_grains models_items_oneOf_1_normalize grain sizes +:::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2 +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_2 -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/normalize grain sizes/items -:name: closed__features_items_oneOf_2_grains models_items_oneOf_1_normalize grain sizes_items +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max distance fault center] -- **default value**: true -- **type**: boolean -- **documentation**: -:::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/model +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_2_model -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/operation +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_2_operation +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/min distance fault center +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_2_min-distance-fault-center -::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2 -:name: closed__features_items_oneOf_2_grains models_items_oneOf_2 +- **default value**:0.0 +- **type**:number +- **documentation**:The minimum distance to the center of the fault. This determines where the linear temperature starts. +:::::::::::::: -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/max distance fault center +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_2_max-distance-fault-center -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/model -:name: closed__features_items_oneOf_2_grains models_items_oneOf_2_model +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The minimum distance to the center of the fault. This determines where the linear temperature end. +:::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/center temperature +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_2_center-temperature -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/min distance fault center -:name: closed__features_items_oneOf_2_grains models_items_oneOf_2_min distance fault center +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the center of this feature in degree Kelvin.If the value is below zero, the an adiabatic temperature is used. +:::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the fault center in meters from which the composition of this feature is present. -::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/side temperature +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_2_side-temperature -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/max distance fault center -:name: closed__features_items_oneOf_2_grains models_items_oneOf_2_max distance fault center +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the sides of this feature in degree Kelvin. If the value is below zero, an adiabatic temperature is used. +:::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the fault in meters to which the composition of this feature is present. -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/compositions -:name: closed__features_items_oneOf_2_grains models_items_oneOf_2_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/compositions/items -:name: closed__features_items_oneOf_2_grains models_items_oneOf_2_compositions_items +::::::::::::::: -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3 +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_3 -::::::::::: +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/rotation matrices -:name: closed__features_items_oneOf_2_grains models_items_oneOf_2_rotation matrices - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the grains which are present there for each compositions. -::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/rotation matrices/items -:name: closed__features_items_oneOf_2_grains models_items_oneOf_2_rotation matrices_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/rotation matrices/items/items -:name: closed__features_items_oneOf_2_grains models_items_oneOf_2_rotation matrices_items_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/rotation matrices/items/items/items -:name: closed__features_items_oneOf_2_grains models_items_oneOf_2_rotation matrices_items_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -:::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3/model +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_3_model -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::::: -:::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3/operation +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_3_operation -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/Euler angles z-x-z -:name: closed__features_items_oneOf_2_grains models_items_oneOf_2_Euler angles z-x-z - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/Euler angles z-x-z/items -:name: closed__features_items_oneOf_2_grains models_items_oneOf_2_Euler angles z-x-z_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/Euler angles z-x-z/items/items -:name: closed__features_items_oneOf_2_grains models_items_oneOf_2_Euler angles z-x-z_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3/min distance fault center +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_3_min-distance-fault-center -:::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from which the composition of this feature is present. +:::::::::::::: -::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3/max distance fault center +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_3_max-distance-fault-center -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/orientation operation -:name: closed__features_items_oneOf_2_grains models_items_oneOf_2_orientation operation +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters to which the composition of this feature is present. +:::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3/temperature +:name: closed_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_3_temperature -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/grain sizes -:name: closed__features_items_oneOf_2_grains models_items_oneOf_2_grain sizes +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/grain sizes/items -:name: closed__features_items_oneOf_2_grains models_items_oneOf_2_grain sizes_items -- **default value**: -1.0 -- **type**: number -- **documentation**: -:::::::::: -::::::::::: +::::::::::::::: +::::::::::::::::: -:::::::::::: +:::::::::::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models +:name: closed_features_items_oneOf_2_segments_items_composition-models -:::::::::::::: +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items +:name: closed_features_items_oneOf_2_segments_items_composition-models_items -::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf +:name: closed_features_items_oneOf_2_segments_items_composition-models_items_oneOf -:::::::::::::::{dropdown} /features/items/oneOf/2/sections -:name: closed__features_items_oneOf_2_sections +:::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1 +:name: closed_features_items_oneOf_2_segments_items_composition-models_items_oneOf_1 -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of feature properties for a coordinate. -::::::::::::::{dropdown} /features/items/oneOf/2/sections/items -:name: closed__features_items_oneOf_2_sections_items +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] -- **documentation**: -- **default value**: -- **type**: object +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/model +:name: closed_features_items_oneOf_2_segments_items_composition-models_items_oneOf_1_model -:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/min depth -:name: closed__features_items_oneOf_2_sections_items_min depth +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/min distance fault center +:name: closed_features_items_oneOf_2_segments_items_composition-models_items_oneOf_1_min-distance-fault-center -:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/max depth -:name: closed__features_items_oneOf_2_sections_items_max depth +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from which the composition of this feature is present. +:::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/max distance fault center +:name: closed_features_items_oneOf_2_segments_items_composition-models_items_oneOf_1_max-distance-fault-center -:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/dip point -:name: closed__features_items_oneOf_2_sections_items_dip point +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters to which the composition of this feature is present. +:::::::::::::: -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: The depth to which this feature is present -::::::::::::{dropdown} /features/items/oneOf/2/sections/items/dip point/items -:name: closed__features_items_oneOf_2_sections_items_dip point_items +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_2_segments_items_composition-models_items_oneOf_1_compositions -- **type**: number -:::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_2_segments_items_composition-models_items_oneOf_1_compositions_items +- **default value**:0 +- **type**:integer +- **documentation**: ::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments -:name: closed__features_items_oneOf_2_sections_items_segments +:::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: The depth to which this feature is present -::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items -:name: closed__features_items_oneOf_2_sections_items_segments_items +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/fractions +:name: closed_features_items_oneOf_2_segments_items_composition-models_items_oneOf_1_fractions -- **type**: object -- **additionalProperties**: false -- **documentation**: -- **required**: [length, thickness, angle] +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/fractions/items +:name: closed_features_items_oneOf_2_segments_items_composition-models_items_oneOf_1_fractions_items -:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/length -:name: closed__features_items_oneOf_2_sections_items_segments_items_length +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::: -- **type**: number -::::::::::: +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/thickness -:name: closed__features_items_oneOf_2_sections_items_segments_items_thickness +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/operation +:name: closed_features_items_oneOf_2_segments_items_composition-models_items_oneOf_1_operation -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/thickness/items -:name: closed__features_items_oneOf_2_sections_items_segments_items_thickness_items +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -- **type**: number -:::::::::: -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/top truncation -:name: closed__features_items_oneOf_2_sections_items_segments_items_top truncation +::::::::::::::: -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/top truncation/items -:name: closed__features_items_oneOf_2_sections_items_segments_items_top truncation_items -- **type**: number -:::::::::: +::::::::::::::::: -::::::::::: +:::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/angle -:name: closed__features_items_oneOf_2_sections_items_segments_items_angle +::::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models +:name: closed_features_items_oneOf_2_segments_items_grains-models -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/angle/items -:name: closed__features_items_oneOf_2_sections_items_segments_items_angle_items +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items +:name: closed_features_items_oneOf_2_segments_items_grains-models_items -- **type**: number -:::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf -::::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1 +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1 -:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] -- **documentation**: -- **default value**: -- **type**: array -::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/model +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1_model -:::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::::: -::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1 -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_1 +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/min distance fault center +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1_min-distance-fault-center -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the fault center in meters from which the composition of this feature is present. +:::::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/model -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_1_model +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/max distance fault center +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1_max-distance-fault-center -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the fault in meters to which the composition of this feature is present. +:::::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/operation -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_1_operation +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1_compositions -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1_compositions_items -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/min distance fault center -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_1_min distance fault center +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::: +:::::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/max distance fault center -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_1_max distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/orientation operation +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1_orientation-operation -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/potential mantle temperature -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_1_potential mantle temperature +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/grain sizes +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1_grain-sizes -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/grain sizes/items +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1_grain-sizes_items -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/thermal expansion coefficient -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_1_thermal expansion coefficient +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::: +:::::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/specific heat -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_1_specific heat +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/normalize grain sizes +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1_normalize-grain-sizes -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/normalize grain sizes/items +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1_normalize-grain-sizes_items +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::::: +:::::::::::::: -:::::::: -::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2 -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_2 -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max distance fault center] +::::::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/model -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_2_model +:::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2 +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2 -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::: +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/operation -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_2_operation +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/model +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_model -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/min distance fault center -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_2_min distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/min distance fault center +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The minimum distance to the center of the fault. This determines where the linear temperature starts. -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the fault center in meters from which the composition of this feature is present. +:::::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/max distance fault center -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_2_max distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/max distance fault center +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The minimum distance to the center of the fault. This determines where the linear temperature end. -::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the fault in meters to which the composition of this feature is present. +:::::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/center temperature -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_2_center temperature +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/compositions +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_compositions -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the center of this feature in degree Kelvin.If the value is below zero, the an adiabatic temperature is used. -::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/compositions/items +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_compositions_items -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/side temperature -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_2_side temperature +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the sides of this feature in degree Kelvin. If the value is below zero, an adiabatic temperature is used. -::::::: +:::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/rotation matrices +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_rotation-matrices + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the grains which are present there for each compositions. +:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/rotation matrices/items +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_rotation-matrices_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/rotation matrices/items/items +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_rotation-matrices_items_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/rotation matrices/items/items/items +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_rotation-matrices_items_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::::: +:::::::::::: -:::::::: +::::::::::::: -::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3 -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_3 +:::::::::::::: -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/Euler angles z-x-z +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3/model -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_3_model +::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::: +:::::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3/operation -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_3_operation +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/orientation operation +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3/min distance fault center -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_3_min distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/grain sizes +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_grain-sizes -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from which the composition of this feature is present. -::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/grain sizes/items +:name: closed_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_grain-sizes_items -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3/max distance fault center -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_3_max distance fault center +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters to which the composition of this feature is present. -::::::: +:::::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3/temperature -:name: closed__features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_3_temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::: +::::::::::::::: -:::::::: +::::::::::::::::: +:::::::::::::::::: -:::::::::: -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models -:name: closed__features_items_oneOf_2_sections_items_segments_items_composition models +::::::::::::::::::: -- **documentation**: -- **default value**: -- **type**: array -::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items -:name: closed__features_items_oneOf_2_sections_items_segments_items_composition models_items +:::::::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf -:name: closed__features_items_oneOf_2_sections_items_segments_items_composition models_items_oneOf +::::::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models +:name: closed_features_items_oneOf_2_temperature-models -::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1 -:name: closed__features_items_oneOf_2_sections_items_segments_items_composition models_items_oneOf_1 +- **documentation**:A list of temperature models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items +:name: closed_features_items_oneOf_2_temperature-models_items -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +::::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/model -:name: closed__features_items_oneOf_2_sections_items_segments_items_composition models_items_oneOf_1_model +:::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1 +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_1 -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::: +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/min distance fault center -:name: closed__features_items_oneOf_2_sections_items_segments_items_composition models_items_oneOf_1_min distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/model +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_1_model -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from which the composition of this feature is present. -::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/max distance fault center -:name: closed__features_items_oneOf_2_sections_items_segments_items_composition models_items_oneOf_1_max distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/operation +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_1_operation -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters to which the composition of this feature is present. -::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_2_sections_items_segments_items_composition models_items_oneOf_1_compositions +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/min distance fault center +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_1_min-distance-fault-center -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_2_sections_items_segments_items_composition models_items_oneOf_1_compositions_items +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::::: -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/max distance fault center +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_1_max-distance-fault-center -::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/fractions -:name: closed__features_items_oneOf_2_sections_items_segments_items_composition models_items_oneOf_1_fractions +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/potential mantle temperature +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_1_potential-mantle-temperature -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/fractions/items -:name: closed__features_items_oneOf_2_sections_items_segments_items_composition models_items_oneOf_1_fractions_items +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::::::: -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/thermal expansion coefficient +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_1_thermal-expansion-coefficient -::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/operation -:name: closed__features_items_oneOf_2_sections_items_segments_items_composition models_items_oneOf_1_operation +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/specific heat +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_1_specific-heat -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::::: -:::::::: +::::::::::::::::: +:::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2 +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_2 -:::::::::: +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max distance fault center] -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/model +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_2_model -:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models - -- **documentation**: -- **default value**: -- **type**: array -::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/operation +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_2_operation -::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1 -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1 +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/min distance fault center +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_2_min-distance-fault-center -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/model -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1_model +- **default value**:0.0 +- **type**:number +- **documentation**:The minimum distance to the center of the fault. This determines where the linear temperature starts. +:::::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/max distance fault center +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_2_max-distance-fault-center -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/min distance fault center -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1_min distance fault center +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The minimum distance to the center of the fault. This determines where the linear temperature end. +:::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the fault center in meters from which the composition of this feature is present. -::::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/center temperature +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_2_center-temperature -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/max distance fault center -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1_max distance fault center +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the center of this feature in degree Kelvin.If the value is below zero, the an adiabatic temperature is used. +:::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the fault in meters to which the composition of this feature is present. -::::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/side temperature +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_2_side-temperature -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1_compositions +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the sides of this feature in degree Kelvin. If the value is below zero, an adiabatic temperature is used. +:::::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::: -::::::: +::::::::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/orientation operation -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1_orientation operation +:::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3 +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_3 -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::: +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/grain sizes -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1_grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3/model +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_3_model -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/grain sizes/items -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1_grain sizes_items +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::::::: -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3/operation +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_3_operation -::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/normalize grain sizes -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1_normalize grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3/min distance fault center +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_3_min-distance-fault-center -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/normalize grain sizes/items -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1_normalize grain sizes_items +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from which the composition of this feature is present. +:::::::::::::::: -- **default value**: true -- **type**: boolean -- **documentation**: -:::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3/max distance fault center +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_3_max-distance-fault-center -::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters to which the composition of this feature is present. +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3/temperature +:name: closed_features_items_oneOf_2_temperature-models_items_oneOf_3_temperature +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::::: -:::::::: -::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2 -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2 - -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] - -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/model -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_model - -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::: - -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/min distance fault center -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_min distance fault center - -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the fault center in meters from which the composition of this feature is present. -::::::: - -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/max distance fault center -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_max distance fault center - -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the fault in meters to which the composition of this feature is present. -::::::: - -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/compositions -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_compositions - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/compositions/items -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_compositions_items - -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::: - -::::::: - -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_rotation matrices - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the grains which are present there for each compositions. -::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_rotation matrices_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items/items -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_rotation matrices_items_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items/items/items -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_rotation matrices_items_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -:::: - -::::: - -:::::: - -::::::: - -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_Euler angles z-x-z - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_Euler angles z-x-z_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_Euler angles z-x-z_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::: - -:::::: - -::::::: - -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/orientation operation -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_orientation operation - -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::: - -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/grain sizes -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_grain sizes - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/grain sizes/items -:name: closed__features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_grain sizes_items - -- **default value**: -1.0 -- **type**: number -- **documentation**: -:::::: - -::::::: +::::::::::::::::: -:::::::: +::::::::::::::::::: +:::::::::::::::::::: -:::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/2/composition models +:name: closed_features_items_oneOf_2_composition-models -::::::::::: +- **documentation**:A list of composition models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items +:name: closed_features_items_oneOf_2_composition-models_items +::::::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf +:name: closed_features_items_oneOf_2_composition-models_items_oneOf +:::::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1 +:name: closed_features_items_oneOf_2_composition-models_items_oneOf_1 -:::::::::::: +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] -::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/model +:name: closed_features_items_oneOf_2_composition-models_items_oneOf_1_model -:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models -:name: closed__features_items_oneOf_2_sections_items_temperature models +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::::::: -- **documentation**: A list of temperature models. -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items -:name: closed__features_items_oneOf_2_sections_items_temperature models_items +::::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/min distance fault center +:name: closed_features_items_oneOf_2_composition-models_items_oneOf_1_min-distance-fault-center -:::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from which the composition of this feature is present. +:::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1 -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_1 +::::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/max distance fault center +:name: closed_features_items_oneOf_2_composition-models_items_oneOf_1_max-distance-fault-center -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/model -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_1_model +::::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_2_composition-models_items_oneOf_1_compositions -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_2_composition-models_items_oneOf_1_compositions_items -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/operation -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_1_operation +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/min distance fault center -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_1_min distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/fractions +:name: closed_features_items_oneOf_2_composition-models_items_oneOf_1_fractions -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/fractions/items +:name: closed_features_items_oneOf_2_composition-models_items_oneOf_1_fractions_items -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/max distance fault center -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_1_max distance fault center +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/potential mantle temperature -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_1_potential mantle temperature +::::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/operation +:name: closed_features_items_oneOf_2_composition-models_items_oneOf_1_operation -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/thermal expansion coefficient -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_1_thermal expansion coefficient -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/specific heat -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_1_specific heat +::::::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::::: +::::::::::::::::::: +:::::::::::::::::::: -:::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/2/grains models +:name: closed_features_items_oneOf_2_grains-models -::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2 -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_2 +- **documentation**:A list of grains models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items +:name: closed_features_items_oneOf_2_grains-models_items -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max distance fault center] +::::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf +:name: closed_features_items_oneOf_2_grains-models_items_oneOf -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/model -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_2_model +:::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1 +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_1 -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::::: - -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/operation -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_2_operation +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/model +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_1_model -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/min distance fault center -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_2_min distance fault center +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The minimum distance to the center of the fault. This determines where the linear temperature starts. -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/min distance fault center +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_1_min-distance-fault-center -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/max distance fault center -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_2_max distance fault center +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the fault center in meters from which the composition of this feature is present. +:::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The minimum distance to the center of the fault. This determines where the linear temperature end. -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/max distance fault center +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_1_max-distance-fault-center -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/center temperature -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_2_center temperature +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the fault in meters to which the composition of this feature is present. +:::::::::::::::: -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the center of this feature in degree Kelvin.If the value is below zero, the an adiabatic temperature is used. -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_1_compositions -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/side temperature -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_2_side temperature +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_1_compositions_items -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the sides of this feature in degree Kelvin. If the value is below zero, an adiabatic temperature is used. -::::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/orientation operation +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_1_orientation-operation -:::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3 -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_3 +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/grain sizes +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_1_grain-sizes -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/grain sizes/items +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_1_grain-sizes_items -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3/model -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_3_model +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::::: +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3/operation -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_3_operation +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/normalize grain sizes +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_1_normalize-grain-sizes -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/normalize grain sizes/items +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_1_normalize-grain-sizes_items -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3/min distance fault center -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_3_min distance fault center +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from which the composition of this feature is present. -::::::::: +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3/max distance fault center -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_3_max distance fault center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters to which the composition of this feature is present. -::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3/temperature -:name: closed__features_items_oneOf_2_sections_items_temperature models_items_oneOf_3_temperature +::::::::::::::::: -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::: +:::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2 +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_2 +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/model +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_2_model -:::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/min distance fault center +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_2_min-distance-fault-center -:::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the fault center in meters from which the composition of this feature is present. +:::::::::::::::: -::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/max distance fault center +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_2_max-distance-fault-center -:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models -:name: closed__features_items_oneOf_2_sections_items_composition models +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the fault in meters to which the composition of this feature is present. +:::::::::::::::: -- **documentation**: A list of composition models. -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items -:name: closed__features_items_oneOf_2_sections_items_composition models_items +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/compositions +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_2_compositions -:::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf -:name: closed__features_items_oneOf_2_sections_items_composition models_items_oneOf +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/compositions/items +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_2_compositions_items -::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1 -:name: closed__features_items_oneOf_2_sections_items_composition models_items_oneOf_1 +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/model -:name: closed__features_items_oneOf_2_sections_items_composition models_items_oneOf_1_model +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/rotation matrices +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_2_rotation-matrices + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the grains which are present there for each compositions. +:::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/rotation matrices/items +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_2_rotation-matrices_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/rotation matrices/items/items +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_2_rotation-matrices_items_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/rotation matrices/items/items/items +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_2_rotation-matrices_items_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/min distance fault center -:name: closed__features_items_oneOf_2_sections_items_composition models_items_oneOf_1_min distance fault center +::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from which the composition of this feature is present. -::::::::: +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/max distance fault center -:name: closed__features_items_oneOf_2_sections_items_composition models_items_oneOf_1_max distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/Euler angles z-x-z +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_2_Euler-angles-z-x-z + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/Euler angles z-x-z/items +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_2_Euler-angles-z-x-z_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/Euler angles z-x-z/items/items +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters to which the composition of this feature is present. -::::::::: +::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_2_sections_items_composition models_items_oneOf_1_compositions +:::::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_2_sections_items_composition models_items_oneOf_1_compositions_items +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/orientation operation +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_2_orientation-operation -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/grain sizes +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_2_grain-sizes -:::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/fractions -:name: closed__features_items_oneOf_2_sections_items_composition models_items_oneOf_1_fractions +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/grain sizes/items +:name: closed_features_items_oneOf_2_grains-models_items_oneOf_2_grain-sizes_items -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/fractions/items -:name: closed__features_items_oneOf_2_sections_items_composition models_items_oneOf_1_fractions_items +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::::::: -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::: +:::::::::::::::: -::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/operation -:name: closed__features_items_oneOf_2_sections_items_composition models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +::::::::::::::::: +::::::::::::::::::: -:::::::::: +:::::::::::::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/2/sections +:name: closed_features_items_oneOf_2_sections -:::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of feature properties for a coordinate. +:::::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items +:name: closed_features_items_oneOf_2_sections_items -::::::::::::: +- **documentation**: +- **default value**: +- **type**:object -:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models -:name: closed__features_items_oneOf_2_sections_items_grains models +::::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/min depth +:name: closed_features_items_oneOf_2_sections_items_min-depth -- **documentation**: A list of grains models. -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items -:name: closed__features_items_oneOf_2_sections_items_grains models_items +- **default value**:0.0 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf +::::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/max depth +:name: closed_features_items_oneOf_2_sections_items_max-depth -::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1 -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_1 +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::: -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +::::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/dip point +:name: closed_features_items_oneOf_2_sections_items_dip-point -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/model -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_1_model +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**:The depth to which this feature is present +:::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/dip point/items +:name: closed_features_items_oneOf_2_sections_items_dip-point_items -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::::: +- **type**:number +::::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/min distance fault center -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_1_min distance fault center +:::::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the fault center in meters from which the composition of this feature is present. -::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments +:name: closed_features_items_oneOf_2_sections_items_segments -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/max distance fault center -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_1_max distance fault center +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:The depth to which this feature is present +:::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items +:name: closed_features_items_oneOf_2_sections_items_segments_items -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the fault in meters to which the composition of this feature is present. -::::::::: +- **type**:object +- **additionalProperties**:false +- **documentation**: +- **required**:[length, thickness, angle] -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_1_compositions +::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/length +:name: closed_features_items_oneOf_2_sections_items_segments_items_length -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_1_compositions_items +- **type**:number +:::::::::::::::: -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/thickness +:name: closed_features_items_oneOf_2_sections_items_segments_items_thickness -::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/thickness/items +:name: closed_features_items_oneOf_2_sections_items_segments_items_thickness_items -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/orientation operation -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_1_orientation operation +- **type**:number +::::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/grain sizes -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_1_grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/top truncation +:name: closed_features_items_oneOf_2_sections_items_segments_items_top-truncation -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/grain sizes/items -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_1_grain sizes_items +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/top truncation/items +:name: closed_features_items_oneOf_2_sections_items_segments_items_top-truncation_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::: +- **type**:number +::::::::::::::: -::::::::: +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/normalize grain sizes -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_1_normalize grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/angle +:name: closed_features_items_oneOf_2_sections_items_segments_items_angle -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/normalize grain sizes/items -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_1_normalize grain sizes_items +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/angle/items +:name: closed_features_items_oneOf_2_sections_items_segments_items_angle_items -- **default value**: true -- **type**: boolean -- **documentation**: -:::::::: +- **type**:number +::::::::::::::: -::::::::: +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items -:::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf -::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2 -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_2 +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1 +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_1 -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/model -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_2_model +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/model +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/min distance fault center -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_2_min distance fault center +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/operation +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_1_operation -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the fault center in meters from which the composition of this feature is present. -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/max distance fault center -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_2_max distance fault center +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/min distance fault center +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_1_min-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the fault in meters to which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/compositions -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_2_compositions +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/max distance fault center +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_1_max-distance-fault-center -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/compositions/items -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_2_compositions_items +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::: -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/potential mantle temperature +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_1_potential-mantle-temperature -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/rotation matrices -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_2_rotation matrices - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the grains which are present there for each compositions. -::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/rotation matrices/items -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_2_rotation matrices_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/rotation matrices/items/items -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_2_rotation matrices_items_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/rotation matrices/items/items/items -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_2_rotation matrices_items_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -:::::: - -::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/thermal expansion coefficient +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_1_thermal-expansion-coefficient -:::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::: -::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/specific heat +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_1_specific-heat -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/Euler angles z-x-z -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_2_Euler angles z-x-z - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/Euler angles z-x-z/items -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_2_Euler angles z-x-z_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_2_Euler angles z-x-z_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::: -:::::::: -::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/orientation operation -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_2_orientation operation +::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2 +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_2 -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/grain sizes -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_2_grain sizes +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max distance fault center] -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/grain sizes/items -:name: closed__features_items_oneOf_2_sections_items_grains models_items_oneOf_2_grain sizes_items +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/model +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_2_model -- **default value**: -1.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::: -::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/operation +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_2_operation +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/min distance fault center +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_2_min-distance-fault-center -:::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The minimum distance to the center of the fault. This determines where the linear temperature starts. +:::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/max distance fault center +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_2_max-distance-fault-center +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The minimum distance to the center of the fault. This determines where the linear temperature end. :::::::::::: -::::::::::::: - -:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/coordinate -:name: closed__features_items_oneOf_2_sections_items_coordinate +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/center temperature +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_2_center-temperature -- **default value**: 0 -- **type**: integer -- **documentation**: The coordinate which should be overwritten -::::::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the center of this feature in degree Kelvin.If the value is below zero, the an adiabatic temperature is used. +:::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/side temperature +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_2_side-temperature +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the sides of this feature in degree Kelvin. If the value is below zero, an adiabatic temperature is used. +:::::::::::: -:::::::::::::: -::::::::::::::: +::::::::::::: +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3 +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_3 -:::::::::::::::: +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] -::::::::::::::::{dropdown} /features/items/oneOf/3 -:name: closed__features_items_oneOf_3 +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3/model +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_3_model -- **type**: object -- **documentation**: Mantle layer object -- **additionalProperties**: false -- **required**: [model, coordinates] +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/3/model -:name: closed__features_items_oneOf_3_model +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3/operation +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_3_operation -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -- **enum**: [mantle layer] -::::::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/3/name -:name: closed__features_items_oneOf_3_name +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3/min distance fault center +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_3_min-distance-fault-center -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -::::::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from which the composition of this feature is present. +:::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/3/coordinates -:name: closed__features_items_oneOf_3_coordinates - -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An array of 2d Points representing an array of coordinates where the feature is located. -::::::::::::::{dropdown} /features/items/oneOf/3/coordinates/items -:name: closed__features_items_oneOf_3_coordinates_items - -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -:::::::::::::{dropdown} /features/items/oneOf/3/coordinates/items/items -:name: closed__features_items_oneOf_3_coordinates_items_items - -- **type**: number -::::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3/max distance fault center +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_3_max-distance-fault-center -:::::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters to which the composition of this feature is present. +:::::::::::: -::::::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3/temperature +:name: closed_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_3_temperature -:::::::::::::::{dropdown} /features/items/oneOf/3/interpolation -:name: closed__features_items_oneOf_3_interpolation +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::: -- **default value**: global -- **type**: string -- **documentation**: What type of interpolation should be used to enforce the minimum points per distance parameter. Options are global, none, linear, monotone spline and continuous monotone spline interpolation. If this value is set to global, the global value for interpolation is used. -::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/3/min depth -:name: closed__features_items_oneOf_3_min depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::::: +::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/3/max depth -:name: closed__features_items_oneOf_3_max depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth to which this feature is present ::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/3/temperature models -:name: closed__features_items_oneOf_3_temperature models +:::::::::::::::: -- **documentation**: A list of temperature models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items -:name: closed__features_items_oneOf_3_temperature models_items +::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models +:name: closed_features_items_oneOf_2_sections_items_segments_items_composition-models -:::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf -:name: closed__features_items_oneOf_3_temperature models_items_oneOf +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items +:name: closed_features_items_oneOf_2_sections_items_segments_items_composition-models_items -::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1 -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_1 +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf +:name: closed_features_items_oneOf_2_sections_items_segments_items_composition-models_items_oneOf -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1 +:name: closed_features_items_oneOf_2_sections_items_segments_items_composition-models_items_oneOf_1 -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/model -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_1_model +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/model +:name: closed_features_items_oneOf_2_sections_items_segments_items_composition-models_items_oneOf_1_model -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/operation -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_1_operation +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/min distance fault center +:name: closed_features_items_oneOf_2_sections_items_segments_items_composition-models_items_oneOf_1_min-distance-fault-center -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_1_min depth +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from which the composition of this feature is present. +:::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/max distance fault center +:name: closed_features_items_oneOf_2_sections_items_segments_items_composition-models_items_oneOf_1_max-distance-fault-center -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_1_max depth +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters to which the composition of this feature is present. +:::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_2_sections_items_segments_items_composition-models_items_oneOf_1_compositions -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/potential mantle temperature -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_1_potential mantle temperature +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_2_sections_items_segments_items_composition-models_items_oneOf_1_compositions_items -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +- **default value**:0 +- **type**:integer +- **documentation**: ::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/thermal expansion coefficient -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_1_thermal expansion coefficient +:::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/fractions +:name: closed_features_items_oneOf_2_sections_items_segments_items_composition-models_items_oneOf_1_fractions -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/specific heat -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_1_specific heat +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/fractions/items +:name: closed_features_items_oneOf_2_sections_items_segments_items_composition-models_items_oneOf_1_fractions_items -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +- **default value**:1.0 +- **type**:number +- **documentation**: ::::::::::: +:::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/operation +:name: closed_features_items_oneOf_2_sections_items_segments_items_composition-models_items_oneOf_1_operation +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] :::::::::::: -::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2 -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_2 -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max depth] -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/model -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_2_model +::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/operation -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_2_operation +::::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_2_min depth +::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_2_max depth +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1 +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1 -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/top temperature -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_2_top temperature +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. -::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/model +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1_model -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/bottom temperature -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_2_bottom temperature +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the top in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. -::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/min distance fault center +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1_min-distance-fault-center +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the fault center in meters from which the composition of this feature is present. +:::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/max distance fault center +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1_max-distance-fault-center +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the fault in meters to which the composition of this feature is present. :::::::::::: -::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3 -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_3 - -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1_compositions -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/model -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_3_model +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1_compositions_items -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] +- **default value**:0 +- **type**:integer +- **documentation**: ::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/operation -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_3_operation +:::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/orientation operation +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1_orientation-operation -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_3_min depth +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/grain sizes +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1_grain-sizes -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_3_max depth +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/grain sizes/items +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1_grain-sizes_items -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. +- **default value**:1.0 +- **type**:number +- **documentation**: ::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/temperature -:name: closed__features_items_oneOf_3_temperature models_items_oneOf_3_temperature +:::::::::::: -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/normalize grain sizes +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1_normalize-grain-sizes +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/normalize grain sizes/items +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1_normalize-grain-sizes_items +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::: :::::::::::: -:::::::::::::: -::::::::::::::: +::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/3/composition models -:name: closed__features_items_oneOf_3_composition models +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2 +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2 -- **documentation**: A list of composition models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items -:name: closed__features_items_oneOf_3_composition models_items +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf -:name: closed__features_items_oneOf_3_composition models_items_oneOf +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/model +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_model -::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1 -:name: closed__features_items_oneOf_3_composition models_items_oneOf_1 +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::: -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/min distance fault center +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_min-distance-fault-center -:::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/model -:name: closed__features_items_oneOf_3_composition models_items_oneOf_1_model +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the fault center in meters from which the composition of this feature is present. +:::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/max distance fault center +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_max-distance-fault-center -:::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth -:name: closed__features_items_oneOf_3_composition models_items_oneOf_1_min depth +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the fault in meters to which the composition of this feature is present. +:::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the composition of this feature is present. -::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/compositions +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_compositions -:::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth -:name: closed__features_items_oneOf_3_composition models_items_oneOf_1_max depth +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/compositions/items +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_compositions_items -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the composition of this feature is present. +- **default value**:0 +- **type**:integer +- **documentation**: ::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_3_composition models_items_oneOf_1_compositions +:::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_3_composition models_items_oneOf_1_compositions_items +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_rotation-matrices + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the grains which are present there for each compositions. +:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_rotation-matrices_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items/items +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_rotation-matrices_items_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items/items/items +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_rotation-matrices_items_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::: -- **default value**: 0 -- **type**: integer -- **documentation**: :::::::::: ::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/fractions -:name: closed__features_items_oneOf_3_composition models_items_oneOf_1_fractions - -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/fractions/items -:name: closed__features_items_oneOf_3_composition models_items_oneOf_1_fractions_items +:::::::::::: -- **default value**: 1.0 -- **type**: number -- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: :::::::::: ::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/operation -:name: closed__features_items_oneOf_3_composition models_items_oneOf_1_operation - -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: - +:::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/orientation operation +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_orientation-operation +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] :::::::::::: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/grain sizes +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_grain-sizes -:::::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/grain sizes/items +:name: closed_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_grain-sizes_items -::::::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/3/grains models -:name: closed__features_items_oneOf_3_grains models +:::::::::::: -- **documentation**: A list of grains models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items -:name: closed__features_items_oneOf_3_grains models_items -:::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf -:name: closed__features_items_oneOf_3_grains models_items_oneOf -::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1 -:name: closed__features_items_oneOf_3_grains models_items_oneOf_1 +::::::::::::: -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/model -:name: closed__features_items_oneOf_3_grains models_items_oneOf_1_model +::::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth -:name: closed__features_items_oneOf_3_grains models_items_oneOf_1_min depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the composition of this feature is present. -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth -:name: closed__features_items_oneOf_3_grains models_items_oneOf_1_max depth +::::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the composition of this feature is present. -::::::::::: +:::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_3_grains models_items_oneOf_1_compositions +::::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models +:name: closed_features_items_oneOf_2_sections_items_temperature-models -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_3_grains models_items_oneOf_1_compositions_items +- **documentation**:A list of temperature models. +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf -::::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1 +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_1 -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/orientation operation -:name: closed__features_items_oneOf_3_grains models_items_oneOf_1_orientation operation +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/model +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_1_model -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/grain sizes -:name: closed__features_items_oneOf_3_grains models_items_oneOf_1_grain sizes +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/grain sizes/items -:name: closed__features_items_oneOf_3_grains models_items_oneOf_1_grain sizes_items +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/operation +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_1_operation -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/min distance fault center +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_1_min-distance-fault-center -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/normalize grain sizes -:name: closed__features_items_oneOf_3_grains models_items_oneOf_1_normalize grain sizes +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/normalize grain sizes/items -:name: closed__features_items_oneOf_3_grains models_items_oneOf_1_normalize grain sizes_items +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/max distance fault center +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_1_max-distance-fault-center -- **default value**: true -- **type**: boolean -- **documentation**: -:::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/potential mantle temperature +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_1_potential-mantle-temperature +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/thermal expansion coefficient +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_1_thermal-expansion-coefficient -:::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2 -:name: closed__features_items_oneOf_3_grains models_items_oneOf_2 +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/specific heat +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_1_specific-heat -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/model -:name: closed__features_items_oneOf_3_grains models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth -:name: closed__features_items_oneOf_3_grains models_items_oneOf_2_min depth +::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the composition of this feature is present. -::::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2 +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_2 -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth -:name: closed__features_items_oneOf_3_grains models_items_oneOf_2_max depth +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max distance fault center] -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the composition of this feature is present. -::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/model +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_2_model -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/compositions -:name: closed__features_items_oneOf_3_grains models_items_oneOf_2_compositions +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/compositions/items -:name: closed__features_items_oneOf_3_grains models_items_oneOf_2_compositions_items +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/operation +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_2_operation -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/min distance fault center +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_2_min-distance-fault-center -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/rotation matrices -:name: closed__features_items_oneOf_3_grains models_items_oneOf_2_rotation matrices - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the grains which are present there for each compositions. -::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/rotation matrices/items -:name: closed__features_items_oneOf_3_grains models_items_oneOf_2_rotation matrices_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/rotation matrices/items/items -:name: closed__features_items_oneOf_3_grains models_items_oneOf_2_rotation matrices_items_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/rotation matrices/items/items/items -:name: closed__features_items_oneOf_3_grains models_items_oneOf_2_rotation matrices_items_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The minimum distance to the center of the fault. This determines where the linear temperature starts. +:::::::::::::: -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/max distance fault center +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_2_max-distance-fault-center -:::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The minimum distance to the center of the fault. This determines where the linear temperature end. +:::::::::::::: -::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/center temperature +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_2_center-temperature -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/Euler angles z-x-z -:name: closed__features_items_oneOf_3_grains models_items_oneOf_2_Euler angles z-x-z - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/Euler angles z-x-z/items -:name: closed__features_items_oneOf_3_grains models_items_oneOf_2_Euler angles z-x-z_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/Euler angles z-x-z/items/items -:name: closed__features_items_oneOf_3_grains models_items_oneOf_2_Euler angles z-x-z_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the center of this feature in degree Kelvin.If the value is below zero, the an adiabatic temperature is used. +:::::::::::::: -:::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/side temperature +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_2_side-temperature -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the sides of this feature in degree Kelvin. If the value is below zero, an adiabatic temperature is used. +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/orientation operation -:name: closed__features_items_oneOf_3_grains models_items_oneOf_2_orientation operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/grain sizes -:name: closed__features_items_oneOf_3_grains models_items_oneOf_2_grain sizes +::::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/grain sizes/items -:name: closed__features_items_oneOf_3_grains models_items_oneOf_2_grain sizes_items +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3 +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_3 -- **default value**: -1.0 -- **type**: number -- **documentation**: -:::::::::: +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] -::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3/model +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_3_model +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3/operation +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_3_operation -:::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3/min distance fault center +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_3_min-distance-fault-center +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from which the composition of this feature is present. :::::::::::::: -::::::::::::::: - +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3/max distance fault center +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_3_max-distance-fault-center +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3/temperature +:name: closed_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_3_temperature -::::::::::::::::{dropdown} /features/items/oneOf/4 -:name: closed__features_items_oneOf_4 +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::: -- **type**: object -- **documentation**: Oceanic plate object -- **additionalProperties**: false -- **required**: [model, coordinates] -:::::::::::::::{dropdown} /features/items/oneOf/4/model -:name: closed__features_items_oneOf_4_model -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -- **enum**: [oceanic plate] ::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/4/name -:name: closed__features_items_oneOf_4_name -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -::::::::::::::: +::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/4/coordinates -:name: closed__features_items_oneOf_4_coordinates - -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An array of 2d Points representing an array of coordinates where the feature is located. -::::::::::::::{dropdown} /features/items/oneOf/4/coordinates/items -:name: closed__features_items_oneOf_4_coordinates_items - -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -:::::::::::::{dropdown} /features/items/oneOf/4/coordinates/items/items -:name: closed__features_items_oneOf_4_coordinates_items_items - -- **type**: number -::::::::::::: +:::::::::::::::::: -:::::::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models +:name: closed_features_items_oneOf_2_sections_items_composition-models -::::::::::::::: +- **documentation**:A list of composition models. +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items +:name: closed_features_items_oneOf_2_sections_items_composition-models_items -:::::::::::::::{dropdown} /features/items/oneOf/4/interpolation -:name: closed__features_items_oneOf_4_interpolation +::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf +:name: closed_features_items_oneOf_2_sections_items_composition-models_items_oneOf -- **default value**: global -- **type**: string -- **documentation**: What type of interpolation should be used to enforce the minimum points per distance parameter. Options are global, none, linear, monotone spline and continuous monotone spline interpolation. If this value is set to global, the global value for interpolation is used. -::::::::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1 +:name: closed_features_items_oneOf_2_sections_items_composition-models_items_oneOf_1 -:::::::::::::::{dropdown} /features/items/oneOf/4/min depth -:name: closed__features_items_oneOf_4_min depth +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/model +:name: closed_features_items_oneOf_2_sections_items_composition-models_items_oneOf_1_model -:::::::::::::::{dropdown} /features/items/oneOf/4/max depth -:name: closed__features_items_oneOf_4_max depth +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/min distance fault center +:name: closed_features_items_oneOf_2_sections_items_composition-models_items_oneOf_1_min-distance-fault-center -:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models -:name: closed__features_items_oneOf_4_temperature models +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from which the composition of this feature is present. +:::::::::::::: -- **documentation**: A list of temperature models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items -:name: closed__features_items_oneOf_4_temperature models_items +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/max distance fault center +:name: closed_features_items_oneOf_2_sections_items_composition-models_items_oneOf_1_max-distance-fault-center -:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf -:name: closed__features_items_oneOf_4_temperature models_items_oneOf +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters to which the composition of this feature is present. +:::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1 -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_1 +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_2_sections_items_composition-models_items_oneOf_1_compositions -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_2_sections_items_composition-models_items_oneOf_1_compositions_items -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/model -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_1_model +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::::::: +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/operation -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_1_operation +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/fractions +:name: closed_features_items_oneOf_2_sections_items_composition-models_items_oneOf_1_fractions -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/fractions/items +:name: closed_features_items_oneOf_2_sections_items_composition-models_items_oneOf_1_fractions_items -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_1_min depth +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_1_max depth +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/operation +:name: closed_features_items_oneOf_2_sections_items_composition-models_items_oneOf_1_operation -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/potential mantle temperature -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_1_potential mantle temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/thermal expansion coefficient -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_1_thermal expansion coefficient +::::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/specific heat -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_1_specific heat +::::::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::::::: +:::::::::::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models +:name: closed_features_items_oneOf_2_sections_items_grains-models +- **documentation**:A list of grains models. +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items +:name: closed_features_items_oneOf_2_sections_items_grains-models_items -:::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf -::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2 -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_2 +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1 +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1 -- **type**: object -- **documentation**: Half space cooling mode -- **additionalProperties**: false -- **required**: [model, ridge coordinates, spreading velocity, max depth] +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/model -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_2_model +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/model +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [half space model] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/operation -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_2_operation +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/min distance fault center +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1_min-distance-fault-center -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the fault center in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_2_min depth +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/max distance fault center +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1_max-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the fault in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_2_max depth +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1_compositions -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present.Because half-space reaches background temperature asymptotically, this value should be ~2 times the nominal plate thickness of 100 km -::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1_compositions_items -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/top temperature -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_2_top temperature +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: -- **default value**: 293.15 -- **type**: number -- **documentation**: The actual surface temperature in degree Kelvin for this feature. -::::::::::: +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/bottom temperature -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_2_bottom temperature +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/orientation operation +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1_orientation-operation -- **default value**: -1.0 -- **type**: number -- **documentation**: The mantle temperature for the half-space cooling modelin degree Kelvin for this feature. If the model has an adiabatic gradientthis should be the mantle potential temperature, and T = Tad + Thalf. -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/spreading velocity -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_2_spreading velocity +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/grain sizes +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1_grain-sizes -- **default value**: -1.0 -- **type**: number -- **documentation**: The spreading velocity of the plate in meter per year. This is the velocity with which one side moves away from the ridge. -::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/grain sizes/items +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1_grain-sizes_items -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/ridge coordinates -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_2_ridge coordinates - -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. -::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/ridge coordinates/items -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_2_ridge coordinates_items - -- **type**: array -- **minItems**: 2 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/ridge coordinates/items/items -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_2_ridge coordinates_items_items - -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/ridge coordinates/items/items/items -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_2_ridge coordinates_items_items_items - -- **type**: number -:::::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/normalize grain sizes +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1_normalize-grain-sizes -::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/normalize grain sizes/items +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1_normalize-grain-sizes_items +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::::: +:::::::::::::: -:::::::::::: -::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3 -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_3 -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max depth] +::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/model -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_3_model +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2 +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2 -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::::::: +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/operation -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_3_operation +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/model +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_model -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_3_min depth +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/min distance fault center +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the fault center in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_3_max depth +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/max distance fault center +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the fault in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/top temperature -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_3_top temperature +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/compositions +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_compositions -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. -::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/compositions/items +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_compositions_items + +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/bottom temperature -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_3_bottom temperature +:::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the top in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/rotation matrices +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_rotation-matrices + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the grains which are present there for each compositions. +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/rotation matrices/items +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_rotation-matrices_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/rotation matrices/items/items +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_rotation-matrices_items_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/rotation matrices/items/items/items +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_rotation-matrices_items_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: ::::::::::: +:::::::::::: +::::::::::::: -:::::::::::: +:::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4 -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_4 +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/Euler angles z-x-z +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_Euler-angles-z-x-z + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/Euler angles z-x-z/items +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::: -- **type**: object -- **documentation**: Plate model. -- **additionalProperties**: false -- **required**: [model, max depth] +::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/model -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_4_model +:::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [plate model] -::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/orientation operation +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_orientation-operation -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/operation -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_4_operation +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/grain sizes +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_grain-sizes -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_4_min depth +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/grain sizes/items +:name: closed_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_grain-sizes_items -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_4_max depth +:::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/top temperature -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_4_top temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::::: +::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/bottom temperature -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_4_bottom temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::::: +::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/spreading velocity -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_4_spreading velocity +:::::::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The spreading velocity of the plate in meter per year. This is the velocity with which one side moves away from the ridge. -::::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/coordinate +:name: closed_features_items_oneOf_2_sections_items_coordinate -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/ridge coordinates -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_4_ridge coordinates - -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. -::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/ridge coordinates/items -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_4_ridge coordinates_items - -- **type**: array -- **minItems**: 2 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/ridge coordinates/items/items -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_4_ridge coordinates_items_items - -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/ridge coordinates/items/items/items -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_4_ridge coordinates_items_items_items - -- **type**: number -:::::::: +- **default value**:0 +- **type**:integer +- **documentation**:The coordinate which should be overwritten +:::::::::::::::::: -::::::::: -:::::::::: -::::::::::: +::::::::::::::::::: +:::::::::::::::::::: -:::::::::::: -::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5 -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_5 +::::::::::::::::::::: -- **type**: object -- **documentation**: Plate model, but with a fixed age. -- **additionalProperties**: false -- **required**: [model, max depth] +:::::::::::::::::::::{dropdown} /features/items/oneOf/3 +:name: closed_features_items_oneOf_3 -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/model -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_5_model +- **type**:object +- **documentation**:Mantle layer object +- **additionalProperties**:false +- **required**:[model, coordinates] -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [plate model constant age] -::::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/3/model +:name: closed_features_items_oneOf_3_model -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/operation -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_5_operation +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +- **enum**:[mantle layer] +:::::::::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/3/name +:name: closed_features_items_oneOf_3_name -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_5_min depth +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +:::::::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/3/coordinates +:name: closed_features_items_oneOf_3_coordinates -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_5_max depth +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An array of 2d Points representing an array of coordinates where the feature is located. +:::::::::::::::::::{dropdown} /features/items/oneOf/3/coordinates/items +:name: closed_features_items_oneOf_3_coordinates_items -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +::::::::::::::::::{dropdown} /features/items/oneOf/3/coordinates/items/items +:name: closed_features_items_oneOf_3_coordinates_items_items -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/top temperature -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_5_top temperature +- **type**:number +:::::::::::::::::: -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::::: +::::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/bottom temperature -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_5_bottom temperature +:::::::::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/3/interpolation +:name: closed_features_items_oneOf_3_interpolation -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/plate age -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_5_plate age +- **default value**:global +- **type**:string +- **documentation**:What type of interpolation should be used to enforce the minimum points per distance parameter. Options are global, none, linear, monotone spline and continuous monotone spline interpolation. If this value is set to global, the global value for interpolation is used. +:::::::::::::::::::: -- **default value**: 80000.0 -- **type**: number -- **documentation**: The age of the plate in year. This age is assigned to the whole plate. -::::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/3/min depth +:name: closed_features_items_oneOf_3_min-depth +- **default value**:0.0 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/3/max depth +:name: closed_features_items_oneOf_3_max-depth -:::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6 -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_6 +::::::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models +:name: closed_features_items_oneOf_3_temperature-models -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] +- **documentation**:A list of temperature models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items +:name: closed_features_items_oneOf_3_temperature-models_items -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/model -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_6_model +::::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::::::: +:::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1 -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/operation -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_6_operation +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/model +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_model -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_6_min depth +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/operation +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_operation -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_6_max depth +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/temperature -:name: closed__features_items_oneOf_4_temperature models_items_oneOf_6_temperature +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::: -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/potential mantle temperature +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_potential-mantle-temperature -:::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/thermal expansion coefficient +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_thermal-expansion-coefficient -:::::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::::: -::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/specific heat +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_specific-heat -:::::::::::::::{dropdown} /features/items/oneOf/4/composition models -:name: closed__features_items_oneOf_4_composition models +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::::: -- **documentation**: A list of composition models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items -:name: closed__features_items_oneOf_4_composition models_items -:::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf -:name: closed__features_items_oneOf_4_composition models_items_oneOf -::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1 -:name: closed__features_items_oneOf_4_composition models_items_oneOf_1 +::::::::::::::::: -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +:::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2 -:::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/model -:name: closed__features_items_oneOf_4_composition models_items_oneOf_1_model +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max depth] -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/model +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_model -:::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth -:name: closed__features_items_oneOf_4_composition models_items_oneOf_1_min depth +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the composition of this feature is present. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/operation +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_operation -:::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth -:name: closed__features_items_oneOf_4_composition models_items_oneOf_1_max depth +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the composition of this feature is present. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth -:::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_4_composition models_items_oneOf_1_compositions +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_4_composition models_items_oneOf_1_compositions_items +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::: -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/top temperature +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_top-temperature -:::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/fractions -:name: closed__features_items_oneOf_4_composition models_items_oneOf_1_fractions +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. +:::::::::::::::: -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/fractions/items -:name: closed__features_items_oneOf_4_composition models_items_oneOf_1_fractions_items +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/bottom temperature +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_bottom-temperature -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the top in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. +:::::::::::::::: -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/operation -:name: closed__features_items_oneOf_4_composition models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +::::::::::::::::: +:::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3 +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] -:::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/model +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_model +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::::::: -:::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/operation +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_operation -::::::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/4/grains models -:name: closed__features_items_oneOf_4_grains models +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth -- **documentation**: A list of grains models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items -:name: closed__features_items_oneOf_4_grains models_items +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf -:name: closed__features_items_oneOf_4_grains models_items_oneOf +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth -::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1 -:name: closed__features_items_oneOf_4_grains models_items_oneOf_1 +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::: -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/temperature +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_temperature -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/model -:name: closed__features_items_oneOf_4_grains models_items_oneOf_1_model +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth -:name: closed__features_items_oneOf_4_grains models_items_oneOf_1_min depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the composition of this feature is present. -::::::::::: +::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth -:name: closed__features_items_oneOf_4_grains models_items_oneOf_1_max depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the composition of this feature is present. -::::::::::: +::::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_4_grains models_items_oneOf_1_compositions +:::::::::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_4_grains models_items_oneOf_1_compositions_items +::::::::::::::::::::{dropdown} /features/items/oneOf/3/composition models +:name: closed_features_items_oneOf_3_composition-models -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **documentation**:A list of composition models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items +:name: closed_features_items_oneOf_3_composition-models_items -::::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf +:name: closed_features_items_oneOf_3_composition-models_items_oneOf -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/orientation operation -:name: closed__features_items_oneOf_4_grains models_items_oneOf_1_orientation operation +:::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1 +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1 -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/grain sizes -:name: closed__features_items_oneOf_4_grains models_items_oneOf_1_grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/model +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_model -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/grain sizes/items -:name: closed__features_items_oneOf_4_grains models_items_oneOf_1_grain sizes_items +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::::::: -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/normalize grain sizes -:name: closed__features_items_oneOf_4_grains models_items_oneOf_1_normalize grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/normalize grain sizes/items -:name: closed__features_items_oneOf_4_grains models_items_oneOf_1_normalize grain sizes_items +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::: -- **default value**: true -- **type**: boolean -- **documentation**: -:::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_compositions -::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_compositions_items +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: +:::::::::::::::: -:::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/fractions +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_fractions -::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2 -:name: closed__features_items_oneOf_4_grains models_items_oneOf_2 +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/fractions/items +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_fractions_items -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/model -:name: closed__features_items_oneOf_4_grains models_items_oneOf_2_model +:::::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/operation +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_operation -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth -:name: closed__features_items_oneOf_4_grains models_items_oneOf_2_min depth +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the composition of this feature is present. -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth -:name: closed__features_items_oneOf_4_grains models_items_oneOf_2_max depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the composition of this feature is present. -::::::::::: +::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/compositions -:name: closed__features_items_oneOf_4_grains models_items_oneOf_2_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/compositions/items -:name: closed__features_items_oneOf_4_grains models_items_oneOf_2_compositions_items +::::::::::::::::::: -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +:::::::::::::::::::: -::::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/3/grains models +:name: closed_features_items_oneOf_3_grains-models -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/rotation matrices -:name: closed__features_items_oneOf_4_grains models_items_oneOf_2_rotation matrices - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the grains which are present there for each compositions. -::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/rotation matrices/items -:name: closed__features_items_oneOf_4_grains models_items_oneOf_2_rotation matrices_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/rotation matrices/items/items -:name: closed__features_items_oneOf_4_grains models_items_oneOf_2_rotation matrices_items_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/rotation matrices/items/items/items -:name: closed__features_items_oneOf_4_grains models_items_oneOf_2_rotation matrices_items_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -:::::::: +- **documentation**:A list of grains models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items +:name: closed_features_items_oneOf_3_grains-models_items -::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf +:name: closed_features_items_oneOf_3_grains-models_items_oneOf -:::::::::: +:::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1 +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1 -::::::::::: +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/Euler angles z-x-z -:name: closed__features_items_oneOf_4_grains models_items_oneOf_2_Euler angles z-x-z - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/Euler angles z-x-z/items -:name: closed__features_items_oneOf_4_grains models_items_oneOf_2_Euler angles z-x-z_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/Euler angles z-x-z/items/items -:name: closed__features_items_oneOf_4_grains models_items_oneOf_2_Euler angles z-x-z_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/model +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_model -:::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::::::: -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/orientation operation -:name: closed__features_items_oneOf_4_grains models_items_oneOf_2_orientation operation +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/grain sizes -:name: closed__features_items_oneOf_4_grains models_items_oneOf_2_grain sizes +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/grain sizes/items -:name: closed__features_items_oneOf_4_grains models_items_oneOf_2_grain sizes_items +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_compositions -- **default value**: -1.0 -- **type**: number -- **documentation**: -:::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_compositions_items -::::::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/orientation operation +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_orientation-operation -:::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/grain sizes +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_grain-sizes -:::::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/grain sizes/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_grain-sizes_items +- **default value**:1.0 +- **type**:number +- **documentation**: ::::::::::::::: +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/normalize grain sizes +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_normalize-grain-sizes -:::::::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/normalize grain sizes/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_normalize-grain-sizes_items -::::::::::::::::{dropdown} /features/items/oneOf/5 -:name: closed__features_items_oneOf_5 +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::::::: -- **type**: object -- **documentation**: Subducting slab object -- **additionalProperties**: false -- **required**: [model, coordinates] +:::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/model -:name: closed__features_items_oneOf_5_model -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -- **enum**: [subducting plate] -::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/name -:name: closed__features_items_oneOf_5_name +::::::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -::::::::::::::: +:::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2 +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2 -:::::::::::::::{dropdown} /features/items/oneOf/5/coordinates -:name: closed__features_items_oneOf_5_coordinates - -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An array of 2d Points representing an array of coordinates where the feature is located. -::::::::::::::{dropdown} /features/items/oneOf/5/coordinates/items -:name: closed__features_items_oneOf_5_coordinates_items - -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -:::::::::::::{dropdown} /features/items/oneOf/5/coordinates/items/items -:name: closed__features_items_oneOf_5_coordinates_items_items - -- **type**: number -::::::::::::: +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/model +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_model -::::::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/interpolation -:name: closed__features_items_oneOf_5_interpolation +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth -- **default value**: global -- **type**: string -- **documentation**: What type of interpolation should be used to enforce the minimum points per distance parameter. Options are global, none, linear, monotone spline and continuous monotone spline interpolation. If this value is set to global, the global value for interpolation is used. -::::::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/min depth -:name: closed__features_items_oneOf_5_min depth +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/max depth -:name: closed__features_items_oneOf_5_max depth +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/compositions +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_compositions -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth to which this feature is present +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/compositions/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_compositions_items + +- **default value**:0 +- **type**:integer +- **documentation**: ::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/dip point -:name: closed__features_items_oneOf_5_dip point +:::::::::::::::: -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: The depth to which this feature is present -::::::::::::::{dropdown} /features/items/oneOf/5/dip point/items -:name: closed__features_items_oneOf_5_dip point_items +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/rotation matrices +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_rotation-matrices + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the grains which are present there for each compositions. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/rotation matrices/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_rotation-matrices_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/rotation matrices/items/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_rotation-matrices_items_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/rotation matrices/items/items/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_rotation-matrices_items_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::::::: -- **type**: number :::::::::::::: ::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/segments -:name: closed__features_items_oneOf_5_segments +:::::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: The depth to which this feature is present -::::::::::::::{dropdown} /features/items/oneOf/5/segments/items -:name: closed__features_items_oneOf_5_segments_items +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/Euler angles z-x-z +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_Euler-angles-z-x-z + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/Euler angles z-x-z/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_Euler-angles-z-x-z_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/Euler angles z-x-z/items/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: -- **type**: object -- **additionalProperties**: false -- **documentation**: -- **required**: [length, thickness, angle] +::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/length -:name: closed__features_items_oneOf_5_segments_items_length +:::::::::::::::: -- **type**: number -::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/orientation operation +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_orientation-operation -:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/thickness -:name: closed__features_items_oneOf_5_segments_items_thickness +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::::{dropdown} /features/items/oneOf/5/segments/items/thickness/items -:name: closed__features_items_oneOf_5_segments_items_thickness_items +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/grain sizes +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_grain-sizes -- **type**: number -:::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/grain sizes/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_grain-sizes_items -::::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/top truncation -:name: closed__features_items_oneOf_5_segments_items_top truncation +:::::::::::::::: -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::::{dropdown} /features/items/oneOf/5/segments/items/top truncation/items -:name: closed__features_items_oneOf_5_segments_items_top truncation_items -- **type**: number -:::::::::::: -::::::::::::: +::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/angle -:name: closed__features_items_oneOf_5_segments_items_angle -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::::{dropdown} /features/items/oneOf/5/segments/items/angle/items -:name: closed__features_items_oneOf_5_segments_items_angle_items +::::::::::::::::::: -- **type**: number -:::::::::::: +:::::::::::::::::::: -::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models -:name: closed__features_items_oneOf_5_segments_items_temperature models -- **documentation**: -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items -:name: closed__features_items_oneOf_5_segments_items_temperature models_items +::::::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf +:::::::::::::::::::::{dropdown} /features/items/oneOf/4 +:name: closed_features_items_oneOf_4 -::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1 -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_1 +- **type**:object +- **documentation**:Oceanic plate object +- **additionalProperties**:false +- **required**:[model, coordinates] -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +::::::::::::::::::::{dropdown} /features/items/oneOf/4/model +:name: closed_features_items_oneOf_4_model -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/model -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_1_model +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +- **enum**:[oceanic plate] +:::::::::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/4/name +:name: closed_features_items_oneOf_4_name -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/operation -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_1_operation +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +:::::::::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/4/coordinates +:name: closed_features_items_oneOf_4_coordinates -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/min distance slab top -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_1_min distance slab top +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An array of 2d Points representing an array of coordinates where the feature is located. +:::::::::::::::::::{dropdown} /features/items/oneOf/4/coordinates/items +:name: closed_features_items_oneOf_4_coordinates_items -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +::::::::::::::::::{dropdown} /features/items/oneOf/4/coordinates/items/items +:name: closed_features_items_oneOf_4_coordinates_items_items -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/max distance slab top -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_1_max distance slab top +- **type**:number +:::::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +::::::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/potential mantle temperature -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_1_potential mantle temperature +:::::::::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/4/interpolation +:name: closed_features_items_oneOf_4_interpolation -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/thermal expansion coefficient -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_1_thermal expansion coefficient +- **default value**:global +- **type**:string +- **documentation**:What type of interpolation should be used to enforce the minimum points per distance parameter. Options are global, none, linear, monotone spline and continuous monotone spline interpolation. If this value is set to global, the global value for interpolation is used. +:::::::::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/4/min depth +:name: closed_features_items_oneOf_4_min-depth -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/specific heat -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_1_specific heat +- **default value**:0.0 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/4/max depth +:name: closed_features_items_oneOf_4_max-depth +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models +:name: closed_features_items_oneOf_4_temperature-models -:::::::::: +- **documentation**:A list of temperature models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items +:name: closed_features_items_oneOf_4_temperature-models_items -::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2 -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_2 +::::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max distance slab top] +:::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1 -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/model -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_2_model +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/model +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_model -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/operation -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_2_operation +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/operation +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_operation -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/min distance slab top -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_2_min distance slab top +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/max distance slab top -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_2_max distance slab top +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/top temperature -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_2_top temperature +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::: -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/potential mantle temperature +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_potential-mantle-temperature -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/bottom temperature -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_2_bottom temperature +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the bottom in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/thermal expansion coefficient +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_thermal-expansion-coefficient +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/specific heat +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_specific-heat -:::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3 -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_3 -- **type**: object -- **documentation**: Mass conserving temperature model. The temperature model uses the heat content (proportional to to thermal mass anomaly) to define a smooth temperature profile that conserves mass along the slab length. An empirical (linear) model is used to define how the minimum temperature increases with depth and how the location of the minimum temperature shifts into the slab interior. The slab is divided in to top and bottom parts, which meet at the location where the minimum temperature occurs in the slab. For the bottom slab the temperature is defined by a half-space cooling model. For the top of the slab the temperature is defined by one side of a 1D infinite space cooling model. The age of the overriding plate is used so the slab temperature at shallow depth smoothly transitions to the temperature of the overriding plate: this is not perfect, and is affected by the value of "top truncation" parameter subducting plate. Also note that the parameter "thickness" for the subducting plate segments needs to be defined but is not used. Note that the empirical model used to define how Tmin increases with depth and how the position of Tmin shift with depth is expected to change somewhat after better calibrating with further tests. -- **additionalProperties**: false -- **required**: [model, plate velocity] -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/model -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_model +::::::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [mass conserving] -::::::::: +:::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2 -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/operation -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_operation +- **type**:object +- **documentation**:Half space cooling mode +- **additionalProperties**:false +- **required**:[model, ridge coordinates, spreading velocity, max depth] -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/model +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_model -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/min distance slab top -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_min distance slab top +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[half space model] +:::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be negative and should be 1.5-2 times larger thatn the nominal slab thickness to allow the diffusion of cold temperatures from in the slab into the mantle above the slab surface. Also note that the top truncation value for the slab segment needs to have a value of -1, otherwise the temperature above the slab will be cut off at a distance less than the value set here. -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/operation +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_operation -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/max distance slab top -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_max distance slab top +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be positive and approximately 2.5-3.0 times larger than the nominal slab thickness to allow the diffusion of coldtemperatures from in the slab into the mantle below the slab surface.For example if the slab starts with cold temperatures over a 100 km wide region, thisparameters should be about 250 km. -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/density -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_density +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::: -- **default value**: 3300.0 -- **type**: number -- **documentation**: The reference density of the subducting plate in $kg/m^3$ -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/plate velocity -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_plate velocity +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the temperature of this feature is present.Because half-space reaches background temperature asymptotically, this value should be ~2 times the nominal plate thickness of 100 km +:::::::::::::::: -- **default value**: NaN -- **type**: number -- **documentation**: The velocity with which the plate subducts in meters per year. -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/top temperature +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_top-temperature -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/coupling depth -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_coupling depth +- **default value**:293.15 +- **type**:number +- **documentation**:The actual surface temperature in degree Kelvin for this feature. +:::::::::::::::: -- **default value**: NaN -- **type**: number -- **documentation**: The depth at which the slab surface first comes in contact with the hot mantle wedge in meters. -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/bottom temperature +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_bottom-temperature -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/shallow dip -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_shallow dip +- **default value**:-1.0 +- **type**:number +- **documentation**:The mantle temperature for the half-space cooling modelin degree Kelvin for this feature. If the model has an adiabatic gradientthis should be the mantle potential temperature, and T = Tad + Thalf. +:::::::::::::::: -- **default value**: NaN -- **type**: number -- **documentation**: The average dip of the slab at depths shallower than the coupling depth in degrees. If the shallow slab dip changes with distance along the slab surface, then this will need to be adjusted to get the temperature above and below the coupling depth to match. -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/spreading velocity +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_spreading-velocity -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/thermal conductivity -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_thermal conductivity +- **default value**:-1.0 +- **type**:number +- **documentation**:The spreading velocity of the plate in meter per year. This is the velocity with which one side moves away from the ridge. +:::::::::::::::: -- **default value**: 3.3 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/ridge coordinates +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_ridge-coordinates + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/ridge coordinates/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_ridge-coordinates_items + +- **type**:array +- **minItems**:2 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/ridge coordinates/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_ridge-coordinates_items_items + +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/ridge coordinates/items/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_ridge-coordinates_items_items_items + +- **type**:number +::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/thermal expansion coefficient -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_thermal expansion coefficient +:::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. -::::::::: +::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/specific heat -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_specific heat +:::::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. -::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/thermal diffusivity -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_thermal diffusivity -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::::: +::::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/adiabatic heating -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_adiabatic heating +:::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3 -- **default value**: true -- **type**: boolean -- **documentation**: Whether adiabatic heating should be used for the slab. -::::::::: +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max depth] -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/taper distance -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_taper distance +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/model +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_model -- **default value**: 100000.0 -- **type**: number -- **documentation**: Distance over which to taper the slab tip.tapers the initial heat content to zero and the minimum temperature to the background temperature. -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/potential mantle temperature -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_potential mantle temperature +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/operation +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_operation -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/ridge coordinates -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_ridge coordinates - -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. -::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/ridge coordinates/items -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_ridge coordinates_items - -- **type**: array -- **minItems**: 2 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: -:::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/ridge coordinates/items/items -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_ridge coordinates_items_items - -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/ridge coordinates/items/items/items -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_ridge coordinates_items_items_items - -- **type**: number -:::::: - -::::::: +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth -:::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::: -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/top temperature +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_top-temperature -:::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. +:::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4 -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_4 +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/bottom temperature +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_bottom-temperature -- **type**: object -- **documentation**: Plate model (based on McKenzie, 1970). -- **additionalProperties**: false -- **required**: [model, plate velocity] +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the top in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. +:::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/model -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [plate model] -::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/operation -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_operation +::::::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +:::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4 -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/min distance slab top -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_min distance slab top +- **type**:object +- **documentation**:Plate model. +- **additionalProperties**:false +- **required**:[model, max depth] -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/model +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_model -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/max distance slab top -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_max distance slab top +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[plate model] +:::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/operation +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_operation -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/density -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_density +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth + +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/top temperature +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_top-temperature + +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/bottom temperature +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_bottom-temperature + +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/spreading velocity +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_spreading-velocity + +- **default value**:-1.0 +- **type**:number +- **documentation**:The spreading velocity of the plate in meter per year. This is the velocity with which one side moves away from the ridge. +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/ridge coordinates +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_ridge-coordinates + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/ridge coordinates/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_ridge-coordinates_items + +- **type**:array +- **minItems**:2 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/ridge coordinates/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_ridge-coordinates_items_items + +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/ridge coordinates/items/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_ridge-coordinates_items_items_items + +- **type**:number +::::::::::::: + +:::::::::::::: + +::::::::::::::: + +:::::::::::::::: + + + +::::::::::::::::: + +:::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5 + +- **type**:object +- **documentation**:Plate model, but with a fixed age. +- **additionalProperties**:false +- **required**:[model, max depth] + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/model +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_model + +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[plate model constant age] +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/operation +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_operation + +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth + +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/top temperature +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_top-temperature + +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/bottom temperature +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_bottom-temperature + +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/plate age +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_plate-age + +- **default value**:80000.0 +- **type**:number +- **documentation**:The age of the plate in year. This age is assigned to the whole plate. +:::::::::::::::: + + + +::::::::::::::::: + +:::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6 + +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/model +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_model + +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/operation +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_operation + +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth + +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/temperature +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_temperature + +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::::: + + + +::::::::::::::::: + + +::::::::::::::::::: + +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/4/composition models +:name: closed_features_items_oneOf_4_composition-models + +- **documentation**:A list of composition models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items +:name: closed_features_items_oneOf_4_composition-models_items + +::::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf +:name: closed_features_items_oneOf_4_composition-models_items_oneOf + +:::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1 +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1 + +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] + +::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/model +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_model + +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth + +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_compositions + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_compositions_items + +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/fractions +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_fractions + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/fractions/items +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_fractions_items + +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::::: + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/operation +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_operation + +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: + + + +::::::::::::::::: + + +::::::::::::::::::: + +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/4/grains models +:name: closed_features_items_oneOf_4_grains-models + +- **documentation**:A list of grains models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items +:name: closed_features_items_oneOf_4_grains-models_items + +::::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf +:name: closed_features_items_oneOf_4_grains-models_items_oneOf + +:::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1 +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1 + +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] + +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/model +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_model + +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth + +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_compositions + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_compositions_items + +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/orientation operation +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_orientation-operation + +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/grain sizes +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_grain-sizes + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/grain sizes/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_grain-sizes_items + +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::::: + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/normalize grain sizes +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_normalize-grain-sizes + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/normalize grain sizes/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_normalize-grain-sizes_items + +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::::::: + +:::::::::::::::: + + + +::::::::::::::::: + +:::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2 +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2 + +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] + +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/model +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_model + +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth + +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/compositions +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_compositions + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/compositions/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_compositions_items + +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/rotation matrices +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_rotation-matrices + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the grains which are present there for each compositions. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/rotation matrices/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_rotation-matrices_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/rotation matrices/items/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_rotation-matrices_items_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/rotation matrices/items/items/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_rotation-matrices_items_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::::::: + +:::::::::::::: + +::::::::::::::: + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/Euler angles z-x-z +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_Euler-angles-z-x-z + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/Euler angles z-x-z/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_Euler-angles-z-x-z_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/Euler angles z-x-z/items/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::: + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/orientation operation +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_orientation-operation + +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/grain sizes +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_grain-sizes + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/grain sizes/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_grain-sizes_items + +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::::::: + +:::::::::::::::: + + + +::::::::::::::::: + + +::::::::::::::::::: + +:::::::::::::::::::: + + + +::::::::::::::::::::: + +:::::::::::::::::::::{dropdown} /features/items/oneOf/5 +:name: closed_features_items_oneOf_5 + +- **type**:object +- **documentation**:Subducting slab object +- **additionalProperties**:false +- **required**:[model, coordinates] + +::::::::::::::::::::{dropdown} /features/items/oneOf/5/model +:name: closed_features_items_oneOf_5_model + +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +- **enum**:[subducting plate] +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/5/name +:name: closed_features_items_oneOf_5_name + +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/5/coordinates +:name: closed_features_items_oneOf_5_coordinates + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An array of 2d Points representing an array of coordinates where the feature is located. +:::::::::::::::::::{dropdown} /features/items/oneOf/5/coordinates/items +:name: closed_features_items_oneOf_5_coordinates_items + +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +::::::::::::::::::{dropdown} /features/items/oneOf/5/coordinates/items/items +:name: closed_features_items_oneOf_5_coordinates_items_items + +- **type**:number +:::::::::::::::::: + +::::::::::::::::::: + +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/5/interpolation +:name: closed_features_items_oneOf_5_interpolation + +- **default value**:global +- **type**:string +- **documentation**:What type of interpolation should be used to enforce the minimum points per distance parameter. Options are global, none, linear, monotone spline and continuous monotone spline interpolation. If this value is set to global, the global value for interpolation is used. +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/5/min depth +:name: closed_features_items_oneOf_5_min-depth + +- **default value**:0.0 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/5/max depth +:name: closed_features_items_oneOf_5_max-depth + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/5/dip point +:name: closed_features_items_oneOf_5_dip-point + +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**:The depth to which this feature is present +:::::::::::::::::::{dropdown} /features/items/oneOf/5/dip point/items +:name: closed_features_items_oneOf_5_dip-point_items + +- **type**:number +::::::::::::::::::: + +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/5/segments +:name: closed_features_items_oneOf_5_segments + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:The depth to which this feature is present +:::::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items +:name: closed_features_items_oneOf_5_segments_items + +- **type**:object +- **additionalProperties**:false +- **documentation**: +- **required**:[length, thickness, angle] + +::::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/length +:name: closed_features_items_oneOf_5_segments_items_length + +- **type**:number +:::::::::::::::::: + +::::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/thickness +:name: closed_features_items_oneOf_5_segments_items_thickness + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/thickness/items +:name: closed_features_items_oneOf_5_segments_items_thickness_items + +- **type**:number +::::::::::::::::: + +:::::::::::::::::: + +::::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/top truncation +:name: closed_features_items_oneOf_5_segments_items_top-truncation + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/top truncation/items +:name: closed_features_items_oneOf_5_segments_items_top-truncation_items + +- **type**:number +::::::::::::::::: + +:::::::::::::::::: + +::::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/angle +:name: closed_features_items_oneOf_5_segments_items_angle + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/angle/items +:name: closed_features_items_oneOf_5_segments_items_angle_items + +- **type**:number +::::::::::::::::: + +:::::::::::::::::: + +::::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models +:name: closed_features_items_oneOf_5_segments_items_temperature-models + +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items -- **default value**: 3300.0 -- **type**: number -- **documentation**: The reference density of the subducting plate in $kg/m^3$ -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/plate velocity -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_plate velocity +:::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1 +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_1 -- **default value**: NaN -- **type**: number -- **documentation**: The velocity in meters per year with which the plate subducts in meters per year. -::::::::: +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/thermal conductivity -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_thermal conductivity +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/model +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_1_model -- **default value**: 2.0 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/thermal expansion coefficient -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_thermal expansion coefficient +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/operation +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_1_operation -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/specific heat -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_specific heat +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/min distance slab top +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_1_min-distance-slab-top -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/adiabatic heating -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_adiabatic heating +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/max distance slab top +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_1_max-distance-slab-top -- **default value**: true -- **type**: boolean -- **documentation**: Wheter adiabatic heating should be used for the slab. Setting the parameter to false leads to equation 26 from McKenzie (1970),which is the result obtained from McKenzie 1969. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/potential mantle temperature -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_potential mantle temperature +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/potential mantle temperature +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_1_potential-mantle-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/thermal expansion coefficient +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_1_thermal-expansion-coefficient +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::: -:::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/specific heat +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_1_specific-heat -::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5 -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_5 +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::: -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5/model -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_5_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::::: +::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5/operation -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_5_operation +:::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2 +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_2 -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max distance slab top] -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5/min distance slab top -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_5_min distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/model +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_2_model -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5/max distance slab top -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_5_max distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/operation +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_2_operation -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5/temperature -:name: closed__features_items_oneOf_5_segments_items_temperature models_items_oneOf_5_temperature +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/min distance slab top +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_2_min-distance-slab-top -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/max distance slab top +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_2_max-distance-slab-top +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/top temperature +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_2_top-temperature + +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/bottom temperature +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_2_bottom-temperature + +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the bottom in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. +:::::::::::::: + + + +::::::::::::::: + +:::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3 +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3 + +- **type**:object +- **documentation**:Mass conserving temperature model. The temperature model uses the heat content (proportional to to thermal mass anomaly) to define a smooth temperature profile that conserves mass along the slab length. An empirical (linear) model is used to define how the minimum temperature increases with depth and how the location of the minimum temperature shifts into the slab interior. The slab is divided in to top and bottom parts, which meet at the location where the minimum temperature occurs in the slab. For the bottom slab the temperature is defined by a half-space cooling model. For the top of the slab the temperature is defined by one side of a 1D infinite space cooling model. The age of the overriding plate is used so the slab temperature at shallow depth smoothly transitions to the temperature of the overriding plate: this is not perfect, and is affected by the value of "top truncation" parameter subducting plate. Also note that the parameter "thickness" for the subducting plate segments needs to be defined but is not used. Note that the empirical model used to define how Tmin increases with depth and how the position of Tmin shift with depth is expected to change somewhat after better calibrating with further tests. +- **additionalProperties**:false +- **required**:[model, plate velocity] + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/model +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_model + +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[mass conserving] +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/operation +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_operation + +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/min distance slab top +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_min-distance-slab-top + +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be negative and should be 1.5-2 times larger thatn the nominal slab thickness to allow the diffusion of cold temperatures from in the slab into the mantle above the slab surface. Also note that the top truncation value for the slab segment needs to have a value of -1, otherwise the temperature above the slab will be cut off at a distance less than the value set here. +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/max distance slab top +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_max-distance-slab-top + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be positive and approximately 2.5-3.0 times larger than the nominal slab thickness to allow the diffusion of coldtemperatures from in the slab into the mantle below the slab surface.For example if the slab starts with cold temperatures over a 100 km wide region, thisparameters should be about 250 km. +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/density +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_density + +- **default value**:3300.0 +- **type**:number +- **documentation**:The reference density of the subducting plate in $kg/m^3$ +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/plate velocity +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_plate-velocity + +- **default value**:NaN +- **type**:number +- **documentation**:The velocity with which the plate subducts in meters per year. +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/coupling depth +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_coupling-depth + +- **default value**:NaN +- **type**:number +- **documentation**:The depth at which the slab surface first comes in contact with the hot mantle wedge in meters. +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/shallow dip +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_shallow-dip + +- **default value**:NaN +- **type**:number +- **documentation**:The average dip of the slab at depths shallower than the coupling depth in degrees. If the shallow slab dip changes with distance along the slab surface, then this will need to be adjusted to get the temperature above and below the coupling depth to match. +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/thermal conductivity +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_thermal-conductivity + +- **default value**:3.3 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/thermal expansion coefficient +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_thermal-expansion-coefficient + +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/specific heat +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_specific-heat + +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/thermal diffusivity +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_thermal-diffusivity + +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/adiabatic heating +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_adiabatic-heating + +- **default value**:true +- **type**:boolean +- **documentation**:Whether adiabatic heating should be used for the slab. +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/taper distance +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_taper-distance + +- **default value**:100000.0 +- **type**:number +- **documentation**:Distance over which to taper the slab tip.tapers the initial heat content to zero and the minimum temperature to the background temperature. +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/potential mantle temperature +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_potential-mantle-temperature + +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/ridge coordinates +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_ridge-coordinates + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. +:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/ridge coordinates/items +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_ridge-coordinates_items + +- **type**:array +- **minItems**:2 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/ridge coordinates/items/items +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_ridge-coordinates_items_items + +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +:::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/ridge coordinates/items/items/items +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_ridge-coordinates_items_items_items + +- **type**:number +::::::::::: :::::::::::: ::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models -:name: closed__features_items_oneOf_5_segments_items_composition models +:::::::::::::: -- **documentation**: -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items -:name: closed__features_items_oneOf_5_segments_items_composition models_items -:::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf -:name: closed__features_items_oneOf_5_segments_items_composition models_items_oneOf -::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1 -:name: closed__features_items_oneOf_5_segments_items_composition models_items_oneOf_1 +::::::::::::::: -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +:::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4 +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4 -:::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/model -:name: closed__features_items_oneOf_5_segments_items_composition models_items_oneOf_1_model +- **type**:object +- **documentation**:Plate model (based on McKenzie, 1970). +- **additionalProperties**:false +- **required**:[model, plate velocity] -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/model +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_model -:::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/min distance slab top -:name: closed__features_items_oneOf_5_segments_items_composition models_items_oneOf_1_min distance slab top +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[plate model] +:::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/operation +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_operation -:::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/max distance slab top -:name: closed__features_items_oneOf_5_segments_items_composition models_items_oneOf_1_max distance slab top +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/min distance slab top +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_min-distance-slab-top -:::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_5_segments_items_composition models_items_oneOf_1_compositions +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_5_segments_items_composition models_items_oneOf_1_compositions_items +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/max distance slab top +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_max-distance-slab-top -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/density +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_density -:::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/fractions -:name: closed__features_items_oneOf_5_segments_items_composition models_items_oneOf_1_fractions +- **default value**:3300.0 +- **type**:number +- **documentation**:The reference density of the subducting plate in $kg/m^3$ +:::::::::::::: -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/fractions/items -:name: closed__features_items_oneOf_5_segments_items_composition models_items_oneOf_1_fractions_items +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/plate velocity +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_plate-velocity -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The velocity in meters per year with which the plate subducts in meters per year. +:::::::::::::: -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/thermal conductivity +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_thermal-conductivity -:::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/operation -:name: closed__features_items_oneOf_5_segments_items_composition models_items_oneOf_1_operation +- **default value**:2.0 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/thermal expansion coefficient +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_thermal-expansion-coefficient +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/specific heat +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_specific-heat -:::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/adiabatic heating +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_adiabatic-heating -:::::::::::: +- **default value**:true +- **type**:boolean +- **documentation**:Wheter adiabatic heating should be used for the slab. Setting the parameter to false leads to equation 26 from McKenzie (1970),which is the result obtained from McKenzie 1969. +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/potential mantle temperature +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_potential-mantle-temperature + +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. +:::::::::::::: + + + +::::::::::::::: + +:::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5 +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_5 + +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5/model +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_5_model + +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5/operation +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_5_operation + +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5/min distance slab top +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_5_min-distance-slab-top + +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5/max distance slab top +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_5_max-distance-slab-top +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5/temperature +:name: closed_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_5_temperature + +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::: + + + +::::::::::::::: + + +::::::::::::::::: + +:::::::::::::::::: + +::::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models +:name: closed_features_items_oneOf_5_segments_items_composition-models + +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items +:name: closed_features_items_oneOf_5_segments_items_composition-models_items + +::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf +:name: closed_features_items_oneOf_5_segments_items_composition-models_items_oneOf + +:::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1 +:name: closed_features_items_oneOf_5_segments_items_composition-models_items_oneOf_1 + +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/model +:name: closed_features_items_oneOf_5_segments_items_composition-models_items_oneOf_1_model + +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/min distance slab top +:name: closed_features_items_oneOf_5_segments_items_composition-models_items_oneOf_1_min-distance-slab-top + +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/max distance slab top +:name: closed_features_items_oneOf_5_segments_items_composition-models_items_oneOf_1_max-distance-slab-top + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_5_segments_items_composition-models_items_oneOf_1_compositions + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_5_segments_items_composition-models_items_oneOf_1_compositions_items + +- **default value**:0 +- **type**:integer +- **documentation**: ::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models -:name: closed__features_items_oneOf_5_segments_items_grains models +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/fractions +:name: closed_features_items_oneOf_5_segments_items_composition-models_items_oneOf_1_fractions -- **documentation**: -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items -:name: closed__features_items_oneOf_5_segments_items_grains models_items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/fractions/items +:name: closed_features_items_oneOf_5_segments_items_composition-models_items_oneOf_1_fractions_items -:::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::: -::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1 -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_1 +:::::::::::::: -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/operation +:name: closed_features_items_oneOf_5_segments_items_composition-models_items_oneOf_1_operation -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/model -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_1_model +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/min distance slab top -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_1_min distance slab top -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the slab top in meters from which the composition of this feature is present. -::::::::: +::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/max distance slab top -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_1_max distance slab top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the slab top in meters to which the composition of this feature is present. -::::::::: +::::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_1_compositions +:::::::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_1_compositions_items +::::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models +:name: closed_features_items_oneOf_5_segments_items_grains-models -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items +:name: closed_features_items_oneOf_5_segments_items_grains-models_items -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/orientation operation -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_1_orientation operation +:::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1 +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1 -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/grain sizes -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_1_grain sizes +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/model +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1_model -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/grain sizes/items -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_1_grain sizes_items +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::::: -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/min distance slab top +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1_min-distance-slab-top -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the slab top in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/normalize grain sizes -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_1_normalize grain sizes +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/max distance slab top +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1_max-distance-slab-top -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/normalize grain sizes/items -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_1_normalize grain sizes_items +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the slab top in meters to which the composition of this feature is present. +:::::::::::::: -- **default value**: true -- **type**: boolean -- **documentation**: -:::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1_compositions -::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1_compositions_items +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: +:::::::::::::: -:::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/orientation operation +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1_orientation-operation -::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2 -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_2 +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/grain sizes +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1_grain-sizes -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/model -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_2_model +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/grain sizes/items +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1_grain-sizes_items -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/min distance slab top -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_2_min distance slab top +:::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the slab top in meters from which the composition of this feature is present. -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/normalize grain sizes +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1_normalize-grain-sizes -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/max distance slab top -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_2_max distance slab top +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/normalize grain sizes/items +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1_normalize-grain-sizes_items -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the slab top in meters to which the composition of this feature is present. -::::::::: +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/compositions -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_2_compositions +:::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/compositions/items -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_2_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: -::::::::: +::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/rotation matrices -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_2_rotation matrices - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the grains which are present there for each compositions. -::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/rotation matrices/items -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_2_rotation matrices_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/rotation matrices/items/items -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_2_rotation matrices_items_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/rotation matrices/items/items/items -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_2_rotation matrices_items_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -:::::: - -::::::: +:::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2 +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2 -:::::::: +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/model +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_model -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/Euler angles z-x-z -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_2_Euler angles z-x-z - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_2_Euler angles z-x-z_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_2_Euler angles z-x-z_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::::: -:::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/min distance slab top +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_min-distance-slab-top -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the slab top in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/orientation operation -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_2_orientation operation +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/max distance slab top +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_max-distance-slab-top -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the slab top in meters to which the composition of this feature is present. +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/compositions +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_compositions + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/compositions/items +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_compositions_items + +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: + +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/rotation matrices +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_rotation-matrices + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the grains which are present there for each compositions. +:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/rotation matrices/items +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_rotation-matrices_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/rotation matrices/items/items +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_rotation-matrices_items_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/rotation matrices/items/items/items +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_rotation-matrices_items_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::::: + +:::::::::::: + +::::::::::::: + +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/Euler angles z-x-z +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::: + +::::::::::::: + +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/orientation operation +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_orientation-operation + +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/grain sizes +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_grain-sizes + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/grain sizes/items +:name: closed_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_grain-sizes_items + +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::::: + +:::::::::::::: + + + +::::::::::::::: + + +::::::::::::::::: + +:::::::::::::::::: + + + +::::::::::::::::::: + +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models +:name: closed_features_items_oneOf_5_temperature-models + +- **documentation**:A list of temperature models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items +:name: closed_features_items_oneOf_5_temperature-models_items + +::::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf + +:::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1 +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_1 + +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] + +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/model +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_1_model + +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/operation +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_1_operation + +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/min distance slab top +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_1_min-distance-slab-top -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/grain sizes -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_2_grain sizes +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/grain sizes/items -:name: closed__features_items_oneOf_5_segments_items_grains models_items_oneOf_2_grain sizes_items +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/max distance slab top +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_1_max-distance-slab-top -- **default value**: -1.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::::: -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/potential mantle temperature +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_1_potential-mantle-temperature +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/thermal expansion coefficient +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_1_thermal-expansion-coefficient -:::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/specific heat +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_1_specific-heat -:::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::::: -::::::::::::: +::::::::::::::::: -:::::::::::::: +:::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2 +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_2 -::::::::::::::: +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max distance slab top] -:::::::::::::::{dropdown} /features/items/oneOf/5/temperature models -:name: closed__features_items_oneOf_5_temperature models +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/model +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_2_model -- **documentation**: A list of temperature models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items -:name: closed__features_items_oneOf_5_temperature models_items +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf -:name: closed__features_items_oneOf_5_temperature models_items_oneOf +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/operation +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_2_operation -::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1 -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_1 +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/min distance slab top +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_2_min-distance-slab-top -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/model -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_1_model +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/max distance slab top +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_2_max-distance-slab-top -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/operation -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_1_operation +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/top temperature +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_2_top-temperature -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/min distance slab top -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_1_min distance slab top +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. +:::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/bottom temperature +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_2_bottom-temperature -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/max distance slab top -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_1_max distance slab top +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the bottom in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. +:::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/potential mantle temperature -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_1_potential mantle temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::::::: +::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/thermal expansion coefficient -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_1_thermal expansion coefficient +:::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3 +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_3 -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::::::: +- **type**:object +- **documentation**:Mass conserving temperature model. The temperature model uses the heat content (proportional to to thermal mass anomaly) to define a smooth temperature profile that conserves mass along the slab length. An empirical (linear) model is used to define how the minimum temperature increases with depth and how the location of the minimum temperature shifts into the slab interior. The slab is divided in to top and bottom parts, which meet at the location where the minimum temperature occurs in the slab. For the bottom slab the temperature is defined by a half-space cooling model. For the top of the slab the temperature is defined by one side of a 1D infinite space cooling model. The age of the overriding plate is used so the slab temperature at shallow depth smoothly transitions to the temperature of the overriding plate: this is not perfect, and is affected by the value of "top truncation" parameter subducting plate. Also note that the parameter "thickness" for the subducting plate segments needs to be defined but is not used. Note that the empirical model used to define how Tmin increases with depth and how the position of Tmin shift with depth is expected to change somewhat after better calibrating with further tests. +- **additionalProperties**:false +- **required**:[model, plate velocity] -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/specific heat -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_1_specific heat +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/model +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_3_model -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[mass conserving] +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/operation +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_3_operation +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/min distance slab top +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_3_min-distance-slab-top -::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2 -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_2 +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be negative and should be 1.5-2 times larger thatn the nominal slab thickness to allow the diffusion of cold temperatures from in the slab into the mantle above the slab surface. Also note that the top truncation value for the slab segment needs to have a value of -1, otherwise the temperature above the slab will be cut off at a distance less than the value set here. +:::::::::::::::: -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max distance slab top] +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/max distance slab top +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_3_max-distance-slab-top -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/model -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_2_model +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be positive and approximately 2.5-3.0 times larger than the nominal slab thickness to allow the diffusion of coldtemperatures from in the slab into the mantle below the slab surface.For example if the slab starts with cold temperatures over a 100 km wide region, thisparameters should be about 250 km. +:::::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/density +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_3_density -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/operation -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_2_operation +- **default value**:3300.0 +- **type**:number +- **documentation**:The reference density of the subducting plate in $kg/m^3$ +:::::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/plate velocity +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_3_plate-velocity -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/min distance slab top -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_2_min distance slab top +- **default value**:NaN +- **type**:number +- **documentation**:The velocity with which the plate subducts in meters per year. +:::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/coupling depth +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_3_coupling-depth -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/max distance slab top -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_2_max distance slab top +- **default value**:NaN +- **type**:number +- **documentation**:The depth at which the slab surface first comes in contact with the hot mantle wedge in meters. +:::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/shallow dip +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_3_shallow-dip -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/top temperature -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_2_top temperature +- **default value**:NaN +- **type**:number +- **documentation**:The average dip of the slab at depths shallower than the coupling depth in degrees. If the shallow slab dip changes with distance along the slab surface, then this will need to be adjusted to get the temperature above and below the coupling depth to match. +:::::::::::::::: -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/thermal conductivity +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_3_thermal-conductivity -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/bottom temperature -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_2_bottom temperature +- **default value**:3.3 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the bottom in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/thermal expansion coefficient +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_3_thermal-expansion-coefficient +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/specific heat +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_3_specific-heat -:::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3 -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_3 +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/thermal diffusivity +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_3_thermal-diffusivity -- **type**: object -- **documentation**: Mass conserving temperature model. The temperature model uses the heat content (proportional to to thermal mass anomaly) to define a smooth temperature profile that conserves mass along the slab length. An empirical (linear) model is used to define how the minimum temperature increases with depth and how the location of the minimum temperature shifts into the slab interior. The slab is divided in to top and bottom parts, which meet at the location where the minimum temperature occurs in the slab. For the bottom slab the temperature is defined by a half-space cooling model. For the top of the slab the temperature is defined by one side of a 1D infinite space cooling model. The age of the overriding plate is used so the slab temperature at shallow depth smoothly transitions to the temperature of the overriding plate: this is not perfect, and is affected by the value of "top truncation" parameter subducting plate. Also note that the parameter "thickness" for the subducting plate segments needs to be defined but is not used. Note that the empirical model used to define how Tmin increases with depth and how the position of Tmin shift with depth is expected to change somewhat after better calibrating with further tests. -- **additionalProperties**: false -- **required**: [model, plate velocity] +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/model -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_3_model +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/adiabatic heating +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_3_adiabatic-heating -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [mass conserving] -::::::::::: +- **default value**:true +- **type**:boolean +- **documentation**:Whether adiabatic heating should be used for the slab. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/operation -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_3_operation +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/taper distance +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_3_taper-distance -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **default value**:100000.0 +- **type**:number +- **documentation**:Distance over which to taper the slab tip.tapers the initial heat content to zero and the minimum temperature to the background temperature. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/min distance slab top -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_3_min distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/potential mantle temperature +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_3_potential-mantle-temperature -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be negative and should be 1.5-2 times larger thatn the nominal slab thickness to allow the diffusion of cold temperatures from in the slab into the mantle above the slab surface. Also note that the top truncation value for the slab segment needs to have a value of -1, otherwise the temperature above the slab will be cut off at a distance less than the value set here. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/max distance slab top -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_3_max distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/ridge coordinates +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_3_ridge-coordinates + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. +:::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/ridge coordinates/items +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_3_ridge-coordinates_items + +- **type**:array +- **minItems**:2 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/ridge coordinates/items/items +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_3_ridge-coordinates_items_items + +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/ridge coordinates/items/items/items +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_3_ridge-coordinates_items_items_items + +- **type**:number +::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be positive and approximately 2.5-3.0 times larger than the nominal slab thickness to allow the diffusion of coldtemperatures from in the slab into the mantle below the slab surface.For example if the slab starts with cold temperatures over a 100 km wide region, thisparameters should be about 250 km. -::::::::::: +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/density -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_3_density +::::::::::::::: -- **default value**: 3300.0 -- **type**: number -- **documentation**: The reference density of the subducting plate in $kg/m^3$ -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/plate velocity -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_3_plate velocity -- **default value**: NaN -- **type**: number -- **documentation**: The velocity with which the plate subducts in meters per year. -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/coupling depth -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_3_coupling depth +::::::::::::::::: -- **default value**: NaN -- **type**: number -- **documentation**: The depth at which the slab surface first comes in contact with the hot mantle wedge in meters. -::::::::::: +:::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4 +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_4 -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/shallow dip -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_3_shallow dip +- **type**:object +- **documentation**:Plate model (based on McKenzie, 1970). +- **additionalProperties**:false +- **required**:[model, plate velocity] -- **default value**: NaN -- **type**: number -- **documentation**: The average dip of the slab at depths shallower than the coupling depth in degrees. If the shallow slab dip changes with distance along the slab surface, then this will need to be adjusted to get the temperature above and below the coupling depth to match. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/model +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_4_model -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/thermal conductivity -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_3_thermal conductivity +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[plate model] +:::::::::::::::: -- **default value**: 3.3 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/operation +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_4_operation -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/thermal expansion coefficient -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_3_thermal expansion coefficient +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/min distance slab top +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_4_min-distance-slab-top -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/specific heat -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_3_specific heat +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/max distance slab top +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_4_max-distance-slab-top -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/thermal diffusivity -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_3_thermal diffusivity +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/density +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_4_density -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/adiabatic heating -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_3_adiabatic heating +- **default value**:3300.0 +- **type**:number +- **documentation**:The reference density of the subducting plate in $kg/m^3$ +:::::::::::::::: -- **default value**: true -- **type**: boolean -- **documentation**: Whether adiabatic heating should be used for the slab. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/plate velocity +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_4_plate-velocity -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/taper distance -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_3_taper distance +- **default value**:NaN +- **type**:number +- **documentation**:The velocity in meters per year with which the plate subducts in meters per year. +:::::::::::::::: -- **default value**: 100000.0 -- **type**: number -- **documentation**: Distance over which to taper the slab tip.tapers the initial heat content to zero and the minimum temperature to the background temperature. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/thermal conductivity +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_4_thermal-conductivity -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/potential mantle temperature -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_3_potential mantle temperature +- **default value**:2.0 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/thermal expansion coefficient +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_4_thermal-expansion-coefficient -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/ridge coordinates -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_3_ridge coordinates - -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. -::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/ridge coordinates/items -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_3_ridge coordinates_items - -- **type**: array -- **minItems**: 2 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/ridge coordinates/items/items -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_3_ridge coordinates_items_items - -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/ridge coordinates/items/items/items -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_3_ridge coordinates_items_items_items - -- **type**: number -:::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::::: -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/specific heat +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_4_specific-heat -:::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::::: -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/adiabatic heating +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_4_adiabatic-heating +- **default value**:true +- **type**:boolean +- **documentation**:Wheter adiabatic heating should be used for the slab. Setting the parameter to false leads to equation 26 from McKenzie (1970),which is the result obtained from McKenzie 1969. +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/potential mantle temperature +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_4_potential-mantle-temperature -:::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. +:::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4 -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_4 -- **type**: object -- **documentation**: Plate model (based on McKenzie, 1970). -- **additionalProperties**: false -- **required**: [model, plate velocity] -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/model -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_4_model +::::::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [plate model] -::::::::::: +:::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5 +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_5 -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/operation -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_4_operation +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5/model +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_5_model -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/min distance slab top -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_4_min distance slab top +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5/operation +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_5_operation -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/max distance slab top -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_4_max distance slab top +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5/min distance slab top +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_5_min-distance-slab-top -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/density -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_4_density +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::::: -- **default value**: 3300.0 -- **type**: number -- **documentation**: The reference density of the subducting plate in $kg/m^3$ -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5/max distance slab top +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_5_max-distance-slab-top -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/plate velocity -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_4_plate velocity +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::::: -- **default value**: NaN -- **type**: number -- **documentation**: The velocity in meters per year with which the plate subducts in meters per year. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5/temperature +:name: closed_features_items_oneOf_5_temperature-models_items_oneOf_5_temperature -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/thermal conductivity -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_4_thermal conductivity +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::::: -- **default value**: 2.0 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/thermal expansion coefficient -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_4_thermal expansion coefficient -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. -::::::::::: +::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/specific heat -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_4_specific heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. -::::::::::: +::::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/adiabatic heating -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_4_adiabatic heating +:::::::::::::::::::: -- **default value**: true -- **type**: boolean -- **documentation**: Wheter adiabatic heating should be used for the slab. Setting the parameter to false leads to equation 26 from McKenzie (1970),which is the result obtained from McKenzie 1969. -::::::::::: +::::::::::::::::::::{dropdown} /features/items/oneOf/5/composition models +:name: closed_features_items_oneOf_5_composition-models -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/potential mantle temperature -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_4_potential mantle temperature +- **documentation**:A list of composition models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items +:name: closed_features_items_oneOf_5_composition-models_items -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. -::::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf +:name: closed_features_items_oneOf_5_composition-models_items_oneOf +:::::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1 +:name: closed_features_items_oneOf_5_composition-models_items_oneOf_1 +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/model +:name: closed_features_items_oneOf_5_composition-models_items_oneOf_1_model -::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5 -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_5 +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::::::: -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] +::::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/min distance slab top +:name: closed_features_items_oneOf_5_composition-models_items_oneOf_1_min-distance-slab-top -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5/model -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_5_model +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/max distance slab top +:name: closed_features_items_oneOf_5_composition-models_items_oneOf_1_max-distance-slab-top -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5/operation -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_5_operation +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_5_composition-models_items_oneOf_1_compositions -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5/min distance slab top -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_5_min distance slab top +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_5_composition-models_items_oneOf_1_compositions_items -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5/max distance slab top -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_5_max distance slab top +:::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/fractions +:name: closed_features_items_oneOf_5_composition-models_items_oneOf_1_fractions -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5/temperature -:name: closed__features_items_oneOf_5_temperature models_items_oneOf_5_temperature +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/fractions/items +:name: closed_features_items_oneOf_5_composition-models_items_oneOf_1_fractions_items -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::::: +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/operation +:name: closed_features_items_oneOf_5_composition-models_items_oneOf_1_operation -:::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -:::::::::::::: -::::::::::::::: +::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/composition models -:name: closed__features_items_oneOf_5_composition models -- **documentation**: A list of composition models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items -:name: closed__features_items_oneOf_5_composition models_items +::::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf -:name: closed__features_items_oneOf_5_composition models_items_oneOf +:::::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1 -:name: closed__features_items_oneOf_5_composition models_items_oneOf_1 +::::::::::::::::::::{dropdown} /features/items/oneOf/5/grains models +:name: closed_features_items_oneOf_5_grains-models -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +- **documentation**:A list of grains models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items +:name: closed_features_items_oneOf_5_grains-models_items -:::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/model -:name: closed__features_items_oneOf_5_composition models_items_oneOf_1_model +::::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf +:name: closed_features_items_oneOf_5_grains-models_items_oneOf -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::::::: +:::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1 +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_1 -:::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/min distance slab top -:name: closed__features_items_oneOf_5_composition models_items_oneOf_1_min distance slab top +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/model +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_1_model -:::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/max distance slab top -:name: closed__features_items_oneOf_5_composition models_items_oneOf_1_max distance slab top +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/min distance slab top +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_1_min-distance-slab-top -:::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_5_composition models_items_oneOf_1_compositions +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the slab top in meters from which the composition of this feature is present. +:::::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_5_composition models_items_oneOf_1_compositions_items +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/max distance slab top +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_1_max-distance-slab-top -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the slab top in meters to which the composition of this feature is present. +:::::::::::::::: -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_1_compositions -:::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/fractions -:name: closed__features_items_oneOf_5_composition models_items_oneOf_1_fractions +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_1_compositions_items -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/fractions/items -:name: closed__features_items_oneOf_5_composition models_items_oneOf_1_fractions_items +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::::: +:::::::::::::::: -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/orientation operation +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_1_orientation-operation -:::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/operation -:name: closed__features_items_oneOf_5_composition models_items_oneOf_1_operation +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/grain sizes +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_1_grain-sizes +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/grain sizes/items +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_1_grain-sizes_items +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::::: -:::::::::::: +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/normalize grain sizes +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_1_normalize-grain-sizes -:::::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/normalize grain sizes/items +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_1_normalize-grain-sizes_items +- **default value**:true +- **type**:boolean +- **documentation**: ::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/grains models -:name: closed__features_items_oneOf_5_grains models - -- **documentation**: A list of grains models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items -:name: closed__features_items_oneOf_5_grains models_items +:::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf -:name: closed__features_items_oneOf_5_grains models_items_oneOf -::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1 -:name: closed__features_items_oneOf_5_grains models_items_oneOf_1 -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/model -:name: closed__features_items_oneOf_5_grains models_items_oneOf_1_model +:::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2 +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_2 -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::::::: +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/min distance slab top -:name: closed__features_items_oneOf_5_grains models_items_oneOf_1_min distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/model +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_2_model -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the slab top in meters from which the composition of this feature is present. -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/max distance slab top -:name: closed__features_items_oneOf_5_grains models_items_oneOf_1_max distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/min distance slab top +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_2_min-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the slab top in meters to which the composition of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the slab top in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_5_grains models_items_oneOf_1_compositions +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/max distance slab top +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_2_max-distance-slab-top -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_5_grains models_items_oneOf_1_compositions_items +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the slab top in meters to which the composition of this feature is present. +:::::::::::::::: -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/compositions +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_2_compositions -::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/compositions/items +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_2_compositions_items -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/orientation operation -:name: closed__features_items_oneOf_5_grains models_items_oneOf_1_orientation operation +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/grain sizes -:name: closed__features_items_oneOf_5_grains models_items_oneOf_1_grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/rotation matrices +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_2_rotation-matrices + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the grains which are present there for each compositions. +:::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/rotation matrices/items +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_2_rotation-matrices_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/rotation matrices/items/items +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_2_rotation-matrices_items_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/rotation matrices/items/items/items +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_2_rotation-matrices_items_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/grain sizes/items -:name: closed__features_items_oneOf_5_grains models_items_oneOf_1_grain sizes_items +:::::::::::::: -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::::: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/normalize grain sizes -:name: closed__features_items_oneOf_5_grains models_items_oneOf_1_normalize grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/Euler angles z-x-z +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_2_Euler-angles-z-x-z + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/Euler angles z-x-z/items +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_2_Euler-angles-z-x-z_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/Euler angles z-x-z/items/items +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/normalize grain sizes/items -:name: closed__features_items_oneOf_5_grains models_items_oneOf_1_normalize grain sizes_items +::::::::::::::: -- **default value**: true -- **type**: boolean -- **documentation**: -:::::::::: +:::::::::::::::: -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/orientation operation +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_2_orientation-operation +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/grain sizes +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_2_grain-sizes -:::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/grain sizes/items +:name: closed_features_items_oneOf_5_grains-models_items_oneOf_2_grain-sizes_items -::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2 -:name: closed__features_items_oneOf_5_grains models_items_oneOf_2 +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::::::: -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/model -:name: closed__features_items_oneOf_5_grains models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/min distance slab top -:name: closed__features_items_oneOf_5_grains models_items_oneOf_2_min distance slab top +::::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the slab top in meters from which the composition of this feature is present. -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/max distance slab top -:name: closed__features_items_oneOf_5_grains models_items_oneOf_2_max distance slab top +::::::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the slab top in meters to which the composition of this feature is present. -::::::::::: +:::::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/compositions -:name: closed__features_items_oneOf_5_grains models_items_oneOf_2_compositions +::::::::::::::::::::{dropdown} /features/items/oneOf/5/sections +:name: closed_features_items_oneOf_5_sections -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/compositions/items -:name: closed__features_items_oneOf_5_grains models_items_oneOf_2_compositions_items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of feature properties for a coordinate. +:::::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items +:name: closed_features_items_oneOf_5_sections_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **documentation**: +- **default value**: +- **type**:object -::::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/min depth +:name: closed_features_items_oneOf_5_sections_items_min-depth -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/rotation matrices -:name: closed__features_items_oneOf_5_grains models_items_oneOf_2_rotation matrices - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the grains which are present there for each compositions. -::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/rotation matrices/items -:name: closed__features_items_oneOf_5_grains models_items_oneOf_2_rotation matrices_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/rotation matrices/items/items -:name: closed__features_items_oneOf_5_grains models_items_oneOf_2_rotation matrices_items_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/rotation matrices/items/items/items -:name: closed__features_items_oneOf_5_grains models_items_oneOf_2_rotation matrices_items_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::: -::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/max depth +:name: closed_features_items_oneOf_5_sections_items_max-depth -:::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::: -::::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/dip point +:name: closed_features_items_oneOf_5_sections_items_dip-point -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/Euler angles z-x-z -:name: closed__features_items_oneOf_5_grains models_items_oneOf_2_Euler angles z-x-z - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/Euler angles z-x-z/items -:name: closed__features_items_oneOf_5_grains models_items_oneOf_2_Euler angles z-x-z_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/Euler angles z-x-z/items/items -:name: closed__features_items_oneOf_5_grains models_items_oneOf_2_Euler angles z-x-z_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::::::: +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**:The depth to which this feature is present +:::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/dip point/items +:name: closed_features_items_oneOf_5_sections_items_dip-point_items -:::::::::: +- **type**:number +::::::::::::::::: -::::::::::: +:::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/orientation operation -:name: closed__features_items_oneOf_5_grains models_items_oneOf_2_orientation operation +::::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments +:name: closed_features_items_oneOf_5_sections_items_segments -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:The depth to which this feature is present +:::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items +:name: closed_features_items_oneOf_5_sections_items_segments_items -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/grain sizes -:name: closed__features_items_oneOf_5_grains models_items_oneOf_2_grain sizes +- **type**:object +- **additionalProperties**:false +- **documentation**: +- **required**:[length, thickness, angle] -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/grain sizes/items -:name: closed__features_items_oneOf_5_grains models_items_oneOf_2_grain sizes_items +::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/length +:name: closed_features_items_oneOf_5_sections_items_segments_items_length -- **default value**: -1.0 -- **type**: number -- **documentation**: -:::::::::: +- **type**:number +:::::::::::::::: -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/thickness +:name: closed_features_items_oneOf_5_sections_items_segments_items_thickness +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/thickness/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_thickness_items +- **type**:number +::::::::::::::: -:::::::::::: +:::::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/top truncation +:name: closed_features_items_oneOf_5_sections_items_segments_items_top-truncation -:::::::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/top truncation/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_top-truncation_items +- **type**:number ::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/sections -:name: closed__features_items_oneOf_5_sections +:::::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of feature properties for a coordinate. -::::::::::::::{dropdown} /features/items/oneOf/5/sections/items -:name: closed__features_items_oneOf_5_sections_items +::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/angle +:name: closed_features_items_oneOf_5_sections_items_segments_items_angle -- **documentation**: -- **default value**: -- **type**: object +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/angle/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_angle_items -:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/min depth -:name: closed__features_items_oneOf_5_sections_items_min depth +- **type**:number +::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::: +:::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/max depth -:name: closed__features_items_oneOf_5_sections_items_max depth +::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::: +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items -:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/dip point -:name: closed__features_items_oneOf_5_sections_items_dip point +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: The depth to which this feature is present -::::::::::::{dropdown} /features/items/oneOf/5/sections/items/dip point/items -:name: closed__features_items_oneOf_5_sections_items_dip point_items +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1 +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_1 -- **type**: number -:::::::::::: +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] -::::::::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/model +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_1_model -:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments -:name: closed__features_items_oneOf_5_sections_items_segments +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: The depth to which this feature is present -::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items -:name: closed__features_items_oneOf_5_sections_items_segments_items +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/operation +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_1_operation -- **type**: object -- **additionalProperties**: false -- **documentation**: -- **required**: [length, thickness, angle] +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/length -:name: closed__features_items_oneOf_5_sections_items_segments_items_length +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/min distance slab top +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_1_min-distance-slab-top -- **type**: number -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/thickness -:name: closed__features_items_oneOf_5_sections_items_segments_items_thickness +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/max distance slab top +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_1_max-distance-slab-top -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/thickness/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_thickness_items +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::: -- **type**: number -:::::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/potential mantle temperature +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_1_potential-mantle-temperature -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/top truncation -:name: closed__features_items_oneOf_5_sections_items_segments_items_top truncation +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/thermal expansion coefficient +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_1_thermal-expansion-coefficient -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/top truncation/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_top truncation_items +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::: -- **type**: number -:::::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/specific heat +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_1_specific-heat -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/angle -:name: closed__features_items_oneOf_5_sections_items_segments_items_angle -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/angle/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_angle_items -- **type**: number -:::::::::: +::::::::::::: -::::::::::: +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2 +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_2 -:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max distance slab top] -- **documentation**: -- **default value**: -- **type**: array -::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/model +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_2_model -:::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::: -::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1 -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_1 +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/operation +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_2_operation -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/model -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_1_model +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/min distance slab top +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_2_min-distance-slab-top -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/operation -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_1_operation +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/max distance slab top +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_2_max-distance-slab-top -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/min distance slab top -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_1_min distance slab top +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/top temperature +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_2_top-temperature -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/max distance slab top -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_1_max distance slab top +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/bottom temperature +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_2_bottom-temperature -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the bottom in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/potential mantle temperature -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_1_potential mantle temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/thermal expansion coefficient -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_1_thermal expansion coefficient +::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::: +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3 +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3 -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/specific heat -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_1_specific heat +- **type**:object +- **documentation**:Mass conserving temperature model. The temperature model uses the heat content (proportional to to thermal mass anomaly) to define a smooth temperature profile that conserves mass along the slab length. An empirical (linear) model is used to define how the minimum temperature increases with depth and how the location of the minimum temperature shifts into the slab interior. The slab is divided in to top and bottom parts, which meet at the location where the minimum temperature occurs in the slab. For the bottom slab the temperature is defined by a half-space cooling model. For the top of the slab the temperature is defined by one side of a 1D infinite space cooling model. The age of the overriding plate is used so the slab temperature at shallow depth smoothly transitions to the temperature of the overriding plate: this is not perfect, and is affected by the value of "top truncation" parameter subducting plate. Also note that the parameter "thickness" for the subducting plate segments needs to be defined but is not used. Note that the empirical model used to define how Tmin increases with depth and how the position of Tmin shift with depth is expected to change somewhat after better calibrating with further tests. +- **additionalProperties**:false +- **required**:[model, plate velocity] -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/model +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_model +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[mass conserving] +:::::::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/operation +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_operation -:::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::: -::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2 -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_2 +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/min distance slab top +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_min-distance-slab-top -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max distance slab top] +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be negative and should be 1.5-2 times larger thatn the nominal slab thickness to allow the diffusion of cold temperatures from in the slab into the mantle above the slab surface. Also note that the top truncation value for the slab segment needs to have a value of -1, otherwise the temperature above the slab will be cut off at a distance less than the value set here. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/model -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_2_model +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/max distance slab top +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_max-distance-slab-top -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be positive and approximately 2.5-3.0 times larger than the nominal slab thickness to allow the diffusion of coldtemperatures from in the slab into the mantle below the slab surface.For example if the slab starts with cold temperatures over a 100 km wide region, thisparameters should be about 250 km. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/operation -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_2_operation +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/density +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_density -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::: +- **default value**:3300.0 +- **type**:number +- **documentation**:The reference density of the subducting plate in $kg/m^3$ +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/min distance slab top -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_2_min distance slab top +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/plate velocity +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_plate-velocity -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The velocity with which the plate subducts in meters per year. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/max distance slab top -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_2_max distance slab top +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/coupling depth +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_coupling-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The depth at which the slab surface first comes in contact with the hot mantle wedge in meters. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/top temperature -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_2_top temperature +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/shallow dip +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_shallow-dip -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. -::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The average dip of the slab at depths shallower than the coupling depth in degrees. If the shallow slab dip changes with distance along the slab surface, then this will need to be adjusted to get the temperature above and below the coupling depth to match. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/bottom temperature -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_2_bottom temperature +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/thermal conductivity +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_thermal-conductivity -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the bottom in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. -::::::: +- **default value**:3.3 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/thermal expansion coefficient +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_thermal-expansion-coefficient +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. +:::::::::::: -:::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/specific heat +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_specific-heat -::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3 -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3 +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. +:::::::::::: -- **type**: object -- **documentation**: Mass conserving temperature model. The temperature model uses the heat content (proportional to to thermal mass anomaly) to define a smooth temperature profile that conserves mass along the slab length. An empirical (linear) model is used to define how the minimum temperature increases with depth and how the location of the minimum temperature shifts into the slab interior. The slab is divided in to top and bottom parts, which meet at the location where the minimum temperature occurs in the slab. For the bottom slab the temperature is defined by a half-space cooling model. For the top of the slab the temperature is defined by one side of a 1D infinite space cooling model. The age of the overriding plate is used so the slab temperature at shallow depth smoothly transitions to the temperature of the overriding plate: this is not perfect, and is affected by the value of "top truncation" parameter subducting plate. Also note that the parameter "thickness" for the subducting plate segments needs to be defined but is not used. Note that the empirical model used to define how Tmin increases with depth and how the position of Tmin shift with depth is expected to change somewhat after better calibrating with further tests. -- **additionalProperties**: false -- **required**: [model, plate velocity] +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/thermal diffusivity +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_thermal-diffusivity -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/model -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_model +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [mass conserving] -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/adiabatic heating +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_adiabatic-heating -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/operation -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_operation +- **default value**:true +- **type**:boolean +- **documentation**:Whether adiabatic heating should be used for the slab. +:::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/taper distance +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_taper-distance -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/min distance slab top -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_min distance slab top +- **default value**:100000.0 +- **type**:number +- **documentation**:Distance over which to taper the slab tip.tapers the initial heat content to zero and the minimum temperature to the background temperature. +:::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be negative and should be 1.5-2 times larger thatn the nominal slab thickness to allow the diffusion of cold temperatures from in the slab into the mantle above the slab surface. Also note that the top truncation value for the slab segment needs to have a value of -1, otherwise the temperature above the slab will be cut off at a distance less than the value set here. -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/potential mantle temperature +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_potential-mantle-temperature -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/max distance slab top -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_max distance slab top +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. +:::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be positive and approximately 2.5-3.0 times larger than the nominal slab thickness to allow the diffusion of coldtemperatures from in the slab into the mantle below the slab surface.For example if the slab starts with cold temperatures over a 100 km wide region, thisparameters should be about 250 km. -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/ridge coordinates +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_ridge-coordinates -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/density -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_density - -- **default value**: 3300.0 -- **type**: number -- **documentation**: The reference density of the subducting plate in $kg/m^3$ -::::::: - -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/plate velocity -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_plate velocity - -- **default value**: NaN -- **type**: number -- **documentation**: The velocity with which the plate subducts in meters per year. -::::::: - -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/coupling depth -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_coupling depth - -- **default value**: NaN -- **type**: number -- **documentation**: The depth at which the slab surface first comes in contact with the hot mantle wedge in meters. -::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/ridge coordinates/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_ridge-coordinates_items -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/shallow dip -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_shallow dip +- **type**:array +- **minItems**:2 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/ridge coordinates/items/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_ridge-coordinates_items_items -- **default value**: NaN -- **type**: number -- **documentation**: The average dip of the slab at depths shallower than the coupling depth in degrees. If the shallow slab dip changes with distance along the slab surface, then this will need to be adjusted to get the temperature above and below the coupling depth to match. -::::::: +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +:::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/ridge coordinates/items/items/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_ridge-coordinates_items_items_items -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/thermal conductivity -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_thermal conductivity +- **type**:number +::::::::: -- **default value**: 3.3 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::: +:::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/thermal expansion coefficient -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_thermal expansion coefficient +::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. -::::::: +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/specific heat -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_specific heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. -::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/thermal diffusivity -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_thermal diffusivity +::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::: +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4 +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4 -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/adiabatic heating -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_adiabatic heating +- **type**:object +- **documentation**:Plate model (based on McKenzie, 1970). +- **additionalProperties**:false +- **required**:[model, plate velocity] -- **default value**: true -- **type**: boolean -- **documentation**: Whether adiabatic heating should be used for the slab. -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/model +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_model -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/taper distance -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_taper distance +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[plate model] +:::::::::::: -- **default value**: 100000.0 -- **type**: number -- **documentation**: Distance over which to taper the slab tip.tapers the initial heat content to zero and the minimum temperature to the background temperature. -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/operation +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_operation -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/potential mantle temperature -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_potential mantle temperature +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/min distance slab top +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_min-distance-slab-top -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/ridge coordinates -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_ridge coordinates +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::: -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. -::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/ridge coordinates/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_ridge coordinates_items +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/max distance slab top +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_max-distance-slab-top -- **type**: array -- **minItems**: 2 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: -:::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/ridge coordinates/items/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_ridge coordinates_items_items +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::: -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/ridge coordinates/items/items/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_ridge coordinates_items_items_items +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/density +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_density -- **type**: number -:::: +- **default value**:3300.0 +- **type**:number +- **documentation**:The reference density of the subducting plate in $kg/m^3$ +:::::::::::: -::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/plate velocity +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_plate-velocity -:::::: +- **default value**:NaN +- **type**:number +- **documentation**:The velocity in meters per year with which the plate subducts in meters per year. +:::::::::::: -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/thermal conductivity +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_thermal-conductivity +- **default value**:2.0 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/thermal expansion coefficient +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_thermal-expansion-coefficient -:::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. +:::::::::::: -::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4 -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4 +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/specific heat +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_specific-heat -- **type**: object -- **documentation**: Plate model (based on McKenzie, 1970). -- **additionalProperties**: false -- **required**: [model, plate velocity] +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/model -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_model +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/adiabatic heating +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_adiabatic-heating -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [plate model] -::::::: +- **default value**:true +- **type**:boolean +- **documentation**:Wheter adiabatic heating should be used for the slab. Setting the parameter to false leads to equation 26 from McKenzie (1970),which is the result obtained from McKenzie 1969. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/operation -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_operation +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/potential mantle temperature +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_potential-mantle-temperature -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/min distance slab top -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_min distance slab top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/max distance slab top -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_max distance slab top +::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::: +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5 +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_5 -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/density -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_density +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] -- **default value**: 3300.0 -- **type**: number -- **documentation**: The reference density of the subducting plate in $kg/m^3$ -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5/model +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_5_model -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/plate velocity -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_plate velocity +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::: -- **default value**: NaN -- **type**: number -- **documentation**: The velocity in meters per year with which the plate subducts in meters per year. -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5/operation +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_5_operation -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/thermal conductivity -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_thermal conductivity +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::: -- **default value**: 2.0 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5/min distance slab top +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_5_min-distance-slab-top -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/thermal expansion coefficient -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_thermal expansion coefficient +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5/max distance slab top +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_5_max-distance-slab-top -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/specific heat -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_specific heat +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5/temperature +:name: closed_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_5_temperature -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/adiabatic heating -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_adiabatic heating +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::: -- **default value**: true -- **type**: boolean -- **documentation**: Wheter adiabatic heating should be used for the slab. Setting the parameter to false leads to equation 26 from McKenzie (1970),which is the result obtained from McKenzie 1969. -::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/potential mantle temperature -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_potential mantle temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. -::::::: +::::::::::::: +::::::::::::::: -:::::::: +:::::::::::::::: -::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5 -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_5 +::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models +:name: closed_features_items_oneOf_5_sections_items_segments_items_composition-models -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_composition-models_items -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5/model -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_5_model +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf +:name: closed_features_items_oneOf_5_sections_items_segments_items_composition-models_items_oneOf -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::: +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1 +:name: closed_features_items_oneOf_5_sections_items_segments_items_composition-models_items_oneOf_1 -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5/operation -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_5_operation +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/model +:name: closed_features_items_oneOf_5_sections_items_segments_items_composition-models_items_oneOf_1_model -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5/min distance slab top -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_5_min distance slab top +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/min distance slab top +:name: closed_features_items_oneOf_5_sections_items_segments_items_composition-models_items_oneOf_1_min-distance-slab-top -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5/max distance slab top -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_5_max distance slab top +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/max distance slab top +:name: closed_features_items_oneOf_5_sections_items_segments_items_composition-models_items_oneOf_1_max-distance-slab-top -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5/temperature -:name: closed__features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_5_temperature +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::: -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_5_sections_items_segments_items_composition-models_items_oneOf_1_compositions +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_composition-models_items_oneOf_1_compositions_items +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::: -:::::::: +:::::::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/fractions +:name: closed_features_items_oneOf_5_sections_items_segments_items_composition-models_items_oneOf_1_fractions -:::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/fractions/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_composition-models_items_oneOf_1_fractions_items +- **default value**:1.0 +- **type**:number +- **documentation**: ::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models -:name: closed__features_items_oneOf_5_sections_items_segments_items_composition models +:::::::::::: -- **documentation**: -- **default value**: -- **type**: array -::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_composition models_items +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/operation +:name: closed_features_items_oneOf_5_sections_items_segments_items_composition-models_items_oneOf_1_operation -:::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf -:name: closed__features_items_oneOf_5_sections_items_segments_items_composition models_items_oneOf +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::: -::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1 -:name: closed__features_items_oneOf_5_sections_items_segments_items_composition models_items_oneOf_1 -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/model -:name: closed__features_items_oneOf_5_sections_items_segments_items_composition models_items_oneOf_1_model +::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/min distance slab top -:name: closed__features_items_oneOf_5_sections_items_segments_items_composition models_items_oneOf_1_min distance slab top +::::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::: +:::::::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/max distance slab top -:name: closed__features_items_oneOf_5_sections_items_segments_items_composition models_items_oneOf_1_max distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::: +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_5_sections_items_segments_items_composition models_items_oneOf_1_compositions +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_composition models_items_oneOf_1_compositions_items +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1 +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1 -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::: +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/model +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1_model -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/fractions -:name: closed__features_items_oneOf_5_sections_items_segments_items_composition models_items_oneOf_1_fractions +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::: -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/fractions/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_composition models_items_oneOf_1_fractions_items +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/min distance slab top +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1_min-distance-slab-top -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the slab top in meters from which the composition of this feature is present. +:::::::::::: -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/max distance slab top +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1_max-distance-slab-top -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/operation -:name: closed__features_items_oneOf_5_sections_items_segments_items_composition models_items_oneOf_1_operation +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the slab top in meters to which the composition of this feature is present. +:::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1_compositions +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1_compositions_items +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::: -:::::::: +:::::::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/orientation operation +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1_orientation-operation -:::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::: -::::::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/grain sizes +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1_grain-sizes -:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models - -- **documentation**: -- **default value**: -- **type**: array -::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/grain sizes/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1_grain-sizes_items -:::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::: -::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1 -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1 +:::::::::::: -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/normalize grain sizes +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1_normalize-grain-sizes -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/model -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1_model +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/normalize grain sizes/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1_normalize-grain-sizes_items -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::: +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/min distance slab top -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1_min distance slab top +:::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the slab top in meters from which the composition of this feature is present. -::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/max distance slab top -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1_max distance slab top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the slab top in meters to which the composition of this feature is present. -::::::: +::::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1_compositions +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2 +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2 -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1_compositions_items +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/model +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_model -::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/orientation operation -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1_orientation operation +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/min distance slab top +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_min-distance-slab-top -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the slab top in meters from which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/grain sizes -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1_grain sizes +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/max distance slab top +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_max-distance-slab-top -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/grain sizes/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1_grain sizes_items +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the slab top in meters to which the composition of this feature is present. +:::::::::::: -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/compositions +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_compositions -::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/compositions/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_compositions_items -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/normalize grain sizes -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1_normalize grain sizes +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/normalize grain sizes/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1_normalize grain sizes_items +:::::::::::: -- **default value**: true -- **type**: boolean -- **documentation**: -:::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_rotation-matrices + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the grains which are present there for each compositions. +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_rotation-matrices_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_rotation-matrices_items_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items/items/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_rotation-matrices_items_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::: -::::::: +:::::::::: +::::::::::: +:::::::::::: -:::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::: -::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2 -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2 - -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] - -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/model -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_model - -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::: - -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/min distance slab top -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_min distance slab top - -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the slab top in meters from which the composition of this feature is present. -::::::: - -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/max distance slab top -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_max distance slab top - -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the slab top in meters to which the composition of this feature is present. -::::::: - -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/compositions -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_compositions - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/compositions/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_compositions_items - -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::: - -::::::: - -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_rotation matrices - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the grains which are present there for each compositions. -::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_rotation matrices_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_rotation matrices_items_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items/items/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_rotation matrices_items_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -:::: - -::::: - -:::::: - -::::::: - -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_Euler angles z-x-z - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_Euler angles z-x-z_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_Euler angles z-x-z_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::: - -:::::: - -::::::: - -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/orientation operation -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_orientation operation - -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::: - -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/grain sizes -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_grain sizes - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/grain sizes/items -:name: closed__features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_grain sizes_items - -- **default value**: -1.0 -- **type**: number -- **documentation**: -:::::: - -::::::: +::::::::::: +:::::::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/orientation operation +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_orientation-operation -:::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/grain sizes +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_grain-sizes -:::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/grain sizes/items +:name: closed_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_grain-sizes_items +- **default value**:-1.0 +- **type**:number +- **documentation**: ::::::::::: +:::::::::::: -:::::::::::: ::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models -:name: closed__features_items_oneOf_5_sections_items_temperature models -- **documentation**: A list of temperature models. -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items -:name: closed__features_items_oneOf_5_sections_items_temperature models_items - -:::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf +::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1 -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_1 +:::::::::::::::: -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/model -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::::: +::::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/operation -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_1_operation +:::::::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models +:name: closed_features_items_oneOf_5_sections_items_temperature-models -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/min distance slab top -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_1_min distance slab top +- **documentation**:A list of temperature models. +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/max distance slab top -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_1_max distance slab top +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1 +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_1 -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/potential mantle temperature -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_1_potential mantle temperature +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/model +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_1_model -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/thermal expansion coefficient -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_1_thermal expansion coefficient +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/operation +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_1_operation -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/specific heat -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_1_specific heat +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/min distance slab top +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_1_min-distance-slab-top -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/max distance slab top +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_1_max-distance-slab-top +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/potential mantle temperature +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_1_potential-mantle-temperature -::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2 -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_2 +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::::: -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max distance slab top] +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/thermal expansion coefficient +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_1_thermal-expansion-coefficient -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/model -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_2_model +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/specific heat +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_1_specific-heat -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/operation -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_2_operation +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/min distance slab top -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_2_min distance slab top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/max distance slab top -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_2_max distance slab top +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2 +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_2 -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max distance slab top] -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/top temperature -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_2_top temperature +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/model +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_2_model -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/bottom temperature -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_2_bottom temperature +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/operation +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_2_operation -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the bottom in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/min distance slab top +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_2_min-distance-slab-top +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/max distance slab top +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_2_max-distance-slab-top -::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3 -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_3 +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -- **type**: object -- **documentation**: Mass conserving temperature model. The temperature model uses the heat content (proportional to to thermal mass anomaly) to define a smooth temperature profile that conserves mass along the slab length. An empirical (linear) model is used to define how the minimum temperature increases with depth and how the location of the minimum temperature shifts into the slab interior. The slab is divided in to top and bottom parts, which meet at the location where the minimum temperature occurs in the slab. For the bottom slab the temperature is defined by a half-space cooling model. For the top of the slab the temperature is defined by one side of a 1D infinite space cooling model. The age of the overriding plate is used so the slab temperature at shallow depth smoothly transitions to the temperature of the overriding plate: this is not perfect, and is affected by the value of "top truncation" parameter subducting plate. Also note that the parameter "thickness" for the subducting plate segments needs to be defined but is not used. Note that the empirical model used to define how Tmin increases with depth and how the position of Tmin shift with depth is expected to change somewhat after better calibrating with further tests. -- **additionalProperties**: false -- **required**: [model, plate velocity] +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/top temperature +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_2_top-temperature -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/model -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_model +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. +:::::::::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [mass conserving] -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/bottom temperature +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_2_bottom-temperature -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/operation -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_operation +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the bottom in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. +:::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/min distance slab top -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_min distance slab top -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be negative and should be 1.5-2 times larger thatn the nominal slab thickness to allow the diffusion of cold temperatures from in the slab into the mantle above the slab surface. Also note that the top truncation value for the slab segment needs to have a value of -1, otherwise the temperature above the slab will be cut off at a distance less than the value set here. -::::::::: +::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/max distance slab top -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_max distance slab top +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3 +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3 -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be positive and approximately 2.5-3.0 times larger than the nominal slab thickness to allow the diffusion of coldtemperatures from in the slab into the mantle below the slab surface.For example if the slab starts with cold temperatures over a 100 km wide region, thisparameters should be about 250 km. -::::::::: +- **type**:object +- **documentation**:Mass conserving temperature model. The temperature model uses the heat content (proportional to to thermal mass anomaly) to define a smooth temperature profile that conserves mass along the slab length. An empirical (linear) model is used to define how the minimum temperature increases with depth and how the location of the minimum temperature shifts into the slab interior. The slab is divided in to top and bottom parts, which meet at the location where the minimum temperature occurs in the slab. For the bottom slab the temperature is defined by a half-space cooling model. For the top of the slab the temperature is defined by one side of a 1D infinite space cooling model. The age of the overriding plate is used so the slab temperature at shallow depth smoothly transitions to the temperature of the overriding plate: this is not perfect, and is affected by the value of "top truncation" parameter subducting plate. Also note that the parameter "thickness" for the subducting plate segments needs to be defined but is not used. Note that the empirical model used to define how Tmin increases with depth and how the position of Tmin shift with depth is expected to change somewhat after better calibrating with further tests. +- **additionalProperties**:false +- **required**:[model, plate velocity] -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/density -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_density +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/model +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_model -- **default value**: 3300.0 -- **type**: number -- **documentation**: The reference density of the subducting plate in $kg/m^3$ -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[mass conserving] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/plate velocity -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_plate velocity +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/operation +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_operation -- **default value**: NaN -- **type**: number -- **documentation**: The velocity with which the plate subducts in meters per year. -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/coupling depth -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_coupling depth +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/min distance slab top +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_min-distance-slab-top -- **default value**: NaN -- **type**: number -- **documentation**: The depth at which the slab surface first comes in contact with the hot mantle wedge in meters. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be negative and should be 1.5-2 times larger thatn the nominal slab thickness to allow the diffusion of cold temperatures from in the slab into the mantle above the slab surface. Also note that the top truncation value for the slab segment needs to have a value of -1, otherwise the temperature above the slab will be cut off at a distance less than the value set here. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/shallow dip -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_shallow dip +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/max distance slab top +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_max-distance-slab-top -- **default value**: NaN -- **type**: number -- **documentation**: The average dip of the slab at depths shallower than the coupling depth in degrees. If the shallow slab dip changes with distance along the slab surface, then this will need to be adjusted to get the temperature above and below the coupling depth to match. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be positive and approximately 2.5-3.0 times larger than the nominal slab thickness to allow the diffusion of coldtemperatures from in the slab into the mantle below the slab surface.For example if the slab starts with cold temperatures over a 100 km wide region, thisparameters should be about 250 km. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/thermal conductivity -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_thermal conductivity +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/density +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_density -- **default value**: 3.3 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::::: +- **default value**:3300.0 +- **type**:number +- **documentation**:The reference density of the subducting plate in $kg/m^3$ +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/thermal expansion coefficient -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_thermal expansion coefficient +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/plate velocity +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_plate-velocity -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. -::::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The velocity with which the plate subducts in meters per year. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/specific heat -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_specific heat +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/coupling depth +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_coupling-depth -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. -::::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The depth at which the slab surface first comes in contact with the hot mantle wedge in meters. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/thermal diffusivity -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_thermal diffusivity +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/shallow dip +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_shallow-dip -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The average dip of the slab at depths shallower than the coupling depth in degrees. If the shallow slab dip changes with distance along the slab surface, then this will need to be adjusted to get the temperature above and below the coupling depth to match. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/adiabatic heating -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_adiabatic heating +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/thermal conductivity +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_thermal-conductivity -- **default value**: true -- **type**: boolean -- **documentation**: Whether adiabatic heating should be used for the slab. -::::::::: +- **default value**:3.3 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/taper distance -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_taper distance +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/thermal expansion coefficient +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_thermal-expansion-coefficient -- **default value**: 100000.0 -- **type**: number -- **documentation**: Distance over which to taper the slab tip.tapers the initial heat content to zero and the minimum temperature to the background temperature. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/potential mantle temperature -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_potential mantle temperature +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/specific heat +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_specific-heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/ridge coordinates -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_ridge coordinates - -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. -::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/ridge coordinates/items -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_ridge coordinates_items - -- **type**: array -- **minItems**: 2 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: -:::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/ridge coordinates/items/items -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_ridge coordinates_items_items - -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/ridge coordinates/items/items/items -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_ridge coordinates_items_items_items - -- **type**: number -:::::: - -::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/thermal diffusivity +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_thermal-diffusivity -:::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::::: -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/adiabatic heating +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_adiabatic-heating +- **default value**:true +- **type**:boolean +- **documentation**:Whether adiabatic heating should be used for the slab. +:::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/taper distance +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_taper-distance -:::::::::: +- **default value**:100000.0 +- **type**:number +- **documentation**:Distance over which to taper the slab tip.tapers the initial heat content to zero and the minimum temperature to the background temperature. +:::::::::::::: -::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4 -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_4 +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/potential mantle temperature +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_potential-mantle-temperature -- **type**: object -- **documentation**: Plate model (based on McKenzie, 1970). -- **additionalProperties**: false -- **required**: [model, plate velocity] +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/model -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_model +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/ridge coordinates +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_ridge-coordinates -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [plate model] -::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/ridge coordinates/items +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_ridge-coordinates_items -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/operation -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_operation +- **type**:array +- **minItems**:2 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/ridge coordinates/items/items +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_ridge-coordinates_items_items -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/ridge coordinates/items/items/items +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_ridge-coordinates_items_items_items -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/min distance slab top -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_min distance slab top +- **type**:number +::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +:::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/max distance slab top -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_max distance slab top +::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/density -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_density -- **default value**: 3300.0 -- **type**: number -- **documentation**: The reference density of the subducting plate in $kg/m^3$ -::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/plate velocity -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_plate velocity +::::::::::::::: -- **default value**: NaN -- **type**: number -- **documentation**: The velocity in meters per year with which the plate subducts in meters per year. -::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4 +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4 -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/thermal conductivity -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_thermal conductivity +- **type**:object +- **documentation**:Plate model (based on McKenzie, 1970). +- **additionalProperties**:false +- **required**:[model, plate velocity] -- **default value**: 2.0 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/model +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_model -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/thermal expansion coefficient -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_thermal expansion coefficient +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[plate model] +:::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/operation +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_operation -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/specific heat -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_specific heat +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/min distance slab top +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_min-distance-slab-top -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/adiabatic heating -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_adiabatic heating +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: -- **default value**: true -- **type**: boolean -- **documentation**: Wheter adiabatic heating should be used for the slab. Setting the parameter to false leads to equation 26 from McKenzie (1970),which is the result obtained from McKenzie 1969. -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/max distance slab top +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_max-distance-slab-top -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/potential mantle temperature -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_potential mantle temperature +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/density +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_density +- **default value**:3300.0 +- **type**:number +- **documentation**:The reference density of the subducting plate in $kg/m^3$ +:::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/plate velocity +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_plate-velocity -:::::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The velocity in meters per year with which the plate subducts in meters per year. +:::::::::::::: -::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5 -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_5 +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/thermal conductivity +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_thermal-conductivity -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] +- **default value**:2.0 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5/model -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_5_model +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/thermal expansion coefficient +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_thermal-expansion-coefficient -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5/operation -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_5_operation +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/specific heat +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_specific-heat -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5/min distance slab top -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_5_min distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/adiabatic heating +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_adiabatic-heating -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +- **default value**:true +- **type**:boolean +- **documentation**:Wheter adiabatic heating should be used for the slab. Setting the parameter to false leads to equation 26 from McKenzie (1970),which is the result obtained from McKenzie 1969. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5/max distance slab top -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_5_max distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/potential mantle temperature +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_potential-mantle-temperature -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5/temperature -:name: closed__features_items_oneOf_5_sections_items_temperature models_items_oneOf_5_temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::: +::::::::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5 +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_5 -:::::::::: +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5/model +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_5_model -:::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::::: -::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5/operation +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_5_operation -:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models -:name: closed__features_items_oneOf_5_sections_items_composition models +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -- **documentation**: A list of composition models. -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items -:name: closed__features_items_oneOf_5_sections_items_composition models_items +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5/min distance slab top +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_5_min-distance-slab-top -:::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf -:name: closed__features_items_oneOf_5_sections_items_composition models_items_oneOf +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: -::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1 -:name: closed__features_items_oneOf_5_sections_items_composition models_items_oneOf_1 +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5/max distance slab top +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_5_max-distance-slab-top -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/model -:name: closed__features_items_oneOf_5_sections_items_composition models_items_oneOf_1_model +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5/temperature +:name: closed_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_5_temperature -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/min distance slab top -:name: closed__features_items_oneOf_5_sections_items_composition models_items_oneOf_1_min distance slab top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/max distance slab top -:name: closed__features_items_oneOf_5_sections_items_composition models_items_oneOf_1_max distance slab top +::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_5_sections_items_composition models_items_oneOf_1_compositions +::::::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_5_sections_items_composition models_items_oneOf_1_compositions_items +:::::::::::::::::: -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models +:name: closed_features_items_oneOf_5_sections_items_composition-models -::::::::: +- **documentation**:A list of composition models. +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items +:name: closed_features_items_oneOf_5_sections_items_composition-models_items -:::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/fractions -:name: closed__features_items_oneOf_5_sections_items_composition models_items_oneOf_1_fractions +::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf +:name: closed_features_items_oneOf_5_sections_items_composition-models_items_oneOf -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/fractions/items -:name: closed__features_items_oneOf_5_sections_items_composition models_items_oneOf_1_fractions_items +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1 +:name: closed_features_items_oneOf_5_sections_items_composition-models_items_oneOf_1 -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::: +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/model +:name: closed_features_items_oneOf_5_sections_items_composition-models_items_oneOf_1_model -:::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/operation -:name: closed__features_items_oneOf_5_sections_items_composition models_items_oneOf_1_operation +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/min distance slab top +:name: closed_features_items_oneOf_5_sections_items_composition-models_items_oneOf_1_min-distance-slab-top +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/max distance slab top +:name: closed_features_items_oneOf_5_sections_items_composition-models_items_oneOf_1_max-distance-slab-top -:::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_5_sections_items_composition-models_items_oneOf_1_compositions -:::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_5_sections_items_composition-models_items_oneOf_1_compositions_items +- **default value**:0 +- **type**:integer +- **documentation**: ::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models -:name: closed__features_items_oneOf_5_sections_items_grains models +:::::::::::::: -- **documentation**: A list of grains models. -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items -:name: closed__features_items_oneOf_5_sections_items_grains models_items +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/fractions +:name: closed_features_items_oneOf_5_sections_items_composition-models_items_oneOf_1_fractions -:::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/fractions/items +:name: closed_features_items_oneOf_5_sections_items_composition-models_items_oneOf_1_fractions_items -::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1 -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_1 +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::: -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/model -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_1_model +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/operation +:name: closed_features_items_oneOf_5_sections_items_composition-models_items_oneOf_1_operation -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/min distance slab top -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_1_min distance slab top -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the slab top in meters from which the composition of this feature is present. -::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/max distance slab top -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_1_max distance slab top +::::::::::::::: -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the slab top in meters to which the composition of this feature is present. -::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/compositions -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_1_compositions +::::::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/compositions/items -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_1_compositions_items +:::::::::::::::::: -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models +:name: closed_features_items_oneOf_5_sections_items_grains-models -::::::::: +- **documentation**:A list of grains models. +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items +:name: closed_features_items_oneOf_5_sections_items_grains-models_items -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/orientation operation -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_1_orientation operation +::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1 +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1 -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/grain sizes -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_1_grain sizes +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/grain sizes/items -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_1_grain sizes_items +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/model +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1_model -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::::: -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/min distance slab top +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1_min-distance-slab-top -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/normalize grain sizes -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_1_normalize grain sizes +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the slab top in meters from which the composition of this feature is present. +:::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/normalize grain sizes/items -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_1_normalize grain sizes_items +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/max distance slab top +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1_max-distance-slab-top -- **default value**: true -- **type**: boolean -- **documentation**: -:::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the slab top in meters to which the composition of this feature is present. +:::::::::::::: -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/compositions +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1_compositions +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/compositions/items +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1_compositions_items +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: -:::::::::: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/orientation operation +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1_orientation-operation -::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2 -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_2 +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/grain sizes +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1_grain-sizes -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/model -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_2_model +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/grain sizes/items +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1_grain-sizes_items -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/min distance slab top -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_2_min distance slab top +:::::::::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the slab top in meters from which the composition of this feature is present. -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/normalize grain sizes +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1_normalize-grain-sizes -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/max distance slab top -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_2_max distance slab top +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/normalize grain sizes/items +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1_normalize-grain-sizes_items -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the slab top in meters to which the composition of this feature is present. -::::::::: +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/compositions -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_2_compositions +:::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/compositions/items -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_2_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: -::::::::: +::::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/rotation matrices -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_2_rotation matrices - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the grains which are present there for each compositions. -::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/rotation matrices/items -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_2_rotation matrices_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/rotation matrices/items/items -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_2_rotation matrices_items_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/rotation matrices/items/items/items -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_2_rotation matrices_items_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -:::::: - -::::::: +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2 +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2 -:::::::: +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/model +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_model -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/Euler angles z-x-z -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_2_Euler angles z-x-z - -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/Euler angles z-x-z/items -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_2_Euler angles z-x-z_items - -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_2_Euler angles z-x-z_items_items - -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::::: -:::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/min distance slab top +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_min-distance-slab-top -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the slab top in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/orientation operation -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_2_orientation operation +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/max distance slab top +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_max-distance-slab-top -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the slab top in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/grain sizes -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_2_grain sizes +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/compositions +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/grain sizes/items -:name: closed__features_items_oneOf_5_sections_items_grains models_items_oneOf_2_grain sizes_items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/compositions/items +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_compositions_items -- **default value**: -1.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/rotation matrices +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_rotation-matrices + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the grains which are present there for each compositions. +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/rotation matrices/items +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_rotation-matrices_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/rotation matrices/items/items +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_rotation-matrices_items_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/rotation matrices/items/items/items +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_rotation-matrices_items_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::::: +:::::::::::: -:::::::::: +::::::::::::: +:::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/Euler angles z-x-z +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_Euler-angles-z-x-z + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/Euler angles z-x-z/items +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: :::::::::::: ::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/coordinate -:name: closed__features_items_oneOf_5_sections_items_coordinate +:::::::::::::: -- **default value**: 0 -- **type**: integer -- **documentation**: The coordinate which should be overwritten -::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/orientation operation +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_orientation-operation + +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/grain sizes +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_grain-sizes +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/grain sizes/items +:name: closed_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_grain-sizes_items + +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::::: :::::::::::::: + + ::::::::::::::: +::::::::::::::::: -:::::::::::::::: +:::::::::::::::::: +::::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/coordinate +:name: closed_features_items_oneOf_5_sections_items_coordinate +- **default value**:0 +- **type**:integer +- **documentation**:The coordinate which should be overwritten :::::::::::::::::: + + ::::::::::::::::::: +:::::::::::::::::::: + + + +::::::::::::::::::::: + + +::::::::::::::::::::::: + +:::::::::::::::::::::::: + diff --git a/tests/app/world_buider_declarations_open.md b/tests/app/world_buider_declarations_open.md index cb499632c..988e30800 100644 --- a/tests/app/world_buider_declarations_open.md +++ b/tests/app/world_buider_declarations_open.md @@ -1,9625 +1,10703 @@ -::::::::::::::::::::{dropdown} / +:::::::::::::::::::::::::{dropdown} / :open: :name: open_ -- **type**: object -- **documentation**: Root object -- **additionalProperties**: false -- **required**: [version, features] +- **type**:object +- **documentation**:Root object +- **additionalProperties**:false +- **required**:[version, features] -:::::::::::::::::::{dropdown} /version +::::::::::::::::::::::::{dropdown} /version :open: :name: open_version -- **default value**: -- **type**: string -- **documentation**: The major and minor version number for which the input file was written. -::::::::::::::::::: +- **default value**: +- **type**:string +- **documentation**:The major and minor version number for which the input file was written. +:::::::::::::::::::::::: -:::::::::::::::::::{dropdown} /cross section +::::::::::::::::::::::::{dropdown} /cross section :open: -:name: open_cross section +:name: open_cross-section -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **uniqueItems**: false -- **documentation**: This is an array of two points along where the cross section is taken -::::::::::::::::::{dropdown} /cross section/items +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **uniqueItems**:false +- **documentation**:This is an array of two points along where the cross section is taken +:::::::::::::::::::::::{dropdown} /cross section/items :open: -:name: open_cross section_items +:name: open_cross-section_items -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -:::::::::::::::::{dropdown} /cross section/items/items +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +::::::::::::::::::::::{dropdown} /cross section/items/items :open: -:name: open_cross section_items_items +:name: open_cross-section_items_items -- **type**: number -::::::::::::::::: +- **type**:number +:::::::::::::::::::::: -:::::::::::::::::: +::::::::::::::::::::::: -::::::::::::::::::: +:::::::::::::::::::::::: -:::::::::::::::::::{dropdown} /potential mantle temperature +::::::::::::::::::::::::{dropdown} /potential mantle temperature :open: -:name: open_potential mantle temperature +:name: open_potential-mantle-temperature -- **default value**: 1600.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. -::::::::::::::::::: +- **default value**:1600.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. +:::::::::::::::::::::::: -:::::::::::::::::::{dropdown} /surface temperature +::::::::::::::::::::::::{dropdown} /surface temperature :open: -:name: open_surface temperature +:name: open_surface-temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the surface in Kelvin. -::::::::::::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the surface in Kelvin. +:::::::::::::::::::::::: -:::::::::::::::::::{dropdown} /force surface temperature +::::::::::::::::::::::::{dropdown} /force surface temperature :open: -:name: open_force surface temperature +:name: open_force-surface-temperature -- **default value**: false -- **type**: boolean -- **documentation**: Force the provided surface temperature to be set at the surface -::::::::::::::::::: +- **default value**:false +- **type**:boolean +- **documentation**:Force the provided surface temperature to be set at the surface +:::::::::::::::::::::::: -:::::::::::::::::::{dropdown} /thermal expansion coefficient +::::::::::::::::::::::::{dropdown} /thermal expansion coefficient :open: -:name: open_thermal expansion coefficient +:name: open_thermal-expansion-coefficient -- **default value**: 0.000035 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. -::::::::::::::::::: +- **default value**:0.000035 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. +:::::::::::::::::::::::: -:::::::::::::::::::{dropdown} /specific heat +::::::::::::::::::::::::{dropdown} /specific heat :open: -:name: open_specific heat +:name: open_specific-heat -- **default value**: 1250.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}.$ -::::::::::::::::::: +- **default value**:1250.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}.$ +:::::::::::::::::::::::: -:::::::::::::::::::{dropdown} /thermal diffusivity +::::::::::::::::::::::::{dropdown} /thermal diffusivity :open: -:name: open_thermal diffusivity +:name: open_thermal-diffusivity -- **default value**: 8.04e-7 -- **type**: number -- **documentation**: The thermal diffusivity in $m^{2} s^{-1}$. -::::::::::::::::::: +- **default value**:8.04e-7 +- **type**:number +- **documentation**:The thermal diffusivity in $m^{2} s^{-1}$. +:::::::::::::::::::::::: -:::::::::::::::::::{dropdown} /maximum distance between coordinates +::::::::::::::::::::::::{dropdown} /maximum distance between coordinates :open: -:name: open_maximum distance between coordinates +:name: open_maximum-distance-between-coordinates -- **default value**: 0.0 -- **type**: number -- **documentation**: This enforces a maximum distance (in degree for spherical coordinates or meter in cartesian coordinates) between coordinates in the model. If the distance is larger, extra points are added by interpolation. Requires interpolation to be not 'none'. -::::::::::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:This enforces a maximum distance (in degree for spherical coordinates or meter in cartesian coordinates) between coordinates in the model. If the distance is larger, extra points are added by interpolation. Requires interpolation to be not 'none'. +:::::::::::::::::::::::: -:::::::::::::::::::{dropdown} /interpolation +::::::::::::::::::::::::{dropdown} /interpolation :open: :name: open_interpolation -- **default value**: none -- **type**: string -- **documentation**: What type of interpolation should be used to enforce the minimum points per distance parameter. Options are none, linear, monotone spline and continuous monotone spline interpolation. -::::::::::::::::::: +- **default value**:none +- **type**:string +- **documentation**:What type of interpolation should be used to enforce the minimum points per distance parameter. Options are none, linear, monotone spline and continuous monotone spline interpolation. +:::::::::::::::::::::::: -:::::::::::::::::::{dropdown} /coordinate system +::::::::::::::::::::::::{dropdown} /coordinate system :open: -:name: open_coordinate system +:name: open_coordinate-system -- **documentation**: A coordinate system. Cartesian or spherical. -- **default value**: cartesian -- **type**: object -::::::::::::::::::{dropdown} /coordinate system/oneOf +- **documentation**:A coordinate system. Cartesian or spherical. +- **default value**:cartesian +- **type**:object +:::::::::::::::::::::::{dropdown} /coordinate system/oneOf :open: -:name: open_coordinate system_oneOf +:name: open_coordinate-system_oneOf -:::::::::::::::::{dropdown} /coordinate system/oneOf/1 +::::::::::::::::::::::{dropdown} /coordinate system/oneOf/1 :open: -:name: open_coordinate system_oneOf_1 +:name: open_coordinate-system_oneOf_1 -- **type**: object -- **documentation**: A Cartesian coordinate sytem. Coordinates are (x,y,z) and extend infintly in all directions. -- **additionalProperties**: false -- **required**: [model] +- **type**:object +- **documentation**:A Cartesian coordinate sytem. Coordinates are (x,y,z) and extend infintly in all directions. +- **additionalProperties**:false +- **required**:[model] -::::::::::::::::{dropdown} /coordinate system/oneOf/1/model +:::::::::::::::::::::{dropdown} /coordinate system/oneOf/1/model :open: -:name: open_coordinate system_oneOf_1_model +:name: open_coordinate-system_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -- **enum**: [cartesian] -:::::::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +- **enum**:[cartesian] +::::::::::::::::::::: -::::::::::::::::: +:::::::::::::::::::::: -:::::::::::::::::{dropdown} /coordinate system/oneOf/2 +::::::::::::::::::::::{dropdown} /coordinate system/oneOf/2 :open: -:name: open_coordinate system_oneOf_2 +:name: open_coordinate-system_oneOf_2 -- **type**: object -- **documentation**: A spherical coordinate system. The coordinates are (radius, longitude, latitude). The radius is set in this plugin, the longitude extends at least from -360 to 360 degrees, and the latitude extends from -90 to 90. It is required to choose a depth method. Please see the manual for more information. -- **additionalProperties**: false -- **required**: [model, depth method] +- **type**:object +- **documentation**:A spherical coordinate system. The coordinates are (radius, longitude, latitude). The radius is set in this plugin, the longitude extends at least from -360 to 360 degrees, and the latitude extends from -90 to 90. It is required to choose a depth method. Please see the manual for more information. +- **additionalProperties**:false +- **required**:[model, depth method] -::::::::::::::::{dropdown} /coordinate system/oneOf/2/model +:::::::::::::::::::::{dropdown} /coordinate system/oneOf/2/model :open: -:name: open_coordinate system_oneOf_2_model +:name: open_coordinate-system_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -- **enum**: [spherical] -:::::::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +- **enum**:[spherical] +::::::::::::::::::::: -::::::::::::::::{dropdown} /coordinate system/oneOf/2/depth method +:::::::::::::::::::::{dropdown} /coordinate system/oneOf/2/depth method :open: -:name: open_coordinate system_oneOf_2_depth method +:name: open_coordinate-system_oneOf_2_depth-method -- **default value**: -- **type**: string -- **documentation**: Which depth method to use in the spherical case. The available options are 'starting point', 'begin segment' and 'begin at end segment'. See the manual section on coordinate systems for more info. -- **enum**: [starting point, begin segment, begin at end segment, continuous] -:::::::::::::::: +- **default value**: +- **type**:string +- **documentation**:Which depth method to use in the spherical case. The available options are 'starting point', 'begin segment' and 'begin at end segment'. See the manual section on coordinate systems for more info. +- **enum**:[starting point, begin segment, begin at end segment, continuous] +::::::::::::::::::::: -::::::::::::::::{dropdown} /coordinate system/oneOf/2/radius +:::::::::::::::::::::{dropdown} /coordinate system/oneOf/2/radius :open: -:name: open_coordinate system_oneOf_2_radius +:name: open_coordinate-system_oneOf_2_radius -- **default value**: 6371000.0 -- **type**: number -- **documentation**: The radius of the sphere. -:::::::::::::::: +- **default value**:6371000.0 +- **type**:number +- **documentation**:The radius of the sphere. +::::::::::::::::::::: -::::::::::::::::: +:::::::::::::::::::::: -::::::::::::::::::: +:::::::::::::::::::::::: -:::::::::::::::::::{dropdown} /features +::::::::::::::::::::::::{dropdown} /features :open: :name: open_features -- **documentation**: A list of features. -- **default value**: -- **type**: array -::::::::::::::::::{dropdown} /features/items +- **documentation**:A list of features. +- **default value**: +- **type**:array +:::::::::::::::::::::::{dropdown} /features/items :open: :name: open_features_items -:::::::::::::::::{dropdown} /features/items/oneOf +::::::::::::::::::::::{dropdown} /features/items/oneOf :open: :name: open_features_items_oneOf -::::::::::::::::{dropdown} /features/items/oneOf/1 +:::::::::::::::::::::{dropdown} /features/items/oneOf/1 :open: :name: open_features_items_oneOf_1 -- **type**: object -- **documentation**: continental plate object -- **additionalProperties**: false -- **required**: [model, coordinates] +- **type**:object +- **documentation**:continental plate object +- **additionalProperties**:false +- **required**:[model, coordinates] -:::::::::::::::{dropdown} /features/items/oneOf/1/model +::::::::::::::::::::{dropdown} /features/items/oneOf/1/model :open: :name: open_features_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -- **enum**: [continental plate] -::::::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +- **enum**:[continental plate] +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/1/name +::::::::::::::::::::{dropdown} /features/items/oneOf/1/name :open: :name: open_features_items_oneOf_1_name -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -::::::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/1/coordinates +::::::::::::::::::::{dropdown} /features/items/oneOf/1/coordinates :open: :name: open_features_items_oneOf_1_coordinates -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An array of 2d Points representing an array of coordinates where the feature is located. -::::::::::::::{dropdown} /features/items/oneOf/1/coordinates/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An array of 2d Points representing an array of coordinates where the feature is located. +:::::::::::::::::::{dropdown} /features/items/oneOf/1/coordinates/items :open: :name: open_features_items_oneOf_1_coordinates_items -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -:::::::::::::{dropdown} /features/items/oneOf/1/coordinates/items/items +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +::::::::::::::::::{dropdown} /features/items/oneOf/1/coordinates/items/items :open: :name: open_features_items_oneOf_1_coordinates_items_items -- **type**: number -::::::::::::: +- **type**:number +:::::::::::::::::: -:::::::::::::: +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/1/interpolation +::::::::::::::::::::{dropdown} /features/items/oneOf/1/interpolation :open: :name: open_features_items_oneOf_1_interpolation -- **default value**: global -- **type**: string -- **documentation**: What type of interpolation should be used to enforce the minimum points per distance parameter. Options are global, none, linear, monotone spline and continuous monotone spline interpolation. If this value is set to global, the global value for interpolation is used. -::::::::::::::: +- **default value**:global +- **type**:string +- **documentation**:What type of interpolation should be used to enforce the minimum points per distance parameter. Options are global, none, linear, monotone spline and continuous monotone spline interpolation. If this value is set to global, the global value for interpolation is used. +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/1/min depth +::::::::::::::::::::{dropdown} /features/items/oneOf/1/min depth :open: -:name: open_features_items_oneOf_1_min depth - -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::::: +:name: open_features_items_oneOf_1_min-depth -:::::::::::::::{dropdown} /features/items/oneOf/1/max depth +:::::::::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf :open: -:name: open_features_items_oneOf_1_max depth - -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::::: +:name: open_features_items_oneOf_1_min-depth_oneOf -:::::::::::::::{dropdown} /features/items/oneOf/1/temperature models +::::::::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf/1 :open: -:name: open_features_items_oneOf_1_temperature models +:name: open_features_items_oneOf_1_min-depth_oneOf_1 -- **documentation**: A list of temperature models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items -:open: -:name: open_features_items_oneOf_1_temperature models_items +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf +::::::::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf/2 :open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf +:name: open_features_items_oneOf_1_min-depth_oneOf_2 -::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1 +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf/2/items :open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_1 - -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +:name: open_features_items_oneOf_1_min-depth_oneOf_2_items -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/model +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf/2/items/items :open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_1_model - -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::::::: +:name: open_features_items_oneOf_1_min-depth_oneOf_2_items_items -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/operation +:::::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf/2/items/items/anyOf :open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_1_operation +:name: open_features_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: - -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth +::::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/1 :open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_1_min depth +:name: open_features_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_1 -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +- **type**:number +- **default value**:0.0 +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth +::::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2 :open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_1_max depth +:name: open_features_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2 -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: - -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/potential mantle temperature +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items :open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_1_potential mantle temperature - -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::::::: +:name: open_features_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/thermal expansion coefficient +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items/items :open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_1_thermal expansion coefficient +:name: open_features_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items_items -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::::::: - -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/specific heat -:open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_1_specific heat +- **type**:number +:::::::::::: -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::::::: +::::::::::::: +:::::::::::::: -:::::::::::: +:::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2 -:open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_2 +::::::::::::::::: -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max depth] +:::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/model -:open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::::::: +:::::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/operation +::::::::::::::::::::{dropdown} /features/items/oneOf/1/max depth :open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_2_operation - -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +:name: open_features_items_oneOf_1_max-depth -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth +:::::::::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf :open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_2_min depth +:name: open_features_items_oneOf_1_max-depth_oneOf -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: - -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth +::::::::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf/1 :open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_2_max depth +:name: open_features_items_oneOf_1_max-depth_oneOf_1 -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/top temperature +::::::::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf/2 :open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_2_top temperature +:name: open_features_items_oneOf_1_max-depth_oneOf_2 -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. -::::::::::: - -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/bottom temperature +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf/2/items :open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_2_bottom temperature - -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the top in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. -::::::::::: - - - -:::::::::::: +:name: open_features_items_oneOf_1_max-depth_oneOf_2_items -::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3 +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf/2/items/items :open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_3 +:name: open_features_items_oneOf_1_max-depth_oneOf_2_items_items -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] - -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/model +:::::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf/2/items/items/anyOf :open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_3_model - -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::::::: +:name: open_features_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/operation +::::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/1 :open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_3_operation +:name: open_features_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_1 -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth +::::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2 :open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_3_min depth +:name: open_features_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2 -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items/items :open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_3_max depth +:name: open_features_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items_items -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: +- **type**:number +:::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/temperature -:open: -:name: open_features_items_oneOf_1_temperature models_items_oneOf_3_temperature +::::::::::::: -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::::: +:::::::::::::: +:::::::::::::::: -:::::::::::: +::::::::::::::::: +:::::::::::::::::: -:::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/1/composition models +::::::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models :open: -:name: open_features_items_oneOf_1_composition models +:name: open_features_items_oneOf_1_temperature-models -- **documentation**: A list of composition models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items +- **documentation**:A list of temperature models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items :open: -:name: open_features_items_oneOf_1_composition models_items +:name: open_features_items_oneOf_1_temperature-models_items -:::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf +::::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf :open: -:name: open_features_items_oneOf_1_composition models_items_oneOf +:name: open_features_items_oneOf_1_temperature-models_items_oneOf -::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1 +:::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1 :open: -:name: open_features_items_oneOf_1_composition models_items_oneOf_1 +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1 -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] -:::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/model +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_1_composition models_items_oneOf_1_model +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/operation :open: -:name: open_features_items_oneOf_1_composition models_items_oneOf_1_min depth +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_operation -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the composition of this feature is present. -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth :open: -:name: open_features_items_oneOf_1_composition models_items_oneOf_1_max depth +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the composition of this feature is present. -::::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf -:::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/compositions +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf/1 :open: -:name: open_features_items_oneOf_1_composition models_items_oneOf_1_compositions +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf_1 + +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/compositions/items +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf/2 :open: -:name: open_features_items_oneOf_1_composition models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf_2 -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf_2_items -::::::::::: +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items -:::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/fractions +:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf :open: -:name: open_features_items_oneOf_1_composition models_items_oneOf_1_fractions +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/fractions/items +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/1 :open: -:name: open_features_items_oneOf_1_composition models_items_oneOf_1_fractions_items +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_1 -- **default value**: 1.0 -- **type**: number -- **documentation**: +- **type**:number +- **default value**:0.0 :::::::::: -::::::::::: +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2 -:::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/operation +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items :open: -:name: open_features_items_oneOf_1_composition models_items_oneOf_1_operation +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: +:::::::::: :::::::::::: +::::::::::::: :::::::::::::: -::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/1/grains models -:open: -:name: open_features_items_oneOf_1_grains models +:::::::::::::::: -- **documentation**: A list of grains models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth :open: -:name: open_features_items_oneOf_1_grains models_items +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth -:::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf +:::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf -::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1 +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf/1 :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_1 +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf_1 -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/model +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf/2 :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_1_model +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf_2 -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf_2_items -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf/2/items/items :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_1_min depth +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the composition of this feature is present. -::::::::::: +:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/1 :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_1_max depth +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_1 -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the composition of this feature is present. -::::::::::: +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2 -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/compositions +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_1_compositions +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items/items :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: -- **default value**: 0 -- **type**: integer -- **documentation**: :::::::::: -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/orientation operation -:open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_1_orientation operation +:::::::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/grain sizes -:open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_1_grain sizes +:::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/grain sizes/items -:open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_1_grain sizes_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::::: +:::::::::::::::: -::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/potential mantle temperature +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_potential-mantle-temperature + +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/normalize grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/thermal expansion coefficient :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_1_normalize grain sizes +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_thermal-expansion-coefficient + +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/normalize grain sizes/items +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/specific heat :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_1_normalize grain sizes_items +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_specific-heat -- **default value**: true -- **type**: boolean -- **documentation**: -:::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::::: -::::::::::: +::::::::::::::::: -:::::::::::: +:::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2 +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2 + +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max depth] -::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2 +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_2 +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_model -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/model +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/operation :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_2_model +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_operation -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_2_min depth +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the composition of this feature is present. -::::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf/1 :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_2_max depth +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf_1 -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the composition of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/compositions +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf/2 :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_2_compositions +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf_2 -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf/2/items :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_2_compositions_items +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf_2_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items -::::::::::: +:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/rotation matrices +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/1 :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_2_rotation matrices +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the rotation matrices of the grains which are present there for each compositions. -::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/rotation matrices/items +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2 :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_2_rotation matrices_items +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2 -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/rotation matrices/items/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_2_rotation matrices_items_items +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/rotation matrices/items/items/items +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items/items :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_2_rotation matrices_items_items_items +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: +- **type**:number :::::::: ::::::::: :::::::::: -::::::::::: -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/Euler angles z-x-z -:open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_2_Euler angles z-x-z +:::::::::::: -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/Euler angles z-x-z/items +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_2_Euler angles z-x-z_items +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/Euler angles z-x-z/items/items +:::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_2_Euler angles z-x-z_items_items +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::::::: +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf_1 -:::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::: -::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf_2 -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/orientation operation +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf/2/items :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_2_orientation operation +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf_2_items -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace, multiply] -::::::::::: +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items -:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/grain sizes +:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_2_grain sizes +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/grain sizes/items +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/1 :open: -:name: open_features_items_oneOf_1_grains models_items_oneOf_2_grain sizes_items +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_1 -- **default value**: -1.0 -- **type**: number -- **documentation**: +- **type**:number +- **default value**:1.7976931348623157e308 :::::::::: -::::::::::: +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2 +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items_items -:::::::::::: +- **type**:number +:::::::: +::::::::: -:::::::::::::: +:::::::::: -::::::::::::::: +:::::::::::: + +::::::::::::: + +:::::::::::::: :::::::::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/2 +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/top temperature :open: -:name: open_features_items_oneOf_2 +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_top-temperature -- **type**: object -- **documentation**: Fault object -- **additionalProperties**: false -- **required**: [model, coordinates] +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. +:::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/2/model +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/bottom temperature :open: -:name: open_features_items_oneOf_2_model +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_bottom-temperature -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -- **enum**: [fault] -::::::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the top in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. +:::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/2/name -:open: -:name: open_features_items_oneOf_2_name -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/2/coordinates -:open: -:name: open_features_items_oneOf_2_coordinates +::::::::::::::::: -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An array of 2d Points representing an array of coordinates where the feature is located. -::::::::::::::{dropdown} /features/items/oneOf/2/coordinates/items +:::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3 :open: -:name: open_features_items_oneOf_2_coordinates_items +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3 -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -:::::::::::::{dropdown} /features/items/oneOf/2/coordinates/items/items +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] + +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/model :open: -:name: open_features_items_oneOf_2_coordinates_items_items +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_model -- **type**: number -::::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::::::: -:::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/operation +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_operation -::::::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/2/interpolation +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth :open: -:name: open_features_items_oneOf_2_interpolation +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth -- **default value**: global -- **type**: string -- **documentation**: What type of interpolation should be used to enforce the minimum points per distance parameter. Options are global, none, linear, monotone spline and continuous monotone spline interpolation. If this value is set to global, the global value for interpolation is used. -::::::::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf -:::::::::::::::{dropdown} /features/items/oneOf/2/min depth +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf/1 :open: -:name: open_features_items_oneOf_2_min depth +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf_1 -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/2/max depth +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf/2 :open: -:name: open_features_items_oneOf_2_max depth +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf_2 -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf_2_items -:::::::::::::::{dropdown} /features/items/oneOf/2/dip point +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf/2/items/items :open: -:name: open_features_items_oneOf_2_dip point +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: The depth to which this feature is present -::::::::::::::{dropdown} /features/items/oneOf/2/dip point/items +:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf :open: -:name: open_features_items_oneOf_2_dip point_items +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf -- **type**: number -:::::::::::::: +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_1 -::::::::::::::: +- **type**:number +- **default value**:0.0 +:::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/2/segments +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2 :open: -:name: open_features_items_oneOf_2_segments +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2 -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: The depth to which this feature is present -::::::::::::::{dropdown} /features/items/oneOf/2/segments/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2/items :open: -:name: open_features_items_oneOf_2_segments_items - -- **type**: object -- **additionalProperties**: false -- **documentation**: -- **required**: [length, thickness, angle] +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2_items -:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/length +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2/items/items :open: -:name: open_features_items_oneOf_2_segments_items_length +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2_items_items -- **type**: number -::::::::::::: +- **type**:number +:::::::: -:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/thickness -:open: -:name: open_features_items_oneOf_2_segments_items_thickness +::::::::: + +:::::::::: -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::::{dropdown} /features/items/oneOf/2/segments/items/thickness/items -:open: -:name: open_features_items_oneOf_2_segments_items_thickness_items -- **type**: number :::::::::::: ::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/top truncation -:open: -:name: open_features_items_oneOf_2_segments_items_top truncation +:::::::::::::: -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::::{dropdown} /features/items/oneOf/2/segments/items/top truncation/items -:open: -:name: open_features_items_oneOf_2_segments_items_top truncation_items -- **type**: number -:::::::::::: +:::::::::::::::: -::::::::::::: +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth -:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/angle +:::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf :open: -:name: open_features_items_oneOf_2_segments_items_angle +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::::{dropdown} /features/items/oneOf/2/segments/items/angle/items +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf/1 :open: -:name: open_features_items_oneOf_2_segments_items_angle_items +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf_1 -- **type**: number -:::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::: -::::::::::::: +::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf_2 -:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf/2/items :open: -:name: open_features_items_oneOf_2_segments_items_temperature models +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf_2_items -- **documentation**: -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf/2/items/items :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items -:::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf +:::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf -::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1 +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/1 :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_1 +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_1 -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/model +::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2 :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_1_model +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/temperature +:open: +:name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_temperature + +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::::: + + + +::::::::::::::::: + + +::::::::::::::::::: + +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/1/composition models +:open: +:name: open_features_items_oneOf_1_composition-models + +- **documentation**:A list of composition models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items +:open: +:name: open_features_items_oneOf_1_composition-models_items + +::::::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf + +:::::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1 +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1 + +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] + +::::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/model +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_model + +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth + +:::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf/1 +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf_1 + +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf/2 +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth + +:::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf_1 + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] ::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/operation +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/compositions +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_compositions + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/compositions/items +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_compositions_items + +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/fractions +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_fractions + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/fractions/items +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_fractions_items + +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::::: + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/operation +:open: +:name: open_features_items_oneOf_1_composition-models_items_oneOf_1_operation + +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: + + + +::::::::::::::::: + + +::::::::::::::::::: + +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/1/grains models +:open: +:name: open_features_items_oneOf_1_grains-models + +- **documentation**:A list of grains models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items +:open: +:name: open_features_items_oneOf_1_grains-models_items + +::::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf + +:::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1 +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1 + +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] + +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/model +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_model + +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth + +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf/1 +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf_1 + +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf/2 +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items/items :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_1_operation +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] ::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/min distance fault center +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth + +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf_1 + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_1_min distance fault center +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. ::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/max distance fault center +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/compositions +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_compositions + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/compositions/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_compositions_items + +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/orientation operation +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_orientation-operation + +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/grain sizes +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_grain-sizes + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/grain sizes/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_grain-sizes_items + +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::::: + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/normalize grain sizes +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_normalize-grain-sizes + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/normalize grain sizes/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_1_normalize-grain-sizes_items + +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::::::: + +:::::::::::::::: + + + +::::::::::::::::: + +:::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2 +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2 + +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] + +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/model +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_model + +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth + +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf/1 +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf_1 + +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf/2 +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth + +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf_1 + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/compositions +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_compositions + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/compositions/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_compositions_items + +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/rotation matrices +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_rotation-matrices + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the rotation matrices of the grains which are present there for each compositions. +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/rotation matrices/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_rotation-matrices_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/rotation matrices/items/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_rotation-matrices_items_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/rotation matrices/items/items/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_rotation-matrices_items_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::::::: + +:::::::::::::: + +::::::::::::::: + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/Euler angles z-x-z +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_Euler-angles-z-x-z + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/Euler angles z-x-z/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_Euler-angles-z-x-z_items + +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/Euler angles z-x-z/items/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items + +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::: + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/orientation operation +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_orientation-operation + +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace, multiply] +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/grain sizes +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_grain-sizes + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/grain sizes/items +:open: +:name: open_features_items_oneOf_1_grains-models_items_oneOf_2_grain-sizes_items + +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::::::: + +:::::::::::::::: + + + +::::::::::::::::: + + +::::::::::::::::::: + +:::::::::::::::::::: + + + +::::::::::::::::::::: + +:::::::::::::::::::::{dropdown} /features/items/oneOf/2 +:open: +:name: open_features_items_oneOf_2 + +- **type**:object +- **documentation**:Fault object +- **additionalProperties**:false +- **required**:[model, coordinates] + +::::::::::::::::::::{dropdown} /features/items/oneOf/2/model +:open: +:name: open_features_items_oneOf_2_model + +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +- **enum**:[fault] +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/2/name +:open: +:name: open_features_items_oneOf_2_name + +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/2/coordinates +:open: +:name: open_features_items_oneOf_2_coordinates + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An array of 2d Points representing an array of coordinates where the feature is located. +:::::::::::::::::::{dropdown} /features/items/oneOf/2/coordinates/items +:open: +:name: open_features_items_oneOf_2_coordinates_items + +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +::::::::::::::::::{dropdown} /features/items/oneOf/2/coordinates/items/items +:open: +:name: open_features_items_oneOf_2_coordinates_items_items + +- **type**:number +:::::::::::::::::: + +::::::::::::::::::: + +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/2/interpolation +:open: +:name: open_features_items_oneOf_2_interpolation + +- **default value**:global +- **type**:string +- **documentation**:What type of interpolation should be used to enforce the minimum points per distance parameter. Options are global, none, linear, monotone spline and continuous monotone spline interpolation. If this value is set to global, the global value for interpolation is used. +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/2/min depth +:open: +:name: open_features_items_oneOf_2_min-depth + +- **default value**:0.0 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/2/max depth +:open: +:name: open_features_items_oneOf_2_max-depth + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/2/dip point +:open: +:name: open_features_items_oneOf_2_dip-point + +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**:The depth to which this feature is present +:::::::::::::::::::{dropdown} /features/items/oneOf/2/dip point/items +:open: +:name: open_features_items_oneOf_2_dip-point_items + +- **type**:number +::::::::::::::::::: + +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/2/segments +:open: +:name: open_features_items_oneOf_2_segments + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:The depth to which this feature is present +:::::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items +:open: +:name: open_features_items_oneOf_2_segments_items + +- **type**:object +- **additionalProperties**:false +- **documentation**: +- **required**:[length, thickness, angle] + +::::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/length +:open: +:name: open_features_items_oneOf_2_segments_items_length + +- **type**:number +:::::::::::::::::: + +::::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/thickness +:open: +:name: open_features_items_oneOf_2_segments_items_thickness + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/thickness/items +:open: +:name: open_features_items_oneOf_2_segments_items_thickness_items + +- **type**:number +::::::::::::::::: + +:::::::::::::::::: + +::::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/top truncation +:open: +:name: open_features_items_oneOf_2_segments_items_top-truncation + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/top truncation/items +:open: +:name: open_features_items_oneOf_2_segments_items_top-truncation_items + +- **type**:number +::::::::::::::::: + +:::::::::::::::::: + +::::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/angle +:open: +:name: open_features_items_oneOf_2_segments_items_angle + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/angle/items +:open: +:name: open_features_items_oneOf_2_segments_items_angle_items + +- **type**:number +::::::::::::::::: + +:::::::::::::::::: + +::::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models +:open: +:name: open_features_items_oneOf_2_segments_items_temperature-models + +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items +:open: +:name: open_features_items_oneOf_2_segments_items_temperature-models_items + +::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf +:open: +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf + +:::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1 +:open: +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_1 + +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] + +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/model +:open: +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_1_model + +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/operation +:open: +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_1_operation + +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/min distance fault center +:open: +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_1_min-distance-fault-center + +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/max distance fault center :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_1_max distance fault center +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_1_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/potential mantle temperature +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/potential mantle temperature :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_1_potential mantle temperature +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_1_potential-mantle-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/thermal expansion coefficient +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/thermal expansion coefficient :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_1_thermal expansion coefficient +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_1_thermal-expansion-coefficient -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/specific heat +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/1/specific heat :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_1_specific heat +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_1_specific-heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2 +:::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2 :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_2 +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_2 -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max distance fault center] +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max distance fault center] -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/model +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_2_model +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/operation +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/operation :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_2_operation +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_2_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/min distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/min distance fault center :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_2_min distance fault center +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_2_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The minimum distance to the center of the fault. This determines where the linear temperature starts. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The minimum distance to the center of the fault. This determines where the linear temperature starts. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/max distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/max distance fault center :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_2_max distance fault center +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_2_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The minimum distance to the center of the fault. This determines where the linear temperature end. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The minimum distance to the center of the fault. This determines where the linear temperature end. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/center temperature +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/center temperature :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_2_center temperature +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_2_center-temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the center of this feature in degree Kelvin.If the value is below zero, the an adiabatic temperature is used. -::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the center of this feature in degree Kelvin.If the value is below zero, the an adiabatic temperature is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/side temperature +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/2/side temperature :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_2_side temperature +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_2_side-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the sides of this feature in degree Kelvin. If the value is below zero, an adiabatic temperature is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the sides of this feature in degree Kelvin. If the value is below zero, an adiabatic temperature is used. +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3 +:::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3 :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_3 +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_3 -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3/model +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3/model :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_3_model +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_3_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3/operation +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3/operation :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_3_operation +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_3_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3/min distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3/min distance fault center :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_3_min distance fault center +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_3_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3/max distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3/max distance fault center :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_3_max distance fault center +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_3_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3/temperature +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/temperature models/items/oneOf/3/temperature :open: -:name: open_features_items_oneOf_2_segments_items_temperature models_items_oneOf_3_temperature +:name: open_features_items_oneOf_2_segments_items_temperature-models_items_oneOf_3_temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::: -:::::::::: +::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::: +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models +::::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models :open: -:name: open_features_items_oneOf_2_segments_items_composition models +:name: open_features_items_oneOf_2_segments_items_composition-models -- **documentation**: -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items :open: -:name: open_features_items_oneOf_2_segments_items_composition models_items +:name: open_features_items_oneOf_2_segments_items_composition-models_items -:::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf +::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf :open: -:name: open_features_items_oneOf_2_segments_items_composition models_items_oneOf +:name: open_features_items_oneOf_2_segments_items_composition-models_items_oneOf -::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1 +:::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1 :open: -:name: open_features_items_oneOf_2_segments_items_composition models_items_oneOf_1 +:name: open_features_items_oneOf_2_segments_items_composition-models_items_oneOf_1 -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/model +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_2_segments_items_composition models_items_oneOf_1_model +:name: open_features_items_oneOf_2_segments_items_composition-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/min distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/min distance fault center :open: -:name: open_features_items_oneOf_2_segments_items_composition models_items_oneOf_1_min distance fault center +:name: open_features_items_oneOf_2_segments_items_composition-models_items_oneOf_1_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/max distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/max distance fault center :open: -:name: open_features_items_oneOf_2_segments_items_composition models_items_oneOf_1_max distance fault center +:name: open_features_items_oneOf_2_segments_items_composition-models_items_oneOf_1_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/compositions +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/compositions :open: -:name: open_features_items_oneOf_2_segments_items_composition models_items_oneOf_1_compositions +:name: open_features_items_oneOf_2_segments_items_composition-models_items_oneOf_1_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/compositions/items :open: -:name: open_features_items_oneOf_2_segments_items_composition models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_2_segments_items_composition-models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/fractions +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/fractions :open: -:name: open_features_items_oneOf_2_segments_items_composition models_items_oneOf_1_fractions +:name: open_features_items_oneOf_2_segments_items_composition-models_items_oneOf_1_fractions -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/fractions/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/fractions/items :open: -:name: open_features_items_oneOf_2_segments_items_composition models_items_oneOf_1_fractions_items +:name: open_features_items_oneOf_2_segments_items_composition-models_items_oneOf_1_fractions_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/operation +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/composition models/items/oneOf/1/operation :open: -:name: open_features_items_oneOf_2_segments_items_composition models_items_oneOf_1_operation +:name: open_features_items_oneOf_2_segments_items_composition-models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -:::::::::: +::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::: +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models +::::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models :open: -:name: open_features_items_oneOf_2_segments_items_grains models +:name: open_features_items_oneOf_2_segments_items_grains-models -- **documentation**: -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items +:name: open_features_items_oneOf_2_segments_items_grains-models_items -:::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf +::::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf -::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1 +:::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1 :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_1 +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1 -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/model +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_1_model +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/min distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/min distance fault center :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_1_min distance fault center +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the fault center in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the fault center in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/max distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/max distance fault center :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_1_max distance fault center +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the fault in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the fault in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/compositions +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/compositions :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_1_compositions +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/compositions/items :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/orientation operation +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/orientation operation :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_1_orientation operation +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/grain sizes +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/grain sizes :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_1_grain sizes +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1_grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/grain sizes/items :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_1_grain sizes_items +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1_grain-sizes_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/normalize grain sizes +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/normalize grain sizes :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_1_normalize grain sizes +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1_normalize-grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/normalize grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/1/normalize grain sizes/items :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_1_normalize grain sizes_items +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_1_normalize-grain-sizes_items -- **default value**: true -- **type**: boolean -- **documentation**: -:::::::: +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2 +:::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2 :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_2 +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2 -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/model +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_2_model +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/min distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/min distance fault center :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_2_min distance fault center +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the fault center in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the fault center in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/max distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/max distance fault center :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_2_max distance fault center +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the fault in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the fault in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/compositions +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/compositions :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_2_compositions +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/compositions/items :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_2_compositions_items +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/rotation matrices +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/rotation matrices :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_2_rotation matrices +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_rotation-matrices -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the grains which are present there for each compositions. -::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/rotation matrices/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the grains which are present there for each compositions. +:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/rotation matrices/items :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_2_rotation matrices_items +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_rotation-matrices_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/rotation matrices/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/rotation matrices/items/items :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_2_rotation matrices_items_items +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_rotation-matrices_items_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/rotation matrices/items/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/rotation matrices/items/items/items :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_2_rotation matrices_items_items_items +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_rotation-matrices_items_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: -:::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::::: -::::::: +:::::::::::: -:::::::: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/Euler angles z-x-z +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/Euler angles z-x-z :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_2_Euler angles z-x-z +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_2_Euler angles z-x-z_items +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_2_Euler angles z-x-z_items_items +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::: -:::::::: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/orientation operation +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/orientation operation :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_2_orientation operation +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/grain sizes +::::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/grain sizes :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_2_grain sizes +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::::{dropdown} /features/items/oneOf/2/segments/items/grains models/items/oneOf/2/grain sizes/items :open: -:name: open_features_items_oneOf_2_segments_items_grains models_items_oneOf_2_grain sizes_items +:name: open_features_items_oneOf_2_segments_items_grains-models_items_oneOf_2_grain-sizes_items -- **default value**: -1.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::: +::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::: +:::::::::::::::::: -:::::::::::::: +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/2/temperature models +::::::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models :open: -:name: open_features_items_oneOf_2_temperature models +:name: open_features_items_oneOf_2_temperature-models -- **documentation**: A list of temperature models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items +- **documentation**:A list of temperature models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items :open: -:name: open_features_items_oneOf_2_temperature models_items +:name: open_features_items_oneOf_2_temperature-models_items -:::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf +::::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf +:name: open_features_items_oneOf_2_temperature-models_items_oneOf -::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1 +:::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1 :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_1 +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_1 -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/model +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_1_model +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/operation +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/operation :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_1_operation +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/min distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/min distance fault center :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_1_min distance fault center +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_1_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/max distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/max distance fault center :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_1_max distance fault center +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_1_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/potential mantle temperature +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/potential mantle temperature :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_1_potential mantle temperature +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_1_potential-mantle-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/thermal expansion coefficient +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/thermal expansion coefficient :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_1_thermal expansion coefficient +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_1_thermal-expansion-coefficient -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/specific heat +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/1/specific heat :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_1_specific heat +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_1_specific-heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2 +:::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2 :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_2 +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_2 -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max distance fault center] +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max distance fault center] -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/model +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_2_model +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/operation +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/operation :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_2_operation +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_2_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/min distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/min distance fault center :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_2_min distance fault center +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_2_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The minimum distance to the center of the fault. This determines where the linear temperature starts. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The minimum distance to the center of the fault. This determines where the linear temperature starts. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/max distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/max distance fault center :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_2_max distance fault center +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_2_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The minimum distance to the center of the fault. This determines where the linear temperature end. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The minimum distance to the center of the fault. This determines where the linear temperature end. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/center temperature +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/center temperature :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_2_center temperature +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_2_center-temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the center of this feature in degree Kelvin.If the value is below zero, the an adiabatic temperature is used. -::::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the center of this feature in degree Kelvin.If the value is below zero, the an adiabatic temperature is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/side temperature +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/2/side temperature :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_2_side temperature +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_2_side-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the sides of this feature in degree Kelvin. If the value is below zero, an adiabatic temperature is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the sides of this feature in degree Kelvin. If the value is below zero, an adiabatic temperature is used. +:::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3 +:::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3 :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_3 +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_3 -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3/model +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3/model :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_3_model +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_3_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3/operation +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3/operation :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_3_operation +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_3_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3/min distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3/min distance fault center :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_3_min distance fault center +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_3_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from which the composition of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3/max distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3/max distance fault center :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_3_max distance fault center +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_3_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters to which the composition of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3/temperature +::::::::::::::::{dropdown} /features/items/oneOf/2/temperature models/items/oneOf/3/temperature :open: -:name: open_features_items_oneOf_2_temperature models_items_oneOf_3_temperature +:name: open_features_items_oneOf_2_temperature-models_items_oneOf_3_temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::::: -:::::::::::: +::::::::::::::::: -:::::::::::::: +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/2/composition models +::::::::::::::::::::{dropdown} /features/items/oneOf/2/composition models :open: -:name: open_features_items_oneOf_2_composition models +:name: open_features_items_oneOf_2_composition-models -- **documentation**: A list of composition models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items +- **documentation**:A list of composition models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items :open: -:name: open_features_items_oneOf_2_composition models_items +:name: open_features_items_oneOf_2_composition-models_items -:::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf +::::::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf :open: -:name: open_features_items_oneOf_2_composition models_items_oneOf +:name: open_features_items_oneOf_2_composition-models_items_oneOf -::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1 +:::::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1 :open: -:name: open_features_items_oneOf_2_composition models_items_oneOf_1 +:name: open_features_items_oneOf_2_composition-models_items_oneOf_1 -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/model +::::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_2_composition models_items_oneOf_1_model +:name: open_features_items_oneOf_2_composition-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/min distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/min distance fault center :open: -:name: open_features_items_oneOf_2_composition models_items_oneOf_1_min distance fault center +:name: open_features_items_oneOf_2_composition-models_items_oneOf_1_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from which the composition of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/max distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/max distance fault center :open: -:name: open_features_items_oneOf_2_composition models_items_oneOf_1_max distance fault center +:name: open_features_items_oneOf_2_composition-models_items_oneOf_1_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters to which the composition of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/compositions +::::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/compositions :open: -:name: open_features_items_oneOf_2_composition models_items_oneOf_1_compositions +:name: open_features_items_oneOf_2_composition-models_items_oneOf_1_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/compositions/items :open: -:name: open_features_items_oneOf_2_composition models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_2_composition-models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/fractions +::::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/fractions :open: -:name: open_features_items_oneOf_2_composition models_items_oneOf_1_fractions +:name: open_features_items_oneOf_2_composition-models_items_oneOf_1_fractions -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/fractions/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/fractions/items :open: -:name: open_features_items_oneOf_2_composition models_items_oneOf_1_fractions_items +:name: open_features_items_oneOf_2_composition-models_items_oneOf_1_fractions_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/operation +::::::::::::::::{dropdown} /features/items/oneOf/2/composition models/items/oneOf/1/operation :open: -:name: open_features_items_oneOf_2_composition models_items_oneOf_1_operation +:name: open_features_items_oneOf_2_composition-models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -:::::::::::: +::::::::::::::::: -:::::::::::::: +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/2/grains models +::::::::::::::::::::{dropdown} /features/items/oneOf/2/grains models :open: -:name: open_features_items_oneOf_2_grains models +:name: open_features_items_oneOf_2_grains-models -- **documentation**: A list of grains models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items +- **documentation**:A list of grains models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items :open: -:name: open_features_items_oneOf_2_grains models_items +:name: open_features_items_oneOf_2_grains-models_items -:::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf +::::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf +:name: open_features_items_oneOf_2_grains-models_items_oneOf -::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1 +:::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1 :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_1 +:name: open_features_items_oneOf_2_grains-models_items_oneOf_1 -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/model +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_1_model +:name: open_features_items_oneOf_2_grains-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/min distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/min distance fault center :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_1_min distance fault center +:name: open_features_items_oneOf_2_grains-models_items_oneOf_1_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the fault center in meters from which the composition of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the fault center in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/max distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/max distance fault center :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_1_max distance fault center +:name: open_features_items_oneOf_2_grains-models_items_oneOf_1_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the fault in meters to which the composition of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the fault in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/compositions +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/compositions :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_1_compositions +:name: open_features_items_oneOf_2_grains-models_items_oneOf_1_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/compositions/items :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_2_grains-models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/orientation operation +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/orientation operation :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_1_orientation operation +:name: open_features_items_oneOf_2_grains-models_items_oneOf_1_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/grain sizes :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_1_grain sizes +:name: open_features_items_oneOf_2_grains-models_items_oneOf_1_grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/grain sizes/items :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_1_grain sizes_items +:name: open_features_items_oneOf_2_grains-models_items_oneOf_1_grain-sizes_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/normalize grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/normalize grain sizes :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_1_normalize grain sizes +:name: open_features_items_oneOf_2_grains-models_items_oneOf_1_normalize-grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/normalize grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/1/normalize grain sizes/items :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_1_normalize grain sizes_items +:name: open_features_items_oneOf_2_grains-models_items_oneOf_1_normalize-grain-sizes_items -- **default value**: true -- **type**: boolean -- **documentation**: -:::::::::: +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2 +:::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2 :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_2 +:name: open_features_items_oneOf_2_grains-models_items_oneOf_2 -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/model +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_2_model +:name: open_features_items_oneOf_2_grains-models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/min distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/min distance fault center :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_2_min distance fault center +:name: open_features_items_oneOf_2_grains-models_items_oneOf_2_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the fault center in meters from which the composition of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the fault center in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/max distance fault center +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/max distance fault center :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_2_max distance fault center +:name: open_features_items_oneOf_2_grains-models_items_oneOf_2_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the fault in meters to which the composition of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the fault in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/compositions +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/compositions :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_2_compositions +:name: open_features_items_oneOf_2_grains-models_items_oneOf_2_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/compositions/items :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_2_compositions_items +:name: open_features_items_oneOf_2_grains-models_items_oneOf_2_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/rotation matrices +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/rotation matrices :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_2_rotation matrices +:name: open_features_items_oneOf_2_grains-models_items_oneOf_2_rotation-matrices -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the grains which are present there for each compositions. -::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/rotation matrices/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the grains which are present there for each compositions. +:::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/rotation matrices/items :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_2_rotation matrices_items +:name: open_features_items_oneOf_2_grains-models_items_oneOf_2_rotation-matrices_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/rotation matrices/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/rotation matrices/items/items :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_2_rotation matrices_items_items +:name: open_features_items_oneOf_2_grains-models_items_oneOf_2_rotation-matrices_items_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/rotation matrices/items/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/rotation matrices/items/items/items :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_2_rotation matrices_items_items_items +:name: open_features_items_oneOf_2_grains-models_items_oneOf_2_rotation-matrices_items_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/Euler angles z-x-z +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/Euler angles z-x-z :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_2_Euler angles z-x-z +:name: open_features_items_oneOf_2_grains-models_items_oneOf_2_Euler-angles-z-x-z -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/Euler angles z-x-z/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/Euler angles z-x-z/items :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_2_Euler angles z-x-z_items +:name: open_features_items_oneOf_2_grains-models_items_oneOf_2_Euler-angles-z-x-z_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/Euler angles z-x-z/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/Euler angles z-x-z/items/items :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_2_Euler angles z-x-z_items_items +:name: open_features_items_oneOf_2_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/orientation operation +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/orientation operation :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_2_orientation operation +:name: open_features_items_oneOf_2_grains-models_items_oneOf_2_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/grain sizes :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_2_grain sizes +:name: open_features_items_oneOf_2_grains-models_items_oneOf_2_grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::::::{dropdown} /features/items/oneOf/2/grains models/items/oneOf/2/grain sizes/items :open: -:name: open_features_items_oneOf_2_grains models_items_oneOf_2_grain sizes_items +:name: open_features_items_oneOf_2_grains-models_items_oneOf_2_grain-sizes_items -- **default value**: -1.0 -- **type**: number -- **documentation**: -:::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::: +::::::::::::::::: -:::::::::::::: +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/2/sections +::::::::::::::::::::{dropdown} /features/items/oneOf/2/sections :open: :name: open_features_items_oneOf_2_sections -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of feature properties for a coordinate. -::::::::::::::{dropdown} /features/items/oneOf/2/sections/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of feature properties for a coordinate. +:::::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items :open: :name: open_features_items_oneOf_2_sections_items -- **documentation**: -- **default value**: -- **type**: object +- **documentation**: +- **default value**: +- **type**:object -:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/min depth +::::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/min depth :open: -:name: open_features_items_oneOf_2_sections_items_min depth +:name: open_features_items_oneOf_2_sections_items_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/max depth +::::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/max depth :open: -:name: open_features_items_oneOf_2_sections_items_max depth +:name: open_features_items_oneOf_2_sections_items_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/dip point +::::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/dip point :open: -:name: open_features_items_oneOf_2_sections_items_dip point +:name: open_features_items_oneOf_2_sections_items_dip-point -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: The depth to which this feature is present -::::::::::::{dropdown} /features/items/oneOf/2/sections/items/dip point/items +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**:The depth to which this feature is present +:::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/dip point/items :open: -:name: open_features_items_oneOf_2_sections_items_dip point_items +:name: open_features_items_oneOf_2_sections_items_dip-point_items -- **type**: number -:::::::::::: +- **type**:number +::::::::::::::::: -::::::::::::: +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments +::::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments :open: :name: open_features_items_oneOf_2_sections_items_segments -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: The depth to which this feature is present -::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:The depth to which this feature is present +:::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items :open: :name: open_features_items_oneOf_2_sections_items_segments_items -- **type**: object -- **additionalProperties**: false -- **documentation**: -- **required**: [length, thickness, angle] +- **type**:object +- **additionalProperties**:false +- **documentation**: +- **required**:[length, thickness, angle] -:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/length +::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/length :open: :name: open_features_items_oneOf_2_sections_items_segments_items_length -- **type**: number -::::::::::: +- **type**:number +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/thickness +::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/thickness :open: :name: open_features_items_oneOf_2_sections_items_segments_items_thickness -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/thickness/items +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/thickness/items :open: :name: open_features_items_oneOf_2_sections_items_segments_items_thickness_items -- **type**: number -:::::::::: +- **type**:number +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/top truncation +::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/top truncation :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_top truncation +:name: open_features_items_oneOf_2_sections_items_segments_items_top-truncation -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/top truncation/items +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/top truncation/items :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_top truncation_items +:name: open_features_items_oneOf_2_sections_items_segments_items_top-truncation_items -- **type**: number -:::::::::: +- **type**:number +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/angle +::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/angle :open: :name: open_features_items_oneOf_2_sections_items_segments_items_angle -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/angle/items +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/angle/items :open: :name: open_features_items_oneOf_2_sections_items_segments_items_angle_items -- **type**: number -:::::::::: +- **type**:number +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models +::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models -- **documentation**: -- **default value**: -- **type**: array -::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items -:::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf -::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1 +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1 :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_1 +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_1 -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/model +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_1_model +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/operation +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/operation :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_1_operation +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/min distance fault center +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/min distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_1_min distance fault center +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_1_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/max distance fault center +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/max distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_1_max distance fault center +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_1_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/potential mantle temperature +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/potential mantle temperature :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_1_potential mantle temperature +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_1_potential-mantle-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/thermal expansion coefficient +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/thermal expansion coefficient :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_1_thermal expansion coefficient +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_1_thermal-expansion-coefficient -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/specific heat +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/1/specific heat :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_1_specific heat +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_1_specific-heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::: -:::::::: +::::::::::::: -::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2 +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2 :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_2 +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_2 -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max distance fault center] +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max distance fault center] -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/model +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_2_model +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/operation +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/operation :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_2_operation +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_2_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/min distance fault center +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/min distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_2_min distance fault center +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_2_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The minimum distance to the center of the fault. This determines where the linear temperature starts. -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The minimum distance to the center of the fault. This determines where the linear temperature starts. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/max distance fault center +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/max distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_2_max distance fault center +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_2_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The minimum distance to the center of the fault. This determines where the linear temperature end. -::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The minimum distance to the center of the fault. This determines where the linear temperature end. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/center temperature +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/center temperature :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_2_center temperature +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_2_center-temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the center of this feature in degree Kelvin.If the value is below zero, the an adiabatic temperature is used. -::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the center of this feature in degree Kelvin.If the value is below zero, the an adiabatic temperature is used. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/side temperature +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/2/side temperature :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_2_side temperature +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_2_side-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the sides of this feature in degree Kelvin. If the value is below zero, an adiabatic temperature is used. -::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the sides of this feature in degree Kelvin. If the value is below zero, an adiabatic temperature is used. +:::::::::::: -:::::::: +::::::::::::: -::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3 +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3 :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_3 +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_3 -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3/model +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3/model :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_3_model +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_3_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3/operation +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3/operation :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_3_operation +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_3_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3/min distance fault center +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3/min distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_3_min distance fault center +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_3_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from which the composition of this feature is present. -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3/max distance fault center +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3/max distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_3_max distance fault center +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_3_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters to which the composition of this feature is present. -::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters to which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3/temperature +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/temperature models/items/oneOf/3/temperature :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_temperature models_items_oneOf_3_temperature +:name: open_features_items_oneOf_2_sections_items_segments_items_temperature-models_items_oneOf_3_temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::: -:::::::: +::::::::::::: -:::::::::: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models +::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_composition models +:name: open_features_items_oneOf_2_sections_items_segments_items_composition-models -- **documentation**: -- **default value**: -- **type**: array -::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_composition models_items +:name: open_features_items_oneOf_2_sections_items_segments_items_composition-models_items -:::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_composition models_items_oneOf +:name: open_features_items_oneOf_2_sections_items_segments_items_composition-models_items_oneOf -::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1 +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1 :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_composition models_items_oneOf_1 +:name: open_features_items_oneOf_2_sections_items_segments_items_composition-models_items_oneOf_1 -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/model +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_composition models_items_oneOf_1_model +:name: open_features_items_oneOf_2_sections_items_segments_items_composition-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/min distance fault center +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/min distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_composition models_items_oneOf_1_min distance fault center +:name: open_features_items_oneOf_2_sections_items_segments_items_composition-models_items_oneOf_1_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from which the composition of this feature is present. -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/max distance fault center +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/max distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_composition models_items_oneOf_1_max distance fault center +:name: open_features_items_oneOf_2_sections_items_segments_items_composition-models_items_oneOf_1_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters to which the composition of this feature is present. -::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters to which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/compositions +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/compositions :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_composition models_items_oneOf_1_compositions +:name: open_features_items_oneOf_2_sections_items_segments_items_composition-models_items_oneOf_1_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/compositions/items :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_composition models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_2_sections_items_segments_items_composition-models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::: -::::::: +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/fractions +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/fractions :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_composition models_items_oneOf_1_fractions +:name: open_features_items_oneOf_2_sections_items_segments_items_composition-models_items_oneOf_1_fractions -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/fractions/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/fractions/items :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_composition models_items_oneOf_1_fractions_items +:name: open_features_items_oneOf_2_sections_items_segments_items_composition-models_items_oneOf_1_fractions_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::: -::::::: +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/operation +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/composition models/items/oneOf/1/operation :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_composition models_items_oneOf_1_operation +:name: open_features_items_oneOf_2_sections_items_segments_items_composition-models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::: -:::::::: +::::::::::::: -:::::::::: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models +::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models -- **documentation**: -- **default value**: -- **type**: array -::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items -:::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf -::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1 +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1 :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1 +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1 -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/model +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1_model +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/min distance fault center +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/min distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1_min distance fault center +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the fault center in meters from which the composition of this feature is present. -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the fault center in meters from which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/max distance fault center +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/max distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1_max distance fault center +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the fault in meters to which the composition of this feature is present. -::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the fault in meters to which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/compositions +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/compositions :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1_compositions +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/compositions/items :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::: -::::::: +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/orientation operation +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/orientation operation :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1_orientation operation +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/grain sizes +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/grain sizes :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1_grain sizes +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1_grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/grain sizes/items :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1_grain sizes_items +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1_grain-sizes_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::: -::::::: +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/normalize grain sizes +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/normalize grain sizes :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1_normalize grain sizes +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1_normalize-grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/normalize grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/1/normalize grain sizes/items :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_1_normalize grain sizes_items +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_1_normalize-grain-sizes_items -- **default value**: true -- **type**: boolean -- **documentation**: -:::::: +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::: -::::::: +:::::::::::: -:::::::: +::::::::::::: -::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2 +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2 :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2 +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2 -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/model +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_model +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/min distance fault center +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/min distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_min distance fault center +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the fault center in meters from which the composition of this feature is present. -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the fault center in meters from which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/max distance fault center +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/max distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_max distance fault center +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the fault in meters to which the composition of this feature is present. -::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the fault in meters to which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/compositions +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/compositions :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_compositions +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/compositions/items :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_compositions_items +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::: -::::::: +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_rotation matrices +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_rotation-matrices -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the grains which are present there for each compositions. -::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the grains which are present there for each compositions. +:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_rotation matrices_items +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_rotation-matrices_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items/items :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_rotation matrices_items_items +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_rotation-matrices_items_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items/items/items :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_rotation matrices_items_items_items +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_rotation-matrices_items_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: -:::: +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::: -::::: +:::::::::: -:::::: +::::::::::: -::::::: +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_Euler angles z-x-z +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_Euler angles z-x-z_items +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_Euler angles z-x-z_items_items +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::: -:::::: +::::::::::: -::::::: +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/orientation operation +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/orientation operation :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_orientation operation +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/grain sizes +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/grain sizes :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_grain sizes +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::{dropdown} /features/items/oneOf/2/sections/items/segments/items/grains models/items/oneOf/2/grain sizes/items :open: -:name: open_features_items_oneOf_2_sections_items_segments_items_grains models_items_oneOf_2_grain sizes_items +:name: open_features_items_oneOf_2_sections_items_segments_items_grains-models_items_oneOf_2_grain-sizes_items -- **default value**: -1.0 -- **type**: number -- **documentation**: -:::::: +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::: -::::::: +:::::::::::: -:::::::: +::::::::::::: -:::::::::: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::: +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models +::::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models :open: -:name: open_features_items_oneOf_2_sections_items_temperature models +:name: open_features_items_oneOf_2_sections_items_temperature-models -- **documentation**: A list of temperature models. -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items +- **documentation**:A list of temperature models. +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items +:name: open_features_items_oneOf_2_sections_items_temperature-models_items -:::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf +::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf -::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1 +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1 :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_1 +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_1 -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/model +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_1_model +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/operation +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/operation :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_1_operation +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/min distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/min distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_1_min distance fault center +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_1_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/max distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/max distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_1_max distance fault center +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_1_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/potential mantle temperature +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/potential mantle temperature :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_1_potential mantle temperature +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_1_potential-mantle-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/thermal expansion coefficient +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/thermal expansion coefficient :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_1_thermal expansion coefficient +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_1_thermal-expansion-coefficient -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/specific heat +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/1/specific heat :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_1_specific heat +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_1_specific-heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2 +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2 :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_2 +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_2 -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max distance fault center] +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max distance fault center] -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/model +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_2_model +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/operation +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/operation :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_2_operation +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_2_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/min distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/min distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_2_min distance fault center +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_2_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The minimum distance to the center of the fault. This determines where the linear temperature starts. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The minimum distance to the center of the fault. This determines where the linear temperature starts. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/max distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/max distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_2_max distance fault center +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_2_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The minimum distance to the center of the fault. This determines where the linear temperature end. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The minimum distance to the center of the fault. This determines where the linear temperature end. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/center temperature +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/center temperature :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_2_center temperature +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_2_center-temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the center of this feature in degree Kelvin.If the value is below zero, the an adiabatic temperature is used. -::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the center of this feature in degree Kelvin.If the value is below zero, the an adiabatic temperature is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/side temperature +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/2/side temperature :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_2_side temperature +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_2_side-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the sides of this feature in degree Kelvin. If the value is below zero, an adiabatic temperature is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the sides of this feature in degree Kelvin. If the value is below zero, an adiabatic temperature is used. +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3 +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3 :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_3 +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_3 -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3/model +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3/model :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_3_model +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_3_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3/operation +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3/operation :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_3_operation +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_3_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3/min distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3/min distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_3_min distance fault center +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_3_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3/max distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3/max distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_3_max distance fault center +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_3_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3/temperature +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/temperature models/items/oneOf/3/temperature :open: -:name: open_features_items_oneOf_2_sections_items_temperature models_items_oneOf_3_temperature +:name: open_features_items_oneOf_2_sections_items_temperature-models_items_oneOf_3_temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::: -:::::::::: +::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::: +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models +::::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models :open: -:name: open_features_items_oneOf_2_sections_items_composition models +:name: open_features_items_oneOf_2_sections_items_composition-models -- **documentation**: A list of composition models. -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items +- **documentation**:A list of composition models. +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items :open: -:name: open_features_items_oneOf_2_sections_items_composition models_items +:name: open_features_items_oneOf_2_sections_items_composition-models_items -:::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf +::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf :open: -:name: open_features_items_oneOf_2_sections_items_composition models_items_oneOf +:name: open_features_items_oneOf_2_sections_items_composition-models_items_oneOf -::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1 +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1 :open: -:name: open_features_items_oneOf_2_sections_items_composition models_items_oneOf_1 +:name: open_features_items_oneOf_2_sections_items_composition-models_items_oneOf_1 -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/model +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_2_sections_items_composition models_items_oneOf_1_model +:name: open_features_items_oneOf_2_sections_items_composition-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/min distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/min distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_composition models_items_oneOf_1_min distance fault center +:name: open_features_items_oneOf_2_sections_items_composition-models_items_oneOf_1_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/max distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/max distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_composition models_items_oneOf_1_max distance fault center +:name: open_features_items_oneOf_2_sections_items_composition-models_items_oneOf_1_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/compositions +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/compositions :open: -:name: open_features_items_oneOf_2_sections_items_composition models_items_oneOf_1_compositions +:name: open_features_items_oneOf_2_sections_items_composition-models_items_oneOf_1_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/compositions/items :open: -:name: open_features_items_oneOf_2_sections_items_composition models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_2_sections_items_composition-models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/fractions +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/fractions :open: -:name: open_features_items_oneOf_2_sections_items_composition models_items_oneOf_1_fractions +:name: open_features_items_oneOf_2_sections_items_composition-models_items_oneOf_1_fractions -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/fractions/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/fractions/items :open: -:name: open_features_items_oneOf_2_sections_items_composition models_items_oneOf_1_fractions_items +:name: open_features_items_oneOf_2_sections_items_composition-models_items_oneOf_1_fractions_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/operation +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/composition models/items/oneOf/1/operation :open: -:name: open_features_items_oneOf_2_sections_items_composition models_items_oneOf_1_operation +:name: open_features_items_oneOf_2_sections_items_composition-models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -:::::::::: +::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::: +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models +::::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models :open: -:name: open_features_items_oneOf_2_sections_items_grains models +:name: open_features_items_oneOf_2_sections_items_grains-models -- **documentation**: A list of grains models. -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items +- **documentation**:A list of grains models. +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items +:name: open_features_items_oneOf_2_sections_items_grains-models_items -:::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf +::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf -::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1 +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1 :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_1 +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1 -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/model +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_1_model +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/min distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/min distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_1_min distance fault center +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the fault center in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the fault center in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/max distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/max distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_1_max distance fault center +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the fault in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the fault in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/compositions +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/compositions :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_1_compositions +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/compositions/items :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/orientation operation +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/orientation operation :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_1_orientation operation +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/grain sizes +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/grain sizes :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_1_grain sizes +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1_grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/grain sizes/items :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_1_grain sizes_items +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1_grain-sizes_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/normalize grain sizes +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/normalize grain sizes :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_1_normalize grain sizes +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1_normalize-grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/normalize grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/1/normalize grain sizes/items :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_1_normalize grain sizes_items +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_1_normalize-grain-sizes_items -- **default value**: true -- **type**: boolean -- **documentation**: -:::::::: +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2 +:::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2 :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_2 +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2 -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/model +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_2_model +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/min distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/min distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_2_min distance fault center +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_min-distance-fault-center -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the fault center in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the fault center in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/max distance fault center +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/max distance fault center :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_2_max distance fault center +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_max-distance-fault-center -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the fault in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the fault in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/compositions +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/compositions :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_2_compositions +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/compositions/items :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_2_compositions_items +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/rotation matrices +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/rotation matrices :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_2_rotation matrices +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_rotation-matrices -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the grains which are present there for each compositions. -::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/rotation matrices/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the grains which are present there for each compositions. +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/rotation matrices/items :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_2_rotation matrices_items +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_rotation-matrices_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/rotation matrices/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/rotation matrices/items/items :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_2_rotation matrices_items_items +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_rotation-matrices_items_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/rotation matrices/items/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/rotation matrices/items/items/items :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_2_rotation matrices_items_items_items +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_rotation-matrices_items_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: -:::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::::: -::::::: +:::::::::::: -:::::::: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/Euler angles z-x-z +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/Euler angles z-x-z :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_2_Euler angles z-x-z +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_Euler-angles-z-x-z -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/Euler angles z-x-z/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/Euler angles z-x-z/items :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_2_Euler angles z-x-z_items +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_2_Euler angles z-x-z_items_items +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::: -:::::::: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/orientation operation +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/orientation operation :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_2_orientation operation +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/grain sizes +::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/grain sizes :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_2_grain sizes +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/grains models/items/oneOf/2/grain sizes/items :open: -:name: open_features_items_oneOf_2_sections_items_grains models_items_oneOf_2_grain sizes_items +:name: open_features_items_oneOf_2_sections_items_grains-models_items_oneOf_2_grain-sizes_items -- **default value**: -1.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::: +::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::: +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/2/sections/items/coordinate +::::::::::::::::::{dropdown} /features/items/oneOf/2/sections/items/coordinate :open: :name: open_features_items_oneOf_2_sections_items_coordinate -- **default value**: 0 -- **type**: integer -- **documentation**: The coordinate which should be overwritten -::::::::::::: +- **default value**:0 +- **type**:integer +- **documentation**:The coordinate which should be overwritten +:::::::::::::::::: -:::::::::::::: +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::: +::::::::::::::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/3 +:::::::::::::::::::::{dropdown} /features/items/oneOf/3 :open: :name: open_features_items_oneOf_3 -- **type**: object -- **documentation**: Mantle layer object -- **additionalProperties**: false -- **required**: [model, coordinates] +- **type**:object +- **documentation**:Mantle layer object +- **additionalProperties**:false +- **required**:[model, coordinates] -:::::::::::::::{dropdown} /features/items/oneOf/3/model +::::::::::::::::::::{dropdown} /features/items/oneOf/3/model :open: :name: open_features_items_oneOf_3_model -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -- **enum**: [mantle layer] -::::::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +- **enum**:[mantle layer] +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/3/name +::::::::::::::::::::{dropdown} /features/items/oneOf/3/name :open: :name: open_features_items_oneOf_3_name -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -::::::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/3/coordinates +::::::::::::::::::::{dropdown} /features/items/oneOf/3/coordinates :open: :name: open_features_items_oneOf_3_coordinates -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An array of 2d Points representing an array of coordinates where the feature is located. -::::::::::::::{dropdown} /features/items/oneOf/3/coordinates/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An array of 2d Points representing an array of coordinates where the feature is located. +:::::::::::::::::::{dropdown} /features/items/oneOf/3/coordinates/items :open: :name: open_features_items_oneOf_3_coordinates_items -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -:::::::::::::{dropdown} /features/items/oneOf/3/coordinates/items/items +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +::::::::::::::::::{dropdown} /features/items/oneOf/3/coordinates/items/items :open: :name: open_features_items_oneOf_3_coordinates_items_items -- **type**: number -::::::::::::: +- **type**:number +:::::::::::::::::: -:::::::::::::: +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/3/interpolation +::::::::::::::::::::{dropdown} /features/items/oneOf/3/interpolation :open: :name: open_features_items_oneOf_3_interpolation -- **default value**: global -- **type**: string -- **documentation**: What type of interpolation should be used to enforce the minimum points per distance parameter. Options are global, none, linear, monotone spline and continuous monotone spline interpolation. If this value is set to global, the global value for interpolation is used. -::::::::::::::: +- **default value**:global +- **type**:string +- **documentation**:What type of interpolation should be used to enforce the minimum points per distance parameter. Options are global, none, linear, monotone spline and continuous monotone spline interpolation. If this value is set to global, the global value for interpolation is used. +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/3/min depth +::::::::::::::::::::{dropdown} /features/items/oneOf/3/min depth :open: -:name: open_features_items_oneOf_3_min depth +:name: open_features_items_oneOf_3_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/3/max depth +::::::::::::::::::::{dropdown} /features/items/oneOf/3/max depth :open: -:name: open_features_items_oneOf_3_max depth +:name: open_features_items_oneOf_3_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/3/temperature models +::::::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models :open: -:name: open_features_items_oneOf_3_temperature models +:name: open_features_items_oneOf_3_temperature-models -- **documentation**: A list of temperature models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items +- **documentation**:A list of temperature models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items :open: -:name: open_features_items_oneOf_3_temperature models_items +:name: open_features_items_oneOf_3_temperature-models_items -:::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf +::::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf +:name: open_features_items_oneOf_3_temperature-models_items_oneOf -::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1 +:::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1 :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_1 +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1 -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/model +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_1_model +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/operation +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/operation :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_1_operation +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_1_min depth +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_1_max depth +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/potential mantle temperature +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/potential mantle temperature :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_1_potential mantle temperature +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_potential-mantle-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/thermal expansion coefficient +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/thermal expansion coefficient :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_1_thermal expansion coefficient +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_thermal-expansion-coefficient -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/specific heat +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/specific heat :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_1_specific heat +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_specific-heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2 +:::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2 :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_2 +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2 -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max depth] +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max depth] -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/model +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_2_model +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/operation +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/operation :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_2_operation +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_2_min depth +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_2_max depth +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/top temperature +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/top temperature :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_2_top temperature +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_top-temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. -::::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/bottom temperature +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/bottom temperature :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_2_bottom temperature +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_bottom-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the top in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the top in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. +:::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3 +:::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3 :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_3 +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3 -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/model +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/model :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_3_model +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/operation +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/operation :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_3_operation +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_3_min depth +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_3_max depth +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/temperature +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/temperature :open: -:name: open_features_items_oneOf_3_temperature models_items_oneOf_3_temperature +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::::: -:::::::::::: +::::::::::::::::: -:::::::::::::: +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/3/composition models +::::::::::::::::::::{dropdown} /features/items/oneOf/3/composition models :open: -:name: open_features_items_oneOf_3_composition models +:name: open_features_items_oneOf_3_composition-models -- **documentation**: A list of composition models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items +- **documentation**:A list of composition models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items :open: -:name: open_features_items_oneOf_3_composition models_items +:name: open_features_items_oneOf_3_composition-models_items -:::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf +::::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf :open: -:name: open_features_items_oneOf_3_composition models_items_oneOf +:name: open_features_items_oneOf_3_composition-models_items_oneOf -::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1 +:::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1 :open: -:name: open_features_items_oneOf_3_composition models_items_oneOf_1 +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1 -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/model +::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_3_composition models_items_oneOf_1_model +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth +::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth :open: -:name: open_features_items_oneOf_3_composition models_items_oneOf_1_min depth +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the composition of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth +::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth :open: -:name: open_features_items_oneOf_3_composition models_items_oneOf_1_max depth +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the composition of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/compositions +::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/compositions :open: -:name: open_features_items_oneOf_3_composition models_items_oneOf_1_compositions +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/compositions/items :open: -:name: open_features_items_oneOf_3_composition models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/fractions +::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/fractions :open: -:name: open_features_items_oneOf_3_composition models_items_oneOf_1_fractions +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_fractions -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/fractions/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/fractions/items :open: -:name: open_features_items_oneOf_3_composition models_items_oneOf_1_fractions_items +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_fractions_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/operation +::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/operation :open: -:name: open_features_items_oneOf_3_composition models_items_oneOf_1_operation +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -:::::::::::: +::::::::::::::::: -:::::::::::::: +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/3/grains models +::::::::::::::::::::{dropdown} /features/items/oneOf/3/grains models :open: -:name: open_features_items_oneOf_3_grains models +:name: open_features_items_oneOf_3_grains-models -- **documentation**: A list of grains models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items +- **documentation**:A list of grains models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items :open: -:name: open_features_items_oneOf_3_grains models_items +:name: open_features_items_oneOf_3_grains-models_items -:::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf +::::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf +:name: open_features_items_oneOf_3_grains-models_items_oneOf -::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1 +:::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1 :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_1 +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1 -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/model +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_1_model +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_1_min depth +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the composition of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_1_max depth +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the composition of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/compositions +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/compositions :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_1_compositions +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/compositions/items :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/orientation operation +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/orientation operation :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_1_orientation operation +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/grain sizes :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_1_grain sizes +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/grain sizes/items :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_1_grain sizes_items +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_grain-sizes_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/normalize grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/normalize grain sizes :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_1_normalize grain sizes +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_normalize-grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/normalize grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/normalize grain sizes/items :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_1_normalize grain sizes_items +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_normalize-grain-sizes_items -- **default value**: true -- **type**: boolean -- **documentation**: -:::::::::: +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2 +:::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2 :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_2 +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2 -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/model +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_2_model +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_2_min depth +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the composition of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_2_max depth +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the composition of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/compositions +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/compositions :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_2_compositions +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/compositions/items :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_2_compositions_items +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/rotation matrices +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/rotation matrices :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_2_rotation matrices +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_rotation-matrices -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the grains which are present there for each compositions. -::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/rotation matrices/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the grains which are present there for each compositions. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/rotation matrices/items :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_2_rotation matrices_items +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_rotation-matrices_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/rotation matrices/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/rotation matrices/items/items :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_2_rotation matrices_items_items +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_rotation-matrices_items_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/rotation matrices/items/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/rotation matrices/items/items/items :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_2_rotation matrices_items_items_items +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_rotation-matrices_items_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/Euler angles z-x-z +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/Euler angles z-x-z :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_2_Euler angles z-x-z +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_Euler-angles-z-x-z -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/Euler angles z-x-z/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/Euler angles z-x-z/items :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_2_Euler angles z-x-z_items +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_Euler-angles-z-x-z_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/Euler angles z-x-z/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/Euler angles z-x-z/items/items :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_2_Euler angles z-x-z_items_items +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/orientation operation +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/orientation operation :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_2_orientation operation +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/grain sizes :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_2_grain sizes +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/grain sizes/items :open: -:name: open_features_items_oneOf_3_grains models_items_oneOf_2_grain sizes_items +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_grain-sizes_items -- **default value**: -1.0 -- **type**: number -- **documentation**: -:::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::: +::::::::::::::::: -:::::::::::::: +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::: +::::::::::::::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/4 +:::::::::::::::::::::{dropdown} /features/items/oneOf/4 :open: :name: open_features_items_oneOf_4 -- **type**: object -- **documentation**: Oceanic plate object -- **additionalProperties**: false -- **required**: [model, coordinates] +- **type**:object +- **documentation**:Oceanic plate object +- **additionalProperties**:false +- **required**:[model, coordinates] -:::::::::::::::{dropdown} /features/items/oneOf/4/model +::::::::::::::::::::{dropdown} /features/items/oneOf/4/model :open: :name: open_features_items_oneOf_4_model -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -- **enum**: [oceanic plate] -::::::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +- **enum**:[oceanic plate] +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/4/name +::::::::::::::::::::{dropdown} /features/items/oneOf/4/name :open: :name: open_features_items_oneOf_4_name -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -::::::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/4/coordinates +::::::::::::::::::::{dropdown} /features/items/oneOf/4/coordinates :open: :name: open_features_items_oneOf_4_coordinates -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An array of 2d Points representing an array of coordinates where the feature is located. -::::::::::::::{dropdown} /features/items/oneOf/4/coordinates/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An array of 2d Points representing an array of coordinates where the feature is located. +:::::::::::::::::::{dropdown} /features/items/oneOf/4/coordinates/items :open: :name: open_features_items_oneOf_4_coordinates_items -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -:::::::::::::{dropdown} /features/items/oneOf/4/coordinates/items/items +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +::::::::::::::::::{dropdown} /features/items/oneOf/4/coordinates/items/items :open: :name: open_features_items_oneOf_4_coordinates_items_items -- **type**: number -::::::::::::: +- **type**:number +:::::::::::::::::: -:::::::::::::: +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/4/interpolation +::::::::::::::::::::{dropdown} /features/items/oneOf/4/interpolation :open: :name: open_features_items_oneOf_4_interpolation -- **default value**: global -- **type**: string -- **documentation**: What type of interpolation should be used to enforce the minimum points per distance parameter. Options are global, none, linear, monotone spline and continuous monotone spline interpolation. If this value is set to global, the global value for interpolation is used. -::::::::::::::: +- **default value**:global +- **type**:string +- **documentation**:What type of interpolation should be used to enforce the minimum points per distance parameter. Options are global, none, linear, monotone spline and continuous monotone spline interpolation. If this value is set to global, the global value for interpolation is used. +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/4/min depth +::::::::::::::::::::{dropdown} /features/items/oneOf/4/min depth :open: -:name: open_features_items_oneOf_4_min depth +:name: open_features_items_oneOf_4_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/4/max depth +::::::::::::::::::::{dropdown} /features/items/oneOf/4/max depth :open: -:name: open_features_items_oneOf_4_max depth +:name: open_features_items_oneOf_4_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models +::::::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models :open: -:name: open_features_items_oneOf_4_temperature models +:name: open_features_items_oneOf_4_temperature-models -- **documentation**: A list of temperature models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items +- **documentation**:A list of temperature models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items :open: -:name: open_features_items_oneOf_4_temperature models_items +:name: open_features_items_oneOf_4_temperature-models_items -:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf +::::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf +:name: open_features_items_oneOf_4_temperature-models_items_oneOf -::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1 +:::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1 :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_1 +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1 -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/model +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_1_model +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/operation +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/operation :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_1_operation +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_1_min depth +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_1_max depth +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/potential mantle temperature +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/potential mantle temperature :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_1_potential mantle temperature +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_potential-mantle-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/thermal expansion coefficient +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/thermal expansion coefficient :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_1_thermal expansion coefficient +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_thermal-expansion-coefficient -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/specific heat +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/specific heat :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_1_specific heat +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_specific-heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2 +:::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2 :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_2 +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2 -- **type**: object -- **documentation**: Half space cooling mode -- **additionalProperties**: false -- **required**: [model, ridge coordinates, spreading velocity, max depth] +- **type**:object +- **documentation**:Half space cooling mode +- **additionalProperties**:false +- **required**:[model, ridge coordinates, spreading velocity, max depth] -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/model +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_2_model +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [half space model] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[half space model] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/operation +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/operation :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_2_operation +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_2_min depth +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_2_max depth +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present.Because half-space reaches background temperature asymptotically, this value should be ~2 times the nominal plate thickness of 100 km -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the temperature of this feature is present.Because half-space reaches background temperature asymptotically, this value should be ~2 times the nominal plate thickness of 100 km +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/top temperature +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/top temperature :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_2_top temperature +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_top-temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The actual surface temperature in degree Kelvin for this feature. -::::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The actual surface temperature in degree Kelvin for this feature. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/bottom temperature +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/bottom temperature :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_2_bottom temperature +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_bottom-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The mantle temperature for the half-space cooling modelin degree Kelvin for this feature. If the model has an adiabatic gradientthis should be the mantle potential temperature, and T = Tad + Thalf. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The mantle temperature for the half-space cooling modelin degree Kelvin for this feature. If the model has an adiabatic gradientthis should be the mantle potential temperature, and T = Tad + Thalf. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/spreading velocity +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/spreading velocity :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_2_spreading velocity +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_spreading-velocity -- **default value**: -1.0 -- **type**: number -- **documentation**: The spreading velocity of the plate in meter per year. This is the velocity with which one side moves away from the ridge. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The spreading velocity of the plate in meter per year. This is the velocity with which one side moves away from the ridge. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/ridge coordinates +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/ridge coordinates :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_2_ridge coordinates +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_ridge-coordinates -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. -::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/ridge coordinates/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/ridge coordinates/items :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_2_ridge coordinates_items +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_ridge-coordinates_items -- **type**: array -- **minItems**: 2 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/ridge coordinates/items/items +- **type**:array +- **minItems**:2 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/ridge coordinates/items/items :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_2_ridge coordinates_items_items +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_ridge-coordinates_items_items -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/ridge coordinates/items/items/items +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/ridge coordinates/items/items/items :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_2_ridge coordinates_items_items_items +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_ridge-coordinates_items_items_items -- **type**: number -:::::::: +- **type**:number +::::::::::::: -::::::::: +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3 +:::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3 :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_3 +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3 -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max depth] +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max depth] -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/model +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/model :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_3_model +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/operation +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/operation :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_3_operation +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_3_min depth +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_3_max depth +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/top temperature +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/top temperature :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_3_top temperature +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_top-temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. -::::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/bottom temperature +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/bottom temperature :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_3_bottom temperature +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_bottom-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the top in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the top in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. +:::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4 +:::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4 :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_4 +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4 -- **type**: object -- **documentation**: Plate model. -- **additionalProperties**: false -- **required**: [model, max depth] +- **type**:object +- **documentation**:Plate model. +- **additionalProperties**:false +- **required**:[model, max depth] -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/model +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/model :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_4_model +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [plate model] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[plate model] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/operation +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/operation :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_4_operation +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_4_min depth +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_4_max depth +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/top temperature +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/top temperature :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_4_top temperature +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_top-temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/bottom temperature +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/bottom temperature :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_4_bottom temperature +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_bottom-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/spreading velocity +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/spreading velocity :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_4_spreading velocity +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_spreading-velocity -- **default value**: -1.0 -- **type**: number -- **documentation**: The spreading velocity of the plate in meter per year. This is the velocity with which one side moves away from the ridge. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The spreading velocity of the plate in meter per year. This is the velocity with which one side moves away from the ridge. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/ridge coordinates +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/ridge coordinates :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_4_ridge coordinates +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_ridge-coordinates -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. -::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/ridge coordinates/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/ridge coordinates/items :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_4_ridge coordinates_items +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_ridge-coordinates_items -- **type**: array -- **minItems**: 2 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/ridge coordinates/items/items +- **type**:array +- **minItems**:2 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/ridge coordinates/items/items :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_4_ridge coordinates_items_items +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_ridge-coordinates_items_items -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/ridge coordinates/items/items/items +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/ridge coordinates/items/items/items :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_4_ridge coordinates_items_items_items +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_ridge-coordinates_items_items_items -- **type**: number -:::::::: +- **type**:number +::::::::::::: -::::::::: +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5 +:::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5 :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_5 +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5 -- **type**: object -- **documentation**: Plate model, but with a fixed age. -- **additionalProperties**: false -- **required**: [model, max depth] +- **type**:object +- **documentation**:Plate model, but with a fixed age. +- **additionalProperties**:false +- **required**:[model, max depth] -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/model +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/model :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_5_model +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [plate model constant age] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[plate model constant age] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/operation +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/operation :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_5_operation +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_5_min depth +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_5_max depth +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/top temperature +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/top temperature :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_5_top temperature +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_top-temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/bottom temperature +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/bottom temperature :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_5_bottom temperature +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_bottom-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/plate age +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/plate age :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_5_plate age +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_plate-age -- **default value**: 80000.0 -- **type**: number -- **documentation**: The age of the plate in year. This age is assigned to the whole plate. -::::::::::: +- **default value**:80000.0 +- **type**:number +- **documentation**:The age of the plate in year. This age is assigned to the whole plate. +:::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6 +:::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6 :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_6 +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6 -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/model +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/model :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_6_model +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/operation +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/operation :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_6_operation +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_6_min depth +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the temperature of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_6_max depth +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the temperature of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/temperature +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/temperature :open: -:name: open_features_items_oneOf_4_temperature models_items_oneOf_6_temperature +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::::: -:::::::::::: +::::::::::::::::: -:::::::::::::: +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/4/composition models +::::::::::::::::::::{dropdown} /features/items/oneOf/4/composition models :open: -:name: open_features_items_oneOf_4_composition models +:name: open_features_items_oneOf_4_composition-models -- **documentation**: A list of composition models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items +- **documentation**:A list of composition models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items :open: -:name: open_features_items_oneOf_4_composition models_items +:name: open_features_items_oneOf_4_composition-models_items -:::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf +::::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf :open: -:name: open_features_items_oneOf_4_composition models_items_oneOf +:name: open_features_items_oneOf_4_composition-models_items_oneOf -::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1 +:::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1 :open: -:name: open_features_items_oneOf_4_composition models_items_oneOf_1 +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1 -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/model +::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_4_composition models_items_oneOf_1_model +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth +::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth :open: -:name: open_features_items_oneOf_4_composition models_items_oneOf_1_min depth +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the composition of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth +::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth :open: -:name: open_features_items_oneOf_4_composition models_items_oneOf_1_max depth +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the composition of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/compositions +::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/compositions :open: -:name: open_features_items_oneOf_4_composition models_items_oneOf_1_compositions +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/compositions/items :open: -:name: open_features_items_oneOf_4_composition models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/fractions +::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/fractions :open: -:name: open_features_items_oneOf_4_composition models_items_oneOf_1_fractions +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_fractions -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/fractions/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/fractions/items :open: -:name: open_features_items_oneOf_4_composition models_items_oneOf_1_fractions_items +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_fractions_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/operation +::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/operation :open: -:name: open_features_items_oneOf_4_composition models_items_oneOf_1_operation +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -:::::::::::: +::::::::::::::::: -:::::::::::::: +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/4/grains models +::::::::::::::::::::{dropdown} /features/items/oneOf/4/grains models :open: -:name: open_features_items_oneOf_4_grains models +:name: open_features_items_oneOf_4_grains-models -- **documentation**: A list of grains models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items +- **documentation**:A list of grains models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items :open: -:name: open_features_items_oneOf_4_grains models_items +:name: open_features_items_oneOf_4_grains-models_items -:::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf +::::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf +:name: open_features_items_oneOf_4_grains-models_items_oneOf -::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1 +:::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1 :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_1 +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1 -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/model +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_1_model +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_1_min depth +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the composition of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_1_max depth +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the composition of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/compositions +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/compositions :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_1_compositions +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/compositions/items :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/orientation operation +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/orientation operation :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_1_orientation operation +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/grain sizes :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_1_grain sizes +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/grain sizes/items :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_1_grain sizes_items +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_grain-sizes_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/normalize grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/normalize grain sizes :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_1_normalize grain sizes +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_normalize-grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/normalize grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/normalize grain sizes/items :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_1_normalize grain sizes_items +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_normalize-grain-sizes_items -- **default value**: true -- **type**: boolean -- **documentation**: -:::::::::: +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2 +:::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2 :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_2 +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2 -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/model +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_2_model +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_2_min depth +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth in meters from which the composition of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_2_max depth +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth in meters to which the composition of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/compositions +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/compositions :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_2_compositions +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/compositions/items :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_2_compositions_items +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/rotation matrices +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/rotation matrices :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_2_rotation matrices +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_rotation-matrices -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the grains which are present there for each compositions. -::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/rotation matrices/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the grains which are present there for each compositions. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/rotation matrices/items :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_2_rotation matrices_items +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_rotation-matrices_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/rotation matrices/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/rotation matrices/items/items :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_2_rotation matrices_items_items +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_rotation-matrices_items_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/rotation matrices/items/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/rotation matrices/items/items/items :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_2_rotation matrices_items_items_items +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_rotation-matrices_items_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/Euler angles z-x-z +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/Euler angles z-x-z :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_2_Euler angles z-x-z +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_Euler-angles-z-x-z -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/Euler angles z-x-z/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/Euler angles z-x-z/items :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_2_Euler angles z-x-z_items +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_Euler-angles-z-x-z_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/Euler angles z-x-z/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/Euler angles z-x-z/items/items :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_2_Euler angles z-x-z_items_items +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/orientation operation +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/orientation operation :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_2_orientation operation +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/grain sizes :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_2_grain sizes +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/grain sizes/items :open: -:name: open_features_items_oneOf_4_grains models_items_oneOf_2_grain sizes_items +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_grain-sizes_items -- **default value**: -1.0 -- **type**: number -- **documentation**: -:::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::: +::::::::::::::::: -:::::::::::::: +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::: +::::::::::::::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/5 +:::::::::::::::::::::{dropdown} /features/items/oneOf/5 :open: :name: open_features_items_oneOf_5 -- **type**: object -- **documentation**: Subducting slab object -- **additionalProperties**: false -- **required**: [model, coordinates] +- **type**:object +- **documentation**:Subducting slab object +- **additionalProperties**:false +- **required**:[model, coordinates] -:::::::::::::::{dropdown} /features/items/oneOf/5/model +::::::::::::::::::::{dropdown} /features/items/oneOf/5/model :open: :name: open_features_items_oneOf_5_model -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -- **enum**: [subducting plate] -::::::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +- **enum**:[subducting plate] +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/name +::::::::::::::::::::{dropdown} /features/items/oneOf/5/name :open: :name: open_features_items_oneOf_5_name -- **default value**: -- **type**: string -- **documentation**: The name which the user has given to the feature. -::::::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name which the user has given to the feature. +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/coordinates +::::::::::::::::::::{dropdown} /features/items/oneOf/5/coordinates :open: :name: open_features_items_oneOf_5_coordinates -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An array of 2d Points representing an array of coordinates where the feature is located. -::::::::::::::{dropdown} /features/items/oneOf/5/coordinates/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An array of 2d Points representing an array of coordinates where the feature is located. +:::::::::::::::::::{dropdown} /features/items/oneOf/5/coordinates/items :open: :name: open_features_items_oneOf_5_coordinates_items -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -:::::::::::::{dropdown} /features/items/oneOf/5/coordinates/items/items +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +::::::::::::::::::{dropdown} /features/items/oneOf/5/coordinates/items/items :open: :name: open_features_items_oneOf_5_coordinates_items_items -- **type**: number -::::::::::::: +- **type**:number +:::::::::::::::::: -:::::::::::::: +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/interpolation +::::::::::::::::::::{dropdown} /features/items/oneOf/5/interpolation :open: :name: open_features_items_oneOf_5_interpolation -- **default value**: global -- **type**: string -- **documentation**: What type of interpolation should be used to enforce the minimum points per distance parameter. Options are global, none, linear, monotone spline and continuous monotone spline interpolation. If this value is set to global, the global value for interpolation is used. -::::::::::::::: +- **default value**:global +- **type**:string +- **documentation**:What type of interpolation should be used to enforce the minimum points per distance parameter. Options are global, none, linear, monotone spline and continuous monotone spline interpolation. If this value is set to global, the global value for interpolation is used. +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/min depth +::::::::::::::::::::{dropdown} /features/items/oneOf/5/min depth :open: -:name: open_features_items_oneOf_5_min depth +:name: open_features_items_oneOf_5_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/max depth +::::::::::::::::::::{dropdown} /features/items/oneOf/5/max depth :open: -:name: open_features_items_oneOf_5_max depth +:name: open_features_items_oneOf_5_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/dip point +::::::::::::::::::::{dropdown} /features/items/oneOf/5/dip point :open: -:name: open_features_items_oneOf_5_dip point +:name: open_features_items_oneOf_5_dip-point -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: The depth to which this feature is present -::::::::::::::{dropdown} /features/items/oneOf/5/dip point/items +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**:The depth to which this feature is present +:::::::::::::::::::{dropdown} /features/items/oneOf/5/dip point/items :open: -:name: open_features_items_oneOf_5_dip point_items +:name: open_features_items_oneOf_5_dip-point_items -- **type**: number -:::::::::::::: +- **type**:number +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/segments +::::::::::::::::::::{dropdown} /features/items/oneOf/5/segments :open: :name: open_features_items_oneOf_5_segments -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: The depth to which this feature is present -::::::::::::::{dropdown} /features/items/oneOf/5/segments/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:The depth to which this feature is present +:::::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items :open: :name: open_features_items_oneOf_5_segments_items -- **type**: object -- **additionalProperties**: false -- **documentation**: -- **required**: [length, thickness, angle] +- **type**:object +- **additionalProperties**:false +- **documentation**: +- **required**:[length, thickness, angle] -:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/length +::::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/length :open: :name: open_features_items_oneOf_5_segments_items_length -- **type**: number -::::::::::::: +- **type**:number +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/thickness +::::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/thickness :open: :name: open_features_items_oneOf_5_segments_items_thickness -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::::{dropdown} /features/items/oneOf/5/segments/items/thickness/items +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/thickness/items :open: :name: open_features_items_oneOf_5_segments_items_thickness_items -- **type**: number -:::::::::::: +- **type**:number +::::::::::::::::: -::::::::::::: +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/top truncation +::::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/top truncation :open: -:name: open_features_items_oneOf_5_segments_items_top truncation +:name: open_features_items_oneOf_5_segments_items_top-truncation -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::::{dropdown} /features/items/oneOf/5/segments/items/top truncation/items +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/top truncation/items :open: -:name: open_features_items_oneOf_5_segments_items_top truncation_items +:name: open_features_items_oneOf_5_segments_items_top-truncation_items -- **type**: number -:::::::::::: +- **type**:number +::::::::::::::::: -::::::::::::: +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/angle +::::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/angle :open: :name: open_features_items_oneOf_5_segments_items_angle -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::::{dropdown} /features/items/oneOf/5/segments/items/angle/items +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/angle/items :open: :name: open_features_items_oneOf_5_segments_items_angle_items -- **type**: number -:::::::::::: +- **type**:number +::::::::::::::::: -::::::::::::: +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models +::::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models :open: -:name: open_features_items_oneOf_5_segments_items_temperature models +:name: open_features_items_oneOf_5_segments_items_temperature-models -- **documentation**: -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items +:name: open_features_items_oneOf_5_segments_items_temperature-models_items -:::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf +::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf -::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1 +:::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1 :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_1 +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_1 -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/model +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_1_model +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/operation +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/operation :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_1_operation +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/min distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/min distance slab top :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_1_min distance slab top +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_1_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/max distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/max distance slab top :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_1_max distance slab top +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_1_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/potential mantle temperature +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/potential mantle temperature :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_1_potential mantle temperature +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_1_potential-mantle-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/thermal expansion coefficient +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/thermal expansion coefficient :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_1_thermal expansion coefficient +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_1_thermal-expansion-coefficient -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/specific heat +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/1/specific heat :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_1_specific heat +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_1_specific-heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2 +:::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2 :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_2 +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_2 -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max distance slab top] +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max distance slab top] -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/model +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_2_model +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/operation +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/operation :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_2_operation +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_2_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/min distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/min distance slab top :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_2_min distance slab top +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_2_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/max distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/max distance slab top :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_2_max distance slab top +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_2_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/top temperature +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/top temperature :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_2_top temperature +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_2_top-temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. -::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/bottom temperature +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/2/bottom temperature :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_2_bottom temperature +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_2_bottom-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the bottom in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the bottom in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3 +:::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3 :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_3 +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3 -- **type**: object -- **documentation**: Mass conserving temperature model. The temperature model uses the heat content (proportional to to thermal mass anomaly) to define a smooth temperature profile that conserves mass along the slab length. An empirical (linear) model is used to define how the minimum temperature increases with depth and how the location of the minimum temperature shifts into the slab interior. The slab is divided in to top and bottom parts, which meet at the location where the minimum temperature occurs in the slab. For the bottom slab the temperature is defined by a half-space cooling model. For the top of the slab the temperature is defined by one side of a 1D infinite space cooling model. The age of the overriding plate is used so the slab temperature at shallow depth smoothly transitions to the temperature of the overriding plate: this is not perfect, and is affected by the value of "top truncation" parameter subducting plate. Also note that the parameter "thickness" for the subducting plate segments needs to be defined but is not used. Note that the empirical model used to define how Tmin increases with depth and how the position of Tmin shift with depth is expected to change somewhat after better calibrating with further tests. -- **additionalProperties**: false -- **required**: [model, plate velocity] +- **type**:object +- **documentation**:Mass conserving temperature model. The temperature model uses the heat content (proportional to to thermal mass anomaly) to define a smooth temperature profile that conserves mass along the slab length. An empirical (linear) model is used to define how the minimum temperature increases with depth and how the location of the minimum temperature shifts into the slab interior. The slab is divided in to top and bottom parts, which meet at the location where the minimum temperature occurs in the slab. For the bottom slab the temperature is defined by a half-space cooling model. For the top of the slab the temperature is defined by one side of a 1D infinite space cooling model. The age of the overriding plate is used so the slab temperature at shallow depth smoothly transitions to the temperature of the overriding plate: this is not perfect, and is affected by the value of "top truncation" parameter subducting plate. Also note that the parameter "thickness" for the subducting plate segments needs to be defined but is not used. Note that the empirical model used to define how Tmin increases with depth and how the position of Tmin shift with depth is expected to change somewhat after better calibrating with further tests. +- **additionalProperties**:false +- **required**:[model, plate velocity] -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/model +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/model :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_model +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [mass conserving] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[mass conserving] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/operation +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/operation :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_operation +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/min distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/min distance slab top :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_min distance slab top +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be negative and should be 1.5-2 times larger thatn the nominal slab thickness to allow the diffusion of cold temperatures from in the slab into the mantle above the slab surface. Also note that the top truncation value for the slab segment needs to have a value of -1, otherwise the temperature above the slab will be cut off at a distance less than the value set here. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be negative and should be 1.5-2 times larger thatn the nominal slab thickness to allow the diffusion of cold temperatures from in the slab into the mantle above the slab surface. Also note that the top truncation value for the slab segment needs to have a value of -1, otherwise the temperature above the slab will be cut off at a distance less than the value set here. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/max distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/max distance slab top :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_max distance slab top +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be positive and approximately 2.5-3.0 times larger than the nominal slab thickness to allow the diffusion of coldtemperatures from in the slab into the mantle below the slab surface.For example if the slab starts with cold temperatures over a 100 km wide region, thisparameters should be about 250 km. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be positive and approximately 2.5-3.0 times larger than the nominal slab thickness to allow the diffusion of coldtemperatures from in the slab into the mantle below the slab surface.For example if the slab starts with cold temperatures over a 100 km wide region, thisparameters should be about 250 km. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/density +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/density :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_density +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_density -- **default value**: 3300.0 -- **type**: number -- **documentation**: The reference density of the subducting plate in $kg/m^3$ -::::::::: +- **default value**:3300.0 +- **type**:number +- **documentation**:The reference density of the subducting plate in $kg/m^3$ +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/plate velocity +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/plate velocity :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_plate velocity +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_plate-velocity -- **default value**: NaN -- **type**: number -- **documentation**: The velocity with which the plate subducts in meters per year. -::::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The velocity with which the plate subducts in meters per year. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/coupling depth +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/coupling depth :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_coupling depth +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_coupling-depth -- **default value**: NaN -- **type**: number -- **documentation**: The depth at which the slab surface first comes in contact with the hot mantle wedge in meters. -::::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The depth at which the slab surface first comes in contact with the hot mantle wedge in meters. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/shallow dip +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/shallow dip :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_shallow dip +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_shallow-dip -- **default value**: NaN -- **type**: number -- **documentation**: The average dip of the slab at depths shallower than the coupling depth in degrees. If the shallow slab dip changes with distance along the slab surface, then this will need to be adjusted to get the temperature above and below the coupling depth to match. -::::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The average dip of the slab at depths shallower than the coupling depth in degrees. If the shallow slab dip changes with distance along the slab surface, then this will need to be adjusted to get the temperature above and below the coupling depth to match. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/thermal conductivity +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/thermal conductivity :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_thermal conductivity +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_thermal-conductivity -- **default value**: 3.3 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::::: +- **default value**:3.3 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/thermal expansion coefficient +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/thermal expansion coefficient :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_thermal expansion coefficient +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_thermal-expansion-coefficient -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/specific heat +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/specific heat :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_specific heat +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_specific-heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/thermal diffusivity +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/thermal diffusivity :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_thermal diffusivity +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_thermal-diffusivity -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/adiabatic heating +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/adiabatic heating :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_adiabatic heating +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_adiabatic-heating -- **default value**: true -- **type**: boolean -- **documentation**: Whether adiabatic heating should be used for the slab. -::::::::: +- **default value**:true +- **type**:boolean +- **documentation**:Whether adiabatic heating should be used for the slab. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/taper distance +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/taper distance :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_taper distance +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_taper-distance -- **default value**: 100000.0 -- **type**: number -- **documentation**: Distance over which to taper the slab tip.tapers the initial heat content to zero and the minimum temperature to the background temperature. -::::::::: +- **default value**:100000.0 +- **type**:number +- **documentation**:Distance over which to taper the slab tip.tapers the initial heat content to zero and the minimum temperature to the background temperature. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/potential mantle temperature +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/potential mantle temperature :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_potential mantle temperature +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_potential-mantle-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/ridge coordinates +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/ridge coordinates :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_ridge coordinates +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_ridge-coordinates -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. -::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/ridge coordinates/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. +:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/ridge coordinates/items :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_ridge coordinates_items +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_ridge-coordinates_items -- **type**: array -- **minItems**: 2 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: -:::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/ridge coordinates/items/items +- **type**:array +- **minItems**:2 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/ridge coordinates/items/items :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_ridge coordinates_items_items +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_ridge-coordinates_items_items -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/ridge coordinates/items/items/items +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +:::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/3/ridge coordinates/items/items/items :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_3_ridge coordinates_items_items_items +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_3_ridge-coordinates_items_items_items -- **type**: number -:::::: +- **type**:number +::::::::::: -::::::: +:::::::::::: -:::::::: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4 +:::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4 :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_4 +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4 -- **type**: object -- **documentation**: Plate model (based on McKenzie, 1970). -- **additionalProperties**: false -- **required**: [model, plate velocity] +- **type**:object +- **documentation**:Plate model (based on McKenzie, 1970). +- **additionalProperties**:false +- **required**:[model, plate velocity] -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/model +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/model :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_model +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [plate model] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[plate model] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/operation +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/operation :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_operation +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/min distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/min distance slab top :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_min distance slab top +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/max distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/max distance slab top :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_max distance slab top +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/density +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/density :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_density +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_density -- **default value**: 3300.0 -- **type**: number -- **documentation**: The reference density of the subducting plate in $kg/m^3$ -::::::::: +- **default value**:3300.0 +- **type**:number +- **documentation**:The reference density of the subducting plate in $kg/m^3$ +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/plate velocity +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/plate velocity :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_plate velocity +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_plate-velocity -- **default value**: NaN -- **type**: number -- **documentation**: The velocity in meters per year with which the plate subducts in meters per year. -::::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The velocity in meters per year with which the plate subducts in meters per year. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/thermal conductivity +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/thermal conductivity :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_thermal conductivity +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_thermal-conductivity -- **default value**: 2.0 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::::: +- **default value**:2.0 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/thermal expansion coefficient +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/thermal expansion coefficient :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_thermal expansion coefficient +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_thermal-expansion-coefficient -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/specific heat +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/specific heat :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_specific heat +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_specific-heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/adiabatic heating +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/adiabatic heating :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_adiabatic heating +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_adiabatic-heating -- **default value**: true -- **type**: boolean -- **documentation**: Wheter adiabatic heating should be used for the slab. Setting the parameter to false leads to equation 26 from McKenzie (1970),which is the result obtained from McKenzie 1969. -::::::::: +- **default value**:true +- **type**:boolean +- **documentation**:Wheter adiabatic heating should be used for the slab. Setting the parameter to false leads to equation 26 from McKenzie (1970),which is the result obtained from McKenzie 1969. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/potential mantle temperature +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/4/potential mantle temperature :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_4_potential mantle temperature +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_4_potential-mantle-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5 +:::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5 :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_5 +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_5 -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5/model +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5/model :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_5_model +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_5_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5/operation +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5/operation :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_5_operation +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_5_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5/min distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5/min distance slab top :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_5_min distance slab top +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_5_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5/max distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5/max distance slab top :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_5_max distance slab top +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_5_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5/temperature +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/temperature models/items/oneOf/5/temperature :open: -:name: open_features_items_oneOf_5_segments_items_temperature models_items_oneOf_5_temperature +:name: open_features_items_oneOf_5_segments_items_temperature-models_items_oneOf_5_temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::: -:::::::::: +::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::: +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models +::::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models :open: -:name: open_features_items_oneOf_5_segments_items_composition models +:name: open_features_items_oneOf_5_segments_items_composition-models -- **documentation**: -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items :open: -:name: open_features_items_oneOf_5_segments_items_composition models_items +:name: open_features_items_oneOf_5_segments_items_composition-models_items -:::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf +::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf :open: -:name: open_features_items_oneOf_5_segments_items_composition models_items_oneOf +:name: open_features_items_oneOf_5_segments_items_composition-models_items_oneOf -::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1 +:::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1 :open: -:name: open_features_items_oneOf_5_segments_items_composition models_items_oneOf_1 +:name: open_features_items_oneOf_5_segments_items_composition-models_items_oneOf_1 -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/model +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_5_segments_items_composition models_items_oneOf_1_model +:name: open_features_items_oneOf_5_segments_items_composition-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/min distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/min distance slab top :open: -:name: open_features_items_oneOf_5_segments_items_composition models_items_oneOf_1_min distance slab top +:name: open_features_items_oneOf_5_segments_items_composition-models_items_oneOf_1_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/max distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/max distance slab top :open: -:name: open_features_items_oneOf_5_segments_items_composition models_items_oneOf_1_max distance slab top +:name: open_features_items_oneOf_5_segments_items_composition-models_items_oneOf_1_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/compositions +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/compositions :open: -:name: open_features_items_oneOf_5_segments_items_composition models_items_oneOf_1_compositions +:name: open_features_items_oneOf_5_segments_items_composition-models_items_oneOf_1_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/compositions/items :open: -:name: open_features_items_oneOf_5_segments_items_composition models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_5_segments_items_composition-models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/fractions +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/fractions :open: -:name: open_features_items_oneOf_5_segments_items_composition models_items_oneOf_1_fractions +:name: open_features_items_oneOf_5_segments_items_composition-models_items_oneOf_1_fractions -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/fractions/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/fractions/items :open: -:name: open_features_items_oneOf_5_segments_items_composition models_items_oneOf_1_fractions_items +:name: open_features_items_oneOf_5_segments_items_composition-models_items_oneOf_1_fractions_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/operation +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/composition models/items/oneOf/1/operation :open: -:name: open_features_items_oneOf_5_segments_items_composition models_items_oneOf_1_operation +:name: open_features_items_oneOf_5_segments_items_composition-models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -:::::::::: +::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::: +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models +::::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models :open: -:name: open_features_items_oneOf_5_segments_items_grains models +:name: open_features_items_oneOf_5_segments_items_grains-models -- **documentation**: -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items +:name: open_features_items_oneOf_5_segments_items_grains-models_items -:::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf +::::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf -::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1 +:::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1 :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_1 +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1 -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/model +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_1_model +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/min distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/min distance slab top :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_1_min distance slab top +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the slab top in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the slab top in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/max distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/max distance slab top :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_1_max distance slab top +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the slab top in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the slab top in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/compositions +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/compositions :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_1_compositions +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/compositions/items :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/orientation operation +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/orientation operation :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_1_orientation operation +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/grain sizes +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/grain sizes :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_1_grain sizes +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1_grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/grain sizes/items :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_1_grain sizes_items +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1_grain-sizes_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/normalize grain sizes +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/normalize grain sizes :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_1_normalize grain sizes +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1_normalize-grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/normalize grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/1/normalize grain sizes/items :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_1_normalize grain sizes_items +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_1_normalize-grain-sizes_items -- **default value**: true -- **type**: boolean -- **documentation**: -:::::::: +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2 +:::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2 :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_2 +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2 -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/model +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_2_model +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/min distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/min distance slab top :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_2_min distance slab top +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the slab top in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the slab top in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/max distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/max distance slab top :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_2_max distance slab top +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the slab top in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the slab top in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/compositions +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/compositions :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_2_compositions +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/compositions/items :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_2_compositions_items +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/rotation matrices +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/rotation matrices :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_2_rotation matrices +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_rotation-matrices -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the grains which are present there for each compositions. -::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/rotation matrices/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the grains which are present there for each compositions. +:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/rotation matrices/items :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_2_rotation matrices_items +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_rotation-matrices_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/rotation matrices/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/rotation matrices/items/items :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_2_rotation matrices_items_items +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_rotation-matrices_items_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/rotation matrices/items/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/rotation matrices/items/items/items :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_2_rotation matrices_items_items_items +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_rotation-matrices_items_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: -:::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::::: -::::::: +:::::::::::: -:::::::: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/Euler angles z-x-z +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/Euler angles z-x-z :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_2_Euler angles z-x-z +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_2_Euler angles z-x-z_items +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_2_Euler angles z-x-z_items_items +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::: -:::::::: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/orientation operation +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/orientation operation :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_2_orientation operation +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/grain sizes +::::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/grain sizes :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_2_grain sizes +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::::{dropdown} /features/items/oneOf/5/segments/items/grains models/items/oneOf/2/grain sizes/items :open: -:name: open_features_items_oneOf_5_segments_items_grains models_items_oneOf_2_grain sizes_items +:name: open_features_items_oneOf_5_segments_items_grains-models_items_oneOf_2_grain-sizes_items -- **default value**: -1.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::: +::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::: +:::::::::::::::::: -:::::::::::::: +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/temperature models +::::::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models :open: -:name: open_features_items_oneOf_5_temperature models +:name: open_features_items_oneOf_5_temperature-models -- **documentation**: A list of temperature models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items +- **documentation**:A list of temperature models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items :open: -:name: open_features_items_oneOf_5_temperature models_items +:name: open_features_items_oneOf_5_temperature-models_items -:::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf +::::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf +:name: open_features_items_oneOf_5_temperature-models_items_oneOf -::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1 +:::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1 :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_1 +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_1 -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/model +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_1_model +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/operation +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/operation :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_1_operation +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/min distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/min distance slab top :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_1_min distance slab top +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_1_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/max distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/max distance slab top :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_1_max distance slab top +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_1_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/potential mantle temperature +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/potential mantle temperature :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_1_potential mantle temperature +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_1_potential-mantle-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/thermal expansion coefficient +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/thermal expansion coefficient :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_1_thermal expansion coefficient +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_1_thermal-expansion-coefficient -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/specific heat +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/1/specific heat :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_1_specific heat +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_1_specific-heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2 +:::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2 :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_2 +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_2 -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max distance slab top] +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max distance slab top] -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/model +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_2_model +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/operation +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/operation :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_2_operation +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_2_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/min distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/min distance slab top :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_2_min distance slab top +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_2_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/max distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/max distance slab top :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_2_max distance slab top +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_2_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/top temperature +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/top temperature :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_2_top temperature +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_2_top-temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. -::::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/bottom temperature +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/2/bottom temperature :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_2_bottom temperature +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_2_bottom-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the bottom in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the bottom in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. +:::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3 +:::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3 :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_3 +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_3 -- **type**: object -- **documentation**: Mass conserving temperature model. The temperature model uses the heat content (proportional to to thermal mass anomaly) to define a smooth temperature profile that conserves mass along the slab length. An empirical (linear) model is used to define how the minimum temperature increases with depth and how the location of the minimum temperature shifts into the slab interior. The slab is divided in to top and bottom parts, which meet at the location where the minimum temperature occurs in the slab. For the bottom slab the temperature is defined by a half-space cooling model. For the top of the slab the temperature is defined by one side of a 1D infinite space cooling model. The age of the overriding plate is used so the slab temperature at shallow depth smoothly transitions to the temperature of the overriding plate: this is not perfect, and is affected by the value of "top truncation" parameter subducting plate. Also note that the parameter "thickness" for the subducting plate segments needs to be defined but is not used. Note that the empirical model used to define how Tmin increases with depth and how the position of Tmin shift with depth is expected to change somewhat after better calibrating with further tests. -- **additionalProperties**: false -- **required**: [model, plate velocity] +- **type**:object +- **documentation**:Mass conserving temperature model. The temperature model uses the heat content (proportional to to thermal mass anomaly) to define a smooth temperature profile that conserves mass along the slab length. An empirical (linear) model is used to define how the minimum temperature increases with depth and how the location of the minimum temperature shifts into the slab interior. The slab is divided in to top and bottom parts, which meet at the location where the minimum temperature occurs in the slab. For the bottom slab the temperature is defined by a half-space cooling model. For the top of the slab the temperature is defined by one side of a 1D infinite space cooling model. The age of the overriding plate is used so the slab temperature at shallow depth smoothly transitions to the temperature of the overriding plate: this is not perfect, and is affected by the value of "top truncation" parameter subducting plate. Also note that the parameter "thickness" for the subducting plate segments needs to be defined but is not used. Note that the empirical model used to define how Tmin increases with depth and how the position of Tmin shift with depth is expected to change somewhat after better calibrating with further tests. +- **additionalProperties**:false +- **required**:[model, plate velocity] -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/model +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/model :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_3_model +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_3_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [mass conserving] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[mass conserving] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/operation +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/operation :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_3_operation +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_3_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/min distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/min distance slab top :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_3_min distance slab top +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_3_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be negative and should be 1.5-2 times larger thatn the nominal slab thickness to allow the diffusion of cold temperatures from in the slab into the mantle above the slab surface. Also note that the top truncation value for the slab segment needs to have a value of -1, otherwise the temperature above the slab will be cut off at a distance less than the value set here. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be negative and should be 1.5-2 times larger thatn the nominal slab thickness to allow the diffusion of cold temperatures from in the slab into the mantle above the slab surface. Also note that the top truncation value for the slab segment needs to have a value of -1, otherwise the temperature above the slab will be cut off at a distance less than the value set here. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/max distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/max distance slab top :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_3_max distance slab top +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_3_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be positive and approximately 2.5-3.0 times larger than the nominal slab thickness to allow the diffusion of coldtemperatures from in the slab into the mantle below the slab surface.For example if the slab starts with cold temperatures over a 100 km wide region, thisparameters should be about 250 km. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be positive and approximately 2.5-3.0 times larger than the nominal slab thickness to allow the diffusion of coldtemperatures from in the slab into the mantle below the slab surface.For example if the slab starts with cold temperatures over a 100 km wide region, thisparameters should be about 250 km. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/density +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/density :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_3_density +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_3_density -- **default value**: 3300.0 -- **type**: number -- **documentation**: The reference density of the subducting plate in $kg/m^3$ -::::::::::: +- **default value**:3300.0 +- **type**:number +- **documentation**:The reference density of the subducting plate in $kg/m^3$ +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/plate velocity +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/plate velocity :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_3_plate velocity +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_3_plate-velocity -- **default value**: NaN -- **type**: number -- **documentation**: The velocity with which the plate subducts in meters per year. -::::::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The velocity with which the plate subducts in meters per year. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/coupling depth +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/coupling depth :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_3_coupling depth +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_3_coupling-depth -- **default value**: NaN -- **type**: number -- **documentation**: The depth at which the slab surface first comes in contact with the hot mantle wedge in meters. -::::::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The depth at which the slab surface first comes in contact with the hot mantle wedge in meters. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/shallow dip +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/shallow dip :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_3_shallow dip +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_3_shallow-dip -- **default value**: NaN -- **type**: number -- **documentation**: The average dip of the slab at depths shallower than the coupling depth in degrees. If the shallow slab dip changes with distance along the slab surface, then this will need to be adjusted to get the temperature above and below the coupling depth to match. -::::::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The average dip of the slab at depths shallower than the coupling depth in degrees. If the shallow slab dip changes with distance along the slab surface, then this will need to be adjusted to get the temperature above and below the coupling depth to match. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/thermal conductivity +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/thermal conductivity :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_3_thermal conductivity +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_3_thermal-conductivity -- **default value**: 3.3 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::::::: +- **default value**:3.3 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/thermal expansion coefficient +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/thermal expansion coefficient :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_3_thermal expansion coefficient +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_3_thermal-expansion-coefficient -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/specific heat +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/specific heat :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_3_specific heat +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_3_specific-heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/thermal diffusivity +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/thermal diffusivity :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_3_thermal diffusivity +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_3_thermal-diffusivity -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/adiabatic heating +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/adiabatic heating :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_3_adiabatic heating +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_3_adiabatic-heating -- **default value**: true -- **type**: boolean -- **documentation**: Whether adiabatic heating should be used for the slab. -::::::::::: +- **default value**:true +- **type**:boolean +- **documentation**:Whether adiabatic heating should be used for the slab. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/taper distance +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/taper distance :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_3_taper distance +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_3_taper-distance -- **default value**: 100000.0 -- **type**: number -- **documentation**: Distance over which to taper the slab tip.tapers the initial heat content to zero and the minimum temperature to the background temperature. -::::::::::: +- **default value**:100000.0 +- **type**:number +- **documentation**:Distance over which to taper the slab tip.tapers the initial heat content to zero and the minimum temperature to the background temperature. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/potential mantle temperature +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/potential mantle temperature :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_3_potential mantle temperature +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_3_potential-mantle-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/ridge coordinates +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/ridge coordinates :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_3_ridge coordinates +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_3_ridge-coordinates -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. -::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/ridge coordinates/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. +:::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/ridge coordinates/items :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_3_ridge coordinates_items +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_3_ridge-coordinates_items -- **type**: array -- **minItems**: 2 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/ridge coordinates/items/items +- **type**:array +- **minItems**:2 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/ridge coordinates/items/items :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_3_ridge coordinates_items_items +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_3_ridge-coordinates_items_items -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/ridge coordinates/items/items/items +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/3/ridge coordinates/items/items/items :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_3_ridge coordinates_items_items_items +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_3_ridge-coordinates_items_items_items -- **type**: number -:::::::: +- **type**:number +::::::::::::: -::::::::: +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4 +:::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4 :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_4 +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_4 -- **type**: object -- **documentation**: Plate model (based on McKenzie, 1970). -- **additionalProperties**: false -- **required**: [model, plate velocity] +- **type**:object +- **documentation**:Plate model (based on McKenzie, 1970). +- **additionalProperties**:false +- **required**:[model, plate velocity] -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/model +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/model :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_4_model +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_4_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [plate model] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[plate model] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/operation +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/operation :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_4_operation +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_4_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/min distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/min distance slab top :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_4_min distance slab top +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_4_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/max distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/max distance slab top :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_4_max distance slab top +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_4_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/density +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/density :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_4_density +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_4_density -- **default value**: 3300.0 -- **type**: number -- **documentation**: The reference density of the subducting plate in $kg/m^3$ -::::::::::: +- **default value**:3300.0 +- **type**:number +- **documentation**:The reference density of the subducting plate in $kg/m^3$ +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/plate velocity +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/plate velocity :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_4_plate velocity +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_4_plate-velocity -- **default value**: NaN -- **type**: number -- **documentation**: The velocity in meters per year with which the plate subducts in meters per year. -::::::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The velocity in meters per year with which the plate subducts in meters per year. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/thermal conductivity +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/thermal conductivity :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_4_thermal conductivity +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_4_thermal-conductivity -- **default value**: 2.0 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::::::: +- **default value**:2.0 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/thermal expansion coefficient +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/thermal expansion coefficient :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_4_thermal expansion coefficient +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_4_thermal-expansion-coefficient -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/specific heat +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/specific heat :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_4_specific heat +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_4_specific-heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/adiabatic heating +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/adiabatic heating :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_4_adiabatic heating +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_4_adiabatic-heating -- **default value**: true -- **type**: boolean -- **documentation**: Wheter adiabatic heating should be used for the slab. Setting the parameter to false leads to equation 26 from McKenzie (1970),which is the result obtained from McKenzie 1969. -::::::::::: +- **default value**:true +- **type**:boolean +- **documentation**:Wheter adiabatic heating should be used for the slab. Setting the parameter to false leads to equation 26 from McKenzie (1970),which is the result obtained from McKenzie 1969. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/potential mantle temperature +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/4/potential mantle temperature :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_4_potential mantle temperature +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_4_potential-mantle-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. -::::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. +:::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5 +:::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5 :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_5 +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_5 -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5/model +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5/model :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_5_model +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_5_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5/operation +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5/operation :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_5_operation +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_5_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5/min distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5/min distance slab top :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_5_min distance slab top +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_5_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5/max distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5/max distance slab top :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_5_max distance slab top +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_5_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5/temperature +::::::::::::::::{dropdown} /features/items/oneOf/5/temperature models/items/oneOf/5/temperature :open: -:name: open_features_items_oneOf_5_temperature models_items_oneOf_5_temperature +:name: open_features_items_oneOf_5_temperature-models_items_oneOf_5_temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::::: -:::::::::::: +::::::::::::::::: -:::::::::::::: +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/composition models +::::::::::::::::::::{dropdown} /features/items/oneOf/5/composition models :open: -:name: open_features_items_oneOf_5_composition models +:name: open_features_items_oneOf_5_composition-models -- **documentation**: A list of composition models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items +- **documentation**:A list of composition models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items :open: -:name: open_features_items_oneOf_5_composition models_items +:name: open_features_items_oneOf_5_composition-models_items -:::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf +::::::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf :open: -:name: open_features_items_oneOf_5_composition models_items_oneOf +:name: open_features_items_oneOf_5_composition-models_items_oneOf -::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1 +:::::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1 :open: -:name: open_features_items_oneOf_5_composition models_items_oneOf_1 +:name: open_features_items_oneOf_5_composition-models_items_oneOf_1 -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/model +::::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_5_composition models_items_oneOf_1_model +:name: open_features_items_oneOf_5_composition-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/min distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/min distance slab top :open: -:name: open_features_items_oneOf_5_composition models_items_oneOf_1_min distance slab top +:name: open_features_items_oneOf_5_composition-models_items_oneOf_1_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/max distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/max distance slab top :open: -:name: open_features_items_oneOf_5_composition models_items_oneOf_1_max distance slab top +:name: open_features_items_oneOf_5_composition-models_items_oneOf_1_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/compositions +::::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/compositions :open: -:name: open_features_items_oneOf_5_composition models_items_oneOf_1_compositions +:name: open_features_items_oneOf_5_composition-models_items_oneOf_1_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/compositions/items :open: -:name: open_features_items_oneOf_5_composition models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_5_composition-models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/fractions +::::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/fractions :open: -:name: open_features_items_oneOf_5_composition models_items_oneOf_1_fractions +:name: open_features_items_oneOf_5_composition-models_items_oneOf_1_fractions -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/fractions/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/fractions/items :open: -:name: open_features_items_oneOf_5_composition models_items_oneOf_1_fractions_items +:name: open_features_items_oneOf_5_composition-models_items_oneOf_1_fractions_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/operation +::::::::::::::::{dropdown} /features/items/oneOf/5/composition models/items/oneOf/1/operation :open: -:name: open_features_items_oneOf_5_composition models_items_oneOf_1_operation +:name: open_features_items_oneOf_5_composition-models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -:::::::::::: +::::::::::::::::: -:::::::::::::: +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/grains models +::::::::::::::::::::{dropdown} /features/items/oneOf/5/grains models :open: -:name: open_features_items_oneOf_5_grains models +:name: open_features_items_oneOf_5_grains-models -- **documentation**: A list of grains models. -- **default value**: -- **type**: array -::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items +- **documentation**:A list of grains models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items :open: -:name: open_features_items_oneOf_5_grains models_items +:name: open_features_items_oneOf_5_grains-models_items -:::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf +::::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf +:name: open_features_items_oneOf_5_grains-models_items_oneOf -::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1 +:::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1 :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_1 +:name: open_features_items_oneOf_5_grains-models_items_oneOf_1 -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/model +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_1_model +:name: open_features_items_oneOf_5_grains-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/min distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/min distance slab top :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_1_min distance slab top +:name: open_features_items_oneOf_5_grains-models_items_oneOf_1_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the slab top in meters from which the composition of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the slab top in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/max distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/max distance slab top :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_1_max distance slab top +:name: open_features_items_oneOf_5_grains-models_items_oneOf_1_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the slab top in meters to which the composition of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the slab top in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/compositions +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/compositions :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_1_compositions +:name: open_features_items_oneOf_5_grains-models_items_oneOf_1_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/compositions/items :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_5_grains-models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/orientation operation +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/orientation operation :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_1_orientation operation +:name: open_features_items_oneOf_5_grains-models_items_oneOf_1_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/grain sizes :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_1_grain sizes +:name: open_features_items_oneOf_5_grains-models_items_oneOf_1_grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/grain sizes/items :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_1_grain sizes_items +:name: open_features_items_oneOf_5_grains-models_items_oneOf_1_grain-sizes_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/normalize grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/normalize grain sizes :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_1_normalize grain sizes +:name: open_features_items_oneOf_5_grains-models_items_oneOf_1_normalize-grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/normalize grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/1/normalize grain sizes/items :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_1_normalize grain sizes_items +:name: open_features_items_oneOf_5_grains-models_items_oneOf_1_normalize-grain-sizes_items -- **default value**: true -- **type**: boolean -- **documentation**: -:::::::::: +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2 +:::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2 :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_2 +:name: open_features_items_oneOf_5_grains-models_items_oneOf_2 -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/model +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_2_model +:name: open_features_items_oneOf_5_grains-models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/min distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/min distance slab top :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_2_min distance slab top +:name: open_features_items_oneOf_5_grains-models_items_oneOf_2_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the slab top in meters from which the composition of this feature is present. -::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the slab top in meters from which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/max distance slab top +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/max distance slab top :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_2_max distance slab top +:name: open_features_items_oneOf_5_grains-models_items_oneOf_2_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the slab top in meters to which the composition of this feature is present. -::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the slab top in meters to which the composition of this feature is present. +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/compositions +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/compositions :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_2_compositions +:name: open_features_items_oneOf_5_grains-models_items_oneOf_2_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/compositions/items :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_2_compositions_items +:name: open_features_items_oneOf_5_grains-models_items_oneOf_2_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/rotation matrices +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/rotation matrices :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_2_rotation matrices +:name: open_features_items_oneOf_5_grains-models_items_oneOf_2_rotation-matrices -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the grains which are present there for each compositions. -::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/rotation matrices/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the grains which are present there for each compositions. +:::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/rotation matrices/items :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_2_rotation matrices_items +:name: open_features_items_oneOf_5_grains-models_items_oneOf_2_rotation-matrices_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/rotation matrices/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/rotation matrices/items/items :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_2_rotation matrices_items_items +:name: open_features_items_oneOf_5_grains-models_items_oneOf_2_rotation-matrices_items_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/rotation matrices/items/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/rotation matrices/items/items/items :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_2_rotation matrices_items_items_items +:name: open_features_items_oneOf_5_grains-models_items_oneOf_2_rotation-matrices_items_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/Euler angles z-x-z +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/Euler angles z-x-z :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_2_Euler angles z-x-z +:name: open_features_items_oneOf_5_grains-models_items_oneOf_2_Euler-angles-z-x-z -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/Euler angles z-x-z/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/Euler angles z-x-z/items :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_2_Euler angles z-x-z_items +:name: open_features_items_oneOf_5_grains-models_items_oneOf_2_Euler-angles-z-x-z_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/Euler angles z-x-z/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/Euler angles z-x-z/items/items :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_2_Euler angles z-x-z_items_items +:name: open_features_items_oneOf_5_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/orientation operation +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/orientation operation :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_2_orientation operation +:name: open_features_items_oneOf_5_grains-models_items_oneOf_2_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/grain sizes +::::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/grain sizes :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_2_grain sizes +:name: open_features_items_oneOf_5_grains-models_items_oneOf_2_grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::::::{dropdown} /features/items/oneOf/5/grains models/items/oneOf/2/grain sizes/items :open: -:name: open_features_items_oneOf_5_grains models_items_oneOf_2_grain sizes_items +:name: open_features_items_oneOf_5_grains-models_items_oneOf_2_grain-sizes_items -- **default value**: -1.0 -- **type**: number -- **documentation**: -:::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::: +::::::::::::::::: -:::::::::::::: +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::{dropdown} /features/items/oneOf/5/sections +::::::::::::::::::::{dropdown} /features/items/oneOf/5/sections :open: :name: open_features_items_oneOf_5_sections -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of feature properties for a coordinate. -::::::::::::::{dropdown} /features/items/oneOf/5/sections/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of feature properties for a coordinate. +:::::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items :open: :name: open_features_items_oneOf_5_sections_items -- **documentation**: -- **default value**: -- **type**: object +- **documentation**: +- **default value**: +- **type**:object -:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/min depth +::::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/min depth :open: -:name: open_features_items_oneOf_5_sections_items_min depth +:name: open_features_items_oneOf_5_sections_items_min-depth -- **default value**: 0.0 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/max depth +::::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/max depth :open: -:name: open_features_items_oneOf_5_sections_items_max depth +:name: open_features_items_oneOf_5_sections_items_max-depth -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The depth to which this feature is present -::::::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The depth to which this feature is present +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/dip point +::::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/dip point :open: -:name: open_features_items_oneOf_5_sections_items_dip point +:name: open_features_items_oneOf_5_sections_items_dip-point -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: The depth to which this feature is present -::::::::::::{dropdown} /features/items/oneOf/5/sections/items/dip point/items +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**:The depth to which this feature is present +:::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/dip point/items :open: -:name: open_features_items_oneOf_5_sections_items_dip point_items +:name: open_features_items_oneOf_5_sections_items_dip-point_items -- **type**: number -:::::::::::: +- **type**:number +::::::::::::::::: -::::::::::::: +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments +::::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments :open: :name: open_features_items_oneOf_5_sections_items_segments -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: The depth to which this feature is present -::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:The depth to which this feature is present +:::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items :open: :name: open_features_items_oneOf_5_sections_items_segments_items -- **type**: object -- **additionalProperties**: false -- **documentation**: -- **required**: [length, thickness, angle] +- **type**:object +- **additionalProperties**:false +- **documentation**: +- **required**:[length, thickness, angle] -:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/length +::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/length :open: :name: open_features_items_oneOf_5_sections_items_segments_items_length -- **type**: number -::::::::::: +- **type**:number +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/thickness +::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/thickness :open: :name: open_features_items_oneOf_5_sections_items_segments_items_thickness -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/thickness/items +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/thickness/items :open: :name: open_features_items_oneOf_5_sections_items_segments_items_thickness_items -- **type**: number -:::::::::: +- **type**:number +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/top truncation +::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/top truncation :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_top truncation +:name: open_features_items_oneOf_5_sections_items_segments_items_top-truncation -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/top truncation/items +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/top truncation/items :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_top truncation_items +:name: open_features_items_oneOf_5_sections_items_segments_items_top-truncation_items -- **type**: number -:::::::::: +- **type**:number +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/angle +::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/angle :open: :name: open_features_items_oneOf_5_sections_items_segments_items_angle -- **type**: array -- **minItems**: 1 -- **maxItems**: 2 -::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/angle/items +- **type**:array +- **minItems**:1 +- **maxItems**:2 +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/angle/items :open: :name: open_features_items_oneOf_5_sections_items_segments_items_angle_items -- **type**: number -:::::::::: +- **type**:number +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models +::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models -- **documentation**: -- **default value**: -- **type**: array -::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items -:::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf -::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1 +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1 :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_1 +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_1 -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/model +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_1_model +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/operation +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/operation :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_1_operation +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/min distance slab top +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/min distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_1_min distance slab top +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_1_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/max distance slab top +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/max distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_1_max distance slab top +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_1_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/potential mantle temperature +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/potential mantle temperature :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_1_potential mantle temperature +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_1_potential-mantle-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/thermal expansion coefficient +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/thermal expansion coefficient :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_1_thermal expansion coefficient +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_1_thermal-expansion-coefficient -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/specific heat +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/1/specific heat :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_1_specific heat +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_1_specific-heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::: -:::::::: +::::::::::::: -::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2 +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2 :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_2 +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_2 -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max distance slab top] +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max distance slab top] -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/model +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_2_model +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/operation +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/operation :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_2_operation +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_2_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/min distance slab top +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/min distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_2_min distance slab top +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_2_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/max distance slab top +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/max distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_2_max distance slab top +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_2_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/top temperature +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/top temperature :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_2_top temperature +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_2_top-temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. -::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/bottom temperature +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/2/bottom temperature :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_2_bottom temperature +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_2_bottom-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the bottom in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. -::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the bottom in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. +:::::::::::: -:::::::: +::::::::::::: -::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3 +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3 :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3 +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3 -- **type**: object -- **documentation**: Mass conserving temperature model. The temperature model uses the heat content (proportional to to thermal mass anomaly) to define a smooth temperature profile that conserves mass along the slab length. An empirical (linear) model is used to define how the minimum temperature increases with depth and how the location of the minimum temperature shifts into the slab interior. The slab is divided in to top and bottom parts, which meet at the location where the minimum temperature occurs in the slab. For the bottom slab the temperature is defined by a half-space cooling model. For the top of the slab the temperature is defined by one side of a 1D infinite space cooling model. The age of the overriding plate is used so the slab temperature at shallow depth smoothly transitions to the temperature of the overriding plate: this is not perfect, and is affected by the value of "top truncation" parameter subducting plate. Also note that the parameter "thickness" for the subducting plate segments needs to be defined but is not used. Note that the empirical model used to define how Tmin increases with depth and how the position of Tmin shift with depth is expected to change somewhat after better calibrating with further tests. -- **additionalProperties**: false -- **required**: [model, plate velocity] +- **type**:object +- **documentation**:Mass conserving temperature model. The temperature model uses the heat content (proportional to to thermal mass anomaly) to define a smooth temperature profile that conserves mass along the slab length. An empirical (linear) model is used to define how the minimum temperature increases with depth and how the location of the minimum temperature shifts into the slab interior. The slab is divided in to top and bottom parts, which meet at the location where the minimum temperature occurs in the slab. For the bottom slab the temperature is defined by a half-space cooling model. For the top of the slab the temperature is defined by one side of a 1D infinite space cooling model. The age of the overriding plate is used so the slab temperature at shallow depth smoothly transitions to the temperature of the overriding plate: this is not perfect, and is affected by the value of "top truncation" parameter subducting plate. Also note that the parameter "thickness" for the subducting plate segments needs to be defined but is not used. Note that the empirical model used to define how Tmin increases with depth and how the position of Tmin shift with depth is expected to change somewhat after better calibrating with further tests. +- **additionalProperties**:false +- **required**:[model, plate velocity] -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/model +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/model :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_model +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [mass conserving] -::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[mass conserving] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/operation +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/operation :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_operation +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/min distance slab top +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/min distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_min distance slab top +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be negative and should be 1.5-2 times larger thatn the nominal slab thickness to allow the diffusion of cold temperatures from in the slab into the mantle above the slab surface. Also note that the top truncation value for the slab segment needs to have a value of -1, otherwise the temperature above the slab will be cut off at a distance less than the value set here. -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be negative and should be 1.5-2 times larger thatn the nominal slab thickness to allow the diffusion of cold temperatures from in the slab into the mantle above the slab surface. Also note that the top truncation value for the slab segment needs to have a value of -1, otherwise the temperature above the slab will be cut off at a distance less than the value set here. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/max distance slab top +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/max distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_max distance slab top +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be positive and approximately 2.5-3.0 times larger than the nominal slab thickness to allow the diffusion of coldtemperatures from in the slab into the mantle below the slab surface.For example if the slab starts with cold temperatures over a 100 km wide region, thisparameters should be about 250 km. -::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be positive and approximately 2.5-3.0 times larger than the nominal slab thickness to allow the diffusion of coldtemperatures from in the slab into the mantle below the slab surface.For example if the slab starts with cold temperatures over a 100 km wide region, thisparameters should be about 250 km. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/density +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/density :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_density +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_density -- **default value**: 3300.0 -- **type**: number -- **documentation**: The reference density of the subducting plate in $kg/m^3$ -::::::: +- **default value**:3300.0 +- **type**:number +- **documentation**:The reference density of the subducting plate in $kg/m^3$ +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/plate velocity +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/plate velocity :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_plate velocity +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_plate-velocity -- **default value**: NaN -- **type**: number -- **documentation**: The velocity with which the plate subducts in meters per year. -::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The velocity with which the plate subducts in meters per year. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/coupling depth +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/coupling depth :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_coupling depth +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_coupling-depth -- **default value**: NaN -- **type**: number -- **documentation**: The depth at which the slab surface first comes in contact with the hot mantle wedge in meters. -::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The depth at which the slab surface first comes in contact with the hot mantle wedge in meters. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/shallow dip +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/shallow dip :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_shallow dip +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_shallow-dip -- **default value**: NaN -- **type**: number -- **documentation**: The average dip of the slab at depths shallower than the coupling depth in degrees. If the shallow slab dip changes with distance along the slab surface, then this will need to be adjusted to get the temperature above and below the coupling depth to match. -::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The average dip of the slab at depths shallower than the coupling depth in degrees. If the shallow slab dip changes with distance along the slab surface, then this will need to be adjusted to get the temperature above and below the coupling depth to match. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/thermal conductivity +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/thermal conductivity :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_thermal conductivity +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_thermal-conductivity -- **default value**: 3.3 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::: +- **default value**:3.3 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/thermal expansion coefficient +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/thermal expansion coefficient :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_thermal expansion coefficient +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_thermal-expansion-coefficient -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. -::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/specific heat +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/specific heat :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_specific heat +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_specific-heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. -::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/thermal diffusivity +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/thermal diffusivity :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_thermal diffusivity +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_thermal-diffusivity -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/adiabatic heating +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/adiabatic heating :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_adiabatic heating +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_adiabatic-heating -- **default value**: true -- **type**: boolean -- **documentation**: Whether adiabatic heating should be used for the slab. -::::::: +- **default value**:true +- **type**:boolean +- **documentation**:Whether adiabatic heating should be used for the slab. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/taper distance +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/taper distance :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_taper distance +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_taper-distance -- **default value**: 100000.0 -- **type**: number -- **documentation**: Distance over which to taper the slab tip.tapers the initial heat content to zero and the minimum temperature to the background temperature. -::::::: +- **default value**:100000.0 +- **type**:number +- **documentation**:Distance over which to taper the slab tip.tapers the initial heat content to zero and the minimum temperature to the background temperature. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/potential mantle temperature +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/potential mantle temperature :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_potential mantle temperature +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_potential-mantle-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. -::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/ridge coordinates +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/ridge coordinates :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_ridge coordinates +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_ridge-coordinates -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. -::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/ridge coordinates/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/ridge coordinates/items :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_ridge coordinates_items +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_ridge-coordinates_items -- **type**: array -- **minItems**: 2 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: -:::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/ridge coordinates/items/items +- **type**:array +- **minItems**:2 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/ridge coordinates/items/items :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_ridge coordinates_items_items +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_ridge-coordinates_items_items -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/ridge coordinates/items/items/items +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +:::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/3/ridge coordinates/items/items/items :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_3_ridge coordinates_items_items_items +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_3_ridge-coordinates_items_items_items -- **type**: number -:::: +- **type**:number +::::::::: -::::: +:::::::::: -:::::: +::::::::::: -::::::: +:::::::::::: -:::::::: +::::::::::::: -::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4 +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4 :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4 +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4 -- **type**: object -- **documentation**: Plate model (based on McKenzie, 1970). -- **additionalProperties**: false -- **required**: [model, plate velocity] +- **type**:object +- **documentation**:Plate model (based on McKenzie, 1970). +- **additionalProperties**:false +- **required**:[model, plate velocity] -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/model +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/model :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_model +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [plate model] -::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[plate model] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/operation +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/operation :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_operation +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/min distance slab top +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/min distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_min distance slab top +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/max distance slab top +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/max distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_max distance slab top +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/density +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/density :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_density +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_density -- **default value**: 3300.0 -- **type**: number -- **documentation**: The reference density of the subducting plate in $kg/m^3$ -::::::: +- **default value**:3300.0 +- **type**:number +- **documentation**:The reference density of the subducting plate in $kg/m^3$ +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/plate velocity +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/plate velocity :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_plate velocity +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_plate-velocity -- **default value**: NaN -- **type**: number -- **documentation**: The velocity in meters per year with which the plate subducts in meters per year. -::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The velocity in meters per year with which the plate subducts in meters per year. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/thermal conductivity +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/thermal conductivity :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_thermal conductivity +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_thermal-conductivity -- **default value**: 2.0 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::: +- **default value**:2.0 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/thermal expansion coefficient +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/thermal expansion coefficient :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_thermal expansion coefficient +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_thermal-expansion-coefficient -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. -::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/specific heat +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/specific heat :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_specific heat +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_specific-heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. -::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/adiabatic heating +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/adiabatic heating :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_adiabatic heating +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_adiabatic-heating -- **default value**: true -- **type**: boolean -- **documentation**: Wheter adiabatic heating should be used for the slab. Setting the parameter to false leads to equation 26 from McKenzie (1970),which is the result obtained from McKenzie 1969. -::::::: +- **default value**:true +- **type**:boolean +- **documentation**:Wheter adiabatic heating should be used for the slab. Setting the parameter to false leads to equation 26 from McKenzie (1970),which is the result obtained from McKenzie 1969. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/potential mantle temperature +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/4/potential mantle temperature :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_4_potential mantle temperature +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_4_potential-mantle-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. -::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. +:::::::::::: -:::::::: +::::::::::::: -::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5 +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5 :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_5 +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_5 -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5/model +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5/model :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_5_model +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_5_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5/operation +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5/operation :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_5_operation +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_5_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5/min distance slab top +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5/min distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_5_min distance slab top +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_5_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5/max distance slab top +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5/max distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_5_max distance slab top +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_5_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5/temperature +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/temperature models/items/oneOf/5/temperature :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_temperature models_items_oneOf_5_temperature +:name: open_features_items_oneOf_5_sections_items_segments_items_temperature-models_items_oneOf_5_temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::: -:::::::: +::::::::::::: -:::::::::: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models +::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_composition models +:name: open_features_items_oneOf_5_sections_items_segments_items_composition-models -- **documentation**: -- **default value**: -- **type**: array -::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_composition models_items +:name: open_features_items_oneOf_5_sections_items_segments_items_composition-models_items -:::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_composition models_items_oneOf +:name: open_features_items_oneOf_5_sections_items_segments_items_composition-models_items_oneOf -::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1 +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1 :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_composition models_items_oneOf_1 +:name: open_features_items_oneOf_5_sections_items_segments_items_composition-models_items_oneOf_1 -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/model +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_composition models_items_oneOf_1_model +:name: open_features_items_oneOf_5_sections_items_segments_items_composition-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/min distance slab top +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/min distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_composition models_items_oneOf_1_min distance slab top +:name: open_features_items_oneOf_5_sections_items_segments_items_composition-models_items_oneOf_1_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/max distance slab top +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/max distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_composition models_items_oneOf_1_max distance slab top +:name: open_features_items_oneOf_5_sections_items_segments_items_composition-models_items_oneOf_1_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/compositions +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/compositions :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_composition models_items_oneOf_1_compositions +:name: open_features_items_oneOf_5_sections_items_segments_items_composition-models_items_oneOf_1_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/compositions/items :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_composition models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_5_sections_items_segments_items_composition-models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::: -::::::: +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/fractions +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/fractions :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_composition models_items_oneOf_1_fractions +:name: open_features_items_oneOf_5_sections_items_segments_items_composition-models_items_oneOf_1_fractions -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/fractions/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/fractions/items :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_composition models_items_oneOf_1_fractions_items +:name: open_features_items_oneOf_5_sections_items_segments_items_composition-models_items_oneOf_1_fractions_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::: -::::::: +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/operation +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/composition models/items/oneOf/1/operation :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_composition models_items_oneOf_1_operation +:name: open_features_items_oneOf_5_sections_items_segments_items_composition-models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::: -:::::::: +::::::::::::: -:::::::::: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models +::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models -- **documentation**: -- **default value**: -- **type**: array -::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items +- **documentation**: +- **default value**: +- **type**:array +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items -:::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf -::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1 +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1 :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1 +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1 -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/model +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1_model +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/min distance slab top +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/min distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1_min distance slab top +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the slab top in meters from which the composition of this feature is present. -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the slab top in meters from which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/max distance slab top +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/max distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1_max distance slab top +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the slab top in meters to which the composition of this feature is present. -::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the slab top in meters to which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/compositions +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/compositions :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1_compositions +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/compositions/items :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::: -::::::: +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/orientation operation +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/orientation operation :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1_orientation operation +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/grain sizes +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/grain sizes :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1_grain sizes +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1_grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/grain sizes/items :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1_grain sizes_items +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1_grain-sizes_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::: -::::::: +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/normalize grain sizes +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/normalize grain sizes :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1_normalize grain sizes +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1_normalize-grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/normalize grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/1/normalize grain sizes/items :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_1_normalize grain sizes_items +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_1_normalize-grain-sizes_items -- **default value**: true -- **type**: boolean -- **documentation**: -:::::: +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::: -::::::: +:::::::::::: -:::::::: +::::::::::::: -::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2 +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2 :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2 +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2 -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/model +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_model +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/min distance slab top +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/min distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_min distance slab top +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the slab top in meters from which the composition of this feature is present. -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the slab top in meters from which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/max distance slab top +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/max distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_max distance slab top +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the slab top in meters to which the composition of this feature is present. -::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the slab top in meters to which the composition of this feature is present. +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/compositions +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/compositions :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_compositions +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/compositions/items :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_compositions_items +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::: -::::::: +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_rotation matrices +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_rotation-matrices -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the grains which are present there for each compositions. -::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the grains which are present there for each compositions. +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_rotation matrices_items +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_rotation-matrices_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items/items :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_rotation matrices_items_items +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_rotation-matrices_items_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/rotation matrices/items/items/items :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_rotation matrices_items_items_items +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_rotation-matrices_items_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: -:::: +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::: -::::: +:::::::::: -:::::: +::::::::::: -::::::: +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_Euler angles z-x-z +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_Euler angles z-x-z_items +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_Euler angles z-x-z_items_items +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::: -:::::: +::::::::::: -::::::: +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/orientation operation +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/orientation operation :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_orientation operation +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::: -:::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/grain sizes +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/grain sizes :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_grain sizes +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/segments/items/grains models/items/oneOf/2/grain sizes/items :open: -:name: open_features_items_oneOf_5_sections_items_segments_items_grains models_items_oneOf_2_grain sizes_items +:name: open_features_items_oneOf_5_sections_items_segments_items_grains-models_items_oneOf_2_grain-sizes_items -- **default value**: -1.0 -- **type**: number -- **documentation**: -:::::: +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::: -::::::: +:::::::::::: -:::::::: +::::::::::::: -:::::::::: +::::::::::::::: -::::::::::: +:::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::: +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models +::::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models :open: -:name: open_features_items_oneOf_5_sections_items_temperature models +:name: open_features_items_oneOf_5_sections_items_temperature-models -- **documentation**: A list of temperature models. -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items +- **documentation**:A list of temperature models. +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items +:name: open_features_items_oneOf_5_sections_items_temperature-models_items -:::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf +::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf -::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1 +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1 :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_1 +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_1 -- **type**: object -- **documentation**: Adiabatic temperature model. Uses global values by default. -- **additionalProperties**: false -- **required**: [model] +- **type**:object +- **documentation**:Adiabatic temperature model. Uses global values by default. +- **additionalProperties**:false +- **required**:[model] -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/model +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_1_model +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [adiabatic] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[adiabatic] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/operation +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/operation :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_1_operation +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/min distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/min distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_1_min distance slab top +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_1_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/max distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/max distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_1_max distance slab top +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_1_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/potential mantle temperature +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/potential mantle temperature :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_1_potential mantle temperature +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_1_potential-mantle-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If the value is lower then zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/thermal expansion coefficient +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/thermal expansion coefficient :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_1_thermal expansion coefficient +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_1_thermal-expansion-coefficient -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansion coefficient in $K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/specific heat +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/1/specific heat :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_1_specific heat +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_1_specific-heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat in $J kg^{-1} K^{-1}$. If the value is lower then zero, the global value is used. +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2 +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2 :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_2 +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_2 -- **type**: object -- **documentation**: Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. -- **additionalProperties**: false -- **required**: [model, max distance slab top] +- **type**:object +- **documentation**:Linear temperature model. Can be set to use an adiabatic temperature at the boundaries. +- **additionalProperties**:false +- **required**:[model, max distance slab top] -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/model +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_2_model +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [linear] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[linear] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/operation +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/operation :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_2_operation +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_2_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/min distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/min distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_2_min distance slab top +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_2_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/max distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/max distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_2_max distance slab top +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_2_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/top temperature +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/top temperature :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_2_top temperature +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_2_top-temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. -::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/bottom temperature +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/2/bottom temperature :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_2_bottom temperature +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_2_bottom-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The temperature at the bottom in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature at the bottom in degree Kelvin of this feature. If the value is below zero, an adiabatic temperature is used. +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3 +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3 :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_3 +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3 -- **type**: object -- **documentation**: Mass conserving temperature model. The temperature model uses the heat content (proportional to to thermal mass anomaly) to define a smooth temperature profile that conserves mass along the slab length. An empirical (linear) model is used to define how the minimum temperature increases with depth and how the location of the minimum temperature shifts into the slab interior. The slab is divided in to top and bottom parts, which meet at the location where the minimum temperature occurs in the slab. For the bottom slab the temperature is defined by a half-space cooling model. For the top of the slab the temperature is defined by one side of a 1D infinite space cooling model. The age of the overriding plate is used so the slab temperature at shallow depth smoothly transitions to the temperature of the overriding plate: this is not perfect, and is affected by the value of "top truncation" parameter subducting plate. Also note that the parameter "thickness" for the subducting plate segments needs to be defined but is not used. Note that the empirical model used to define how Tmin increases with depth and how the position of Tmin shift with depth is expected to change somewhat after better calibrating with further tests. -- **additionalProperties**: false -- **required**: [model, plate velocity] +- **type**:object +- **documentation**:Mass conserving temperature model. The temperature model uses the heat content (proportional to to thermal mass anomaly) to define a smooth temperature profile that conserves mass along the slab length. An empirical (linear) model is used to define how the minimum temperature increases with depth and how the location of the minimum temperature shifts into the slab interior. The slab is divided in to top and bottom parts, which meet at the location where the minimum temperature occurs in the slab. For the bottom slab the temperature is defined by a half-space cooling model. For the top of the slab the temperature is defined by one side of a 1D infinite space cooling model. The age of the overriding plate is used so the slab temperature at shallow depth smoothly transitions to the temperature of the overriding plate: this is not perfect, and is affected by the value of "top truncation" parameter subducting plate. Also note that the parameter "thickness" for the subducting plate segments needs to be defined but is not used. Note that the empirical model used to define how Tmin increases with depth and how the position of Tmin shift with depth is expected to change somewhat after better calibrating with further tests. +- **additionalProperties**:false +- **required**:[model, plate velocity] -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/model +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/model :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_model +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [mass conserving] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[mass conserving] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/operation +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/operation :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_operation +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/min distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/min distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_min distance slab top +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be negative and should be 1.5-2 times larger thatn the nominal slab thickness to allow the diffusion of cold temperatures from in the slab into the mantle above the slab surface. Also note that the top truncation value for the slab segment needs to have a value of -1, otherwise the temperature above the slab will be cut off at a distance less than the value set here. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be negative and should be 1.5-2 times larger thatn the nominal slab thickness to allow the diffusion of cold temperatures from in the slab into the mantle above the slab surface. Also note that the top truncation value for the slab segment needs to have a value of -1, otherwise the temperature above the slab will be cut off at a distance less than the value set here. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/max distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/max distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_max distance slab top +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be positive and approximately 2.5-3.0 times larger than the nominal slab thickness to allow the diffusion of coldtemperatures from in the slab into the mantle below the slab surface.For example if the slab starts with cold temperatures over a 100 km wide region, thisparameters should be about 250 km. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance in meters from the top surface of the slab over which the temperature is determined by this feature. This parameter should be positive and approximately 2.5-3.0 times larger than the nominal slab thickness to allow the diffusion of coldtemperatures from in the slab into the mantle below the slab surface.For example if the slab starts with cold temperatures over a 100 km wide region, thisparameters should be about 250 km. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/density +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/density :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_density +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_density -- **default value**: 3300.0 -- **type**: number -- **documentation**: The reference density of the subducting plate in $kg/m^3$ -::::::::: +- **default value**:3300.0 +- **type**:number +- **documentation**:The reference density of the subducting plate in $kg/m^3$ +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/plate velocity +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/plate velocity :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_plate velocity +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_plate-velocity -- **default value**: NaN -- **type**: number -- **documentation**: The velocity with which the plate subducts in meters per year. -::::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The velocity with which the plate subducts in meters per year. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/coupling depth +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/coupling depth :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_coupling depth +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_coupling-depth -- **default value**: NaN -- **type**: number -- **documentation**: The depth at which the slab surface first comes in contact with the hot mantle wedge in meters. -::::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The depth at which the slab surface first comes in contact with the hot mantle wedge in meters. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/shallow dip +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/shallow dip :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_shallow dip +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_shallow-dip -- **default value**: NaN -- **type**: number -- **documentation**: The average dip of the slab at depths shallower than the coupling depth in degrees. If the shallow slab dip changes with distance along the slab surface, then this will need to be adjusted to get the temperature above and below the coupling depth to match. -::::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The average dip of the slab at depths shallower than the coupling depth in degrees. If the shallow slab dip changes with distance along the slab surface, then this will need to be adjusted to get the temperature above and below the coupling depth to match. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/thermal conductivity +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/thermal conductivity :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_thermal conductivity +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_thermal-conductivity -- **default value**: 3.3 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::::: +- **default value**:3.3 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/thermal expansion coefficient +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/thermal expansion coefficient :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_thermal expansion coefficient +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_thermal-expansion-coefficient -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/specific heat +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/specific heat :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_specific heat +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_specific-heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/thermal diffusivity +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/thermal diffusivity :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_thermal diffusivity +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_thermal-diffusivity -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/adiabatic heating +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/adiabatic heating :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_adiabatic heating +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_adiabatic-heating -- **default value**: true -- **type**: boolean -- **documentation**: Whether adiabatic heating should be used for the slab. -::::::::: +- **default value**:true +- **type**:boolean +- **documentation**:Whether adiabatic heating should be used for the slab. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/taper distance +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/taper distance :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_taper distance +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_taper-distance -- **default value**: 100000.0 -- **type**: number -- **documentation**: Distance over which to taper the slab tip.tapers the initial heat content to zero and the minimum temperature to the background temperature. -::::::::: +- **default value**:100000.0 +- **type**:number +- **documentation**:Distance over which to taper the slab tip.tapers the initial heat content to zero and the minimum temperature to the background temperature. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/potential mantle temperature +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/potential mantle temperature :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_potential mantle temperature +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_potential-mantle-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/ridge coordinates +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/ridge coordinates :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_ridge coordinates +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_ridge-coordinates -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. -::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/ridge coordinates/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/ridge coordinates/items :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_ridge coordinates_items +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_ridge-coordinates_items -- **type**: array -- **minItems**: 2 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: -:::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/ridge coordinates/items/items +- **type**:array +- **minItems**:2 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/ridge coordinates/items/items :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_ridge coordinates_items_items +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_ridge-coordinates_items_items -- **type**: array -- **minItems**: 2 -- **maxItems**: 2 -- **documentation**: -::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/ridge coordinates/items/items/items +- **type**:array +- **minItems**:2 +- **maxItems**:2 +- **documentation**: +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/3/ridge coordinates/items/items/items :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_3_ridge coordinates_items_items_items +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_3_ridge-coordinates_items_items_items -- **type**: number -:::::: +- **type**:number +::::::::::: -::::::: +:::::::::::: -:::::::: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4 +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4 :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_4 +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4 -- **type**: object -- **documentation**: Plate model (based on McKenzie, 1970). -- **additionalProperties**: false -- **required**: [model, plate velocity] +- **type**:object +- **documentation**:Plate model (based on McKenzie, 1970). +- **additionalProperties**:false +- **required**:[model, plate velocity] -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/model +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/model :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_model +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [plate model] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[plate model] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/operation +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/operation :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_operation +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/min distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/min distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_min distance slab top +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/max distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/max distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_max distance slab top +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/density +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/density :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_density +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_density -- **default value**: 3300.0 -- **type**: number -- **documentation**: The reference density of the subducting plate in $kg/m^3$ -::::::::: +- **default value**:3300.0 +- **type**:number +- **documentation**:The reference density of the subducting plate in $kg/m^3$ +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/plate velocity +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/plate velocity :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_plate velocity +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_plate-velocity -- **default value**: NaN -- **type**: number -- **documentation**: The velocity in meters per year with which the plate subducts in meters per year. -::::::::: +- **default value**:NaN +- **type**:number +- **documentation**:The velocity in meters per year with which the plate subducts in meters per year. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/thermal conductivity +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/thermal conductivity :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_thermal conductivity +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_thermal-conductivity -- **default value**: 2.0 -- **type**: number -- **documentation**: The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. -::::::::: +- **default value**:2.0 +- **type**:number +- **documentation**:The thermal conductivity of the subducting plate material in $W m^{-1} K^{-1}$. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/thermal expansion coefficient +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/thermal expansion coefficient :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_thermal expansion coefficient +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_thermal-expansion-coefficient -- **default value**: -1.0 -- **type**: number -- **documentation**: The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The thermal expansivity of the subducting plate material in $K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/specific heat +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/specific heat :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_specific heat +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_specific-heat -- **default value**: -1.0 -- **type**: number -- **documentation**: The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The specific heat of the subducting plate material in $J kg^{-1} K^{-1}$. If smaller than zero, the global value is used. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/adiabatic heating +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/adiabatic heating :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_adiabatic heating +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_adiabatic-heating -- **default value**: true -- **type**: boolean -- **documentation**: Wheter adiabatic heating should be used for the slab. Setting the parameter to false leads to equation 26 from McKenzie (1970),which is the result obtained from McKenzie 1969. -::::::::: +- **default value**:true +- **type**:boolean +- **documentation**:Wheter adiabatic heating should be used for the slab. Setting the parameter to false leads to equation 26 from McKenzie (1970),which is the result obtained from McKenzie 1969. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/potential mantle temperature +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/4/potential mantle temperature :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_4_potential mantle temperature +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_4_potential-mantle-temperature -- **default value**: -1.0 -- **type**: number -- **documentation**: The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. -::::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**:The potential temperature of the mantle at the surface in Kelvin. If smaller than zero, the global value is used. +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5 +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5 :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_5 +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_5 -- **type**: object -- **documentation**: Uniform temperature model. Set the temperature to a constan value. -- **additionalProperties**: false -- **required**: [model, temperature] +- **type**:object +- **documentation**:Uniform temperature model. Set the temperature to a constan value. +- **additionalProperties**:false +- **required**:[model, temperature] -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5/model +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5/model :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_5_model +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_5_model -- **default value**: -- **type**: string -- **documentation**: The name of the temperature model. -- **enum**: [uniform] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the temperature model. +- **enum**:[uniform] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5/operation +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5/operation :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_5_operation +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_5_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). -- **enum**: [replace, add, subtract] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace), add the value to the previously define value (add) or subtract the value to the previously define value (subtract). +- **enum**:[replace, add, subtract] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5/min distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5/min distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_5_min distance slab top +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_5_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5/max distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5/max distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_5_max distance slab top +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_5_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5/temperature +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/temperature models/items/oneOf/5/temperature :open: -:name: open_features_items_oneOf_5_sections_items_temperature models_items_oneOf_5_temperature +:name: open_features_items_oneOf_5_sections_items_temperature-models_items_oneOf_5_temperature -- **default value**: 293.15 -- **type**: number -- **documentation**: The temperature in degree Kelvin which this feature should have -::::::::: +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::: -:::::::::: +::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::: +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models +::::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models :open: -:name: open_features_items_oneOf_5_sections_items_composition models +:name: open_features_items_oneOf_5_sections_items_composition-models -- **documentation**: A list of composition models. -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items +- **documentation**:A list of composition models. +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items :open: -:name: open_features_items_oneOf_5_sections_items_composition models_items +:name: open_features_items_oneOf_5_sections_items_composition-models_items -:::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf +::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf :open: -:name: open_features_items_oneOf_5_sections_items_composition models_items_oneOf +:name: open_features_items_oneOf_5_sections_items_composition-models_items_oneOf -::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1 +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1 :open: -:name: open_features_items_oneOf_5_sections_items_composition models_items_oneOf_1 +:name: open_features_items_oneOf_5_sections_items_composition-models_items_oneOf_1 -- **type**: object -- **documentation**: Uniform compositional model. Sets constant compositional field. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/model +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_5_sections_items_composition models_items_oneOf_1_model +:name: open_features_items_oneOf_5_sections_items_composition-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the composition model. -- **enum**: [uniform] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/min distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/min distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_composition models_items_oneOf_1_min distance slab top +:name: open_features_items_oneOf_5_sections_items_composition-models_items_oneOf_1_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: todo The depth in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:todo The depth in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/max distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/max distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_composition models_items_oneOf_1_max distance slab top +:name: open_features_items_oneOf_5_sections_items_composition-models_items_oneOf_1_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: todo The depth in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:todo The depth in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/compositions +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/compositions :open: -:name: open_features_items_oneOf_5_sections_items_composition models_items_oneOf_1_compositions +:name: open_features_items_oneOf_5_sections_items_composition-models_items_oneOf_1_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/compositions/items :open: -:name: open_features_items_oneOf_5_sections_items_composition models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_5_sections_items_composition-models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/fractions +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/fractions :open: -:name: open_features_items_oneOf_5_sections_items_composition models_items_oneOf_1_fractions +:name: open_features_items_oneOf_5_sections_items_composition-models_items_oneOf_1_fractions -- **type**: array -- **minItems**: 1 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: TA list of compositional fractions corresponding to the compositions list. -::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/fractions/items +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:TA list of compositional fractions corresponding to the compositions list. +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/fractions/items :open: -:name: open_features_items_oneOf_5_sections_items_composition models_items_oneOf_1_fractions_items +:name: open_features_items_oneOf_5_sections_items_composition-models_items_oneOf_1_fractions_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/operation +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/composition models/items/oneOf/1/operation :open: -:name: open_features_items_oneOf_5_sections_items_composition models_items_oneOf_1_operation +:name: open_features_items_oneOf_5_sections_items_composition-models_items_oneOf_1_operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -:::::::::: +::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::: +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models +::::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models :open: -:name: open_features_items_oneOf_5_sections_items_grains models +:name: open_features_items_oneOf_5_sections_items_grains-models -- **documentation**: A list of grains models. -- **default value**: -- **type**: array -::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items +- **documentation**:A list of grains models. +- **default value**: +- **type**:array +:::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items +:name: open_features_items_oneOf_5_sections_items_grains-models_items -:::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf +::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf -::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1 +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1 :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_1 +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1 -- **type**: object -- **documentation**: Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Random uniform distribution grains model. The size of the grains can be independently set to a single value or to a random distribution. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/model +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/model :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_1_model +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [random uniform distribution] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[random uniform distribution] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/min distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/min distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_1_min distance slab top +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the slab top in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the slab top in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/max distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/max distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_1_max distance slab top +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the slab top in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the slab top in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/compositions +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/compositions :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_1_compositions +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/compositions/items :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_1_compositions_items +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/orientation operation +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/orientation operation :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_1_orientation operation +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/grain sizes +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/grain sizes :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_1_grain sizes +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1_grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. -::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be randomized between 0 and 1. +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/grain sizes/items :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_1_grain sizes_items +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1_grain-sizes_items -- **default value**: 1.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:1.0 +- **type**:number +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/normalize grain sizes +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/normalize grain sizes :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_1_normalize grain sizes +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1_normalize-grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. -::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/normalize grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of whether the sizes of the grains should be normalized or not. If normalized, the total of the grains of a composition will be equal to 1. +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/1/normalize grain sizes/items :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_1_normalize grain sizes_items +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_1_normalize-grain-sizes_items -- **default value**: true -- **type**: boolean -- **documentation**: -:::::::: +- **default value**:true +- **type**:boolean +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::: +::::::::::::::: -::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2 +:::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2 :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_2 +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2 -- **type**: object -- **documentation**: Uniform grains model. All grains start exactly the same. -- **additionalProperties**: false -- **required**: [model, compositions] +- **type**:object +- **documentation**:Uniform grains model. All grains start exactly the same. +- **additionalProperties**:false +- **required**:[model, compositions] -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/model +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/model :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_2_model +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_model -- **default value**: -- **type**: string -- **documentation**: The name of the grains model. -- **enum**: [uniform] -::::::::: +- **default value**: +- **type**:string +- **documentation**:The name of the grains model. +- **enum**:[uniform] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/min distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/min distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_2_min distance slab top +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_min-distance-slab-top -- **default value**: 0.0 -- **type**: number -- **documentation**: The distance from the slab top in meters from which the composition of this feature is present. -::::::::: +- **default value**:0.0 +- **type**:number +- **documentation**:The distance from the slab top in meters from which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/max distance slab top +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/max distance slab top :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_2_max distance slab top +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_max-distance-slab-top -- **default value**: 1.7976931348623157e308 -- **type**: number -- **documentation**: The distance from the slab top in meters to which the composition of this feature is present. -::::::::: +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**:The distance from the slab top in meters to which the composition of this feature is present. +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/compositions +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/compositions :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_2_compositions +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_compositions -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the integer labels of the composition which are present there. -::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/compositions/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the integer labels of the composition which are present there. +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/compositions/items :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_2_compositions_items +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_compositions_items -- **default value**: 0 -- **type**: integer -- **documentation**: -:::::::: +- **default value**:0 +- **type**:integer +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/rotation matrices +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/rotation matrices :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_2_rotation matrices +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_rotation-matrices -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the labels of the grains which are present there for each compositions. -::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/rotation matrices/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the labels of the grains which are present there for each compositions. +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/rotation matrices/items :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_2_rotation matrices_items +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_rotation-matrices_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/rotation matrices/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/rotation matrices/items/items :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_2_rotation matrices_items_items +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_rotation-matrices_items_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/rotation matrices/items/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +:::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/rotation matrices/items/items/items :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_2_rotation matrices_items_items_items +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_rotation-matrices_items_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: -:::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +::::::::::: -::::::: +:::::::::::: -:::::::: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/Euler angles z-x-z +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/Euler angles z-x-z :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_2_Euler angles z-x-z +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_Euler-angles-z-x-z -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list with the z-x-z Euler angles of the grains which are present there for each compositions. -::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/Euler angles z-x-z/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list with the z-x-z Euler angles of the grains which are present there for each compositions. +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/Euler angles z-x-z/items :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_2_Euler angles z-x-z_items +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items -- **type**: array -- **minItems**: 3 -- **maxItems**: 3 -- **uniqueItems**: false -- **documentation**: -:::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items +- **type**:array +- **minItems**:3 +- **maxItems**:3 +- **uniqueItems**:false +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/Euler angles z-x-z/items/items :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_2_Euler angles z-x-z_items_items +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_Euler-angles-z-x-z_items_items -- **default value**: 0.0 -- **type**: number -- **documentation**: -::::::: +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::: -:::::::: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/orientation operation +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/orientation operation :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_2_orientation operation +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_orientation-operation -- **default value**: replace -- **type**: string -- **documentation**: Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. -- **enum**: [replace] -::::::::: +- **default value**:replace +- **type**:string +- **documentation**:Whether the value should replace any value previously defined at this location (replace) or add the value to the previously define value (add, not implemented). Replacing implies that all values not explicitly defined are set to zero. +- **enum**:[replace] +:::::::::::::: -:::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/grain sizes +::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/grain sizes :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_2_grain sizes +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_grain-sizes -- **type**: array -- **minItems**: 0 -- **maxItems**: 4294967295 -- **uniqueItems**: false -- **documentation**: A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. -::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/grain sizes/items +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:A list of the size of all of the grains in each composition. If set to <0, the size will be set so that the total is equal to 1. +:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/grains models/items/oneOf/2/grain sizes/items :open: -:name: open_features_items_oneOf_5_sections_items_grains models_items_oneOf_2_grain sizes_items +:name: open_features_items_oneOf_5_sections_items_grains-models_items_oneOf_2_grain-sizes_items -- **default value**: -1.0 -- **type**: number -- **documentation**: -:::::::: +- **default value**:-1.0 +- **type**:number +- **documentation**: +::::::::::::: -::::::::: +:::::::::::::: -:::::::::: +::::::::::::::: -:::::::::::: +::::::::::::::::: -::::::::::::: +:::::::::::::::::: -:::::::::::::{dropdown} /features/items/oneOf/5/sections/items/coordinate +::::::::::::::::::{dropdown} /features/items/oneOf/5/sections/items/coordinate :open: :name: open_features_items_oneOf_5_sections_items_coordinate -- **default value**: 0 -- **type**: integer -- **documentation**: The coordinate which should be overwritten -::::::::::::: +- **default value**:0 +- **type**:integer +- **documentation**:The coordinate which should be overwritten +:::::::::::::::::: -:::::::::::::: +::::::::::::::::::: -::::::::::::::: +:::::::::::::::::::: -:::::::::::::::: +::::::::::::::::::::: -:::::::::::::::::: +::::::::::::::::::::::: -::::::::::::::::::: +:::::::::::::::::::::::: From 5402d5bdffc6a2c3a50376e306b005457c4a7088 Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Thu, 24 Mar 2022 13:53:18 -0700 Subject: [PATCH 15/26] Add continental_min_max_surface_spherical test. --- .../continental_min_max_surface_spherical.dat | 293 ++++++++++++++++++ .../continental_min_max_surface_spherical.wb | 42 +++ .../screen-output.log | 285 +++++++++++++++++ 3 files changed, 620 insertions(+) create mode 100644 tests/app/continental_min_max_surface_spherical.dat create mode 100644 tests/app/continental_min_max_surface_spherical.wb create mode 100644 tests/app/continental_min_max_surface_spherical/screen-output.log diff --git a/tests/app/continental_min_max_surface_spherical.dat b/tests/app/continental_min_max_surface_spherical.dat new file mode 100644 index 000000000..7331c6bb7 --- /dev/null +++ b/tests/app/continental_min_max_surface_spherical.dat @@ -0,0 +1,293 @@ +# This is a comment in the data +# file. +# Now define parameters: +# dim = 3 +# compositions = 5 +# grain compositions = 2 +# number of grains = 2 +# convert spherical = true +# R long lat d g T c1 c2 c3 c4 c5 +1 0 0 1 10 +1 0 0 10e3 10 +1 0 0 40e3 10 +1 0 0 60e3 10 +1 0 0 150e3 10 +1 0 0 250e3 10 +1 0 0 350e3 10 +1 0 2.5 1 10 +1 0 2.5 10e3 10 +1 0 2.5 40e3 10 +1 0 2.5 60e3 10 +1 0 2.5 150e3 10 +1 0 2.5 250e3 10 +1 0 2.5 350e3 10 +1 0 5 1 10 +1 0 5 10e3 10 +1 0 5 40e3 10 +1 0 5 60e3 10 +1 0 5 150e3 10 +1 0 5 250e3 10 +1 0 5 350e3 10 +1 0 5.07 1 10 +1 0 7.5 1 10 +1 0 7.5 10e3 10 +1 0 7.5 40e3 10 +1 0 7.5 60e3 10 +1 0 7.5 150e3 10 +1 0 7.5 250e3 10 +1 0 7.5 350e3 10 +1 0 10 1 10 +1 0 10 10e3 10 +1 0 10 40e3 10 +1 0 10 60e3 10 +1 0 10 150e3 10 +1 0 10 250e3 10 +1 0 10 350e3 10 +1 5 0 1 10 +1 5 0 10e3 10 +1 5 0 40e3 10 +1 5 0 60e3 10 +1 5 0 150e3 10 +1 5 0 250e3 10 +1 5 0 350e3 10 +1 5 2.5 1 10 +1 5 2.5 10e3 10 +1 5 2.5 40e3 10 +1 5 2.5 60e3 10 +1 5 2.5 150e3 10 +1 5 2.5 250e3 10 +1 5 2.5 350e3 10 +1 5 5 1 10 +1 5 5 10e3 10 +1 5 5 40e3 10 +1 5 5 60e3 10 +1 5 5 150e3 10 +1 5 5 250e3 10 +1 5 5 350e3 10 +1 5 5.07 1 10 +1 5 7.5 1 10 +1 5 7.5 10e3 10 +1 5 7.5 40e3 10 +1 5 7.5 60e3 10 +1 5 7.5 150e3 10 +1 5 7.5 250e3 10 +1 5 7.5 350e3 10 +1 5 10 1 10 +1 5 10 10e3 10 +1 5 10 40e3 10 +1 5 10 60e3 10 +1 5 10 150e3 10 +1 5 10 250e3 10 +1 5 10 350e3 10 +1 10 0 10e3 10 +1 10 0 40e3 10 +1 10 0 60e3 10 +1 10 0 150e3 10 +1 10 0 250e3 10 +1 10 0 350e3 10 +1 10 2.5 1 10 +1 10 2.5 10e3 10 +1 10 2.5 40e3 10 +1 10 2.5 60e3 10 +1 10 2.5 150e3 10 +1 10 2.5 250e3 10 +1 10 2.5 350e3 10 +1 10 5 1 10 +1 10 5 10e3 10 +1 10 5 40e3 10 +1 10 5 60e3 10 +1 10 5 150e3 10 +1 10 5 250e3 10 +1 10 5 350e3 10 +1 10 5.07 1 10 +1 10 7.5 1 10 +1 10 7.5 10e3 10 +1 10 7.5 40e3 10 +1 10 7.5 60e3 10 +1 10 7.5 150e3 10 +1 10 7.5 250e3 10 +1 10 7.5 350e3 10 +1 10 10 1 10 +1 10 10 10e3 10 +1 10 10 40e3 10 +1 10 10 60e3 10 +1 10 10 150e3 10 +1 10 10 250e3 10 +1 10 10 350e3 10 +1 175 0 1 10 +1 175 0 10e3 10 +1 175 0 40e3 10 +1 175 0 60e3 10 +1 175 0 150e3 10 +1 175 0 250e3 10 +1 175 0 350e3 10 +1 175 2.5 1 10 +1 175 2.5 10e3 10 +1 175 2.5 40e3 10 +1 175 2.5 60e3 10 +1 175 2.5 150e3 10 +1 175 2.5 250e3 10 +1 175 2.5 350e3 10 +1 175 5 1 10 +1 175 5 10e3 10 +1 175 5 40e3 10 +1 175 5 60e3 10 +1 175 5 150e3 10 +1 175 5 250e3 10 +1 175 5 350e3 10 +1 175 5.07 1 10 +1 175 7.5 1 10 +1 175 7.5 10e3 10 +1 175 7.5 40e3 10 +1 175 7.5 60e3 10 +1 175 7.5 150e3 10 +1 175 7.5 250e3 10 +1 175 7.5 350e3 10 +1 175 10 1 10 +1 175 10 10e3 10 +1 175 10 40e3 10 +1 175 10 60e3 10 +1 175 10 150e3 10 +1 175 10 250e3 10 +1 175 10 350e3 10 +1 180 0 1 10 +1 180 0 10e3 10 +1 180 0 40e3 10 +1 180 0 60e3 10 +1 180 0 150e3 10 +1 180 0 250e3 10 +1 180 0 350e3 10 +1 180 2.5 1 10 +1 180 2.5 10e3 10 +1 180 2.5 40e3 10 +1 180 2.5 60e3 10 +1 180 2.5 150e3 10 +1 180 2.5 250e3 10 +1 180 2.5 350e3 10 +1 180 5 1 10 +1 180 5 10e3 10 +1 180 5 40e3 10 +1 180 5 60e3 10 +1 180 5 150e3 10 +1 180 5 250e3 10 +1 180 5 350e3 10 +1 180 5.07 1 10 +1 180 7.5 1 10 +1 180 7.5 10e3 10 +1 180 7.5 40e3 10 +1 180 7.5 60e3 10 +1 180 7.5 150e3 10 +1 180 7.5 250e3 10 +1 180 7.5 350e3 10 +1 180 10 1 10 +1 180 10 10e3 10 +1 180 10 40e3 10 +1 180 10 60e3 10 +1 180 10 150e3 10 +1 180 10 250e3 10 +1 180 10 350e3 10 +1 185 0 10e3 10 +1 185 0 40e3 10 +1 185 0 60e3 10 +1 185 0 150e3 10 +1 185 0 250e3 10 +1 185 0 350e3 10 +1 185 2.5 1 10 +1 185 2.5 10e3 10 +1 185 2.5 40e3 10 +1 185 2.5 60e3 10 +1 185 2.5 150e3 10 +1 185 2.5 250e3 10 +1 185 2.5 350e3 10 +1 185 5 1 10 +1 185 5 10e3 10 +1 185 5 40e3 10 +1 185 5 60e3 10 +1 185 5 150e3 10 +1 185 5 250e3 10 +1 185 5 350e3 10 +1 185 5.07 1 10 +1 185 7.5 1 10 +1 185 7.5 10e3 10 +1 185 7.5 40e3 10 +1 185 7.5 60e3 10 +1 185 7.5 150e3 10 +1 185 7.5 250e3 10 +1 185 7.5 350e3 10 +1 185 10 1 10 +1 185 10 10e3 10 +1 185 10 40e3 10 +1 185 10 60e3 10 +1 185 10 150e3 10 +1 185 10 250e3 10 +1 185 10 350e3 10 +1 -184.9 1.2 1 10 +1 -184.9 1.2 10e3 10 +1 -184.9 1.2 40e3 10 +1 -184.9 1.2 60e3 10 +1 -184.9 1.2 150e3 10 +1 -184.9 1.2 250e3 10 +1 -184.9 1.2 350e3 10 +1 175.05 3.15 1 10 +1 175.05 3.15 10e3 10 +1 175.05 3.15 40e3 10 +1 175.05 3.15 60e3 10 +1 175.05 3.15 150e3 10 +1 175.05 3.15 250e3 10 +1 175.05 3.15 350e3 10 +1 175.15 1.05 1 10 +1 175.15 1.05 10e3 10 +1 175.15 1.05 40e3 10 +1 175.15 1.05 60e3 10 +1 175.15 1.05 150e3 10 +1 175.15 1.05 250e3 10 +1 175.15 1.05 350e3 10 +1 -184.85 1.05 1 10 +1 -184.85 1.05 10e3 10 +1 -184.85 1.05 40e3 10 +1 -184.85 1.05 60e3 10 +1 -184.85 1.05 150e3 10 +1 -184.85 1.05 250e3 10 +1 -184.85 1.05 350e3 10 +1 -179.6 8.2 1 10 +1 -179.6 8.2 10e3 10 +1 -179.6 8.2 40e3 10 +1 -179.6 8.2 60e3 10 +1 -179.6 8.2 150e3 10 +1 -179.6 8.2 250e3 10 +1 -179.6 8.2 350e3 10 +1 180.4 8.2 1 10 +1 180.4 8.2 10e3 10 +1 180.4 8.2 40e3 10 +1 180.4 8.2 60e3 10 +1 180.4 8.2 150e3 10 +1 180.4 8.2 250e3 10 +1 180.4 8.2 350e3 10 +1 -175 4.95 1 10 +1 -175 4.95 10e3 10 +1 -175 4.95 40e3 10 +1 -175 4.95 60e3 10 +1 -175 4.95 150e3 10 +1 -175 4.95 250e3 10 +1 -175 4.95 350e3 10 +1 185 4.95 1 10 +1 185 4.95 10e3 10 +1 185 4.95 40e3 10 +1 185 4.95 60e3 10 +1 185 4.95 150e3 10 +1 185 4.95 250e3 10 +1 185 4.95 350e3 10 +1 -179.95 2.55 1 10 +1 -179.95 2.55 10e3 10 +1 -179.95 2.55 40e3 10 +1 -179.95 2.55 60e3 10 +1 -179.95 2.55 150e3 10 +1 -179.95 2.55 250e3 10 +1 -179.95 2.55 350e3 10 +1 180.05 2.55 1 10 +1 180.05 2.55 10e3 10 +1 180.05 2.55 40e3 10 +1 180.05 2.55 60e3 10 +1 180.05 2.55 150e3 10 +1 180.05 2.55 250e3 10 +1 180.05 2.55 350e3 10 \ No newline at end of file diff --git a/tests/app/continental_min_max_surface_spherical.wb b/tests/app/continental_min_max_surface_spherical.wb new file mode 100644 index 000000000..30190d5e9 --- /dev/null +++ b/tests/app/continental_min_max_surface_spherical.wb @@ -0,0 +1,42 @@ +{ +"version":"0.5", +"coordinate system":{"model":"spherical", "depth method":"begin at end segment"}, +"features":[ + { + "model":"continental plate", "name":"Var thickness continent", "coordinates":[[0,10],[10,10],[10,0],[0,0]], + "min depth":[[50e3,[[0,5]]],[200e3,[[10,5]]]], "max depth":[[300e3],[200e3,[[0,5],[10,5]]]], + "temperature models":[ + {"model":"uniform", "min depth":[[50e3,[[0,5]]],[200e3,[[10,5]]]], "max depth":[[200e3],[100e3,[[0,5],[10,5],[0,0]]]], "temperature":150}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[0,5],[10,5],[0,0]]]], "max depth":[[300e3],[200e3,[[0,5],[10,5]]]], "temperature":200} + ], + "composition models":[ + {"model":"uniform", "min depth":[[50e3,[[0,5]]],[200e3,[[10,5]]]], "max depth":[[200e3],[100e3,[[0,5],[10,5],[0,0]]]], "compositions":[0]}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[0,5],[10,5],[0,0]]]], "max depth":[[300e3],[200e3,[[0,5],[10,5]]]], "compositions":[1]} + ], + "grains models":[ + {"model":"uniform", "compositions":[0,1],"rotation matrices":[[[1,2,3],[4,5,6],[7,8,9]],[[10,11,12],[13,14,15],[16,17,18]]],"grain sizes":[-1,0.2], + "min depth":[[50e3,[[0,5]]],[200e3,[[10,5]]]], "max depth":[[200e3],[100e3,[[0,5],[10,5],[0,0]]]]}, + {"model":"uniform", "compositions":[0,1],"rotation matrices":[[[19,20,21],[22,23,24],[25,26,27]],[[28,29,30],[31,32,33],[34,35,36]]],"grain sizes":[-1,0.3], + "min depth":[[200e3],[100e3,[[0,5],[10,5],[0,0]]]], "max depth":[[300e3],[200e3,[[0,5],[10,5]]]]} + ] + }, + { + "model":"continental plate", "name":"Var thickness continent 2", "coordinates":[[175,10],[185,10],[185,0],[175,0]], + "min depth":[[50e3,[[175,5]]],[200e3,[[185,5]]]], "max depth":[[300e3],[200e3,[[175,5],[185,5]]]], + "temperature models":[ + {"model":"uniform", "min depth":[[50e3,[[175,5]]],[200e3,[[185,5]]]], "max depth":[[200e3],[100e3,[[175,5],[185,5],[175,0]]]], "temperature":150}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[175,5],[185,5],[175,0]]]], "max depth":[[300e3],[200e3,[[175,5],[185,5]]]], "temperature":200} + ], + "composition models":[ + {"model":"uniform", "min depth":[[50e3,[[175,5]]],[200e3,[[185,5]]]], "max depth":[[200e3],[100e3,[[175,5],[185,5],[175,0]]]], "compositions":[0]}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[175,5],[185,5],[175,0]]]], "max depth":[[300e3],[200e3,[[175,5],[185,5]]]], "compositions":[1]} + ], + "grains models":[ + {"model":"uniform", "compositions":[175,1],"rotation matrices":[[[1,2,3],[4,5,6],[7,8,9]],[[185,11,12],[13,14,15],[16,17,18]]],"grain sizes":[-1,0.2], + "min depth":[[50e3,[[175,5]]],[200e3,[[185,5]]]], "max depth":[[200e3],[100e3,[[175,5],[185,5],[175,0]]]]}, + {"model":"uniform", "compositions":[175,1],"rotation matrices":[[[19,20,21],[22,23,24],[25,26,27]],[[28,29,30],[31,32,33],[34,35,36]]],"grain sizes":[-1,0.3], + "min depth":[[200e3],[100e3,[[175,5],[185,5],[175,0]]]], "max depth":[[300e3],[200e3,[[175,5],[185,5]]]]} + ] + } +] +} diff --git a/tests/app/continental_min_max_surface_spherical/screen-output.log b/tests/app/continental_min_max_surface_spherical/screen-output.log new file mode 100644 index 000000000..efd37999b --- /dev/null +++ b/tests/app/continental_min_max_surface_spherical/screen-output.log @@ -0,0 +1,285 @@ +# x y z d g T c0 c1 c2 c3 c4 gs0-0 gm0-0[0:0] gm0-0[0:1] gm0-0[0:2] gm0-0[1:0] gm0-0[1:1] gm0-0[1:2] gm0-0[2:0] gm0-0[2:1] gm0-0[2:2] gs0-1 gm0-1[0:0] gm0-1[0:1] gm0-1[0:2] gm0-1[1:0] gm0-1[1:1] gm0-1[1:2] gm0-1[2:0] gm0-1[2:1] gm0-1[2:2] gs1-0 gm1-0[0:0] gm1-0[0:1] gm1-0[0:2] gm1-0[1:0] gm1-0[1:1] gm1-0[1:2] gm1-0[2:0] gm1-0[2:1] gm1-0[2:2] gs1-1 gm1-1[0:0] gm1-1[0:1] gm1-1[0:2] gm1-1[1:0] gm1-1[1:1] gm1-1[1:2] gm1-1[2:0] gm1-1[2:1] gm1-1[2:2] +1 0 0 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 0 10e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 0 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 0 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 0 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 0 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 0 0 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 2.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 2.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 2.5 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 2.5 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 2.5 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 2.5 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 0 2.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 5 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 5 150e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 0 5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 5.07 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 7.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 7.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 7.5 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 7.5 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 7.5 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 7.5 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 0 7.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 0 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 0 10e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 0 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 0 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 0 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 0 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 5 0 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 2.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 2.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 2.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 2.5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 2.5 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 2.5 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 5 2.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5 150e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 5 5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5.07 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 7.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 7.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 7.5 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 7.5 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 7.5 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 7.5 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 5 7.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 0 10e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 0 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 0 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 0 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 0 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 10 0 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 2.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 2.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 2.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 2.5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 2.5 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 2.5 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 10 2.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5.07 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 7.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 7.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 7.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 7.5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 7.5 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 7.5 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 10 7.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 10 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 10 10e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 10 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 10 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 10 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 10 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 10 10 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 0 1 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 0 10e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 0 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 0 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 0 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175 0 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175 0 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 2.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 2.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 2.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 2.5 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 2.5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175 2.5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 2.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 5 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175 5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 5.07 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 7.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 7.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 7.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 7.5 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 7.5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175 7.5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 7.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 10 1 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 10 10e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 10 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 10 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 10 150e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 10 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175 10 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 0 1 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 0 10e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 0 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 0 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 0 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180 0 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180 0 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 2.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 2.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 2.5 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 2.5 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 2.5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180 2.5 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180 2.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180 5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5.07 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 7.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 7.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 7.5 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 7.5 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 7.5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180 7.5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 7.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 0 10e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 0 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 0 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 0 150e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 0 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 185 0 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 2.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 2.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 2.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 2.5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 2.5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 185 2.5 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 185 2.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5.07 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 7.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 7.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 7.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 7.5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 7.5 150e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 7.5 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 185 7.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 10 1 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 10 10e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 10 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 10 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 10 150e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 10 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 185 10 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -184.9 1.2 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -184.9 1.2 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -184.9 1.2 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -184.9 1.2 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -184.9 1.2 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 -184.9 1.2 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 -184.9 1.2 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.05 3.15 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.05 3.15 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.05 3.15 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175.05 3.15 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175.05 3.15 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175.05 3.15 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.05 3.15 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.15 1.05 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.15 1.05 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.15 1.05 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175.15 1.05 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175.15 1.05 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175.15 1.05 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175.15 1.05 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -184.85 1.05 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -184.85 1.05 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -184.85 1.05 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -184.85 1.05 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -184.85 1.05 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 -184.85 1.05 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 -184.85 1.05 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.6 8.2 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.6 8.2 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.6 8.2 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -179.6 8.2 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -179.6 8.2 150e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -179.6 8.2 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 -179.6 8.2 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.4 8.2 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.4 8.2 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.4 8.2 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180.4 8.2 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180.4 8.2 150e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180.4 8.2 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180.4 8.2 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.95 2.55 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.95 2.55 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.95 2.55 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -179.95 2.55 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -179.95 2.55 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 -179.95 2.55 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.95 2.55 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.05 2.55 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.05 2.55 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.05 2.55 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180.05 2.55 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180.05 2.55 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180.05 2.55 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.05 2.55 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 From dc22f1a7699b758d7bd7218f63a700b66e58f5ea Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Thu, 24 Mar 2022 13:53:39 -0700 Subject: [PATCH 16/26] Add continental_min_max_surface test. --- tests/app/continental_min_max_surface.dat | 62 +++++++++++++++++++ tests/app/continental_min_max_surface.wb | 24 +++++++ .../screen-output.log | 55 ++++++++++++++++ 3 files changed, 141 insertions(+) create mode 100644 tests/app/continental_min_max_surface.dat create mode 100644 tests/app/continental_min_max_surface.wb create mode 100644 tests/app/continental_min_max_surface/screen-output.log diff --git a/tests/app/continental_min_max_surface.dat b/tests/app/continental_min_max_surface.dat new file mode 100644 index 000000000..6db2e291b --- /dev/null +++ b/tests/app/continental_min_max_surface.dat @@ -0,0 +1,62 @@ +# This is a comment in the data +# file. +# Now define parameters: +# dim = 3 +# compositions = 5 +# grain compositions = 2 +# number of grains = 2 +# x y z d g T c1 c2 c3 c4 c5 +0 0 1 1 10 +0 0 1 40e3 10 +0 0 1 60e3 10 +0 0 1 150e3 10 +0 0 1 250e3 10 +0 0 1 350e3 10 +0 250e3 1 1 10 +0 250e3 1 40e3 10 +0 250e3 1 60e3 10 +0 250e3 1 150e3 10 +0 250e3 1 250e3 10 +0 250e3 1 350e3 10 +0 500e3 1 1 10 +0 500e3 1 40e3 10 +0 500e3 1 60e3 10 +0 500e3 1 150e3 10 +0 500e3 1 250e3 10 +0 500e3 1 350e3 10 +0 750e3 1 1 10 +0 1000e3 1 1 10 +250e3 0 1 1 10 +250e3 0 40e3 1 10 +250e3 0 60e3 1 10 +250e3 0 250e3 1 10 +250e3 0 350e3 1 10 +250e3 250e3 1 1 10 +250e3 250e3 1 40e3 10 +250e3 250e3 1 60e3 10 +250e3 250e3 1 150e3 10 +250e3 250e3 1 250e3 10 +250e3 250e3 1 350e3 10 +250e3 500e3 1 1 10 +250e3 500e3 1 40e3 10 +250e3 500e3 1 60e3 10 +250e3 500e3 1 150e3 10 +250e3 500e3 1 250e3 10 +250e3 500e3 1 350e3 10 +250e3 750e3 1 1 10 +250e3 1000e3 1 1 10 +500e3 0 1 1 10 +500e3 250e3 1 1 10 +500e3 500e3 1 1 10 +500e3 750e3 1 1 10 +500e3 1000e3 1 1 10 +750e3 0 1 1 10 +750e3 250e3 1 1 10 +750e3 500e3 1 1 10 +750e3 750e3 1 1 10 +750e3 1000e3 1 1 10 +1000e3 0 1 1 10 +1000e3 250e3 1 1 10 +1000e3 500e3 1 1 10 +1000e3 750e3 1 1 10 +1000e3 1000e3 1 1 10 diff --git a/tests/app/continental_min_max_surface.wb b/tests/app/continental_min_max_surface.wb new file mode 100644 index 000000000..0951685f0 --- /dev/null +++ b/tests/app/continental_min_max_surface.wb @@ -0,0 +1,24 @@ +{ +"version":"0.5", +"coordinate system":{"model":"cartesian"}, +"features":[ + { + "model":"continental plate", "name":"Var thickness continent", "coordinates":[[0,1000e3],[1000e3,1000e3],[1000e3,0],[0,0]], + "min depth":[[50e3,[[0,500e3]]],[200e3,[[1000e3,500e3]]]], "max depth":[[300e3],[200e3,[[0,500e3],[1000e3,500e3]]]], + "temperature models":[ + {"model":"uniform", "min depth":[[50e3,[[0,500e3]]],[200e3,[[1000e3,500e3]]]], "max depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]], "temperature":150}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]], "max depth":[[300e3],[200e3,[[0,500e3],[1000e3,500e3]]]], "temperature":200} + ], + "composition models":[ + {"model":"uniform", "min depth":[[50e3,[[0,500e3]]],[200e3,[[1000e3,500e3]]]], "max depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]], "compositions":[0]}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]], "max depth":[[300e3],[200e3,[[0,500e3],[1000e3,500e3]]]], "compositions":[1]} + ], + "grains models":[ + {"model":"uniform", "compositions":[0,1],"rotation matrices":[[[1,2,3],[4,5,6],[7,8,9]],[[10,11,12],[13,14,15],[16,17,18]]],"grain sizes":[-1,0.2], + "min depth":[[50e3,[[0,500e3]]],[200e3,[[1000e3,500e3]]]], "max depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]]}, + {"model":"uniform", "compositions":[0,1],"rotation matrices":[[[19,20,21],[22,23,24],[25,26,27]],[[28,29,30],[31,32,33],[34,35,36]]],"grain sizes":[-1,0.3], + "min depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]], "max depth":[[300e3],[200e3,[[0,500e3],[1000e3,500e3]]]]} + ] + } +] +} diff --git a/tests/app/continental_min_max_surface/screen-output.log b/tests/app/continental_min_max_surface/screen-output.log new file mode 100644 index 000000000..aa384f884 --- /dev/null +++ b/tests/app/continental_min_max_surface/screen-output.log @@ -0,0 +1,55 @@ +# x y z d g T c0 c1 c2 c3 c4 gs0-0 gm0-0[0:0] gm0-0[0:1] gm0-0[0:2] gm0-0[1:0] gm0-0[1:1] gm0-0[1:2] gm0-0[2:0] gm0-0[2:1] gm0-0[2:2] gs0-1 gm0-1[0:0] gm0-1[0:1] gm0-1[0:2] gm0-1[1:0] gm0-1[1:1] gm0-1[1:2] gm0-1[2:0] gm0-1[2:1] gm0-1[2:2] gs1-0 gm1-0[0:0] gm1-0[0:1] gm1-0[0:2] gm1-0[1:0] gm1-0[1:1] gm1-0[1:2] gm1-0[2:0] gm1-0[2:1] gm1-0[2:2] gs1-1 gm1-1[0:0] gm1-1[0:1] gm1-1[0:2] gm1-1[1:0] gm1-1[1:1] gm1-1[1:2] gm1-1[2:0] gm1-1[2:1] gm1-1[2:2] +0 0 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 0 1 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 0 1 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 0 1 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 0 1 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +0 0 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 250e3 1 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 250e3 1 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 250e3 1 150e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +0 250e3 1 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +0 250e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 500e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 500e3 1 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 500e3 1 150e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +0 500e3 1 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 500e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 40e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 60e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 250e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 350e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 250e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 250e3 1 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 250e3 1 150e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +250e3 250e3 1 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +250e3 250e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 500e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 500e3 1 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 500e3 1 150e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +250e3 500e3 1 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 500e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +500e3 0 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +500e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +500e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +500e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +500e3 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +750e3 0 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +750e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +750e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +750e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +750e3 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1000e3 0 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1000e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1000e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1000e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1000e3 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 From bd1625db8cb73f07da9d0efd29dcee59eca39688 Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Thu, 24 Mar 2022 13:54:17 -0700 Subject: [PATCH 17/26] update type data and expand the unit tester. --- tests/data/type_data.json | 9 ++ tests/unit_tests/unit_test_world_builder.cc | 123 +++++++++++++++++++- 2 files changed, 128 insertions(+), 4 deletions(-) diff --git a/tests/data/type_data.json b/tests/data/type_data.json index 92f9b401d..925754d35 100644 --- a/tests/data/type_data.json +++ b/tests/data/type_data.json @@ -4,6 +4,15 @@ "string":"mystring 0", "2d point": [10, 11], "3d point": [12, 13, 14], +"one value at points one value": 200, +"one value at points one value string": "test1", +"array value at points one value": [[250]], +"array value at points one value string": [["test2"]], +"value at points default ap": [[100,[[1,2],[3,4]]],[200,[[5,6]]],[300,[[-10,10]]]], +"value at points set ap": [[100,[[1,2],[3,4]]],[105],[200,[[5,6]]],[300,[[-10,10]]]], +"value at points set ap val string": [[100,[[1,2],[3,4]]],[105],["test3",[[5,6]]],[300,[[-10,10]]]], +"value at points set ap p1 string": [[100,[[1,2],[3,4]]],[105],[200,[[5,6]]],[300,[["test4",10]]]], +"value at points set ap p2 string": [[100,[[1,2],[3,4]]],[105],[200,[[5,6]]],[300,[[-10,"test5"]]]], "unsigned int array" :[25,26,27], "bool array" :[true,false,true,false,true,false], "bool array nob" :[true,false,true,false,"True","false"], diff --git a/tests/unit_tests/unit_test_world_builder.cc b/tests/unit_tests/unit_test_world_builder.cc index ba7d58d01..eb7f2ad24 100644 --- a/tests/unit_tests/unit_test_world_builder.cc +++ b/tests/unit_tests/unit_test_world_builder.cc @@ -36,14 +36,18 @@ #include "world_builder/types/double.h" #include "world_builder/types/interface.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" #include "world_builder/types/plugin_system.h" #include "world_builder/types/point.h" #include "world_builder/types/segment.h" #include "world_builder/types/string.h" #include "world_builder/types/unsigned_int.h" +#include "world_builder/types/value_at_points.h" +#include "world_builder/objects/surface.h" #include "world_builder/utilities.h" #include "world_builder/world.h" + extern "C" { #include "world_builder/wrapper_c.h" } @@ -625,10 +629,11 @@ TEST_CASE("WorldBuilder Utilities: Natural Coordinate") CHECK(std::isnan(ivp1_array[0])); CHECK(std::isnan(ivp1_array[1])); CHECK(std::isnan(ivp1_array[2])); - CHECK_THROWS(ivp1.get_surface_coordinates()); - CHECK_THROWS(ivp1.get_depth_coordinate()); - CHECK_THROWS(ivp1.get_depth_coordinate()); - CHECK_THROWS(ivp1.get_ref_depth_coordinate()); + CHECK_THROWS_WITH(ivp1.get_surface_coordinates(),Contains("Coordinate system not implemented.")); + CHECK_THROWS_WITH(ivp1.get_surface_point(),Contains("Coordinate system not implemented.")); + CHECK_THROWS_WITH(ivp1.get_depth_coordinate(),Contains("Coordinate system not implemented.")); + CHECK_THROWS_WITH(ivp1.get_depth_coordinate(),Contains("Coordinate system not implemented.")); + CHECK_THROWS_WITH(ivp1.get_ref_depth_coordinate(),Contains("Coordinate system not implemented.")); CHECK(std::isnan(invalid->distance_between_points_at_same_depth(Point<3>(1,2,3,CoordinateSystem::invalid), Point<3>(1,2,3,CoordinateSystem::invalid)))); CHECK(invalid->depth_method() == DepthMethod::none); @@ -3886,6 +3891,116 @@ TEST_CASE("WorldBuilder Parameters") Contains("internal error: could not retrieve the default value at")); CHECK(prm.get("string") == "mystring 0"); + prm.enter_subsection("properties"); + + { + WorldBuilder::World world_temp(file_name); + Parameters prm_temp(world_temp); + prm_temp.declare_entry("test",Types::OneOf(Types::OneOf(Types::Double(101),Types::Double(102)),Types::Double(103)),"doc"); + + CHECK(rapidjson::Pointer("/test/oneOf/0/oneOf/0/default value").Get(prm_temp.declarations)->GetDouble() == Approx(101.)); + CHECK(rapidjson::Pointer("/test/oneOf/0/oneOf/1/default value").Get(prm_temp.declarations)->GetDouble() == Approx(102.)); + CHECK(rapidjson::Pointer("/test/oneOf/1/default value").Get(prm_temp.declarations)->GetDouble() == Approx(103.)); + } + prm.declare_entry("one value at points one value string",Types::OneOf(Types::Double(101.),Types::Array(Types::ValueAtPoints(101.))), + "Documentation"); + prm.declare_entry("array value at points one value string",Types::OneOf(Types::Double(101.),Types::Array(Types::ValueAtPoints(101.))), + "Documentation"); + prm.declare_entry("value at points set ap val string",Types::OneOf(Types::Double(101.),Types::Array(Types::ValueAtPoints(101.))), + "Documentation"); + prm.declare_entry("value at points set ap p1 string",Types::OneOf(Types::Double(101.),Types::Array(Types::ValueAtPoints(101.))), + "Documentation"); + prm.declare_entry("value at points set ap p2 string",Types::OneOf(Types::Double(101.),Types::Array(Types::ValueAtPoints(101.))), + "Documentation"); + prm.declare_entry("one value at points one value",Types::OneOf(Types::Double(101.),Types::Array(Types::ValueAtPoints(101.))), + "Documentation"); + prm.declare_entry("array value at points one value",Types::OneOf(Types::Double(101.),Types::Array(Types::ValueAtPoints(101.))), + "Documentation"); + prm.declare_entry("value at points",Types::OneOf(Types::Double(101.),Types::Array(Types::ValueAtPoints(101.))), + "Documentation"); + prm.declare_entry("value at points default ap",Types::OneOf(Types::Double(101.),Types::Array(Types::ValueAtPoints(101.))), + "Documentation"); + prm.leave_subsection(); + std::vector > additional_points = {Point<2>(-10,-10,cartesian),Point<2>(-10,10,cartesian), + Point<2>(10,10,cartesian),Point<2>(10,-10,cartesian) + }; + CHECK_THROWS_WITH(prm.get("value at points non existant",additional_points), Contains("internal error: could not retrieve")); + std::pair,std::vector> v_at_p_one_value = prm.get("one value at points one value",additional_points); + + CHECK(v_at_p_one_value.first.size() == 1); + CHECK(v_at_p_one_value.first[0] == Approx(200)); + CHECK(v_at_p_one_value.second.size() == 0); + + { + Objects::Surface surface(v_at_p_one_value); + CHECK(surface.local_value(Point<2>(0,0,CoordinateSystem::cartesian)) == Approx(200.)); + } + std::pair,std::vector> v_at_p_one_array_value = prm.get("array value at points one value",additional_points); + + CHECK(v_at_p_one_array_value.first.size() == 1); + CHECK(v_at_p_one_array_value.first[0] == Approx(250)); + CHECK(v_at_p_one_array_value.second.size() == 0); + + std::pair,std::vector> v_at_p_full_default = prm.get("value at points",additional_points); + + CHECK(v_at_p_full_default.first.size() == 1); + CHECK(v_at_p_full_default.first[0] == Approx(101)); + CHECK(v_at_p_full_default.second.size() == 0); + + std::pair,std::vector> v_at_p_dap = prm.get("value at points default ap",additional_points); + + CHECK(v_at_p_dap.first.size() == 7); + CHECK(v_at_p_dap.first[0] == Approx(101)); + CHECK(v_at_p_dap.first[1] == Approx(300)); + CHECK(v_at_p_dap.first[2] == Approx(101)); + CHECK(v_at_p_dap.first[3] == Approx(101)); + CHECK(v_at_p_dap.first[4] == Approx(100)); + CHECK(v_at_p_dap.first[5] == Approx(100)); + CHECK(v_at_p_dap.first[6] == Approx(200)); + CHECK(v_at_p_dap.second.size() == 14); + CHECK(v_at_p_dap.second[0] == Approx(-10)); + CHECK(v_at_p_dap.second[1] == Approx(-10)); + CHECK(v_at_p_dap.second[2] == Approx(-10)); + CHECK(v_at_p_dap.second[3] == Approx(10)); + CHECK(v_at_p_dap.second[4] == Approx(10)); + CHECK(v_at_p_dap.second[5] == Approx(10)); + CHECK(v_at_p_dap.second[6] == Approx(10)); + CHECK(v_at_p_dap.second[7] == Approx(-10)); + CHECK(v_at_p_dap.second[8] == Approx(1)); + CHECK(v_at_p_dap.second[9] == Approx(2)); + CHECK(v_at_p_dap.second[10] == Approx(3)); + CHECK(v_at_p_dap.second[11] == Approx(4)); + CHECK(v_at_p_dap.second[12] == Approx(5)); + CHECK(v_at_p_dap.second[13] == Approx(6)); + + { + Objects::Surface surface(v_at_p_dap); + + CHECK(surface.local_value(Point<2>(0,0,CoordinateSystem::cartesian)) == Approx(100.1666666667)); + CHECK(surface.local_value(Point<2>(0.99,1.99,CoordinateSystem::cartesian)) == Approx(100.0099545455)); + CHECK(surface.local_value(Point<2>(1.01,2.01,CoordinateSystem::cartesian)) == Approx(100.)); + CHECK(surface.local_value(Point<2>(0.99,0.99,CoordinateSystem::cartesian)) == Approx(100.0841666667)); + CHECK(surface.local_value(Point<2>(1.01,1.01,CoordinateSystem::cartesian)) == Approx(100.0825)); + CHECK(surface.local_value(Point<2>(2.99,3.99,CoordinateSystem::cartesian)) == Approx(100.)); + CHECK(surface.local_value(Point<2>(2.01,4.01,CoordinateSystem::cartesian)) == Approx(110.5263157895)); + CHECK(surface.local_value(Point<2>(-0.5,7.48,CoordinateSystem::cartesian)) == Approx(236.5025)); + CHECK(surface.local_value(Point<2>(-1,7.6,CoordinateSystem::cartesian)) == Approx(240.0)); + CHECK(surface.local_value(Point<2>(-2.4,8.2,CoordinateSystem::cartesian)) == Approx(246.5425)); + CHECK_THROWS_WITH(surface.local_value(Point<2>(11,11,CoordinateSystem::cartesian)), Contains("The requested point was not in any triangle.")); + } + + + CHECK_THROWS_WITH(prm.get("one value at points one value string",additional_points), + Contains("Could not convert values of /one value at points one value string into a double. The provided value was \"test1\".")); + CHECK_THROWS_WITH(prm.get("array value at points one value string",additional_points), + Contains("Could not convert values of /array value at points one value string/0/0 into a double. The provided value was \"test2\".")); + CHECK_THROWS_WITH(prm.get("value at points set ap val string",additional_points), + Contains("Could not convert values of /value at points set ap val string/2/0 into doubles. The provided value was \"test3\".")); + CHECK_THROWS_WITH(prm.get("value at points set ap p1 string",additional_points), + Contains("Could not convert values of /value at points set ap p1 string/3/1/0/0 into a Point<2> array, because it could not convert the 1st sub-elements into doubles. The provided value was \"test4\".")); + CHECK_THROWS_WITH(prm.get("value at points set ap p2 string",additional_points), + Contains("Could not convert values of /value at points set ap p2 string/3/1/0/1 into a Point<2> array, because it could not convert the 2nd sub-elements into doubles. The provided value was \"test5\".")); + CHECK_THROWS_WITH(prm.get_vector("non existent unsigned int vector"), Contains("internal error: could not retrieve the minItems value at")); From f3a6e491155321205e875775666259cf9f3ccae9 Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Fri, 25 Mar 2022 15:41:10 -0700 Subject: [PATCH 18/26] Add min an max surfaces to oceanic plates. --- .../world_builder/features/oceanic_plate.h | 3 + .../composition/interface.h | 4 +- .../composition/uniform.h | 6 +- .../oceanic_plate_models/grains/interface.h | 4 +- .../grains/random_uniform_distribution.h | 9 +- .../oceanic_plate_models/grains/uniform.h | 9 +- .../temperature/adiabatic.h | 6 +- .../temperature/half_space_model.h | 6 +- .../temperature/interface.h | 4 +- .../oceanic_plate_models/temperature/linear.h | 6 +- .../temperature/plate_model.h | 6 +- .../temperature/plate_model_constant_age.h | 6 +- .../temperature/uniform.h | 6 +- source/features/oceanic_plate.cc | 118 ++++++---- .../composition/uniform.cc | 33 ++- .../grains/random_uniform_distribution.cc | 175 +++++++------- .../oceanic_plate_models/grains/uniform.cc | 33 ++- .../temperature/adiabatic.cc | 56 +++-- .../temperature/half_space_model.cc | 193 ++++++++-------- .../temperature/linear.cc | 66 +++--- .../temperature/plate_model.cc | 213 +++++++++--------- .../temperature/plate_model_constant_age.cc | 91 ++++---- .../temperature/uniform.cc | 24 +- 23 files changed, 625 insertions(+), 452 deletions(-) diff --git a/include/world_builder/features/oceanic_plate.h b/include/world_builder/features/oceanic_plate.h index c5e4a8ca4..910b8c2b9 100644 --- a/include/world_builder/features/oceanic_plate.h +++ b/include/world_builder/features/oceanic_plate.h @@ -22,6 +22,7 @@ #include "world_builder/features/interface.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder @@ -147,7 +148,9 @@ namespace WorldBuilder std::vector > grains_models; double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; }; } // namespace Features } // namespace WorldBuilder diff --git a/include/world_builder/features/oceanic_plate_models/composition/interface.h b/include/world_builder/features/oceanic_plate_models/composition/interface.h index 27f42e701..dabef6592 100644 --- a/include/world_builder/features/oceanic_plate_models/composition/interface.h +++ b/include/world_builder/features/oceanic_plate_models/composition/interface.h @@ -22,6 +22,7 @@ #include "world_builder/parameters.h" +#include "world_builder/utilities.h" namespace WorldBuilder @@ -69,7 +70,7 @@ namespace WorldBuilder * declare and read in the world builder file into the parameters class */ virtual - void parse_entries(Parameters &prm) = 0; + void parse_entries(Parameters &prm, const std::vector> &coordinates) = 0; /** @@ -77,6 +78,7 @@ namespace WorldBuilder */ virtual double get_composition(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const unsigned int composition_number, double composition, diff --git a/include/world_builder/features/oceanic_plate_models/composition/uniform.h b/include/world_builder/features/oceanic_plate_models/composition/uniform.h index 1a3eefc07..cdc3a964a 100644 --- a/include/world_builder/features/oceanic_plate_models/composition/uniform.h +++ b/include/world_builder/features/oceanic_plate_models/composition/uniform.h @@ -22,6 +22,7 @@ #include "world_builder/features/oceanic_plate_models/composition/interface.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder @@ -61,7 +62,7 @@ namespace WorldBuilder /** * declare and read in the world builder file into the parameters class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** @@ -69,6 +70,7 @@ namespace WorldBuilder * gravity and current composition. */ double get_composition(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const unsigned int composition_number, double composition, @@ -79,7 +81,9 @@ namespace WorldBuilder private: // uniform composition submodule parameters double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; std::vector compositions; std::vector fractions; std::string operation; diff --git a/include/world_builder/features/oceanic_plate_models/grains/interface.h b/include/world_builder/features/oceanic_plate_models/grains/interface.h index a587d35c1..b4aa5d31b 100644 --- a/include/world_builder/features/oceanic_plate_models/grains/interface.h +++ b/include/world_builder/features/oceanic_plate_models/grains/interface.h @@ -23,6 +23,7 @@ #include "world_builder/grains.h" #include "world_builder/parameters.h" +#include "world_builder/utilities.h" namespace WorldBuilder @@ -66,7 +67,7 @@ namespace WorldBuilder * declare and read in the world builder file into the parameters class */ virtual - void parse_entries(Parameters &prm) = 0; + void parse_entries(Parameters &prm, const std::vector> &coordinates) = 0; /** @@ -75,6 +76,7 @@ namespace WorldBuilder virtual WorldBuilder::grains get_grains(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const unsigned int composition_number, WorldBuilder::grains grains, diff --git a/include/world_builder/features/oceanic_plate_models/grains/random_uniform_distribution.h b/include/world_builder/features/oceanic_plate_models/grains/random_uniform_distribution.h index 4f85dd28a..2bf872e95 100644 --- a/include/world_builder/features/oceanic_plate_models/grains/random_uniform_distribution.h +++ b/include/world_builder/features/oceanic_plate_models/grains/random_uniform_distribution.h @@ -22,6 +22,7 @@ #include "world_builder/features/oceanic_plate_models/grains/interface.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder { @@ -78,14 +79,16 @@ namespace WorldBuilder * declare and read in the world builder file into the parameters * class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** * Returns a grains based on the given position, composition (e.g. * olivine and/or enstatite)depth in the model, gravity and current grains. */ WorldBuilder::grains - get_grains(const Point<3> &position, const double depth, + get_grains(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, + const double depth, const unsigned int composition_number, WorldBuilder::grains grains, const double feature_min_depth, @@ -94,7 +97,9 @@ namespace WorldBuilder private: // uniform grains submodule parameters double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; std::vector grains; std::vector compositions; std::string operation; diff --git a/include/world_builder/features/oceanic_plate_models/grains/uniform.h b/include/world_builder/features/oceanic_plate_models/grains/uniform.h index f11d6873f..a8a3b7456 100644 --- a/include/world_builder/features/oceanic_plate_models/grains/uniform.h +++ b/include/world_builder/features/oceanic_plate_models/grains/uniform.h @@ -22,6 +22,7 @@ #include "world_builder/features/oceanic_plate_models/grains/interface.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder { @@ -78,14 +79,16 @@ namespace WorldBuilder * declare and read in the world builder file into the parameters * class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** * Returns a grains based on the given position, composition (e.g. * olivine and/or enstatite)depth in the model, gravity and current grains. */ WorldBuilder::grains - get_grains(const Point<3> &position, const double depth, + get_grains(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, + const double depth, const unsigned int composition_number, WorldBuilder::grains grains, const double feature_min_depth, @@ -94,7 +97,9 @@ namespace WorldBuilder private: // uniform grains submodule parameters double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; std::vector grains; std::vector compositions; std::string operation; diff --git a/include/world_builder/features/oceanic_plate_models/temperature/adiabatic.h b/include/world_builder/features/oceanic_plate_models/temperature/adiabatic.h index 0fe71cd3b..e7adba330 100644 --- a/include/world_builder/features/oceanic_plate_models/temperature/adiabatic.h +++ b/include/world_builder/features/oceanic_plate_models/temperature/adiabatic.h @@ -23,6 +23,7 @@ #include "world_builder/features/oceanic_plate_models/temperature/interface.h" #include "world_builder/features/utilities.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder @@ -62,7 +63,7 @@ namespace WorldBuilder /** * declare and read in the world builder file into the parameters class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** @@ -70,6 +71,7 @@ namespace WorldBuilder * gravity and current temperature. */ double get_temperature(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity, double temperature, @@ -80,7 +82,9 @@ namespace WorldBuilder private: // adiabatic temperature submodule parameters double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; /** * Todo */ diff --git a/include/world_builder/features/oceanic_plate_models/temperature/half_space_model.h b/include/world_builder/features/oceanic_plate_models/temperature/half_space_model.h index c694ed1cc..518611666 100644 --- a/include/world_builder/features/oceanic_plate_models/temperature/half_space_model.h +++ b/include/world_builder/features/oceanic_plate_models/temperature/half_space_model.h @@ -23,6 +23,7 @@ #include "world_builder/features/oceanic_plate_models/temperature/interface.h" #include "world_builder/features/utilities.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder @@ -64,7 +65,7 @@ namespace WorldBuilder /** * declare and read in the world builder file into the parameters class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** @@ -72,6 +73,7 @@ namespace WorldBuilder * gravity and current temperature. */ double get_temperature(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity, double temperature, @@ -82,7 +84,9 @@ namespace WorldBuilder private: // plate model temperature submodule parameters double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; double top_temperature; double bottom_temperature; double spreading_velocity; diff --git a/include/world_builder/features/oceanic_plate_models/temperature/interface.h b/include/world_builder/features/oceanic_plate_models/temperature/interface.h index a6decedf9..4b1eb79ae 100644 --- a/include/world_builder/features/oceanic_plate_models/temperature/interface.h +++ b/include/world_builder/features/oceanic_plate_models/temperature/interface.h @@ -22,6 +22,7 @@ #include "world_builder/parameters.h" +#include "world_builder/utilities.h" namespace WorldBuilder @@ -69,7 +70,7 @@ namespace WorldBuilder * declare and read in the world builder file into the parameters class */ virtual - void parse_entries(Parameters &prm) = 0; + void parse_entries(Parameters &prm, const std::vector> &coordinates) = 0; /** @@ -77,6 +78,7 @@ namespace WorldBuilder */ virtual double get_temperature(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity, double temperature, diff --git a/include/world_builder/features/oceanic_plate_models/temperature/linear.h b/include/world_builder/features/oceanic_plate_models/temperature/linear.h index bfccf2436..55d153816 100644 --- a/include/world_builder/features/oceanic_plate_models/temperature/linear.h +++ b/include/world_builder/features/oceanic_plate_models/temperature/linear.h @@ -23,6 +23,7 @@ #include "world_builder/features/oceanic_plate_models/temperature/interface.h" #include "world_builder/features/utilities.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder @@ -62,7 +63,7 @@ namespace WorldBuilder /** * declare and read in the world builder file into the parameters class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** @@ -70,6 +71,7 @@ namespace WorldBuilder * gravity and current temperature. */ double get_temperature(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity, double temperature, @@ -80,7 +82,9 @@ namespace WorldBuilder private: // linear temperature submodule parameters double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; double top_temperature; double bottom_temperature; Utilities::Operations operation; diff --git a/include/world_builder/features/oceanic_plate_models/temperature/plate_model.h b/include/world_builder/features/oceanic_plate_models/temperature/plate_model.h index 57b225887..e0b7fd754 100644 --- a/include/world_builder/features/oceanic_plate_models/temperature/plate_model.h +++ b/include/world_builder/features/oceanic_plate_models/temperature/plate_model.h @@ -23,6 +23,7 @@ #include "world_builder/features/oceanic_plate_models/temperature/interface.h" #include "world_builder/features/utilities.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder @@ -67,7 +68,7 @@ namespace WorldBuilder /** * declare and read in the world builder file into the parameters class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** @@ -75,6 +76,7 @@ namespace WorldBuilder * gravity and current temperature. */ double get_temperature(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity, double temperature, @@ -85,7 +87,9 @@ namespace WorldBuilder private: // plate model temperature submodule parameters double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; double top_temperature; double bottom_temperature; double spreading_velocity; diff --git a/include/world_builder/features/oceanic_plate_models/temperature/plate_model_constant_age.h b/include/world_builder/features/oceanic_plate_models/temperature/plate_model_constant_age.h index d007947f9..e3ab5ed8c 100644 --- a/include/world_builder/features/oceanic_plate_models/temperature/plate_model_constant_age.h +++ b/include/world_builder/features/oceanic_plate_models/temperature/plate_model_constant_age.h @@ -23,6 +23,7 @@ #include "world_builder/features/oceanic_plate_models/temperature/interface.h" #include "world_builder/features/utilities.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder @@ -67,7 +68,7 @@ namespace WorldBuilder /** * declare and read in the world builder file into the parameters class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** @@ -75,6 +76,7 @@ namespace WorldBuilder * gravity and current temperature. */ double get_temperature(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity, double temperature, @@ -85,7 +87,9 @@ namespace WorldBuilder private: // plate model constant age temperature submodule parameters double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; double top_temperature; double bottom_temperature; double plate_age; diff --git a/include/world_builder/features/oceanic_plate_models/temperature/uniform.h b/include/world_builder/features/oceanic_plate_models/temperature/uniform.h index 386a2e099..c29238fd5 100644 --- a/include/world_builder/features/oceanic_plate_models/temperature/uniform.h +++ b/include/world_builder/features/oceanic_plate_models/temperature/uniform.h @@ -23,6 +23,7 @@ #include "world_builder/features/oceanic_plate_models/temperature/interface.h" #include "world_builder/features/utilities.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder @@ -62,7 +63,7 @@ namespace WorldBuilder /** * declare and read in the world builder file into the parameters class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** @@ -70,6 +71,7 @@ namespace WorldBuilder * gravity and current temperature. */ double get_temperature(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity, double temperature, @@ -80,7 +82,9 @@ namespace WorldBuilder private: // uniform temperature submodule parameters double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; double temperature; Utilities::Operations operation; diff --git a/source/features/oceanic_plate.cc b/source/features/oceanic_plate.cc index 8a145340a..623e423d9 100644 --- a/source/features/oceanic_plate.cc +++ b/source/features/oceanic_plate.cc @@ -19,14 +19,17 @@ #include "world_builder/features/oceanic_plate.h" - #include "world_builder/features/oceanic_plate_models/composition/interface.h" #include "world_builder/features/oceanic_plate_models/grains/interface.h" #include "world_builder/features/oceanic_plate_models/temperature/interface.h" #include "world_builder/nan.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/array.h" +#include "world_builder/types/one_of.h" +#include "world_builder/types/value_at_points.h" #include "world_builder/types/plugin_system.h" +#include "world_builder/kd_tree.h" #include "world_builder/world.h" @@ -56,9 +59,9 @@ namespace WorldBuilder { prm.declare_entry("", Types::Object(required_entries), "Oceanic plate object"); - prm.declare_entry("min depth", Types::Double(0), - "The depth to which this feature is present"); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), + "The depth from which this feature is present"); + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth to which this feature is present"); prm.declare_entry("temperature models", Types::PluginSystem("", Features::OceanicPlateModels::Temperature::Interface::declare_entries, {"model"}), @@ -80,8 +83,11 @@ namespace WorldBuilder this->name = prm.get("name"); this->get_coordinates("coordinates", prm, coordinate_system); - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; prm.get_unique_pointers("temperature models", temperature_models); @@ -92,7 +98,7 @@ namespace WorldBuilder { prm.enter_subsection(std::to_string(i)); { - temperature_models[i]->parse_entries(prm); + temperature_models[i]->parse_entries(prm,coordinates); } prm.leave_subsection(); } @@ -108,7 +114,7 @@ namespace WorldBuilder { prm.enter_subsection(std::to_string(i)); { - composition_models[i]->parse_entries(prm); + composition_models[i]->parse_entries(prm,coordinates); } prm.leave_subsection(); } @@ -124,7 +130,7 @@ namespace WorldBuilder { prm.enter_subsection(std::to_string(i)); { - grains_models[i]->parse_entries(prm); + grains_models[i]->parse_entries(prm,coordinates); } prm.leave_subsection(); } @@ -144,20 +150,26 @@ namespace WorldBuilder WorldBuilder::Utilities::polygon_contains_point(coordinates, Point<2>(position_in_natural_coordinates.get_surface_coordinates(), world->parameters.coordinate_system->natural_coordinate_system()))) { - for (const auto &temperature_model: temperature_models) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - temperature = temperature_model->get_temperature(position_in_cartesian_coordinates, - depth, - gravity_norm, - temperature, - min_depth, - max_depth); - - WBAssert(!std::isnan(temperature), "Temparture is not a number: " << temperature - << ", based on a temperature model with the name " << temperature_model->get_name()); - WBAssert(std::isfinite(temperature), "Temparture is not a finite: " << temperature - << ", based on a temperature model with the name " << temperature_model->get_name()); - + for (const auto &temperature_model: temperature_models) + { + temperature = temperature_model->get_temperature(position_in_cartesian_coordinates, + position_in_natural_coordinates, + depth, + gravity_norm, + temperature, + min_depth_local, + max_depth_local); + + WBAssert(!std::isnan(temperature), "Temparture is not a number: " << temperature + << ", based on a temperature model with the name " << temperature_model->get_name()); + WBAssert(std::isfinite(temperature), "Temparture is not a finite: " << temperature + << ", based on a temperature model with the name " << temperature_model->get_name()); + + } } } @@ -175,19 +187,25 @@ namespace WorldBuilder WorldBuilder::Utilities::polygon_contains_point(coordinates, Point<2>(position_in_natural_coordinates.get_surface_coordinates(), world->parameters.coordinate_system->natural_coordinate_system()))) { - for (const auto &composition_model: composition_models) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - composition = composition_model->get_composition(position_in_cartesian_coordinates, - depth, - composition_number, - composition, - min_depth, - max_depth); - - WBAssert(!std::isnan(composition), "Composition is not a number: " << composition - << ", based on a temperature model with the name " << composition_model->get_name()); - WBAssert(std::isfinite(composition), "Composition is not a finite: " << composition - << ", based on a temperature model with the name " << composition_model->get_name()); + for (const auto &composition_model: composition_models) + { + composition = composition_model->get_composition(position_in_cartesian_coordinates, + position_in_natural_coordinates, + depth, + composition_number, + composition, + min_depth_local, + max_depth_local); + + WBAssert(!std::isnan(composition), "Composition is not a number: " << composition + << ", based on a temperature model with the name " << composition_model->get_name()); + WBAssert(std::isfinite(composition), "Composition is not a finite: " << composition + << ", based on a temperature model with the name " << composition_model->get_name()); + } } } @@ -206,20 +224,26 @@ namespace WorldBuilder WorldBuilder::Utilities::polygon_contains_point(coordinates, Point<2>(position_in_natural_coordinates.get_surface_coordinates(), world->parameters.coordinate_system->natural_coordinate_system()))) { - for (const auto &grains_model: grains_models) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - grains = grains_model->get_grains(position_in_cartesian_coordinates, - depth, - composition_number, - grains, - min_depth, - max_depth); - - /*WBAssert(!std::isnan(composition), "Composition is not a number: " << composition - << ", based on a temperature model with the name " << composition_model->get_name()); - WBAssert(std::isfinite(composition), "Composition is not a finite: " << composition - << ", based on a temperature model with the name " << composition_model->get_name());*/ - + for (const auto &grains_model: grains_models) + { + grains = grains_model->get_grains(position_in_cartesian_coordinates, + position_in_natural_coordinates, + depth, + composition_number, + grains, + min_depth_local, + max_depth_local); + + /*WBAssert(!std::isnan(composition), "Composition is not a number: " << composition + << ", based on a temperature model with the name " << composition_model->get_name()); + WBAssert(std::isfinite(composition), "Composition is not a finite: " << composition + << ", based on a temperature model with the name " << composition_model->get_name());*/ + + } } } diff --git a/source/features/oceanic_plate_models/composition/uniform.cc b/source/features/oceanic_plate_models/composition/uniform.cc index 9c738d3c0..a87818117 100644 --- a/source/features/oceanic_plate_models/composition/uniform.cc +++ b/source/features/oceanic_plate_models/composition/uniform.cc @@ -24,7 +24,10 @@ #include "world_builder/types/array.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" +#include "world_builder/types/value_at_points.h" #include "world_builder/types/unsigned_int.h" +#include "world_builder/kd_tree.h" #include "world_builder/utilities.h" @@ -61,9 +64,9 @@ namespace WorldBuilder "Uniform compositional model. Sets constant compositional field."); // Declare entries of this plugin - prm.declare_entry("min depth", Types::Double(0), + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), "The depth in meters from which the composition of this feature is present."); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth in meters to which the composition of this feature is present."); prm.declare_entry("compositions", Types::Array(Types::UnsignedInt(),0), "A list with the labels of the composition which are present there."); @@ -77,10 +80,12 @@ namespace WorldBuilder } void - Uniform::parse_entries(Parameters &prm) + Uniform::parse_entries(Parameters &prm, const std::vector> &coordinates) { - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; compositions = prm.get_vector("compositions"); fractions = prm.get_vector("fractions"); operation = prm.get("operation"); @@ -92,6 +97,7 @@ namespace WorldBuilder double Uniform::get_composition(const Point<3> & /*position_in_cartesian_coordinates*/, + const NaturalCoordinate &position_in_natural_coordinates, const double depth, const unsigned int composition_number, double composition_, @@ -101,16 +107,21 @@ namespace WorldBuilder double composition = composition_; if (depth <= max_depth && depth >= min_depth) { - for (unsigned int i =0; i < compositions.size(); ++i) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - if (compositions[i] == composition_number) + for (unsigned int i =0; i < compositions.size(); ++i) { - return fractions[i]; + if (compositions[i] == composition_number) + { + return fractions[i]; + } } - } - if (operation == "replace") - return 0.0; + if (operation == "replace") + return 0.0; + } } return composition; } diff --git a/source/features/oceanic_plate_models/grains/random_uniform_distribution.cc b/source/features/oceanic_plate_models/grains/random_uniform_distribution.cc index 8274dad4c..a5f7d4869 100644 --- a/source/features/oceanic_plate_models/grains/random_uniform_distribution.cc +++ b/source/features/oceanic_plate_models/grains/random_uniform_distribution.cc @@ -26,7 +26,10 @@ #include "world_builder/types/bool.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" +#include "world_builder/types/value_at_points.h" #include "world_builder/types/unsigned_int.h" +#include "world_builder/kd_tree.h" #include "world_builder/utilities.h" #include "world_builder/world.h" @@ -63,9 +66,9 @@ namespace WorldBuilder "to a single value or to a random distribution."); // Declare entries of this plugin - prm.declare_entry("min depth", Types::Double(0), + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), "The depth in meters from which the composition of this feature is present."); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth in meters to which the composition of this feature is present."); prm.declare_entry("compositions", Types::Array(Types::UnsignedInt(),0), @@ -89,10 +92,12 @@ namespace WorldBuilder } void - RandomUniformDistribution::parse_entries(Parameters &prm) + RandomUniformDistribution::parse_entries(Parameters &prm, const std::vector> &coordinates) { - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; compositions = prm.get_vector("compositions"); operation = prm.get("orientation operation"); @@ -111,6 +116,7 @@ namespace WorldBuilder WorldBuilder::grains RandomUniformDistribution::get_grains(const Point<3> & /*position_in_cartesian_coordinates*/, + const NaturalCoordinate &position_in_natural_coordinates, const double depth, const unsigned int composition_number, WorldBuilder::grains grains_, @@ -120,87 +126,92 @@ namespace WorldBuilder WorldBuilder::grains grains_local = grains_; if (depth <= max_depth && depth >= min_depth) { - for (unsigned int i =0; i < compositions.size(); ++i) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - if (compositions[i] == composition_number) + for (unsigned int i =0; i < compositions.size(); ++i) { - std::uniform_real_distribution<> dist(0.0,1.0); - for (auto &&it_rotation_matrices : grains_local.rotation_matrices) + if (compositions[i] == composition_number) { - // set a uniform random a_cosine_matrix per grain - // This function is based on an article in Graphic Gems III, written by James Arvo, Cornell University (p 116-120). - // The original code can be found on http://www.realtimerendering.com/resources/GraphicsGems/gemsiii/rand_rotation.c - // and is licenend accourding to this website with the following licence: - // - // "The Graphics Gems code is copyright-protected. In other words, you cannot claim the text of the code as your own and - // resell it. Using the code is permitted in any program, product, or library, non-commercial or commercial. Giving credit - // is not required, though is a nice gesture. The code comes as-is, and if there are any flaws or problems with any Gems - // code, nobody involved with Gems - authors, editors, publishers, or webmasters - are to be held responsible. Basically, - // don't be a jerk, and remember that anything free comes with no guarantee."" - // - // The book saids in the preface the following: "As in the first two volumes, all of the C and C++ code in this book is in - // the public domain, and is yours to study, modify, and use." - - // first generate three random numbers between 0 and 1 and multiply them with 2 PI or 2 for z. Note that these are not the same as phi_1, theta and phi_2. - double one = dist(world->get_random_number_engine()); - double two = dist(world->get_random_number_engine()); - double three = dist(world->get_random_number_engine()); - - double theta = 2.0 * const_pi * one; // Rotation about the pole (Z) - double phi = 2.0 * const_pi * two; // For direction of pole deflection. - double z = 2.0* three; //For magnitude of pole deflection. - - // Compute a vector V used for distributing points over the sphere - // via the reflection I - V Transpose(V). This formulation of V - // will guarantee that if x[1] and x[2] are uniformly distributed, - // the reflected points will be uniform on the sphere. Note that V - // has length sqrt(2) to eliminate the 2 in the Householder matrix. - - double r = std::sqrt( z ); - double Vx = std::sin( phi ) * r; - double Vy = std::cos( phi ) * r; - double Vz = std::sqrt( 2.F - z ); - - // Compute the row vector S = Transpose(V) * R, where R is a simple - // rotation by theta about the z-axis. No need to compute Sz since - // it's just Vz. - - double st = std::sin( theta ); - double ct = std::cos( theta ); - double Sx = Vx * ct - Vy * st; - double Sy = Vx * st + Vy * ct; - - // Construct the rotation matrix ( V Transpose(V) - I ) R, which - // is equivalent to V S - R. - - it_rotation_matrices[0][0] = Vx * Sx - ct; - it_rotation_matrices[0][1] = Vx * Sy - st; - it_rotation_matrices[0][2] = Vx * Vz; - - it_rotation_matrices[1][0] = Vy * Sx + st; - it_rotation_matrices[1][1] = Vy * Sy - ct; - it_rotation_matrices[1][2] = Vy * Vz; - - it_rotation_matrices[2][0] = Vz * Sx; - it_rotation_matrices[2][1] = Vz * Sy; - it_rotation_matrices[2][2] = 1.0 - z; // This equals Vz * Vz - 1.0 + std::uniform_real_distribution<> dist(0.0,1.0); + for (auto &&it_rotation_matrices : grains_local.rotation_matrices) + { + // set a uniform random a_cosine_matrix per grain + // This function is based on an article in Graphic Gems III, written by James Arvo, Cornell University (p 116-120). + // The original code can be found on http://www.realtimerendering.com/resources/GraphicsGems/gemsiii/rand_rotation.c + // and is licenend accourding to this website with the following licence: + // + // "The Graphics Gems code is copyright-protected. In other words, you cannot claim the text of the code as your own and + // resell it. Using the code is permitted in any program, product, or library, non-commercial or commercial. Giving credit + // is not required, though is a nice gesture. The code comes as-is, and if there are any flaws or problems with any Gems + // code, nobody involved with Gems - authors, editors, publishers, or webmasters - are to be held responsible. Basically, + // don't be a jerk, and remember that anything free comes with no guarantee."" + // + // The book saids in the preface the following: "As in the first two volumes, all of the C and C++ code in this book is in + // the public domain, and is yours to study, modify, and use." + + // first generate three random numbers between 0 and 1 and multiply them with 2 PI or 2 for z. Note that these are not the same as phi_1, theta and phi_2. + double one = dist(world->get_random_number_engine()); + double two = dist(world->get_random_number_engine()); + double three = dist(world->get_random_number_engine()); + + double theta = 2.0 * const_pi * one; // Rotation about the pole (Z) + double phi = 2.0 * const_pi * two; // For direction of pole deflection. + double z = 2.0* three; //For magnitude of pole deflection. + + // Compute a vector V used for distributing points over the sphere + // via the reflection I - V Transpose(V). This formulation of V + // will guarantee that if x[1] and x[2] are uniformly distributed, + // the reflected points will be uniform on the sphere. Note that V + // has length sqrt(2) to eliminate the 2 in the Householder matrix. + + double r = std::sqrt( z ); + double Vx = std::sin( phi ) * r; + double Vy = std::cos( phi ) * r; + double Vz = std::sqrt( 2.F - z ); + + // Compute the row vector S = Transpose(V) * R, where R is a simple + // rotation by theta about the z-axis. No need to compute Sz since + // it's just Vz. + + double st = std::sin( theta ); + double ct = std::cos( theta ); + double Sx = Vx * ct - Vy * st; + double Sy = Vx * st + Vy * ct; + + // Construct the rotation matrix ( V Transpose(V) - I ) R, which + // is equivalent to V S - R. + + it_rotation_matrices[0][0] = Vx * Sx - ct; + it_rotation_matrices[0][1] = Vx * Sy - st; + it_rotation_matrices[0][2] = Vx * Vz; + + it_rotation_matrices[1][0] = Vy * Sx + st; + it_rotation_matrices[1][1] = Vy * Sy - ct; + it_rotation_matrices[1][2] = Vy * Vz; + + it_rotation_matrices[2][0] = Vz * Sx; + it_rotation_matrices[2][1] = Vz * Sy; + it_rotation_matrices[2][2] = 1.0 - z; // This equals Vz * Vz - 1.0 + } + + double total_size = 0; + for (auto &&it_sizes : grains_local.sizes) + { + it_sizes = grain_sizes[i] < 0 ? dist(world->get_random_number_engine()) : grain_sizes[i]; + total_size += it_sizes; + } + + if (normalize_grain_sizes[i]) + { + double one_over_total_size = 1/total_size; + std::transform(grains_local.sizes.begin(), grains_local.sizes.end(), grains_local.sizes.begin(), + [one_over_total_size](double sizes) -> double { return sizes *one_over_total_size; }); + } + + return grains_local; } - - double total_size = 0; - for (auto &&it_sizes : grains_local.sizes) - { - it_sizes = grain_sizes[i] < 0 ? dist(world->get_random_number_engine()) : grain_sizes[i]; - total_size += it_sizes; - } - - if (normalize_grain_sizes[i]) - { - double one_over_total_size = 1/total_size; - std::transform(grains_local.sizes.begin(), grains_local.sizes.end(), grains_local.sizes.begin(), - [one_over_total_size](double sizes) -> double { return sizes *one_over_total_size; }); - } - - return grains_local; } } } diff --git a/source/features/oceanic_plate_models/grains/uniform.cc b/source/features/oceanic_plate_models/grains/uniform.cc index 06b2c8033..fbb0f0c3f 100644 --- a/source/features/oceanic_plate_models/grains/uniform.cc +++ b/source/features/oceanic_plate_models/grains/uniform.cc @@ -24,7 +24,10 @@ #include "world_builder/types/array.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" +#include "world_builder/types/value_at_points.h" #include "world_builder/types/unsigned_int.h" +#include "world_builder/kd_tree.h" #include "world_builder/utilities.h" @@ -61,9 +64,9 @@ namespace WorldBuilder "Uniform grains model. All grains start exactly the same."); // Declare entries of this plugin - prm.declare_entry("min depth", Types::Double(0), + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), "The depth in meters from which the composition of this feature is present."); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth in meters to which the composition of this feature is present."); prm.declare_entry("compositions", Types::Array(Types::UnsignedInt(),0), @@ -88,10 +91,12 @@ namespace WorldBuilder } void - Uniform::parse_entries(Parameters &prm) + Uniform::parse_entries(Parameters &prm, const std::vector> &coordinates) { - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; compositions = prm.get_vector("compositions"); const bool set_euler_angles = prm.check_entry("Euler angles z-x-z"); @@ -133,6 +138,7 @@ namespace WorldBuilder WorldBuilder::grains Uniform::get_grains(const Point<3> & /*position_in_cartesian_coordinates*/, + const NaturalCoordinate &position_in_natural_coordinates, const double depth, const unsigned int composition_number, WorldBuilder::grains grains_, @@ -142,17 +148,22 @@ namespace WorldBuilder WorldBuilder::grains grains_local = grains_; if (depth <= max_depth && depth >= min_depth) { - for (unsigned int i =0; i < compositions.size(); ++i) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - if (compositions[i] == composition_number) + for (unsigned int i =0; i < compositions.size(); ++i) { - std::fill(grains_local.rotation_matrices.begin(),grains_local.rotation_matrices.end(),rotation_matrices[i]); + if (compositions[i] == composition_number) + { + std::fill(grains_local.rotation_matrices.begin(),grains_local.rotation_matrices.end(),rotation_matrices[i]); - const double size = grain_sizes[i] < 0 ? 1.0/static_cast(grains_local.sizes.size()) : grain_sizes[i]; - std::fill(grains_local.sizes.begin(),grains_local.sizes.end(),size); + const double size = grain_sizes[i] < 0 ? 1.0/static_cast(grains_local.sizes.size()) : grain_sizes[i]; + std::fill(grains_local.sizes.begin(),grains_local.sizes.end(),size); - return grains_local; + return grains_local; + } } } } diff --git a/source/features/oceanic_plate_models/temperature/adiabatic.cc b/source/features/oceanic_plate_models/temperature/adiabatic.cc index 692d1ab41..3b556b8c9 100644 --- a/source/features/oceanic_plate_models/temperature/adiabatic.cc +++ b/source/features/oceanic_plate_models/temperature/adiabatic.cc @@ -22,7 +22,11 @@ #include "world_builder/nan.h" #include "world_builder/types/double.h" +#include "world_builder/types/array.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" +#include "world_builder/types/value_at_points.h" +#include "world_builder/kd_tree.h" #include "world_builder/utilities.h" #include "world_builder/world.h" @@ -61,10 +65,10 @@ namespace WorldBuilder "Adiabatic temperature model. Uses global values by default."); // Declare entries of this plugin - prm.declare_entry("min depth", Types::Double(0), + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), "The depth in meters from which the temperature of this feature is present."); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth in meters to which the temperature of this feature is present."); prm.declare_entry("potential mantle temperature", Types::Double(-1), @@ -82,11 +86,13 @@ namespace WorldBuilder } void - Adiabatic::parse_entries(Parameters &prm) + Adiabatic::parse_entries(Parameters &prm, const std::vector> &coordinates) { - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; operation = Utilities::string_operations_to_enum(prm.get("operation")); potential_mantle_temperature = prm.get("potential mantle temperature"); @@ -123,6 +129,7 @@ namespace WorldBuilder double Adiabatic::get_temperature(const Point<3> & /*position_in_cartesian_coordinates*/, + const NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity_norm, double temperature_, @@ -132,23 +139,28 @@ namespace WorldBuilder if (depth <= max_depth && depth >= min_depth) { - const double adabatic_temperature = potential_mantle_temperature * - std::exp(((thermal_expansion_coefficient * gravity_norm) / - specific_heat) * depth); - - - WBAssert(!std::isnan(adabatic_temperature), - "adabatic_temperature is not a number: " << adabatic_temperature << ". " - <<"Parameters: potential_mantle_temperature = " << potential_mantle_temperature - <<", thermal_expansion_coefficient = " << thermal_expansion_coefficient - << ", gravity_norm = " << gravity_norm - << ", specific_heat = " << specific_heat - << ", depth = " << depth); - - WBAssert(std::isfinite(adabatic_temperature), - "adabatic_temperature is not a finite: " << adabatic_temperature << '.'); - - return Utilities::apply_operation(operation,temperature_,adabatic_temperature); + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) + { + const double adabatic_temperature = potential_mantle_temperature * + std::exp(((thermal_expansion_coefficient * gravity_norm) / + specific_heat) * depth); + + + WBAssert(!std::isnan(adabatic_temperature), + "adabatic_temperature is not a number: " << adabatic_temperature << ". " + <<"Parameters: potential_mantle_temperature = " << potential_mantle_temperature + <<", thermal_expansion_coefficient = " << thermal_expansion_coefficient + << ", gravity_norm = " << gravity_norm + << ", specific_heat = " << specific_heat + << ", depth = " << depth); + + WBAssert(std::isfinite(adabatic_temperature), + "adabatic_temperature is not a finite: " << adabatic_temperature << '.'); + + return Utilities::apply_operation(operation,temperature_,adabatic_temperature); + } } diff --git a/source/features/oceanic_plate_models/temperature/half_space_model.cc b/source/features/oceanic_plate_models/temperature/half_space_model.cc index 99c706632..0dceec4f3 100644 --- a/source/features/oceanic_plate_models/temperature/half_space_model.cc +++ b/source/features/oceanic_plate_models/temperature/half_space_model.cc @@ -24,7 +24,10 @@ #include "world_builder/types/array.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" +#include "world_builder/types/value_at_points.h" #include "world_builder/types/point.h" +#include "world_builder/kd_tree.h" #include "world_builder/utilities.h" #include "world_builder/world.h" @@ -64,10 +67,10 @@ namespace WorldBuilder "Half space cooling mode"); // Declare entries of this plugin - prm.declare_entry("min depth", Types::Double(0), + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), "The depth in meters from which the temperature of this feature is present."); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth in meters to which the temperature of this feature is present." "Because half-space reaches background temperature asymptotically, " "this value should be ~2 times the nominal plate thickness of 100 km" ); @@ -92,11 +95,13 @@ namespace WorldBuilder } void - HalfSpaceModel::parse_entries(Parameters &prm) + HalfSpaceModel::parse_entries(Parameters &prm, const std::vector> &coordinates) { - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; operation = Utilities::string_operations_to_enum(prm.get("operation")); top_temperature = prm.get("top temperature"); bottom_temperature = prm.get("bottom temperature"); @@ -114,6 +119,7 @@ namespace WorldBuilder double HalfSpaceModel::get_temperature(const Point<3> &position, + const NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity_norm, double temperature_, @@ -122,120 +128,125 @@ namespace WorldBuilder { if (depth <= max_depth && depth >= min_depth) { - WorldBuilder::Utilities::NaturalCoordinate position_in_natural_coordinates_at_min_depth = WorldBuilder::Utilities::NaturalCoordinate(position, - *(world->parameters.coordinate_system)); - position_in_natural_coordinates_at_min_depth.get_ref_depth_coordinate() += depth-min_depth; + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) + { + WorldBuilder::Utilities::NaturalCoordinate position_in_natural_coordinates_at_min_depth = WorldBuilder::Utilities::NaturalCoordinate(position, + *(world->parameters.coordinate_system)); + position_in_natural_coordinates_at_min_depth.get_ref_depth_coordinate() += depth-min_depth; - double bottom_temperature_local = bottom_temperature; + double bottom_temperature_local = bottom_temperature; - if (bottom_temperature_local < 0) - { - bottom_temperature_local = this->world->potential_mantle_temperature * - std::exp(((this->world->thermal_expansion_coefficient* gravity_norm) / - this->world->specific_heat) * depth); - } + if (bottom_temperature_local < 0) + { + bottom_temperature_local = this->world->potential_mantle_temperature * + std::exp(((this->world->thermal_expansion_coefficient* gravity_norm) / + this->world->specific_heat) * depth); + } - double distance_ridge = std::numeric_limits::max(); + double distance_ridge = std::numeric_limits::max(); - const CoordinateSystem coordinate_system = world->parameters.coordinate_system->natural_coordinate_system(); + const CoordinateSystem coordinate_system = world->parameters.coordinate_system->natural_coordinate_system(); - // first find if the coordinate is on this side of a ridge - unsigned int relevant_ridge = 0; - const Point<2> check_point(position_in_natural_coordinates_at_min_depth.get_surface_coordinates(), - position_in_natural_coordinates_at_min_depth.get_coordinate_system()); + // first find if the coordinate is on this side of a ridge + unsigned int relevant_ridge = 0; + const Point<2> check_point(position_in_natural_coordinates_at_min_depth.get_surface_coordinates(), + position_in_natural_coordinates_at_min_depth.get_coordinate_system()); - // if there is only one ridge, there is no transform - if (mid_oceanic_ridges.size() > 1) - { - // There are more than one ridge, so there are transform faults - // Find the first which is on the same side - for (relevant_ridge = 0; relevant_ridge < mid_oceanic_ridges.size()-1; relevant_ridge++) + // if there is only one ridge, there is no transform + if (mid_oceanic_ridges.size() > 1) { - const Point<2> transform_point_0 = mid_oceanic_ridges[relevant_ridge+1][0]; - const Point<2> transform_point_1 = mid_oceanic_ridges[relevant_ridge][mid_oceanic_ridges[relevant_ridge].size()-1]; - const Point<2> reference_point = mid_oceanic_ridges[relevant_ridge][0]; - - const bool reference_on_side_of_line = (transform_point_1[0] - transform_point_0[0]) - * (reference_point[1] - transform_point_0[1]) - - (transform_point_1[1] - transform_point_0[1]) - * (reference_point[0] - transform_point_0[0]) - < 0; - const bool checkpoint_on_side_of_line = (transform_point_1[0] - transform_point_0[0]) - * (check_point[1] - transform_point_0[1]) - - (transform_point_1[1] - transform_point_0[1]) - * (check_point[0] - transform_point_0[0]) - < 0; - - - if (reference_on_side_of_line == checkpoint_on_side_of_line) + // There are more than one ridge, so there are transform faults + // Find the first which is on the same side + for (relevant_ridge = 0; relevant_ridge < mid_oceanic_ridges.size()-1; relevant_ridge++) { - break; - } + const Point<2> transform_point_0 = mid_oceanic_ridges[relevant_ridge+1][0]; + const Point<2> transform_point_1 = mid_oceanic_ridges[relevant_ridge][mid_oceanic_ridges[relevant_ridge].size()-1]; + const Point<2> reference_point = mid_oceanic_ridges[relevant_ridge][0]; + + const bool reference_on_side_of_line = (transform_point_1[0] - transform_point_0[0]) + * (reference_point[1] - transform_point_0[1]) + - (transform_point_1[1] - transform_point_0[1]) + * (reference_point[0] - transform_point_0[0]) + < 0; + const bool checkpoint_on_side_of_line = (transform_point_1[0] - transform_point_0[0]) + * (check_point[1] - transform_point_0[1]) + - (transform_point_1[1] - transform_point_0[1]) + * (check_point[0] - transform_point_0[0]) + < 0; + + + if (reference_on_side_of_line == checkpoint_on_side_of_line) + { + break; + } + } } - } - for (unsigned int i_coordinate = 0; i_coordinate < mid_oceanic_ridges[relevant_ridge].size() - 1; i_coordinate++) - { - const Point<2> segment_point0 = mid_oceanic_ridges[relevant_ridge][i_coordinate]; - const Point<2> segment_point1 = mid_oceanic_ridges[relevant_ridge][i_coordinate + 1]; + for (unsigned int i_coordinate = 0; i_coordinate < mid_oceanic_ridges[relevant_ridge].size() - 1; i_coordinate++) + { + const Point<2> segment_point0 = mid_oceanic_ridges[relevant_ridge][i_coordinate]; + const Point<2> segment_point1 = mid_oceanic_ridges[relevant_ridge][i_coordinate + 1]; - // based on http://geomalgorithms.com/a02-_lines.html - const Point<2> v = segment_point1 - segment_point0; - const Point<2> w = check_point - segment_point0; + // based on http://geomalgorithms.com/a02-_lines.html + const Point<2> v = segment_point1 - segment_point0; + const Point<2> w = check_point - segment_point0; - const double c1 = (w[0] * v[0] + w[1] * v[1]); - const double c2 = (v[0] * v[0] + v[1] * v[1]); + const double c1 = (w[0] * v[0] + w[1] * v[1]); + const double c2 = (v[0] * v[0] + v[1] * v[1]); - Point<2> Pb(coordinate_system); - // This part is needed when we want to consider segments instead of lines - // If you want to have infinite lines, use only the else statement. + Point<2> Pb(coordinate_system); + // This part is needed when we want to consider segments instead of lines + // If you want to have infinite lines, use only the else statement. - if (c1 <= 0) - Pb=segment_point0; - else if (c2 <= c1) - Pb=segment_point1; - else - Pb = segment_point0 + (c1 / c2) * v; + if (c1 <= 0) + Pb=segment_point0; + else if (c2 <= c1) + Pb=segment_point1; + else + Pb = segment_point0 + (c1 / c2) * v; - Point<3> compare_point(coordinate_system); + Point<3> compare_point(coordinate_system); - compare_point[0] = coordinate_system == cartesian ? Pb[0] : position_in_natural_coordinates_at_min_depth.get_depth_coordinate(); - compare_point[1] = coordinate_system == cartesian ? Pb[1] : Pb[0]; - compare_point[2] = coordinate_system == cartesian ? position_in_natural_coordinates_at_min_depth.get_depth_coordinate() : Pb[1]; + compare_point[0] = coordinate_system == cartesian ? Pb[0] : position_in_natural_coordinates_at_min_depth.get_depth_coordinate(); + compare_point[1] = coordinate_system == cartesian ? Pb[1] : Pb[0]; + compare_point[2] = coordinate_system == cartesian ? position_in_natural_coordinates_at_min_depth.get_depth_coordinate() : Pb[1]; - distance_ridge = std::min(distance_ridge, - this->world->parameters.coordinate_system->distance_between_points_at_same_depth(Point<3>(position_in_natural_coordinates_at_min_depth.get_coordinates(), - position_in_natural_coordinates_at_min_depth.get_coordinate_system()), - compare_point)); + distance_ridge = std::min(distance_ridge, + this->world->parameters.coordinate_system->distance_between_points_at_same_depth(Point<3>(position_in_natural_coordinates_at_min_depth.get_coordinates(), + position_in_natural_coordinates_at_min_depth.get_coordinate_system()), + compare_point)); - } + } - const double thermal_diffusivity = this->world->thermal_diffusivity; - const double age = distance_ridge / spreading_velocity; + const double thermal_diffusivity = this->world->thermal_diffusivity; + const double age = distance_ridge / spreading_velocity; - double temperature = bottom_temperature_local; + double temperature = bottom_temperature_local; - temperature = temperature + (top_temperature - bottom_temperature_local)*std::erfc(depth/(2*std::sqrt(thermal_diffusivity*age))); + temperature = temperature + (top_temperature - bottom_temperature_local)*std::erfc(depth/(2*std::sqrt(thermal_diffusivity*age))); - WBAssert(!std::isnan(temperature), "Temperature inside half-space cooling model is not a number: " << temperature - << ". Relevant variables: bottom_temperature_local = " << bottom_temperature_local - << ", top_temperature = " << top_temperature - << ", max_depth = " << max_depth - << ", spreading_velocity = " << spreading_velocity - << ", thermal_diffusivity = " << thermal_diffusivity - << ", age = " << age << '.'); - WBAssert(std::isfinite(temperature), "Temperature inside half-space cooling model is not a finite: " << temperature << ". Relevant variables: bottom_temperature_local = " << bottom_temperature_local - << ", top_temperature = " << top_temperature - << ", spreading_velocity = " << spreading_velocity - << ", thermal_diffusivity = " << thermal_diffusivity - << ", age = " << age << '.'); + WBAssert(!std::isnan(temperature), "Temperature inside half-space cooling model is not a number: " << temperature + << ". Relevant variables: bottom_temperature_local = " << bottom_temperature_local + << ", top_temperature = " << top_temperature + << ", max_depth = " << max_depth + << ", spreading_velocity = " << spreading_velocity + << ", thermal_diffusivity = " << thermal_diffusivity + << ", age = " << age << '.'); + WBAssert(std::isfinite(temperature), "Temperature inside half-space cooling model is not a finite: " << temperature << ". Relevant variables: bottom_temperature_local = " << bottom_temperature_local + << ", top_temperature = " << top_temperature + << ", spreading_velocity = " << spreading_velocity + << ", thermal_diffusivity = " << thermal_diffusivity + << ", age = " << age << '.'); - return Utilities::apply_operation(operation,temperature_,temperature); + return Utilities::apply_operation(operation,temperature_,temperature); + } } return temperature_; } diff --git a/source/features/oceanic_plate_models/temperature/linear.cc b/source/features/oceanic_plate_models/temperature/linear.cc index a4bd19307..8afcf5fbc 100644 --- a/source/features/oceanic_plate_models/temperature/linear.cc +++ b/source/features/oceanic_plate_models/temperature/linear.cc @@ -21,8 +21,12 @@ #include "world_builder/nan.h" +#include "world_builder/types/array.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" +#include "world_builder/types/value_at_points.h" +#include "world_builder/kd_tree.h" #include "world_builder/utilities.h" #include "world_builder/world.h" @@ -61,10 +65,10 @@ namespace WorldBuilder "Linear temperature model. Can be set to use an adiabatic temperature at the boundaries."); // Declare entries of this plugin - prm.declare_entry("min depth", Types::Double(0), + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), "The depth in meters from which the temperature of this feature is present."); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth in meters to which the temperature of this feature is present."); prm.declare_entry("top temperature", Types::Double(293.15), @@ -77,10 +81,12 @@ namespace WorldBuilder } void - Linear::parse_entries(Parameters &prm) + Linear::parse_entries(Parameters &prm, const std::vector> &coordinates) { - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; WBAssert(max_depth >= min_depth, "max depth needs to be larger or equal to min depth."); operation = Utilities::string_operations_to_enum(prm.get("operation")); top_temperature = prm.get("top temperature"); @@ -90,6 +96,7 @@ namespace WorldBuilder double Linear::get_temperature(const Point<3> & /*position_in_cartesian_coordinates*/, + const NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity_norm, double temperature_, @@ -98,30 +105,35 @@ namespace WorldBuilder { if (depth <= max_depth && depth >= min_depth) { - const double min_depth_local = std::max(feature_min_depth, min_depth); - const double max_depth_local = std::min(feature_max_depth, max_depth); - - double top_temperature_local = top_temperature; - if (top_temperature_local < 0) - { - top_temperature_local = this->world->potential_mantle_temperature * - std::exp(((this->world->thermal_expansion_coefficient * gravity_norm) / - this->world->specific_heat) * min_depth_local); - } - - double bottom_temperature_local = bottom_temperature; - if (bottom_temperature_local < 0) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - bottom_temperature_local = this->world->potential_mantle_temperature * - std::exp(((this->world->thermal_expansion_coefficient * gravity_norm) / - this->world->specific_heat) * max_depth_local); + const double min_depth_local_local = std::max(feature_min_depth, min_depth_local); + const double max_depth_local_local = std::min(feature_max_depth, max_depth_local); + + double top_temperature_local = top_temperature; + if (top_temperature_local < 0) + { + top_temperature_local = this->world->potential_mantle_temperature * + std::exp(((this->world->thermal_expansion_coefficient * gravity_norm) / + this->world->specific_heat) * min_depth_local_local); + } + + double bottom_temperature_local = bottom_temperature; + if (bottom_temperature_local < 0) + { + bottom_temperature_local = this->world->potential_mantle_temperature * + std::exp(((this->world->thermal_expansion_coefficient * gravity_norm) / + this->world->specific_heat) * max_depth_local_local); + } + + const double new_temperature = top_temperature_local + + (depth - min_depth_local_local) * + ((bottom_temperature_local - top_temperature_local) / (max_depth_local_local - min_depth_local_local)); + + return Utilities::apply_operation(operation,temperature_,new_temperature); } - - const double new_temperature = top_temperature_local + - (depth - min_depth_local) * - ((bottom_temperature_local - top_temperature_local) / (max_depth_local - min_depth_local)); - - return Utilities::apply_operation(operation,temperature_,new_temperature); } diff --git a/source/features/oceanic_plate_models/temperature/plate_model.cc b/source/features/oceanic_plate_models/temperature/plate_model.cc index f3c4ed2c2..25d7c39bd 100644 --- a/source/features/oceanic_plate_models/temperature/plate_model.cc +++ b/source/features/oceanic_plate_models/temperature/plate_model.cc @@ -24,7 +24,10 @@ #include "world_builder/types/array.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" +#include "world_builder/types/value_at_points.h" #include "world_builder/types/point.h" +#include "world_builder/kd_tree.h" #include "world_builder/utilities.h" #include "world_builder/world.h" @@ -64,10 +67,10 @@ namespace WorldBuilder "Plate model."); // Declare entries of this plugin - prm.declare_entry("min depth", Types::Double(0), + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), "The depth in meters from which the temperature of this feature is present."); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth in meters to which the temperature of this feature is present."); prm.declare_entry("top temperature", Types::Double(293.15), @@ -89,11 +92,13 @@ namespace WorldBuilder } void - PlateModel::parse_entries(Parameters &prm) + PlateModel::parse_entries(Parameters &prm, const std::vector> &coordinates) { - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; operation = Utilities::string_operations_to_enum(prm.get("operation")); top_temperature = prm.get("top temperature"); bottom_temperature = prm.get("bottom temperature"); @@ -111,6 +116,7 @@ namespace WorldBuilder double PlateModel::get_temperature(const Point<3> &position, + const NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity_norm, double temperature_, @@ -119,130 +125,135 @@ namespace WorldBuilder { if (depth <= max_depth && depth >= min_depth) { - WorldBuilder::Utilities::NaturalCoordinate position_in_natural_coordinates_at_min_depth = WorldBuilder::Utilities::NaturalCoordinate(position, - *(world->parameters.coordinate_system)); - position_in_natural_coordinates_at_min_depth.get_ref_depth_coordinate() += depth-min_depth; + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) + { + WorldBuilder::Utilities::NaturalCoordinate position_in_natural_coordinates_at_min_depth = WorldBuilder::Utilities::NaturalCoordinate(position, + *(world->parameters.coordinate_system)); + position_in_natural_coordinates_at_min_depth.get_ref_depth_coordinate() += depth-min_depth; - double bottom_temperature_local = bottom_temperature; + double bottom_temperature_local = bottom_temperature; - if (bottom_temperature_local < 0) - { - bottom_temperature_local = this->world->potential_mantle_temperature * - std::exp(((this->world->thermal_expansion_coefficient* gravity_norm) / - this->world->specific_heat) * depth); - } + if (bottom_temperature_local < 0) + { + bottom_temperature_local = this->world->potential_mantle_temperature * + std::exp(((this->world->thermal_expansion_coefficient* gravity_norm) / + this->world->specific_heat) * depth); + } - const int sommation_number = 100; + const int sommation_number = 100; - double distance_ridge = std::numeric_limits::max(); + double distance_ridge = std::numeric_limits::max(); - const CoordinateSystem coordinate_system = world->parameters.coordinate_system->natural_coordinate_system(); + const CoordinateSystem coordinate_system = world->parameters.coordinate_system->natural_coordinate_system(); - // first find if the coordinate is on this side of a ridge - unsigned int relevant_ridge = 0; - const Point<2> check_point(position_in_natural_coordinates_at_min_depth.get_surface_coordinates(),position_in_natural_coordinates_at_min_depth.get_coordinate_system()); + // first find if the coordinate is on this side of a ridge + unsigned int relevant_ridge = 0; + const Point<2> check_point(position_in_natural_coordinates_at_min_depth.get_surface_coordinates(),position_in_natural_coordinates_at_min_depth.get_coordinate_system()); - // if there is only one ridge, there is no transform - if (mid_oceanic_ridges.size() > 1) - { - // There are more than one ridge, so there are transform faults - // Find the first which is on the same side - for (relevant_ridge = 0; relevant_ridge < mid_oceanic_ridges.size()-1; relevant_ridge++) + // if there is only one ridge, there is no transform + if (mid_oceanic_ridges.size() > 1) { - const Point<2> transform_point_0 = mid_oceanic_ridges[relevant_ridge+1][0]; - const Point<2> transform_point_1 = mid_oceanic_ridges[relevant_ridge][mid_oceanic_ridges[relevant_ridge].size()-1]; - const Point<2> reference_point = mid_oceanic_ridges[relevant_ridge][0]; - - const bool reference_on_side_of_line = (transform_point_1[0] - transform_point_0[0]) - * (reference_point[1] - transform_point_0[1]) - - (transform_point_1[1] - transform_point_0[1]) - * (reference_point[0] - transform_point_0[0]) - < 0; - const bool checkpoint_on_side_of_line = (transform_point_1[0] - transform_point_0[0]) - * (check_point[1] - transform_point_0[1]) - - (transform_point_1[1] - transform_point_0[1]) - * (check_point[0] - transform_point_0[0]) - < 0; - - - if (reference_on_side_of_line == checkpoint_on_side_of_line) + // There are more than one ridge, so there are transform faults + // Find the first which is on the same side + for (relevant_ridge = 0; relevant_ridge < mid_oceanic_ridges.size()-1; relevant_ridge++) { - break; - } + const Point<2> transform_point_0 = mid_oceanic_ridges[relevant_ridge+1][0]; + const Point<2> transform_point_1 = mid_oceanic_ridges[relevant_ridge][mid_oceanic_ridges[relevant_ridge].size()-1]; + const Point<2> reference_point = mid_oceanic_ridges[relevant_ridge][0]; + + const bool reference_on_side_of_line = (transform_point_1[0] - transform_point_0[0]) + * (reference_point[1] - transform_point_0[1]) + - (transform_point_1[1] - transform_point_0[1]) + * (reference_point[0] - transform_point_0[0]) + < 0; + const bool checkpoint_on_side_of_line = (transform_point_1[0] - transform_point_0[0]) + * (check_point[1] - transform_point_0[1]) + - (transform_point_1[1] - transform_point_0[1]) + * (check_point[0] - transform_point_0[0]) + < 0; + + + if (reference_on_side_of_line == checkpoint_on_side_of_line) + { + break; + } + } } - } - for (unsigned int i_coordinate = 0; i_coordinate < mid_oceanic_ridges[relevant_ridge].size() - 1; i_coordinate++) - { - const Point<2> segment_point0 = mid_oceanic_ridges[relevant_ridge][i_coordinate]; - const Point<2> segment_point1 = mid_oceanic_ridges[relevant_ridge][i_coordinate + 1]; + for (unsigned int i_coordinate = 0; i_coordinate < mid_oceanic_ridges[relevant_ridge].size() - 1; i_coordinate++) + { + const Point<2> segment_point0 = mid_oceanic_ridges[relevant_ridge][i_coordinate]; + const Point<2> segment_point1 = mid_oceanic_ridges[relevant_ridge][i_coordinate + 1]; - // based on http://geomalgorithms.com/a02-_lines.html - const Point<2> v = segment_point1 - segment_point0; - const Point<2> w = check_point - segment_point0; + // based on http://geomalgorithms.com/a02-_lines.html + const Point<2> v = segment_point1 - segment_point0; + const Point<2> w = check_point - segment_point0; - const double c1 = (w[0] * v[0] + w[1] * v[1]); - const double c2 = (v[0] * v[0] + v[1] * v[1]); + const double c1 = (w[0] * v[0] + w[1] * v[1]); + const double c2 = (v[0] * v[0] + v[1] * v[1]); - Point<2> Pb(coordinate_system); - // This part is needed when we want to consider segments instead of lines - // If you want to have infinite lines, use only the else statement. + Point<2> Pb(coordinate_system); + // This part is needed when we want to consider segments instead of lines + // If you want to have infinite lines, use only the else statement. - if (c1 <= 0) - Pb=segment_point0; - else if (c2 <= c1) - Pb=segment_point1; - else - Pb = segment_point0 + (c1 / c2) * v; + if (c1 <= 0) + Pb=segment_point0; + else if (c2 <= c1) + Pb=segment_point1; + else + Pb = segment_point0 + (c1 / c2) * v; - Point<3> compare_point(coordinate_system); + Point<3> compare_point(coordinate_system); - compare_point[0] = coordinate_system == cartesian ? Pb[0] : position_in_natural_coordinates_at_min_depth.get_depth_coordinate(); - compare_point[1] = coordinate_system == cartesian ? Pb[1] : Pb[0]; - compare_point[2] = coordinate_system == cartesian ? position_in_natural_coordinates_at_min_depth.get_depth_coordinate() : Pb[1]; + compare_point[0] = coordinate_system == cartesian ? Pb[0] : position_in_natural_coordinates_at_min_depth.get_depth_coordinate(); + compare_point[1] = coordinate_system == cartesian ? Pb[1] : Pb[0]; + compare_point[2] = coordinate_system == cartesian ? position_in_natural_coordinates_at_min_depth.get_depth_coordinate() : Pb[1]; - distance_ridge = std::min(distance_ridge,this->world->parameters.coordinate_system->distance_between_points_at_same_depth(Point<3>(position_in_natural_coordinates_at_min_depth.get_coordinates(),position_in_natural_coordinates_at_min_depth.get_coordinate_system()),compare_point)); + distance_ridge = std::min(distance_ridge,this->world->parameters.coordinate_system->distance_between_points_at_same_depth(Point<3>(position_in_natural_coordinates_at_min_depth.get_coordinates(),position_in_natural_coordinates_at_min_depth.get_coordinate_system()),compare_point)); - } + } - // some aliases - //const double top_temperature = top_temperature; - //const double spreading_velocity = spreading_velocity; - const double thermal_diffusivity = this->world->thermal_diffusivity; - const double age = distance_ridge / spreading_velocity; - double temperature = top_temperature + (bottom_temperature_local - top_temperature) * (depth / max_depth); + // some aliases + //const double top_temperature = top_temperature; + //const double spreading_velocity = spreading_velocity; + const double thermal_diffusivity = this->world->thermal_diffusivity; + const double age = distance_ridge / spreading_velocity; + double temperature = top_temperature + (bottom_temperature_local - top_temperature) * (depth / max_depth); - // This formula addresses the horizontal heat transfer by having the spreading velocity and distance to the ridge in it. - // (Chapter 7 Heat, Fowler M. The solid earth: an introduction to global geophysics[M]. Cambridge University Press, 1990) - for (int i = 1; i::max()), + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth in meters to which the temperature of this feature is present."); prm.declare_entry("top temperature", Types::Double(293.15), @@ -81,11 +84,13 @@ namespace WorldBuilder } void - PlateModelConstantAge::parse_entries(Parameters &prm) + PlateModelConstantAge::parse_entries(Parameters &prm, const std::vector> &coordinates) { - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; operation = Utilities::string_operations_to_enum(prm.get("operation")); top_temperature = prm.get("top temperature"); bottom_temperature = prm.get("bottom temperature"); @@ -95,6 +100,7 @@ namespace WorldBuilder double PlateModelConstantAge::get_temperature(const Point<3> & /*position*/, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity_norm, double temperature_, @@ -103,44 +109,49 @@ namespace WorldBuilder { if (depth <= max_depth && depth >= min_depth) { - double bottom_temperature_local = bottom_temperature; - - if (bottom_temperature_local < 0) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - bottom_temperature_local = this->world->potential_mantle_temperature * - std::exp(((this->world->thermal_expansion_coefficient* gravity_norm) / - this->world->specific_heat) * depth); - } - const int sommation_number = 100; + double bottom_temperature_local = bottom_temperature; + + if (bottom_temperature_local < 0) + { + bottom_temperature_local = this->world->potential_mantle_temperature * + std::exp(((this->world->thermal_expansion_coefficient* gravity_norm) / + this->world->specific_heat) * depth); + } + const int sommation_number = 100; + + // some aliases + //const double top_temperature = top_temperature; + const double thermal_diffusivity = this->world->thermal_diffusivity; + double temperature = top_temperature + (bottom_temperature_local - top_temperature) * (depth / max_depth); + + // This formula ignores the horizontal heat transfer by just having the age of the plate in it. + // (Chapter 7 Heat, Fowler M. The solid earth: an introduction to global geophysics[M]. Cambridge University Press, 1990) + for (int i = 1; i::max()), + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth in meters to which the temperature of this feature is present."); prm.declare_entry("temperature", Types::Double(293.15), @@ -72,11 +76,13 @@ namespace WorldBuilder } void - Uniform::parse_entries(Parameters &prm) + Uniform::parse_entries(Parameters &prm, const std::vector> &coordinates) { - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; operation = Utilities::string_operations_to_enum(prm.get("operation")); temperature = prm.get("temperature"); } @@ -84,6 +90,7 @@ namespace WorldBuilder double Uniform::get_temperature(const Point<3> & /*position_in_cartesian_coordinates*/, + const NaturalCoordinate &position_in_natural_coordinates, const double depth, const double /*gravity*/, double temperature_, @@ -93,7 +100,12 @@ namespace WorldBuilder if (depth <= max_depth && depth >= min_depth) { - return Utilities::apply_operation(operation,temperature_,temperature); + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) + { + return Utilities::apply_operation(operation,temperature_,temperature); + } } return temperature_; From fc71ad2b4062444bc30e5ec17b3748bc82bbd363 Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Fri, 25 Mar 2022 15:43:40 -0700 Subject: [PATCH 19/26] Add oceanic_min_max_surface_spherical test. --- .../app/oceanic_min_max_surface_spherical.dat | 293 ++++++++++++++++++ .../app/oceanic_min_max_surface_spherical.wb | 42 +++ .../screen-output.log | 285 +++++++++++++++++ 3 files changed, 620 insertions(+) create mode 100644 tests/app/oceanic_min_max_surface_spherical.dat create mode 100644 tests/app/oceanic_min_max_surface_spherical.wb create mode 100644 tests/app/oceanic_min_max_surface_spherical/screen-output.log diff --git a/tests/app/oceanic_min_max_surface_spherical.dat b/tests/app/oceanic_min_max_surface_spherical.dat new file mode 100644 index 000000000..7331c6bb7 --- /dev/null +++ b/tests/app/oceanic_min_max_surface_spherical.dat @@ -0,0 +1,293 @@ +# This is a comment in the data +# file. +# Now define parameters: +# dim = 3 +# compositions = 5 +# grain compositions = 2 +# number of grains = 2 +# convert spherical = true +# R long lat d g T c1 c2 c3 c4 c5 +1 0 0 1 10 +1 0 0 10e3 10 +1 0 0 40e3 10 +1 0 0 60e3 10 +1 0 0 150e3 10 +1 0 0 250e3 10 +1 0 0 350e3 10 +1 0 2.5 1 10 +1 0 2.5 10e3 10 +1 0 2.5 40e3 10 +1 0 2.5 60e3 10 +1 0 2.5 150e3 10 +1 0 2.5 250e3 10 +1 0 2.5 350e3 10 +1 0 5 1 10 +1 0 5 10e3 10 +1 0 5 40e3 10 +1 0 5 60e3 10 +1 0 5 150e3 10 +1 0 5 250e3 10 +1 0 5 350e3 10 +1 0 5.07 1 10 +1 0 7.5 1 10 +1 0 7.5 10e3 10 +1 0 7.5 40e3 10 +1 0 7.5 60e3 10 +1 0 7.5 150e3 10 +1 0 7.5 250e3 10 +1 0 7.5 350e3 10 +1 0 10 1 10 +1 0 10 10e3 10 +1 0 10 40e3 10 +1 0 10 60e3 10 +1 0 10 150e3 10 +1 0 10 250e3 10 +1 0 10 350e3 10 +1 5 0 1 10 +1 5 0 10e3 10 +1 5 0 40e3 10 +1 5 0 60e3 10 +1 5 0 150e3 10 +1 5 0 250e3 10 +1 5 0 350e3 10 +1 5 2.5 1 10 +1 5 2.5 10e3 10 +1 5 2.5 40e3 10 +1 5 2.5 60e3 10 +1 5 2.5 150e3 10 +1 5 2.5 250e3 10 +1 5 2.5 350e3 10 +1 5 5 1 10 +1 5 5 10e3 10 +1 5 5 40e3 10 +1 5 5 60e3 10 +1 5 5 150e3 10 +1 5 5 250e3 10 +1 5 5 350e3 10 +1 5 5.07 1 10 +1 5 7.5 1 10 +1 5 7.5 10e3 10 +1 5 7.5 40e3 10 +1 5 7.5 60e3 10 +1 5 7.5 150e3 10 +1 5 7.5 250e3 10 +1 5 7.5 350e3 10 +1 5 10 1 10 +1 5 10 10e3 10 +1 5 10 40e3 10 +1 5 10 60e3 10 +1 5 10 150e3 10 +1 5 10 250e3 10 +1 5 10 350e3 10 +1 10 0 10e3 10 +1 10 0 40e3 10 +1 10 0 60e3 10 +1 10 0 150e3 10 +1 10 0 250e3 10 +1 10 0 350e3 10 +1 10 2.5 1 10 +1 10 2.5 10e3 10 +1 10 2.5 40e3 10 +1 10 2.5 60e3 10 +1 10 2.5 150e3 10 +1 10 2.5 250e3 10 +1 10 2.5 350e3 10 +1 10 5 1 10 +1 10 5 10e3 10 +1 10 5 40e3 10 +1 10 5 60e3 10 +1 10 5 150e3 10 +1 10 5 250e3 10 +1 10 5 350e3 10 +1 10 5.07 1 10 +1 10 7.5 1 10 +1 10 7.5 10e3 10 +1 10 7.5 40e3 10 +1 10 7.5 60e3 10 +1 10 7.5 150e3 10 +1 10 7.5 250e3 10 +1 10 7.5 350e3 10 +1 10 10 1 10 +1 10 10 10e3 10 +1 10 10 40e3 10 +1 10 10 60e3 10 +1 10 10 150e3 10 +1 10 10 250e3 10 +1 10 10 350e3 10 +1 175 0 1 10 +1 175 0 10e3 10 +1 175 0 40e3 10 +1 175 0 60e3 10 +1 175 0 150e3 10 +1 175 0 250e3 10 +1 175 0 350e3 10 +1 175 2.5 1 10 +1 175 2.5 10e3 10 +1 175 2.5 40e3 10 +1 175 2.5 60e3 10 +1 175 2.5 150e3 10 +1 175 2.5 250e3 10 +1 175 2.5 350e3 10 +1 175 5 1 10 +1 175 5 10e3 10 +1 175 5 40e3 10 +1 175 5 60e3 10 +1 175 5 150e3 10 +1 175 5 250e3 10 +1 175 5 350e3 10 +1 175 5.07 1 10 +1 175 7.5 1 10 +1 175 7.5 10e3 10 +1 175 7.5 40e3 10 +1 175 7.5 60e3 10 +1 175 7.5 150e3 10 +1 175 7.5 250e3 10 +1 175 7.5 350e3 10 +1 175 10 1 10 +1 175 10 10e3 10 +1 175 10 40e3 10 +1 175 10 60e3 10 +1 175 10 150e3 10 +1 175 10 250e3 10 +1 175 10 350e3 10 +1 180 0 1 10 +1 180 0 10e3 10 +1 180 0 40e3 10 +1 180 0 60e3 10 +1 180 0 150e3 10 +1 180 0 250e3 10 +1 180 0 350e3 10 +1 180 2.5 1 10 +1 180 2.5 10e3 10 +1 180 2.5 40e3 10 +1 180 2.5 60e3 10 +1 180 2.5 150e3 10 +1 180 2.5 250e3 10 +1 180 2.5 350e3 10 +1 180 5 1 10 +1 180 5 10e3 10 +1 180 5 40e3 10 +1 180 5 60e3 10 +1 180 5 150e3 10 +1 180 5 250e3 10 +1 180 5 350e3 10 +1 180 5.07 1 10 +1 180 7.5 1 10 +1 180 7.5 10e3 10 +1 180 7.5 40e3 10 +1 180 7.5 60e3 10 +1 180 7.5 150e3 10 +1 180 7.5 250e3 10 +1 180 7.5 350e3 10 +1 180 10 1 10 +1 180 10 10e3 10 +1 180 10 40e3 10 +1 180 10 60e3 10 +1 180 10 150e3 10 +1 180 10 250e3 10 +1 180 10 350e3 10 +1 185 0 10e3 10 +1 185 0 40e3 10 +1 185 0 60e3 10 +1 185 0 150e3 10 +1 185 0 250e3 10 +1 185 0 350e3 10 +1 185 2.5 1 10 +1 185 2.5 10e3 10 +1 185 2.5 40e3 10 +1 185 2.5 60e3 10 +1 185 2.5 150e3 10 +1 185 2.5 250e3 10 +1 185 2.5 350e3 10 +1 185 5 1 10 +1 185 5 10e3 10 +1 185 5 40e3 10 +1 185 5 60e3 10 +1 185 5 150e3 10 +1 185 5 250e3 10 +1 185 5 350e3 10 +1 185 5.07 1 10 +1 185 7.5 1 10 +1 185 7.5 10e3 10 +1 185 7.5 40e3 10 +1 185 7.5 60e3 10 +1 185 7.5 150e3 10 +1 185 7.5 250e3 10 +1 185 7.5 350e3 10 +1 185 10 1 10 +1 185 10 10e3 10 +1 185 10 40e3 10 +1 185 10 60e3 10 +1 185 10 150e3 10 +1 185 10 250e3 10 +1 185 10 350e3 10 +1 -184.9 1.2 1 10 +1 -184.9 1.2 10e3 10 +1 -184.9 1.2 40e3 10 +1 -184.9 1.2 60e3 10 +1 -184.9 1.2 150e3 10 +1 -184.9 1.2 250e3 10 +1 -184.9 1.2 350e3 10 +1 175.05 3.15 1 10 +1 175.05 3.15 10e3 10 +1 175.05 3.15 40e3 10 +1 175.05 3.15 60e3 10 +1 175.05 3.15 150e3 10 +1 175.05 3.15 250e3 10 +1 175.05 3.15 350e3 10 +1 175.15 1.05 1 10 +1 175.15 1.05 10e3 10 +1 175.15 1.05 40e3 10 +1 175.15 1.05 60e3 10 +1 175.15 1.05 150e3 10 +1 175.15 1.05 250e3 10 +1 175.15 1.05 350e3 10 +1 -184.85 1.05 1 10 +1 -184.85 1.05 10e3 10 +1 -184.85 1.05 40e3 10 +1 -184.85 1.05 60e3 10 +1 -184.85 1.05 150e3 10 +1 -184.85 1.05 250e3 10 +1 -184.85 1.05 350e3 10 +1 -179.6 8.2 1 10 +1 -179.6 8.2 10e3 10 +1 -179.6 8.2 40e3 10 +1 -179.6 8.2 60e3 10 +1 -179.6 8.2 150e3 10 +1 -179.6 8.2 250e3 10 +1 -179.6 8.2 350e3 10 +1 180.4 8.2 1 10 +1 180.4 8.2 10e3 10 +1 180.4 8.2 40e3 10 +1 180.4 8.2 60e3 10 +1 180.4 8.2 150e3 10 +1 180.4 8.2 250e3 10 +1 180.4 8.2 350e3 10 +1 -175 4.95 1 10 +1 -175 4.95 10e3 10 +1 -175 4.95 40e3 10 +1 -175 4.95 60e3 10 +1 -175 4.95 150e3 10 +1 -175 4.95 250e3 10 +1 -175 4.95 350e3 10 +1 185 4.95 1 10 +1 185 4.95 10e3 10 +1 185 4.95 40e3 10 +1 185 4.95 60e3 10 +1 185 4.95 150e3 10 +1 185 4.95 250e3 10 +1 185 4.95 350e3 10 +1 -179.95 2.55 1 10 +1 -179.95 2.55 10e3 10 +1 -179.95 2.55 40e3 10 +1 -179.95 2.55 60e3 10 +1 -179.95 2.55 150e3 10 +1 -179.95 2.55 250e3 10 +1 -179.95 2.55 350e3 10 +1 180.05 2.55 1 10 +1 180.05 2.55 10e3 10 +1 180.05 2.55 40e3 10 +1 180.05 2.55 60e3 10 +1 180.05 2.55 150e3 10 +1 180.05 2.55 250e3 10 +1 180.05 2.55 350e3 10 \ No newline at end of file diff --git a/tests/app/oceanic_min_max_surface_spherical.wb b/tests/app/oceanic_min_max_surface_spherical.wb new file mode 100644 index 000000000..cf1995064 --- /dev/null +++ b/tests/app/oceanic_min_max_surface_spherical.wb @@ -0,0 +1,42 @@ +{ +"version":"0.5", +"coordinate system":{"model":"spherical", "depth method":"begin at end segment"}, +"features":[ + { + "model":"oceanic plate", "name":"Var thickness continent", "coordinates":[[0,10],[10,10],[10,0],[0,0]], + "min depth":[[50e3,[[0,5]]],[200e3,[[10,5]]]], "max depth":[[300e3],[200e3,[[0,5],[10,5]]]], + "temperature models":[ + {"model":"uniform", "min depth":[[50e3,[[0,5]]],[200e3,[[10,5]]]], "max depth":[[200e3],[100e3,[[0,5],[10,5],[0,0]]]], "temperature":150}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[0,5],[10,5],[0,0]]]], "max depth":[[300e3],[200e3,[[0,5],[10,5]]]], "temperature":200} + ], + "composition models":[ + {"model":"uniform", "min depth":[[50e3,[[0,5]]],[200e3,[[10,5]]]], "max depth":[[200e3],[100e3,[[0,5],[10,5],[0,0]]]], "compositions":[0]}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[0,5],[10,5],[0,0]]]], "max depth":[[300e3],[200e3,[[0,5],[10,5]]]], "compositions":[1]} + ], + "grains models":[ + {"model":"uniform", "compositions":[0,1],"rotation matrices":[[[1,2,3],[4,5,6],[7,8,9]],[[10,11,12],[13,14,15],[16,17,18]]],"grain sizes":[-1,0.2], + "min depth":[[50e3,[[0,5]]],[200e3,[[10,5]]]], "max depth":[[200e3],[100e3,[[0,5],[10,5],[0,0]]]]}, + {"model":"uniform", "compositions":[0,1],"rotation matrices":[[[19,20,21],[22,23,24],[25,26,27]],[[28,29,30],[31,32,33],[34,35,36]]],"grain sizes":[-1,0.3], + "min depth":[[200e3],[100e3,[[0,5],[10,5],[0,0]]]], "max depth":[[300e3],[200e3,[[0,5],[10,5]]]]} + ] + }, + { + "model":"oceanic plate", "name":"Var thickness continent 2", "coordinates":[[175,10],[185,10],[185,0],[175,0]], + "min depth":[[50e3,[[175,5]]],[200e3,[[185,5]]]], "max depth":[[300e3],[200e3,[[175,5],[185,5]]]], + "temperature models":[ + {"model":"uniform", "min depth":[[50e3,[[175,5]]],[200e3,[[185,5]]]], "max depth":[[200e3],[100e3,[[175,5],[185,5],[175,0]]]], "temperature":150}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[175,5],[185,5],[175,0]]]], "max depth":[[300e3],[200e3,[[175,5],[185,5]]]], "temperature":200} + ], + "composition models":[ + {"model":"uniform", "min depth":[[50e3,[[175,5]]],[200e3,[[185,5]]]], "max depth":[[200e3],[100e3,[[175,5],[185,5],[175,0]]]], "compositions":[0]}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[175,5],[185,5],[175,0]]]], "max depth":[[300e3],[200e3,[[175,5],[185,5]]]], "compositions":[1]} + ], + "grains models":[ + {"model":"uniform", "compositions":[175,1],"rotation matrices":[[[1,2,3],[4,5,6],[7,8,9]],[[185,11,12],[13,14,15],[16,17,18]]],"grain sizes":[-1,0.2], + "min depth":[[50e3,[[175,5]]],[200e3,[[185,5]]]], "max depth":[[200e3],[100e3,[[175,5],[185,5],[175,0]]]]}, + {"model":"uniform", "compositions":[175,1],"rotation matrices":[[[19,20,21],[22,23,24],[25,26,27]],[[28,29,30],[31,32,33],[34,35,36]]],"grain sizes":[-1,0.3], + "min depth":[[200e3],[100e3,[[175,5],[185,5],[175,0]]]], "max depth":[[300e3],[200e3,[[175,5],[185,5]]]]} + ] + } +] +} diff --git a/tests/app/oceanic_min_max_surface_spherical/screen-output.log b/tests/app/oceanic_min_max_surface_spherical/screen-output.log new file mode 100644 index 000000000..efd37999b --- /dev/null +++ b/tests/app/oceanic_min_max_surface_spherical/screen-output.log @@ -0,0 +1,285 @@ +# x y z d g T c0 c1 c2 c3 c4 gs0-0 gm0-0[0:0] gm0-0[0:1] gm0-0[0:2] gm0-0[1:0] gm0-0[1:1] gm0-0[1:2] gm0-0[2:0] gm0-0[2:1] gm0-0[2:2] gs0-1 gm0-1[0:0] gm0-1[0:1] gm0-1[0:2] gm0-1[1:0] gm0-1[1:1] gm0-1[1:2] gm0-1[2:0] gm0-1[2:1] gm0-1[2:2] gs1-0 gm1-0[0:0] gm1-0[0:1] gm1-0[0:2] gm1-0[1:0] gm1-0[1:1] gm1-0[1:2] gm1-0[2:0] gm1-0[2:1] gm1-0[2:2] gs1-1 gm1-1[0:0] gm1-1[0:1] gm1-1[0:2] gm1-1[1:0] gm1-1[1:1] gm1-1[1:2] gm1-1[2:0] gm1-1[2:1] gm1-1[2:2] +1 0 0 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 0 10e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 0 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 0 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 0 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 0 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 0 0 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 2.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 2.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 2.5 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 2.5 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 2.5 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 2.5 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 0 2.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 5 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 5 150e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 0 5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 5.07 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 7.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 7.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 7.5 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 7.5 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 7.5 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 7.5 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 0 7.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 0 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 0 10e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 0 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 0 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 0 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 0 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 5 0 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 2.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 2.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 2.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 2.5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 2.5 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 2.5 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 5 2.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5 150e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 5 5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5.07 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 7.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 7.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 7.5 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 7.5 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 7.5 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 7.5 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 5 7.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 0 10e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 0 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 0 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 0 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 0 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 10 0 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 2.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 2.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 2.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 2.5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 2.5 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 2.5 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 10 2.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5.07 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 7.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 7.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 7.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 7.5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 7.5 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 7.5 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 10 7.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 10 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 10 10e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 10 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 10 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 10 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 10 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 10 10 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 0 1 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 0 10e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 0 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 0 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 0 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175 0 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175 0 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 2.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 2.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 2.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 2.5 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 2.5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175 2.5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 2.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 5 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175 5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 5.07 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 7.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 7.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 7.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 7.5 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 7.5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175 7.5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 7.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 10 1 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 10 10e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 10 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 10 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 10 150e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 10 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175 10 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 0 1 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 0 10e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 0 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 0 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 0 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180 0 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180 0 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 2.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 2.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 2.5 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 2.5 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 2.5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180 2.5 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180 2.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180 5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5.07 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 7.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 7.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 7.5 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 7.5 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 7.5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180 7.5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 7.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 0 10e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 0 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 0 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 0 150e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 0 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 185 0 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 2.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 2.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 2.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 2.5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 2.5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 185 2.5 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 185 2.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5.07 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 7.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 7.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 7.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 7.5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 7.5 150e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 7.5 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 185 7.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 10 1 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 10 10e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 10 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 10 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 10 150e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 10 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 185 10 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -184.9 1.2 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -184.9 1.2 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -184.9 1.2 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -184.9 1.2 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -184.9 1.2 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 -184.9 1.2 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 -184.9 1.2 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.05 3.15 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.05 3.15 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.05 3.15 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175.05 3.15 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175.05 3.15 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175.05 3.15 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.05 3.15 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.15 1.05 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.15 1.05 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.15 1.05 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175.15 1.05 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175.15 1.05 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175.15 1.05 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175.15 1.05 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -184.85 1.05 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -184.85 1.05 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -184.85 1.05 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -184.85 1.05 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -184.85 1.05 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 -184.85 1.05 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 -184.85 1.05 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.6 8.2 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.6 8.2 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.6 8.2 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -179.6 8.2 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -179.6 8.2 150e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -179.6 8.2 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 -179.6 8.2 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.4 8.2 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.4 8.2 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.4 8.2 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180.4 8.2 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180.4 8.2 150e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180.4 8.2 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180.4 8.2 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.95 2.55 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.95 2.55 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.95 2.55 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -179.95 2.55 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -179.95 2.55 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 -179.95 2.55 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.95 2.55 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.05 2.55 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.05 2.55 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.05 2.55 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180.05 2.55 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180.05 2.55 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180.05 2.55 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.05 2.55 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 From ad270956a10bda09a120fccc904cd0cc47aad6b1 Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Fri, 25 Mar 2022 15:43:59 -0700 Subject: [PATCH 20/26] Add oceanic_min_max_surface test. --- tests/app/oceanic_min_max_surface.dat | 62 +++++++++++++++++++ tests/app/oceanic_min_max_surface.wb | 24 +++++++ .../oceanic_min_max_surface/screen-output.log | 55 ++++++++++++++++ 3 files changed, 141 insertions(+) create mode 100644 tests/app/oceanic_min_max_surface.dat create mode 100644 tests/app/oceanic_min_max_surface.wb create mode 100644 tests/app/oceanic_min_max_surface/screen-output.log diff --git a/tests/app/oceanic_min_max_surface.dat b/tests/app/oceanic_min_max_surface.dat new file mode 100644 index 000000000..6db2e291b --- /dev/null +++ b/tests/app/oceanic_min_max_surface.dat @@ -0,0 +1,62 @@ +# This is a comment in the data +# file. +# Now define parameters: +# dim = 3 +# compositions = 5 +# grain compositions = 2 +# number of grains = 2 +# x y z d g T c1 c2 c3 c4 c5 +0 0 1 1 10 +0 0 1 40e3 10 +0 0 1 60e3 10 +0 0 1 150e3 10 +0 0 1 250e3 10 +0 0 1 350e3 10 +0 250e3 1 1 10 +0 250e3 1 40e3 10 +0 250e3 1 60e3 10 +0 250e3 1 150e3 10 +0 250e3 1 250e3 10 +0 250e3 1 350e3 10 +0 500e3 1 1 10 +0 500e3 1 40e3 10 +0 500e3 1 60e3 10 +0 500e3 1 150e3 10 +0 500e3 1 250e3 10 +0 500e3 1 350e3 10 +0 750e3 1 1 10 +0 1000e3 1 1 10 +250e3 0 1 1 10 +250e3 0 40e3 1 10 +250e3 0 60e3 1 10 +250e3 0 250e3 1 10 +250e3 0 350e3 1 10 +250e3 250e3 1 1 10 +250e3 250e3 1 40e3 10 +250e3 250e3 1 60e3 10 +250e3 250e3 1 150e3 10 +250e3 250e3 1 250e3 10 +250e3 250e3 1 350e3 10 +250e3 500e3 1 1 10 +250e3 500e3 1 40e3 10 +250e3 500e3 1 60e3 10 +250e3 500e3 1 150e3 10 +250e3 500e3 1 250e3 10 +250e3 500e3 1 350e3 10 +250e3 750e3 1 1 10 +250e3 1000e3 1 1 10 +500e3 0 1 1 10 +500e3 250e3 1 1 10 +500e3 500e3 1 1 10 +500e3 750e3 1 1 10 +500e3 1000e3 1 1 10 +750e3 0 1 1 10 +750e3 250e3 1 1 10 +750e3 500e3 1 1 10 +750e3 750e3 1 1 10 +750e3 1000e3 1 1 10 +1000e3 0 1 1 10 +1000e3 250e3 1 1 10 +1000e3 500e3 1 1 10 +1000e3 750e3 1 1 10 +1000e3 1000e3 1 1 10 diff --git a/tests/app/oceanic_min_max_surface.wb b/tests/app/oceanic_min_max_surface.wb new file mode 100644 index 000000000..ef62ef2c6 --- /dev/null +++ b/tests/app/oceanic_min_max_surface.wb @@ -0,0 +1,24 @@ +{ +"version":"0.5", +"coordinate system":{"model":"cartesian"}, +"features":[ + { + "model":"oceanic plate", "name":"Var thickness continent", "coordinates":[[0,1000e3],[1000e3,1000e3],[1000e3,0],[0,0]], + "min depth":[[50e3,[[0,500e3]]],[200e3,[[1000e3,500e3]]]], "max depth":[[300e3],[200e3,[[0,500e3],[1000e3,500e3]]]], + "temperature models":[ + {"model":"uniform", "min depth":[[50e3,[[0,500e3]]],[200e3,[[1000e3,500e3]]]], "max depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]], "temperature":150}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]], "max depth":[[300e3],[200e3,[[0,500e3],[1000e3,500e3]]]], "temperature":200} + ], + "composition models":[ + {"model":"uniform", "min depth":[[50e3,[[0,500e3]]],[200e3,[[1000e3,500e3]]]], "max depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]], "compositions":[0]}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]], "max depth":[[300e3],[200e3,[[0,500e3],[1000e3,500e3]]]], "compositions":[1]} + ], + "grains models":[ + {"model":"uniform", "compositions":[0,1],"rotation matrices":[[[1,2,3],[4,5,6],[7,8,9]],[[10,11,12],[13,14,15],[16,17,18]]],"grain sizes":[-1,0.2], + "min depth":[[50e3,[[0,500e3]]],[200e3,[[1000e3,500e3]]]], "max depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]]}, + {"model":"uniform", "compositions":[0,1],"rotation matrices":[[[19,20,21],[22,23,24],[25,26,27]],[[28,29,30],[31,32,33],[34,35,36]]],"grain sizes":[-1,0.3], + "min depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]], "max depth":[[300e3],[200e3,[[0,500e3],[1000e3,500e3]]]]} + ] + } +] +} diff --git a/tests/app/oceanic_min_max_surface/screen-output.log b/tests/app/oceanic_min_max_surface/screen-output.log new file mode 100644 index 000000000..aa384f884 --- /dev/null +++ b/tests/app/oceanic_min_max_surface/screen-output.log @@ -0,0 +1,55 @@ +# x y z d g T c0 c1 c2 c3 c4 gs0-0 gm0-0[0:0] gm0-0[0:1] gm0-0[0:2] gm0-0[1:0] gm0-0[1:1] gm0-0[1:2] gm0-0[2:0] gm0-0[2:1] gm0-0[2:2] gs0-1 gm0-1[0:0] gm0-1[0:1] gm0-1[0:2] gm0-1[1:0] gm0-1[1:1] gm0-1[1:2] gm0-1[2:0] gm0-1[2:1] gm0-1[2:2] gs1-0 gm1-0[0:0] gm1-0[0:1] gm1-0[0:2] gm1-0[1:0] gm1-0[1:1] gm1-0[1:2] gm1-0[2:0] gm1-0[2:1] gm1-0[2:2] gs1-1 gm1-1[0:0] gm1-1[0:1] gm1-1[0:2] gm1-1[1:0] gm1-1[1:1] gm1-1[1:2] gm1-1[2:0] gm1-1[2:1] gm1-1[2:2] +0 0 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 0 1 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 0 1 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 0 1 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 0 1 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +0 0 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 250e3 1 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 250e3 1 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 250e3 1 150e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +0 250e3 1 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +0 250e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 500e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 500e3 1 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 500e3 1 150e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +0 500e3 1 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 500e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 40e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 60e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 250e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 350e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 250e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 250e3 1 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 250e3 1 150e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +250e3 250e3 1 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +250e3 250e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 500e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 500e3 1 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 500e3 1 150e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +250e3 500e3 1 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 500e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +500e3 0 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +500e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +500e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +500e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +500e3 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +750e3 0 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +750e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +750e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +750e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +750e3 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1000e3 0 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1000e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1000e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1000e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1000e3 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 From fe7b1512749fb470096cd16058db573e8ee6d649 Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Fri, 25 Mar 2022 15:44:25 -0700 Subject: [PATCH 21/26] Update world builder declarations markdown files. --- tests/app/world_buider_declarations_closed.md | 1592 ++++++++++++++-- tests/app/world_buider_declarations_open.md | 1660 ++++++++++++++++- 2 files changed, 3100 insertions(+), 152 deletions(-) diff --git a/tests/app/world_buider_declarations_closed.md b/tests/app/world_buider_declarations_closed.md index 80474afe0..f3ffeac4f 100644 --- a/tests/app/world_buider_declarations_closed.md +++ b/tests/app/world_buider_declarations_closed.md @@ -248,6 +248,7 @@ ::::::::::::::::::::{dropdown} /features/items/oneOf/1/min depth :name: closed_features_items_oneOf_1_min-depth +- **documentation**:The depth from which this feature is present :::::::::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf :name: closed_features_items_oneOf_1_min-depth_oneOf @@ -323,6 +324,7 @@ ::::::::::::::::::::{dropdown} /features/items/oneOf/1/max depth :name: closed_features_items_oneOf_1_max-depth +- **documentation**:The depth to which this feature is present :::::::::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf :name: closed_features_items_oneOf_1_max-depth_oneOf @@ -436,6 +438,7 @@ ::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth :name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth +- **documentation**:The depth in meters from which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf :name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf @@ -511,6 +514,7 @@ ::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth :name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth +- **documentation**:The depth in meters to which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf :name: closed_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf @@ -640,6 +644,7 @@ ::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth :name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth +- **documentation**:The depth in meters from which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf :name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf @@ -715,6 +720,7 @@ ::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth :name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth +- **documentation**:The depth in meters to which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf :name: closed_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf @@ -836,6 +842,7 @@ ::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth :name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth +- **documentation**:The depth in meters from which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf :name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf @@ -911,6 +918,7 @@ ::::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth :name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth +- **documentation**:The depth in meters to which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf :name: closed_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf @@ -1032,6 +1040,7 @@ ::::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth :name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth +- **documentation**:The depth in meters from which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf :name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf @@ -1107,6 +1116,7 @@ ::::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth :name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth +- **documentation**:The depth in meters to which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf :name: closed_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf @@ -1265,6 +1275,7 @@ ::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth :name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth +- **documentation**:The depth in meters from which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf :name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf @@ -1340,6 +1351,7 @@ ::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth :name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth +- **documentation**:The depth in meters to which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf :name: closed_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf @@ -1499,6 +1511,7 @@ ::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth :name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth +- **documentation**:The depth in meters from which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf :name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf @@ -1574,6 +1587,7 @@ ::::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth :name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth +- **documentation**:The depth in meters to which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf :name: closed_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf @@ -5037,17 +5051,153 @@ ::::::::::::::::::::{dropdown} /features/items/oneOf/4/min depth :name: closed_features_items_oneOf_4_min-depth +- **documentation**:The depth from which this feature is present +:::::::::::::::::::{dropdown} /features/items/oneOf/4/min depth/oneOf +:name: closed_features_items_oneOf_4_min-depth_oneOf + +::::::::::::::::::{dropdown} /features/items/oneOf/4/min depth/oneOf/1 +:name: closed_features_items_oneOf_4_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth to which this feature is present +- **documentation**: +:::::::::::::::::: + +::::::::::::::::::{dropdown} /features/items/oneOf/4/min depth/oneOf/2 +:name: closed_features_items_oneOf_4_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::::::{dropdown} /features/items/oneOf/4/min depth/oneOf/2/items +:name: closed_features_items_oneOf_4_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::::::{dropdown} /features/items/oneOf/4/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_4_min-depth_oneOf_2_items_items + +:::::::::::::::{dropdown} /features/items/oneOf/4/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_4_min-depth_oneOf_2_items_items_anyOf + +::::::::::::::{dropdown} /features/items/oneOf/4/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_4_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_4_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::::::{dropdown} /features/items/oneOf/4/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_4_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::::::{dropdown} /features/items/oneOf/4/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_4_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::: + +:::::::::::::::::: + + :::::::::::::::::::: ::::::::::::::::::::{dropdown} /features/items/oneOf/4/max depth :name: closed_features_items_oneOf_4_max-depth +- **documentation**:The depth to which this feature is present +:::::::::::::::::::{dropdown} /features/items/oneOf/4/max depth/oneOf +:name: closed_features_items_oneOf_4_max-depth_oneOf + +::::::::::::::::::{dropdown} /features/items/oneOf/4/max depth/oneOf/1 +:name: closed_features_items_oneOf_4_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth to which this feature is present +- **documentation**: +:::::::::::::::::: + +::::::::::::::::::{dropdown} /features/items/oneOf/4/max depth/oneOf/2 +:name: closed_features_items_oneOf_4_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::::::{dropdown} /features/items/oneOf/4/max depth/oneOf/2/items +:name: closed_features_items_oneOf_4_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::::::{dropdown} /features/items/oneOf/4/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_4_max-depth_oneOf_2_items_items + +:::::::::::::::{dropdown} /features/items/oneOf/4/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_4_max-depth_oneOf_2_items_items_anyOf + +::::::::::::::{dropdown} /features/items/oneOf/4/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_4_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_4_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::::::{dropdown} /features/items/oneOf/4/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_4_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::::::{dropdown} /features/items/oneOf/4/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_4_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::: + +:::::::::::::::::: + + :::::::::::::::::::: ::::::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models @@ -5091,17 +5241,153 @@ ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth :name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth/oneOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth/oneOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth/oneOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth/oneOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth :name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth/oneOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth/oneOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth/oneOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth/oneOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/potential mantle temperature @@ -5161,51 +5447,187 @@ ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth :name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth -- **default value**:0.0 -- **type**:number - **documentation**:The depth in meters from which the temperature of this feature is present. -:::::::::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth/oneOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth_oneOf -::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth -:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth/oneOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth_oneOf_1 -- **default value**:1.7976931348623157e308 +- **default value**:0.0 - **type**:number -- **documentation**:The depth in meters to which the temperature of this feature is present.Because half-space reaches background temperature asymptotically, this value should be ~2 times the nominal plate thickness of 100 km -:::::::::::::::: +- **documentation**: +:::::::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/top temperature -:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_top-temperature +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth/oneOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth_oneOf_2 -- **default value**:293.15 -- **type**:number -- **documentation**:The actual surface temperature in degree Kelvin for this feature. -:::::::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth/oneOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth_oneOf_2_items -::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/bottom temperature -:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_bottom-temperature +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items -- **default value**:-1.0 -- **type**:number -- **documentation**:The mantle temperature for the half-space cooling modelin degree Kelvin for this feature. If the model has an adiabatic gradientthis should be the mantle potential temperature, and T = Tad + Thalf. -:::::::::::::::: +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf -::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/spreading velocity -:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_spreading-velocity +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_1 -- **default value**:-1.0 - **type**:number -- **documentation**:The spreading velocity of the plate in meter per year. This is the velocity with which one side moves away from the ridge. -:::::::::::::::: +- **default value**:0.0 +:::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/ridge coordinates -:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_ridge-coordinates +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2 - **type**:array - **minItems**:1 - **maxItems**:4294967295 -- **uniqueItems**:false -- **documentation**:An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth + +- **documentation**:The depth in meters to which the temperature of this feature is present.Because half-space reaches background temperature asymptotically, this value should be ~2 times the nominal plate thickness of 100 km +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth/oneOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth/oneOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth_oneOf_1 + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth/oneOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth/oneOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/top temperature +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_top-temperature + +- **default value**:293.15 +- **type**:number +- **documentation**:The actual surface temperature in degree Kelvin for this feature. +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/bottom temperature +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_bottom-temperature + +- **default value**:-1.0 +- **type**:number +- **documentation**:The mantle temperature for the half-space cooling modelin degree Kelvin for this feature. If the model has an adiabatic gradientthis should be the mantle potential temperature, and T = Tad + Thalf. +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/spreading velocity +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_spreading-velocity + +- **default value**:-1.0 +- **type**:number +- **documentation**:The spreading velocity of the plate in meter per year. This is the velocity with which one side moves away from the ridge. +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/ridge coordinates +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_ridge-coordinates + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. :::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/ridge coordinates/items :name: closed_features_items_oneOf_4_temperature-models_items_oneOf_2_ridge-coordinates_items @@ -5266,17 +5688,153 @@ ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth :name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth/oneOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth/oneOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth/oneOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth/oneOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth :name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth/oneOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth/oneOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth/oneOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth/oneOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/top temperature @@ -5328,53 +5886,189 @@ ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth :name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth -- **default value**:0.0 -- **type**:number - **documentation**:The depth in meters from which the temperature of this feature is present. -:::::::::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth/oneOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth_oneOf -::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth -:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth/oneOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth_oneOf_1 -- **default value**:1.7976931348623157e308 +- **default value**:0.0 - **type**:number -- **documentation**:The depth in meters to which the temperature of this feature is present. -:::::::::::::::: +- **documentation**: +:::::::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/top temperature -:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_top-temperature +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth/oneOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth_oneOf_2 -- **default value**:293.15 -- **type**:number -- **documentation**:The temperature in degree Kelvin which this feature should have -:::::::::::::::: +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth/oneOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth_oneOf_2_items -::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/bottom temperature -:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_bottom-temperature +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth_oneOf_2_items_items -- **default value**:-1.0 -- **type**:number -- **documentation**:The temperature in degree Kelvin which this feature should have -:::::::::::::::: +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth_oneOf_2_items_items_anyOf -::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/spreading velocity -:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_spreading-velocity +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth_oneOf_2_items_items_anyOf_1 -- **default value**:-1.0 - **type**:number -- **documentation**:The spreading velocity of the plate in meter per year. This is the velocity with which one side moves away from the ridge. -:::::::::::::::: +- **default value**:0.0 +:::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/ridge coordinates -:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_ridge-coordinates +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth_oneOf_2_items_items_anyOf_2 - **type**:array - **minItems**:1 - **maxItems**:4294967295 -- **uniqueItems**:false -- **documentation**:An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. -:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/ridge coordinates/items -:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_ridge-coordinates_items +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth + +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth/oneOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth/oneOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth_oneOf_1 + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth/oneOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth/oneOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/top temperature +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_top-temperature + +- **default value**:293.15 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/bottom temperature +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_bottom-temperature + +- **default value**:-1.0 +- **type**:number +- **documentation**:The temperature in degree Kelvin which this feature should have +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/spreading velocity +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_spreading-velocity + +- **default value**:-1.0 +- **type**:number +- **documentation**:The spreading velocity of the plate in meter per year. This is the velocity with which one side moves away from the ridge. +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/ridge coordinates +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_ridge-coordinates + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**:An list of ridges. Each ridge is a lists of at least 2 2d points which define the location of the ridge. You need to define at least one ridge.So the an exmple with two ridges is [[[10,20],[20,30],[10,40]],[[50,10],[60,10]]]. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/ridge coordinates/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_4_ridge-coordinates_items - **type**:array - **minItems**:2 @@ -5433,17 +6127,153 @@ ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth :name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth/oneOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth/oneOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth/oneOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth/oneOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth :name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth/oneOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth/oneOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth/oneOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth/oneOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/top temperature @@ -5503,17 +6333,153 @@ ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth :name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth/oneOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth/oneOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth/oneOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth/oneOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth :name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth/oneOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth/oneOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth/oneOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth/oneOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/temperature @@ -5526,56 +6492,192 @@ -::::::::::::::::: +::::::::::::::::: + + +::::::::::::::::::: + +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/4/composition models +:name: closed_features_items_oneOf_4_composition-models + +- **documentation**:A list of composition models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items +:name: closed_features_items_oneOf_4_composition-models_items + +::::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf +:name: closed_features_items_oneOf_4_composition-models_items_oneOf + +:::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1 +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1 + +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] + +::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/model +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_model + +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth + +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth/oneOf +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth/oneOf/1 +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth_oneOf_1 + +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth/oneOf/2 +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth/oneOf/2/items +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth + +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth/oneOf +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth/oneOf/1 +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth_oneOf_1 + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth/oneOf/2 +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth/oneOf/2/items +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf +::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_1 -::::::::::::::::::: +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: -:::::::::::::::::::: +::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2 -::::::::::::::::::::{dropdown} /features/items/oneOf/4/composition models -:name: closed_features_items_oneOf_4_composition-models +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items -- **documentation**:A list of composition models. -- **default value**: - **type**:array -:::::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items -:name: closed_features_items_oneOf_4_composition-models_items +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items_items -::::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf -:name: closed_features_items_oneOf_4_composition-models_items_oneOf +- **type**:number +:::::::: -:::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1 -:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1 +::::::::: -- **type**:object -- **documentation**:Uniform compositional model. Sets constant compositional field. -- **additionalProperties**:false -- **required**:[model, compositions] +:::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/model -:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_model -- **default value**: -- **type**:string -- **documentation**:The name of the composition model. -- **enum**:[uniform] -:::::::::::::::: +:::::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth -:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth +::::::::::::: -- **default value**:0.0 -- **type**:number -- **documentation**:The depth in meters from which the composition of this feature is present. -:::::::::::::::: +:::::::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth -:name: closed_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth -- **default value**:1.7976931348623157e308 -- **type**:number -- **documentation**:The depth in meters to which the composition of this feature is present. :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/compositions @@ -5664,17 +6766,153 @@ ::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth :name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth/oneOf +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth/oneOf/1 +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the composition of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth/oneOf/2 +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth/oneOf/2/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth :name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth/oneOf +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth/oneOf/1 +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the composition of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth/oneOf/2 +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth/oneOf/2/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/compositions @@ -5764,17 +7002,153 @@ ::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth :name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth/oneOf +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth/oneOf/1 +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the composition of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth/oneOf/2 +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth/oneOf/2/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth :name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth/oneOf +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth/oneOf/1 +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the composition of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth/oneOf/2 +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth/oneOf/2/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/compositions diff --git a/tests/app/world_buider_declarations_open.md b/tests/app/world_buider_declarations_open.md index 988e30800..4fef8e547 100644 --- a/tests/app/world_buider_declarations_open.md +++ b/tests/app/world_buider_declarations_open.md @@ -279,6 +279,7 @@ :open: :name: open_features_items_oneOf_1_min-depth +- **documentation**:The depth from which this feature is present :::::::::::::::::::{dropdown} /features/items/oneOf/1/min depth/oneOf :open: :name: open_features_items_oneOf_1_min-depth_oneOf @@ -365,6 +366,7 @@ :open: :name: open_features_items_oneOf_1_max-depth +- **documentation**:The depth to which this feature is present :::::::::::::::::::{dropdown} /features/items/oneOf/1/max depth/oneOf :open: :name: open_features_items_oneOf_1_max-depth_oneOf @@ -495,6 +497,7 @@ :open: :name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth +- **documentation**:The depth in meters from which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/min depth/oneOf :open: :name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_min-depth_oneOf @@ -581,6 +584,7 @@ :open: :name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth +- **documentation**:The depth in meters to which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/1/max depth/oneOf :open: :name: open_features_items_oneOf_1_temperature-models_items_oneOf_1_max-depth_oneOf @@ -727,6 +731,7 @@ :open: :name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth +- **documentation**:The depth in meters from which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/min depth/oneOf :open: :name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_min-depth_oneOf @@ -813,6 +818,7 @@ :open: :name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth +- **documentation**:The depth in meters to which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/2/max depth/oneOf :open: :name: open_features_items_oneOf_1_temperature-models_items_oneOf_2_max-depth_oneOf @@ -950,6 +956,7 @@ :open: :name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth +- **documentation**:The depth in meters from which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/min depth/oneOf :open: :name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_min-depth_oneOf @@ -1036,6 +1043,7 @@ :open: :name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth +- **documentation**:The depth in meters to which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/temperature models/items/oneOf/3/max depth/oneOf :open: :name: open_features_items_oneOf_1_temperature-models_items_oneOf_3_max-depth_oneOf @@ -1174,6 +1182,7 @@ :open: :name: open_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth +- **documentation**:The depth in meters from which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/min depth/oneOf :open: :name: open_features_items_oneOf_1_composition-models_items_oneOf_1_min-depth_oneOf @@ -1260,6 +1269,7 @@ :open: :name: open_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth +- **documentation**:The depth in meters to which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/composition models/items/oneOf/1/max depth/oneOf :open: :name: open_features_items_oneOf_1_composition-models_items_oneOf_1_max-depth_oneOf @@ -1439,6 +1449,7 @@ :open: :name: open_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth +- **documentation**:The depth in meters from which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/min depth/oneOf :open: :name: open_features_items_oneOf_1_grains-models_items_oneOf_1_min-depth_oneOf @@ -1525,6 +1536,7 @@ :open: :name: open_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth +- **documentation**:The depth in meters to which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/1/max depth/oneOf :open: :name: open_features_items_oneOf_1_grains-models_items_oneOf_1_max-depth_oneOf @@ -1704,6 +1716,7 @@ :open: :name: open_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth +- **documentation**:The depth in meters from which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/min depth/oneOf :open: :name: open_features_items_oneOf_1_grains-models_items_oneOf_2_min-depth_oneOf @@ -1790,6 +1803,7 @@ :open: :name: open_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth +- **documentation**:The depth in meters to which the composition of this feature is present. :::::::::::::::{dropdown} /features/items/oneOf/1/grains models/items/oneOf/2/max depth/oneOf :open: :name: open_features_items_oneOf_1_grains-models_items_oneOf_2_max-depth_oneOf @@ -5658,18 +5672,174 @@ :open: :name: open_features_items_oneOf_4_min-depth +- **documentation**:The depth from which this feature is present +:::::::::::::::::::{dropdown} /features/items/oneOf/4/min depth/oneOf +:open: +:name: open_features_items_oneOf_4_min-depth_oneOf + +::::::::::::::::::{dropdown} /features/items/oneOf/4/min depth/oneOf/1 +:open: +:name: open_features_items_oneOf_4_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth to which this feature is present +- **documentation**: +:::::::::::::::::: + +::::::::::::::::::{dropdown} /features/items/oneOf/4/min depth/oneOf/2 +:open: +:name: open_features_items_oneOf_4_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::::::{dropdown} /features/items/oneOf/4/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_4_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::::::{dropdown} /features/items/oneOf/4/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_4_min-depth_oneOf_2_items_items + +:::::::::::::::{dropdown} /features/items/oneOf/4/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_4_min-depth_oneOf_2_items_items_anyOf + +::::::::::::::{dropdown} /features/items/oneOf/4/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_4_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_4_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::::::{dropdown} /features/items/oneOf/4/min depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_4_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::::::{dropdown} /features/items/oneOf/4/min depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_4_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::: + +:::::::::::::::::: + + :::::::::::::::::::: ::::::::::::::::::::{dropdown} /features/items/oneOf/4/max depth :open: :name: open_features_items_oneOf_4_max-depth +- **documentation**:The depth to which this feature is present +:::::::::::::::::::{dropdown} /features/items/oneOf/4/max depth/oneOf +:open: +:name: open_features_items_oneOf_4_max-depth_oneOf + +::::::::::::::::::{dropdown} /features/items/oneOf/4/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_4_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth to which this feature is present +- **documentation**: +:::::::::::::::::: + +::::::::::::::::::{dropdown} /features/items/oneOf/4/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_4_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::::::{dropdown} /features/items/oneOf/4/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_4_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::::::{dropdown} /features/items/oneOf/4/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_4_max-depth_oneOf_2_items_items + +:::::::::::::::{dropdown} /features/items/oneOf/4/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_4_max-depth_oneOf_2_items_items_anyOf + +::::::::::::::{dropdown} /features/items/oneOf/4/max depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_4_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_4_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::::::{dropdown} /features/items/oneOf/4/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_4_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::::::{dropdown} /features/items/oneOf/4/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_4_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::: + +:::::::::::::::::: + + :::::::::::::::::::: ::::::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models @@ -5720,18 +5890,174 @@ :open: :name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth/oneOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth/oneOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth/oneOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth :open: :name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth/oneOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/1/potential mantle temperature @@ -5798,18 +6124,174 @@ :open: :name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth -- **default value**:0.0 -- **type**:number - **documentation**:The depth in meters from which the temperature of this feature is present. -:::::::::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth/oneOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth/oneOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth_oneOf_1 + +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth/oneOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth :open: :name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth +- **documentation**:The depth in meters to which the temperature of this feature is present.Because half-space reaches background temperature asymptotically, this value should be ~2 times the nominal plate thickness of 100 km +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth/oneOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the temperature of this feature is present.Because half-space reaches background temperature asymptotically, this value should be ~2 times the nominal plate thickness of 100 km +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/2/top temperature @@ -5915,18 +6397,174 @@ :open: :name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth/oneOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth/oneOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth/oneOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth :open: :name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth/oneOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/3/top temperature @@ -5984,26 +6622,182 @@ :open: :name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth -- **default value**:0.0 -- **type**:number - **documentation**:The depth in meters from which the temperature of this feature is present. -:::::::::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth/oneOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth_oneOf -::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth/oneOf/1 :open: -:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth_oneOf_1 -- **default value**:1.7976931348623157e308 +- **default value**:0.0 - **type**:number -- **documentation**:The depth in meters to which the temperature of this feature is present. -:::::::::::::::: +- **documentation**: +:::::::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/top temperature +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth/oneOf/2 :open: -:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_top-temperature +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth_oneOf_2 -- **default value**:293.15 -- **type**:number +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/min depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth + +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth/oneOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth_oneOf_1 + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/4/top temperature +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_4_top-temperature + +- **default value**:293.15 +- **type**:number - **documentation**:The temperature in degree Kelvin which this feature should have :::::::::::::::: @@ -6101,18 +6895,174 @@ :open: :name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth/oneOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth/oneOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth/oneOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/min depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth :open: :name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth/oneOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_5_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/5/top temperature @@ -6179,18 +7129,174 @@ :open: :name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth/oneOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth/oneOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth/oneOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/min depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth :open: :name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth/oneOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_4_temperature-models_items_oneOf_6_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/temperature models/items/oneOf/6/temperature @@ -6245,22 +7351,178 @@ - **enum**:[uniform] :::::::::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth -:open: -:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth +::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth + +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth/oneOf +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth/oneOf/1 +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth_oneOf_1 + +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth/oneOf/2 +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth + +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth/oneOf +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth_oneOf_1 + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: -- **default value**:0.0 -- **type**:number -- **documentation**:The depth in meters from which the composition of this feature is present. -:::::::::::::::: +:::::::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/max depth -:open: -:name: open_features_items_oneOf_4_composition-models_items_oneOf_1_max-depth -- **default value**:1.7976931348623157e308 -- **type**:number -- **documentation**:The depth in meters to which the composition of this feature is present. :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/composition models/items/oneOf/1/compositions @@ -6360,18 +7622,174 @@ :open: :name: open_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth/oneOf +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth/oneOf/1 +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the composition of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth/oneOf/2 +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth :open: :name: open_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth/oneOf +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the composition of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/1/compositions @@ -6471,18 +7889,174 @@ :open: :name: open_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth/oneOf +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth/oneOf/1 +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the composition of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth/oneOf/2 +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth :open: :name: open_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth/oneOf +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the composition of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_4_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/4/grains models/items/oneOf/2/compositions From f61163cf227a0a5b5a1c4a91ecb5873e2ca847b7 Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Fri, 25 Mar 2022 17:26:03 -0700 Subject: [PATCH 22/26] Add min an max surfaces to mantle layers. --- include/world_builder/features/mantle_layer.h | 3 + .../composition/interface.h | 4 +- .../mantle_layer_models/composition/uniform.h | 6 +- .../mantle_layer_models/grains/interface.h | 4 +- .../grains/random_uniform_distribution.h | 9 +- .../mantle_layer_models/grains/uniform.h | 9 +- .../temperature/adiabatic.h | 6 +- .../temperature/interface.h | 4 +- .../mantle_layer_models/temperature/linear.h | 6 +- .../mantle_layer_models/temperature/uniform.h | 6 +- source/features/mantle_layer.cc | 119 +++++++----- .../composition/uniform.cc | 32 ++-- .../grains/random_uniform_distribution.cc | 174 +++++++++--------- .../mantle_layer_models/grains/uniform.cc | 32 ++-- .../temperature/adiabatic.cc | 56 +++--- .../mantle_layer_models/temperature/linear.cc | 67 ++++--- .../temperature/uniform.cc | 24 ++- 17 files changed, 341 insertions(+), 220 deletions(-) diff --git a/include/world_builder/features/mantle_layer.h b/include/world_builder/features/mantle_layer.h index 48b55e7ec..21adf981e 100644 --- a/include/world_builder/features/mantle_layer.h +++ b/include/world_builder/features/mantle_layer.h @@ -22,6 +22,7 @@ #include "world_builder/features/interface.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder @@ -147,7 +148,9 @@ namespace WorldBuilder std::vector > grains_models; double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; }; diff --git a/include/world_builder/features/mantle_layer_models/composition/interface.h b/include/world_builder/features/mantle_layer_models/composition/interface.h index 2f4dc1f0c..9f95b2d00 100644 --- a/include/world_builder/features/mantle_layer_models/composition/interface.h +++ b/include/world_builder/features/mantle_layer_models/composition/interface.h @@ -22,6 +22,7 @@ #include "world_builder/parameters.h" +#include "world_builder/utilities.h" namespace WorldBuilder @@ -69,7 +70,7 @@ namespace WorldBuilder * declare and read in the world builder file into the parameters class */ virtual - void parse_entries(Parameters &prm) = 0; + void parse_entries(Parameters &prm, const std::vector> &coordinates) = 0; /** @@ -77,6 +78,7 @@ namespace WorldBuilder */ virtual double get_composition(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const unsigned int composition_number, double composition, diff --git a/include/world_builder/features/mantle_layer_models/composition/uniform.h b/include/world_builder/features/mantle_layer_models/composition/uniform.h index 678e3aa63..b24c11088 100644 --- a/include/world_builder/features/mantle_layer_models/composition/uniform.h +++ b/include/world_builder/features/mantle_layer_models/composition/uniform.h @@ -22,6 +22,7 @@ #include "world_builder/features/mantle_layer_models/composition/interface.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder @@ -61,7 +62,7 @@ namespace WorldBuilder /** * declare and read in the world builder file into the parameters class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** @@ -69,6 +70,7 @@ namespace WorldBuilder * gravity and current composition. */ double get_composition(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const unsigned int composition_number, double composition, @@ -79,7 +81,9 @@ namespace WorldBuilder private: // uniform composition submodule parameters double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; std::vector compositions; std::vector fractions; std::string operation; diff --git a/include/world_builder/features/mantle_layer_models/grains/interface.h b/include/world_builder/features/mantle_layer_models/grains/interface.h index be3e052d4..cb652a7a1 100644 --- a/include/world_builder/features/mantle_layer_models/grains/interface.h +++ b/include/world_builder/features/mantle_layer_models/grains/interface.h @@ -23,6 +23,7 @@ #include "world_builder/grains.h" #include "world_builder/parameters.h" +#include "world_builder/utilities.h" namespace WorldBuilder @@ -70,7 +71,7 @@ namespace WorldBuilder * declare and read in the world builder file into the parameters class */ virtual - void parse_entries(Parameters &prm) = 0; + void parse_entries(Parameters &prm, const std::vector> &coordinates) = 0; /** @@ -79,6 +80,7 @@ namespace WorldBuilder virtual WorldBuilder::grains get_grains(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const unsigned int composition_number, WorldBuilder::grains grains, diff --git a/include/world_builder/features/mantle_layer_models/grains/random_uniform_distribution.h b/include/world_builder/features/mantle_layer_models/grains/random_uniform_distribution.h index d122f6e0d..4c7a0c301 100644 --- a/include/world_builder/features/mantle_layer_models/grains/random_uniform_distribution.h +++ b/include/world_builder/features/mantle_layer_models/grains/random_uniform_distribution.h @@ -22,6 +22,7 @@ #include "world_builder/features/mantle_layer_models/grains/interface.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder { @@ -78,14 +79,16 @@ namespace WorldBuilder * declare and read in the world builder file into the parameters * class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** * Returns a grains based on the given position, composition (e.g. * olivine and/or enstatite)depth in the model, gravity and current grains. */ WorldBuilder::grains - get_grains(const Point<3> &position, const double depth, + get_grains(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, + const double depth, const unsigned int composition_number, WorldBuilder::grains grains, const double feature_min_depth, @@ -94,7 +97,9 @@ namespace WorldBuilder private: // uniform grains submodule parameters double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; std::vector grains; std::vector compositions; std::string operation; diff --git a/include/world_builder/features/mantle_layer_models/grains/uniform.h b/include/world_builder/features/mantle_layer_models/grains/uniform.h index 8fad66b58..c3d63daa1 100644 --- a/include/world_builder/features/mantle_layer_models/grains/uniform.h +++ b/include/world_builder/features/mantle_layer_models/grains/uniform.h @@ -22,6 +22,7 @@ #include "world_builder/features/mantle_layer_models/grains/interface.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder { @@ -78,14 +79,16 @@ namespace WorldBuilder * declare and read in the world builder file into the parameters * class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** * Returns a grains based on the given position, composition (e.g. * olivine and/or enstatite)depth in the model, gravity and current grains. */ WorldBuilder::grains - get_grains(const Point<3> &position, const double depth, + get_grains(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, + const double depth, const unsigned int composition_number, WorldBuilder::grains grains, const double feature_min_depth, @@ -94,7 +97,9 @@ namespace WorldBuilder private: // uniform grains submodule parameters double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; std::vector grains; std::vector compositions; std::string operation; diff --git a/include/world_builder/features/mantle_layer_models/temperature/adiabatic.h b/include/world_builder/features/mantle_layer_models/temperature/adiabatic.h index fee0ff69f..cc57b05f6 100644 --- a/include/world_builder/features/mantle_layer_models/temperature/adiabatic.h +++ b/include/world_builder/features/mantle_layer_models/temperature/adiabatic.h @@ -23,6 +23,7 @@ #include "world_builder/features/mantle_layer_models/temperature/interface.h" #include "world_builder/features/utilities.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder @@ -62,7 +63,7 @@ namespace WorldBuilder /** * declare and read in the world builder file into the parameters class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** @@ -70,6 +71,7 @@ namespace WorldBuilder * gravity and current temperature. */ double get_temperature(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity, double temperature, @@ -80,7 +82,9 @@ namespace WorldBuilder private: // adiabatic temperature submodule parameters double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; /** * Todo */ diff --git a/include/world_builder/features/mantle_layer_models/temperature/interface.h b/include/world_builder/features/mantle_layer_models/temperature/interface.h index a56f89cb8..58bf70fdc 100644 --- a/include/world_builder/features/mantle_layer_models/temperature/interface.h +++ b/include/world_builder/features/mantle_layer_models/temperature/interface.h @@ -22,6 +22,7 @@ #include "world_builder/parameters.h" +#include "world_builder/utilities.h" namespace WorldBuilder @@ -69,7 +70,7 @@ namespace WorldBuilder * declare and read in the world builder file into the parameters class */ virtual - void parse_entries(Parameters &prm) = 0; + void parse_entries(Parameters &prm, const std::vector> &coordinates) = 0; /** @@ -77,6 +78,7 @@ namespace WorldBuilder */ virtual double get_temperature(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity, double temperature, diff --git a/include/world_builder/features/mantle_layer_models/temperature/linear.h b/include/world_builder/features/mantle_layer_models/temperature/linear.h index 505b35329..460c74399 100644 --- a/include/world_builder/features/mantle_layer_models/temperature/linear.h +++ b/include/world_builder/features/mantle_layer_models/temperature/linear.h @@ -23,6 +23,7 @@ #include "world_builder/features/mantle_layer_models/temperature/interface.h" #include "world_builder/features/utilities.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder @@ -62,7 +63,7 @@ namespace WorldBuilder /** * declare and read in the world builder file into the parameters class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** @@ -70,6 +71,7 @@ namespace WorldBuilder * gravity and current temperature. */ double get_temperature(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity, double temperature, @@ -80,7 +82,9 @@ namespace WorldBuilder private: // linear temperature submodule parameters double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; double top_temperature; double bottom_temperature; Utilities::Operations operation; diff --git a/include/world_builder/features/mantle_layer_models/temperature/uniform.h b/include/world_builder/features/mantle_layer_models/temperature/uniform.h index dcc4c901b..1ff6f6d33 100644 --- a/include/world_builder/features/mantle_layer_models/temperature/uniform.h +++ b/include/world_builder/features/mantle_layer_models/temperature/uniform.h @@ -23,6 +23,7 @@ #include "world_builder/features/mantle_layer_models/temperature/interface.h" #include "world_builder/features/utilities.h" +#include "world_builder/objects/surface.h" namespace WorldBuilder @@ -62,7 +63,7 @@ namespace WorldBuilder /** * declare and read in the world builder file into the parameters class */ - void parse_entries(Parameters &prm) override final; + void parse_entries(Parameters &prm, const std::vector> &coordinates) override final; /** @@ -70,6 +71,7 @@ namespace WorldBuilder * gravity and current temperature. */ double get_temperature(const Point<3> &position, + const WorldBuilder::Utilities::NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity, double temperature, @@ -80,7 +82,9 @@ namespace WorldBuilder private: // uniform temperature submodule parameters double min_depth; + Objects::Surface min_depth_surface; double max_depth; + Objects::Surface max_depth_surface; double temperature; Utilities::Operations operation; diff --git a/source/features/mantle_layer.cc b/source/features/mantle_layer.cc index 88131142b..ee22045e1 100644 --- a/source/features/mantle_layer.cc +++ b/source/features/mantle_layer.cc @@ -23,9 +23,13 @@ #include "world_builder/features/mantle_layer_models/composition/interface.h" #include "world_builder/features/mantle_layer_models/grains/interface.h" #include "world_builder/features/mantle_layer_models/temperature/interface.h" +#include "world_builder/types/array.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" +#include "world_builder/types/value_at_points.h" #include "world_builder/types/plugin_system.h" +#include "world_builder/kd_tree.h" #include "world_builder/world.h" @@ -53,9 +57,9 @@ namespace WorldBuilder { prm.declare_entry("", Types::Object(required_entries), "Mantle layer object"); - prm.declare_entry("min depth", Types::Double(0), - "The depth to which this feature is present"); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), + "The depth from which this feature is present"); + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth to which this feature is present"); prm.declare_entry("temperature models", Types::PluginSystem("", Features::MantleLayerModels::Temperature::Interface::declare_entries, {"model"}), @@ -76,8 +80,11 @@ namespace WorldBuilder this->name = prm.get("name"); this->get_coordinates("coordinates", prm, coordinate_system); - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; prm.get_unique_pointers("temperature models", temperature_models); @@ -88,7 +95,7 @@ namespace WorldBuilder { prm.enter_subsection(std::to_string(i)); { - temperature_models[i]->parse_entries(prm); + temperature_models[i]->parse_entries(prm,coordinates); } prm.leave_subsection(); } @@ -104,7 +111,7 @@ namespace WorldBuilder { prm.enter_subsection(std::to_string(i)); { - composition_models[i]->parse_entries(prm); + composition_models[i]->parse_entries(prm,coordinates); } prm.leave_subsection(); } @@ -120,7 +127,7 @@ namespace WorldBuilder { prm.enter_subsection(std::to_string(i)); { - grains_models[i]->parse_entries(prm); + grains_models[i]->parse_entries(prm,coordinates); } prm.leave_subsection(); } @@ -140,20 +147,26 @@ namespace WorldBuilder WorldBuilder::Utilities::polygon_contains_point(coordinates, Point<2>(position_in_natural_coordinates.get_surface_coordinates(), world->parameters.coordinate_system->natural_coordinate_system()))) { - for (const auto &temperature_model: temperature_models) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - temperature = temperature_model->get_temperature(position_in_cartesian_coordinates, - depth, - gravity_norm, - temperature, - min_depth, - max_depth); - - WBAssert(!std::isnan(temperature), "Temparture is not a number: " << temperature - << ", based on a temperature model with the name " << temperature_model->get_name()); - WBAssert(std::isfinite(temperature), "Temparture is not a finite: " << temperature - << ", based on a temperature model with the name " << temperature_model->get_name()); - + for (const auto &temperature_model: temperature_models) + { + temperature = temperature_model->get_temperature(position_in_cartesian_coordinates, + position_in_natural_coordinates, + depth, + gravity_norm, + temperature, + min_depth_local, + max_depth_local); + + WBAssert(!std::isnan(temperature), "Temparture is not a number: " << temperature + << ", based on a temperature model with the name " << temperature_model->get_name()); + WBAssert(std::isfinite(temperature), "Temparture is not a finite: " << temperature + << ", based on a temperature model with the name " << temperature_model->get_name()); + + } } } @@ -171,20 +184,26 @@ namespace WorldBuilder WorldBuilder::Utilities::polygon_contains_point(coordinates, Point<2>(position_in_natural_coordinates.get_surface_coordinates(), world->parameters.coordinate_system->natural_coordinate_system()))) { - for (const auto &composition_model: composition_models) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - composition = composition_model->get_composition(position_in_cartesian_coordinates, - depth, - composition_number, - composition, - min_depth, - max_depth); - - WBAssert(!std::isnan(composition), "Composition is not a number: " << composition - << ", based on a temperature model with the name " << composition_model->get_name()); - WBAssert(std::isfinite(composition), "Composition is not a finite: " << composition - << ", based on a temperature model with the name " << composition_model->get_name()); - + for (const auto &composition_model: composition_models) + { + composition = composition_model->get_composition(position_in_cartesian_coordinates, + position_in_natural_coordinates, + depth, + composition_number, + composition, + min_depth_local, + max_depth_local); + + WBAssert(!std::isnan(composition), "Composition is not a number: " << composition + << ", based on a temperature model with the name " << composition_model->get_name()); + WBAssert(std::isfinite(composition), "Composition is not a finite: " << composition + << ", based on a temperature model with the name " << composition_model->get_name()); + + } } } @@ -204,20 +223,26 @@ namespace WorldBuilder WorldBuilder::Utilities::polygon_contains_point(coordinates, Point<2>(position_in_natural_coordinates.get_surface_coordinates(), world->parameters.coordinate_system->natural_coordinate_system()))) { - for (const auto &grains_model: grains_models) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - grains = grains_model->get_grains(position_in_cartesian_coordinates, - depth, - composition_number, - grains, - min_depth, - max_depth); - - /*WBAssert(!std::isnan(composition), "Composition is not a number: " << composition - << ", based on a temperature model with the name " << composition_model->get_name()); - WBAssert(std::isfinite(composition), "Composition is not a finite: " << composition - << ", based on a temperature model with the name " << composition_model->get_name());*/ - + for (const auto &grains_model: grains_models) + { + grains = grains_model->get_grains(position_in_cartesian_coordinates, + position_in_natural_coordinates, + depth, + composition_number, + grains, + min_depth_local, + max_depth_local); + + /*WBAssert(!std::isnan(composition), "Composition is not a number: " << composition + << ", based on a temperature model with the name " << composition_model->get_name()); + WBAssert(std::isfinite(composition), "Composition is not a finite: " << composition + << ", based on a temperature model with the name " << composition_model->get_name());*/ + + } } } diff --git a/source/features/mantle_layer_models/composition/uniform.cc b/source/features/mantle_layer_models/composition/uniform.cc index 904d97e11..303b60d9f 100644 --- a/source/features/mantle_layer_models/composition/uniform.cc +++ b/source/features/mantle_layer_models/composition/uniform.cc @@ -24,6 +24,8 @@ #include "world_builder/types/array.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" +#include "world_builder/types/value_at_points.h" #include "world_builder/types/unsigned_int.h" #include "world_builder/utilities.h" @@ -61,9 +63,9 @@ namespace WorldBuilder "Uniform compositional model. Sets constant compositional field."); // Declare entries of this plugin - prm.declare_entry("min depth", Types::Double(0), + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), "The depth in meters from which the composition of this feature is present."); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth in meters to which the composition of this feature is present."); prm.declare_entry("compositions", Types::Array(Types::UnsignedInt(),0), "A list with the labels of the composition which are present there."); @@ -77,10 +79,12 @@ namespace WorldBuilder } void - Uniform::parse_entries(Parameters &prm) + Uniform::parse_entries(Parameters &prm, const std::vector> &coordinates) { - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; compositions = prm.get_vector("compositions"); fractions = prm.get_vector("fractions"); operation = prm.get("operation"); @@ -92,6 +96,7 @@ namespace WorldBuilder double Uniform::get_composition(const Point<3> & /*position_in_cartesian_coordinates*/, + const NaturalCoordinate &position_in_natural_coordinates, const double depth, const unsigned int composition_number, double composition_, @@ -101,16 +106,21 @@ namespace WorldBuilder double composition = composition_; if (depth <= max_depth && depth >= min_depth) { - for (unsigned int i =0; i < compositions.size(); ++i) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - if (compositions[i] == composition_number) + for (unsigned int i =0; i < compositions.size(); ++i) { - return fractions[i]; + if (compositions[i] == composition_number) + { + return fractions[i]; + } } - } - if (operation == "replace") - return 0.0; + if (operation == "replace") + return 0.0; + } } return composition; } diff --git a/source/features/mantle_layer_models/grains/random_uniform_distribution.cc b/source/features/mantle_layer_models/grains/random_uniform_distribution.cc index f827586a0..4b022bd8c 100644 --- a/source/features/mantle_layer_models/grains/random_uniform_distribution.cc +++ b/source/features/mantle_layer_models/grains/random_uniform_distribution.cc @@ -26,6 +26,8 @@ #include "world_builder/types/bool.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" +#include "world_builder/types/value_at_points.h" #include "world_builder/types/unsigned_int.h" #include "world_builder/utilities.h" #include "world_builder/world.h" @@ -63,9 +65,9 @@ namespace WorldBuilder "to a single value or to a random distribution."); // Declare entries of this plugin - prm.declare_entry("min depth", Types::Double(0), + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), "The depth in meters from which the composition of this feature is present."); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth in meters to which the composition of this feature is present."); prm.declare_entry("compositions", Types::Array(Types::UnsignedInt(),0), @@ -89,10 +91,12 @@ namespace WorldBuilder } void - RandomUniformDistribution::parse_entries(Parameters &prm) + RandomUniformDistribution::parse_entries(Parameters &prm, const std::vector> &coordinates) { - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; compositions = prm.get_vector("compositions"); operation = prm.get("orientation operation"); @@ -111,6 +115,7 @@ namespace WorldBuilder WorldBuilder::grains RandomUniformDistribution::get_grains(const Point<3> & /*position_in_cartesian_coordinates*/, + const NaturalCoordinate &position_in_natural_coordinates, const double depth, const unsigned int composition_number, WorldBuilder::grains grains_, @@ -120,87 +125,92 @@ namespace WorldBuilder WorldBuilder::grains grains_local = grains_; if (depth <= max_depth && depth >= min_depth) { - for (unsigned int i =0; i < compositions.size(); ++i) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - if (compositions[i] == composition_number) + for (unsigned int i =0; i < compositions.size(); ++i) { - std::uniform_real_distribution<> dist(0.0,1.0); - for (auto &&it_rotation_matrices : grains_local.rotation_matrices) + if (compositions[i] == composition_number) { - // set a uniform random a_cosine_matrix per grain - // This function is based on an article in Graphic Gems III, written by James Arvo, Cornell University (p 116-120). - // The original code can be found on http://www.realtimerendering.com/resources/GraphicsGems/gemsiii/rand_rotation.c - // and is licenend accourding to this website with the following licence: - // - // "The Graphics Gems code is copyright-protected. In other words, you cannot claim the text of the code as your own and - // resell it. Using the code is permitted in any program, product, or library, non-commercial or commercial. Giving credit - // is not required, though is a nice gesture. The code comes as-is, and if there are any flaws or problems with any Gems - // code, nobody involved with Gems - authors, editors, publishers, or webmasters - are to be held responsible. Basically, - // don't be a jerk, and remember that anything free comes with no guarantee."" - // - // The book saids in the preface the following: "As in the first two volumes, all of the C and C++ code in this book is in - // the public domain, and is yours to study, modify, and use." - - // first generate three random numbers between 0 and 1 and multiply them with 2 PI or 2 for z. Note that these are not the same as phi_1, theta and phi_2. - double one = dist(world->get_random_number_engine()); - double two = dist(world->get_random_number_engine()); - double three = dist(world->get_random_number_engine()); - - double theta = 2.0 * const_pi * one; // Rotation about the pole (Z) - double phi = 2.0 * const_pi * two; // For direction of pole deflection. - double z = 2.0* three; //For magnitude of pole deflection. - - // Compute a vector V used for distributing points over the sphere - // via the reflection I - V Transpose(V). This formulation of V - // will guarantee that if x[1] and x[2] are uniformly distributed, - // the reflected points will be uniform on the sphere. Note that V - // has length sqrt(2) to eliminate the 2 in the Householder matrix. - - double r = std::sqrt( z ); - double Vx = std::sin( phi ) * r; - double Vy = std::cos( phi ) * r; - double Vz = std::sqrt( 2.F - z ); - - // Compute the row vector S = Transpose(V) * R, where R is a simple - // rotation by theta about the z-axis. No need to compute Sz since - // it's just Vz. - - double st = std::sin( theta ); - double ct = std::cos( theta ); - double Sx = Vx * ct - Vy * st; - double Sy = Vx * st + Vy * ct; - - // Construct the rotation matrix ( V Transpose(V) - I ) R, which - // is equivalent to V S - R. - - it_rotation_matrices[0][0] = Vx * Sx - ct; - it_rotation_matrices[0][1] = Vx * Sy - st; - it_rotation_matrices[0][2] = Vx * Vz; - - it_rotation_matrices[1][0] = Vy * Sx + st; - it_rotation_matrices[1][1] = Vy * Sy - ct; - it_rotation_matrices[1][2] = Vy * Vz; - - it_rotation_matrices[2][0] = Vz * Sx; - it_rotation_matrices[2][1] = Vz * Sy; - it_rotation_matrices[2][2] = 1.0 - z; // This equals Vz * Vz - 1.0 + std::uniform_real_distribution<> dist(0.0,1.0); + for (auto &&it_rotation_matrices : grains_local.rotation_matrices) + { + // set a uniform random a_cosine_matrix per grain + // This function is based on an article in Graphic Gems III, written by James Arvo, Cornell University (p 116-120). + // The original code can be found on http://www.realtimerendering.com/resources/GraphicsGems/gemsiii/rand_rotation.c + // and is licenend accourding to this website with the following licence: + // + // "The Graphics Gems code is copyright-protected. In other words, you cannot claim the text of the code as your own and + // resell it. Using the code is permitted in any program, product, or library, non-commercial or commercial. Giving credit + // is not required, though is a nice gesture. The code comes as-is, and if there are any flaws or problems with any Gems + // code, nobody involved with Gems - authors, editors, publishers, or webmasters - are to be held responsible. Basically, + // don't be a jerk, and remember that anything free comes with no guarantee."" + // + // The book saids in the preface the following: "As in the first two volumes, all of the C and C++ code in this book is in + // the public domain, and is yours to study, modify, and use." + + // first generate three random numbers between 0 and 1 and multiply them with 2 PI or 2 for z. Note that these are not the same as phi_1, theta and phi_2. + double one = dist(world->get_random_number_engine()); + double two = dist(world->get_random_number_engine()); + double three = dist(world->get_random_number_engine()); + + double theta = 2.0 * const_pi * one; // Rotation about the pole (Z) + double phi = 2.0 * const_pi * two; // For direction of pole deflection. + double z = 2.0* three; //For magnitude of pole deflection. + + // Compute a vector V used for distributing points over the sphere + // via the reflection I - V Transpose(V). This formulation of V + // will guarantee that if x[1] and x[2] are uniformly distributed, + // the reflected points will be uniform on the sphere. Note that V + // has length sqrt(2) to eliminate the 2 in the Householder matrix. + + double r = std::sqrt( z ); + double Vx = std::sin( phi ) * r; + double Vy = std::cos( phi ) * r; + double Vz = std::sqrt( 2.F - z ); + + // Compute the row vector S = Transpose(V) * R, where R is a simple + // rotation by theta about the z-axis. No need to compute Sz since + // it's just Vz. + + double st = std::sin( theta ); + double ct = std::cos( theta ); + double Sx = Vx * ct - Vy * st; + double Sy = Vx * st + Vy * ct; + + // Construct the rotation matrix ( V Transpose(V) - I ) R, which + // is equivalent to V S - R. + + it_rotation_matrices[0][0] = Vx * Sx - ct; + it_rotation_matrices[0][1] = Vx * Sy - st; + it_rotation_matrices[0][2] = Vx * Vz; + + it_rotation_matrices[1][0] = Vy * Sx + st; + it_rotation_matrices[1][1] = Vy * Sy - ct; + it_rotation_matrices[1][2] = Vy * Vz; + + it_rotation_matrices[2][0] = Vz * Sx; + it_rotation_matrices[2][1] = Vz * Sy; + it_rotation_matrices[2][2] = 1.0 - z; // This equals Vz * Vz - 1.0 + } + + double total_size = 0; + for (auto &&it_sizes : grains_local.sizes) + { + it_sizes = grain_sizes[i] < 0 ? dist(world->get_random_number_engine()) : grain_sizes[i]; + total_size += it_sizes; + } + + if (normalize_grain_sizes[i]) + { + const double one_over_total_size = 1/total_size; + std::transform(grains_local.sizes.begin(), grains_local.sizes.end(), grains_local.sizes.begin(), + [one_over_total_size](double sizes) -> double { return sizes *one_over_total_size; }); + } + + return grains_local; } - - double total_size = 0; - for (auto &&it_sizes : grains_local.sizes) - { - it_sizes = grain_sizes[i] < 0 ? dist(world->get_random_number_engine()) : grain_sizes[i]; - total_size += it_sizes; - } - - if (normalize_grain_sizes[i]) - { - const double one_over_total_size = 1/total_size; - std::transform(grains_local.sizes.begin(), grains_local.sizes.end(), grains_local.sizes.begin(), - [one_over_total_size](double sizes) -> double { return sizes *one_over_total_size; }); - } - - return grains_local; } } } diff --git a/source/features/mantle_layer_models/grains/uniform.cc b/source/features/mantle_layer_models/grains/uniform.cc index 14ea57e48..af76cbd1d 100644 --- a/source/features/mantle_layer_models/grains/uniform.cc +++ b/source/features/mantle_layer_models/grains/uniform.cc @@ -24,6 +24,8 @@ #include "world_builder/types/array.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" +#include "world_builder/types/value_at_points.h" #include "world_builder/types/unsigned_int.h" #include "world_builder/utilities.h" @@ -61,9 +63,9 @@ namespace WorldBuilder "Uniform grains model. All grains start exactly the same."); // Declare entries of this plugin - prm.declare_entry("min depth", Types::Double(0), + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), "The depth in meters from which the composition of this feature is present."); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth in meters to which the composition of this feature is present."); prm.declare_entry("compositions", Types::Array(Types::UnsignedInt(),0), @@ -88,10 +90,12 @@ namespace WorldBuilder } void - Uniform::parse_entries(Parameters &prm) + Uniform::parse_entries(Parameters &prm, const std::vector> &coordinates) { - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; compositions = prm.get_vector("compositions"); const bool set_euler_angles = prm.check_entry("Euler angles z-x-z"); @@ -133,6 +137,7 @@ namespace WorldBuilder WorldBuilder::grains Uniform::get_grains(const Point<3> & /*position_in_cartesian_coordinates*/, + const NaturalCoordinate &position_in_natural_coordinates, const double depth, const unsigned int composition_number, WorldBuilder::grains grains_, @@ -142,16 +147,21 @@ namespace WorldBuilder WorldBuilder::grains grains_local = grains_; if (depth <= max_depth && depth >= min_depth) { - for (unsigned int i =0; i < compositions.size(); ++i) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - if (compositions[i] == composition_number) + for (unsigned int i =0; i < compositions.size(); ++i) { - std::fill(grains_local.rotation_matrices.begin(),grains_local.rotation_matrices.end(),rotation_matrices[i]); + if (compositions[i] == composition_number) + { + std::fill(grains_local.rotation_matrices.begin(),grains_local.rotation_matrices.end(),rotation_matrices[i]); - const double size = grain_sizes[i] < 0 ? 1.0/static_cast(grains_local.sizes.size()) : grain_sizes[i]; - std::fill(grains_local.sizes.begin(),grains_local.sizes.end(),size); + const double size = grain_sizes[i] < 0 ? 1.0/static_cast(grains_local.sizes.size()) : grain_sizes[i]; + std::fill(grains_local.sizes.begin(),grains_local.sizes.end(),size); - return grains_local; + return grains_local; + } } } } diff --git a/source/features/mantle_layer_models/temperature/adiabatic.cc b/source/features/mantle_layer_models/temperature/adiabatic.cc index 9746e149c..e0615cb01 100644 --- a/source/features/mantle_layer_models/temperature/adiabatic.cc +++ b/source/features/mantle_layer_models/temperature/adiabatic.cc @@ -21,8 +21,11 @@ #include "world_builder/nan.h" +#include "world_builder/types/array.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" +#include "world_builder/types/value_at_points.h" #include "world_builder/utilities.h" #include "world_builder/world.h" @@ -61,10 +64,10 @@ namespace WorldBuilder "Adiabatic temperature model. Uses global values by default."); // Declare entries of this plugin - prm.declare_entry("min depth", Types::Double(0), + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), "The depth in meters from which the temperature of this feature is present."); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth in meters to which the temperature of this feature is present."); prm.declare_entry("potential mantle temperature", Types::Double(-1), @@ -82,11 +85,12 @@ namespace WorldBuilder } void - Adiabatic::parse_entries(Parameters &prm) + Adiabatic::parse_entries(Parameters &prm, const std::vector> &coordinates) { - - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; operation = Utilities::string_operations_to_enum(prm.get("operation")); potential_mantle_temperature = prm.get("potential mantle temperature"); @@ -123,6 +127,7 @@ namespace WorldBuilder double Adiabatic::get_temperature(const Point<3> & /*position_in_cartesian_coordinates*/, + const NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity_norm, double temperature_, @@ -132,23 +137,28 @@ namespace WorldBuilder if (depth <= max_depth && depth >= min_depth) { - const double adabatic_temperature = potential_mantle_temperature * - std::exp(((thermal_expansion_coefficient * gravity_norm) / - specific_heat) * depth); - - - WBAssert(!std::isnan(adabatic_temperature), - "adabatic_temperature is not a number: " << adabatic_temperature << ". " - <<"Parameters: potential_mantle_temperature = " << potential_mantle_temperature - <<", thermal_expansion_coefficient = " << thermal_expansion_coefficient - << ", gravity_norm = " << gravity_norm - << ", specific_heat = " << specific_heat - << ", depth = " << depth); - - WBAssert(std::isfinite(adabatic_temperature), - "adabatic_temperature is not a finite: " << adabatic_temperature << '.'); - - return Utilities::apply_operation(operation,temperature_,adabatic_temperature); + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) + { + const double adabatic_temperature = potential_mantle_temperature * + std::exp(((thermal_expansion_coefficient * gravity_norm) / + specific_heat) * depth); + + + WBAssert(!std::isnan(adabatic_temperature), + "adabatic_temperature is not a number: " << adabatic_temperature << ". " + <<"Parameters: potential_mantle_temperature = " << potential_mantle_temperature + <<", thermal_expansion_coefficient = " << thermal_expansion_coefficient + << ", gravity_norm = " << gravity_norm + << ", specific_heat = " << specific_heat + << ", depth = " << depth); + + WBAssert(std::isfinite(adabatic_temperature), + "adabatic_temperature is not a finite: " << adabatic_temperature << '.'); + + return Utilities::apply_operation(operation,temperature_,adabatic_temperature); + } } return temperature_; diff --git a/source/features/mantle_layer_models/temperature/linear.cc b/source/features/mantle_layer_models/temperature/linear.cc index def14ef4c..a5e2fc53f 100644 --- a/source/features/mantle_layer_models/temperature/linear.cc +++ b/source/features/mantle_layer_models/temperature/linear.cc @@ -21,8 +21,11 @@ #include "world_builder/nan.h" +#include "world_builder/types/array.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" +#include "world_builder/types/value_at_points.h" #include "world_builder/utilities.h" #include "world_builder/world.h" @@ -61,10 +64,10 @@ namespace WorldBuilder "Linear temperature model. Can be set to use an adiabatic temperature at the boundaries."); // Declare entries of this plugin - prm.declare_entry("min depth", Types::Double(0), + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), "The depth in meters from which the temperature of this feature is present."); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth in meters to which the temperature of this feature is present."); prm.declare_entry("top temperature", Types::Double(293.15), @@ -77,10 +80,12 @@ namespace WorldBuilder } void - Linear::parse_entries(Parameters &prm) + Linear::parse_entries(Parameters &prm, const std::vector> &coordinates) { - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; WBAssert(max_depth >= min_depth, "max depth needs to be larger or equal to min depth."); operation = Utilities::string_operations_to_enum(prm.get("operation")); top_temperature = prm.get("top temperature"); @@ -90,6 +95,7 @@ namespace WorldBuilder double Linear::get_temperature(const Point<3> & /*position_in_cartesian_coordinates*/, + const NaturalCoordinate &position_in_natural_coordinates, const double depth, const double gravity_norm, double temperature_, @@ -98,31 +104,36 @@ namespace WorldBuilder { if (depth <= max_depth && depth >= min_depth) { - const double min_depth_local = std::max(feature_min_depth, min_depth); - const double max_depth_local = std::min(feature_max_depth, max_depth); - - double top_temperature_local = top_temperature; - if (top_temperature_local < 0) + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) { - top_temperature_local = this->world->potential_mantle_temperature * - std::exp(((this->world->thermal_expansion_coefficient * gravity_norm) / - this->world->specific_heat) * min_depth_local); + const double min_depth_local_local = std::max(feature_min_depth, min_depth_local); + const double max_depth_local_local = std::min(feature_max_depth, max_depth_local); + + double top_temperature_local = top_temperature; + if (top_temperature_local < 0) + { + top_temperature_local = this->world->potential_mantle_temperature * + std::exp(((this->world->thermal_expansion_coefficient * gravity_norm) / + this->world->specific_heat) * min_depth_local_local); + } + + double bottom_temperature_local = bottom_temperature; + if (bottom_temperature_local < 0) + { + bottom_temperature_local = this->world->potential_mantle_temperature * + std::exp(((this->world->thermal_expansion_coefficient * gravity_norm) / + this->world->specific_heat) * max_depth_local_local); + + } + + const double new_temperature = top_temperature_local + + (depth - min_depth_local_local) * + ((bottom_temperature_local - top_temperature_local) / (max_depth_local_local - min_depth_local_local)); + + return Utilities::apply_operation(operation,temperature_,new_temperature); } - - double bottom_temperature_local = bottom_temperature; - if (bottom_temperature_local < 0) - { - bottom_temperature_local = this->world->potential_mantle_temperature * - std::exp(((this->world->thermal_expansion_coefficient * gravity_norm) / - this->world->specific_heat) * max_depth_local); - - } - - const double new_temperature = top_temperature_local + - (depth - min_depth_local) * - ((bottom_temperature_local - top_temperature_local) / (max_depth_local - min_depth_local)); - - return Utilities::apply_operation(operation,temperature_,new_temperature); } diff --git a/source/features/mantle_layer_models/temperature/uniform.cc b/source/features/mantle_layer_models/temperature/uniform.cc index c968843dc..cc080c775 100644 --- a/source/features/mantle_layer_models/temperature/uniform.cc +++ b/source/features/mantle_layer_models/temperature/uniform.cc @@ -21,8 +21,11 @@ #include "world_builder/nan.h" +#include "world_builder/types/array.h" #include "world_builder/types/double.h" #include "world_builder/types/object.h" +#include "world_builder/types/one_of.h" +#include "world_builder/types/value_at_points.h" #include "world_builder/utilities.h" @@ -60,10 +63,10 @@ namespace WorldBuilder "Uniform temperature model. Set the temperature to a constan value."); // Declare entries of this plugin - prm.declare_entry("min depth", Types::Double(0), + prm.declare_entry("min depth", Types::OneOf(Types::Double(0),Types::Array(Types::ValueAtPoints(0.))), "The depth in meters from which the temperature of this feature is present."); - prm.declare_entry("max depth", Types::Double(std::numeric_limits::max()), + prm.declare_entry("max depth", Types::OneOf(Types::Double(std::numeric_limits::max()),Types::Array(Types::ValueAtPoints(std::numeric_limits::max()))), "The depth in meters to which the temperature of this feature is present."); prm.declare_entry("temperature", Types::Double(293.15), @@ -73,11 +76,12 @@ namespace WorldBuilder } void - Uniform::parse_entries(Parameters &prm) + Uniform::parse_entries(Parameters &prm, const std::vector> &coordinates) { - - min_depth = prm.get("min depth"); - max_depth = prm.get("max depth"); + min_depth_surface = Objects::Surface(prm.get("min depth",coordinates)); + min_depth = min_depth_surface.minimum; + max_depth_surface = Objects::Surface(prm.get("max depth",coordinates)); + max_depth = max_depth_surface.maximum; operation = Utilities::string_operations_to_enum(prm.get("operation")); temperature = prm.get("temperature"); } @@ -85,6 +89,7 @@ namespace WorldBuilder double Uniform::get_temperature(const Point<3> & /*position_in_cartesian_coordinates*/, + const NaturalCoordinate &position_in_natural_coordinates, const double depth, const double /*gravity*/, double temperature_, @@ -94,7 +99,12 @@ namespace WorldBuilder if (depth <= max_depth && depth >= min_depth) { - return Utilities::apply_operation(operation,temperature_,temperature); + const double min_depth_local = min_depth_surface.constant_value ? min_depth : min_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + const double max_depth_local = max_depth_surface.constant_value ? max_depth : max_depth_surface.local_value(position_in_natural_coordinates.get_surface_point()); + if (depth <= max_depth_local && depth >= min_depth_local) + { + return Utilities::apply_operation(operation,temperature_,temperature); + } } return temperature_; From b8ce188a87ac2afbfe04ee8cef2b34236298446a Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Fri, 25 Mar 2022 17:27:15 -0700 Subject: [PATCH 23/26] Add mantle_layer_min_max_surface_spherical test. --- ...mantle_layer_min_max_surface_spherical.dat | 293 ++++++++++++++++++ .../mantle_layer_min_max_surface_spherical.wb | 42 +++ .../screen-output.log | 285 +++++++++++++++++ 3 files changed, 620 insertions(+) create mode 100644 tests/app/mantle_layer_min_max_surface_spherical.dat create mode 100644 tests/app/mantle_layer_min_max_surface_spherical.wb create mode 100644 tests/app/mantle_layer_min_max_surface_spherical/screen-output.log diff --git a/tests/app/mantle_layer_min_max_surface_spherical.dat b/tests/app/mantle_layer_min_max_surface_spherical.dat new file mode 100644 index 000000000..7331c6bb7 --- /dev/null +++ b/tests/app/mantle_layer_min_max_surface_spherical.dat @@ -0,0 +1,293 @@ +# This is a comment in the data +# file. +# Now define parameters: +# dim = 3 +# compositions = 5 +# grain compositions = 2 +# number of grains = 2 +# convert spherical = true +# R long lat d g T c1 c2 c3 c4 c5 +1 0 0 1 10 +1 0 0 10e3 10 +1 0 0 40e3 10 +1 0 0 60e3 10 +1 0 0 150e3 10 +1 0 0 250e3 10 +1 0 0 350e3 10 +1 0 2.5 1 10 +1 0 2.5 10e3 10 +1 0 2.5 40e3 10 +1 0 2.5 60e3 10 +1 0 2.5 150e3 10 +1 0 2.5 250e3 10 +1 0 2.5 350e3 10 +1 0 5 1 10 +1 0 5 10e3 10 +1 0 5 40e3 10 +1 0 5 60e3 10 +1 0 5 150e3 10 +1 0 5 250e3 10 +1 0 5 350e3 10 +1 0 5.07 1 10 +1 0 7.5 1 10 +1 0 7.5 10e3 10 +1 0 7.5 40e3 10 +1 0 7.5 60e3 10 +1 0 7.5 150e3 10 +1 0 7.5 250e3 10 +1 0 7.5 350e3 10 +1 0 10 1 10 +1 0 10 10e3 10 +1 0 10 40e3 10 +1 0 10 60e3 10 +1 0 10 150e3 10 +1 0 10 250e3 10 +1 0 10 350e3 10 +1 5 0 1 10 +1 5 0 10e3 10 +1 5 0 40e3 10 +1 5 0 60e3 10 +1 5 0 150e3 10 +1 5 0 250e3 10 +1 5 0 350e3 10 +1 5 2.5 1 10 +1 5 2.5 10e3 10 +1 5 2.5 40e3 10 +1 5 2.5 60e3 10 +1 5 2.5 150e3 10 +1 5 2.5 250e3 10 +1 5 2.5 350e3 10 +1 5 5 1 10 +1 5 5 10e3 10 +1 5 5 40e3 10 +1 5 5 60e3 10 +1 5 5 150e3 10 +1 5 5 250e3 10 +1 5 5 350e3 10 +1 5 5.07 1 10 +1 5 7.5 1 10 +1 5 7.5 10e3 10 +1 5 7.5 40e3 10 +1 5 7.5 60e3 10 +1 5 7.5 150e3 10 +1 5 7.5 250e3 10 +1 5 7.5 350e3 10 +1 5 10 1 10 +1 5 10 10e3 10 +1 5 10 40e3 10 +1 5 10 60e3 10 +1 5 10 150e3 10 +1 5 10 250e3 10 +1 5 10 350e3 10 +1 10 0 10e3 10 +1 10 0 40e3 10 +1 10 0 60e3 10 +1 10 0 150e3 10 +1 10 0 250e3 10 +1 10 0 350e3 10 +1 10 2.5 1 10 +1 10 2.5 10e3 10 +1 10 2.5 40e3 10 +1 10 2.5 60e3 10 +1 10 2.5 150e3 10 +1 10 2.5 250e3 10 +1 10 2.5 350e3 10 +1 10 5 1 10 +1 10 5 10e3 10 +1 10 5 40e3 10 +1 10 5 60e3 10 +1 10 5 150e3 10 +1 10 5 250e3 10 +1 10 5 350e3 10 +1 10 5.07 1 10 +1 10 7.5 1 10 +1 10 7.5 10e3 10 +1 10 7.5 40e3 10 +1 10 7.5 60e3 10 +1 10 7.5 150e3 10 +1 10 7.5 250e3 10 +1 10 7.5 350e3 10 +1 10 10 1 10 +1 10 10 10e3 10 +1 10 10 40e3 10 +1 10 10 60e3 10 +1 10 10 150e3 10 +1 10 10 250e3 10 +1 10 10 350e3 10 +1 175 0 1 10 +1 175 0 10e3 10 +1 175 0 40e3 10 +1 175 0 60e3 10 +1 175 0 150e3 10 +1 175 0 250e3 10 +1 175 0 350e3 10 +1 175 2.5 1 10 +1 175 2.5 10e3 10 +1 175 2.5 40e3 10 +1 175 2.5 60e3 10 +1 175 2.5 150e3 10 +1 175 2.5 250e3 10 +1 175 2.5 350e3 10 +1 175 5 1 10 +1 175 5 10e3 10 +1 175 5 40e3 10 +1 175 5 60e3 10 +1 175 5 150e3 10 +1 175 5 250e3 10 +1 175 5 350e3 10 +1 175 5.07 1 10 +1 175 7.5 1 10 +1 175 7.5 10e3 10 +1 175 7.5 40e3 10 +1 175 7.5 60e3 10 +1 175 7.5 150e3 10 +1 175 7.5 250e3 10 +1 175 7.5 350e3 10 +1 175 10 1 10 +1 175 10 10e3 10 +1 175 10 40e3 10 +1 175 10 60e3 10 +1 175 10 150e3 10 +1 175 10 250e3 10 +1 175 10 350e3 10 +1 180 0 1 10 +1 180 0 10e3 10 +1 180 0 40e3 10 +1 180 0 60e3 10 +1 180 0 150e3 10 +1 180 0 250e3 10 +1 180 0 350e3 10 +1 180 2.5 1 10 +1 180 2.5 10e3 10 +1 180 2.5 40e3 10 +1 180 2.5 60e3 10 +1 180 2.5 150e3 10 +1 180 2.5 250e3 10 +1 180 2.5 350e3 10 +1 180 5 1 10 +1 180 5 10e3 10 +1 180 5 40e3 10 +1 180 5 60e3 10 +1 180 5 150e3 10 +1 180 5 250e3 10 +1 180 5 350e3 10 +1 180 5.07 1 10 +1 180 7.5 1 10 +1 180 7.5 10e3 10 +1 180 7.5 40e3 10 +1 180 7.5 60e3 10 +1 180 7.5 150e3 10 +1 180 7.5 250e3 10 +1 180 7.5 350e3 10 +1 180 10 1 10 +1 180 10 10e3 10 +1 180 10 40e3 10 +1 180 10 60e3 10 +1 180 10 150e3 10 +1 180 10 250e3 10 +1 180 10 350e3 10 +1 185 0 10e3 10 +1 185 0 40e3 10 +1 185 0 60e3 10 +1 185 0 150e3 10 +1 185 0 250e3 10 +1 185 0 350e3 10 +1 185 2.5 1 10 +1 185 2.5 10e3 10 +1 185 2.5 40e3 10 +1 185 2.5 60e3 10 +1 185 2.5 150e3 10 +1 185 2.5 250e3 10 +1 185 2.5 350e3 10 +1 185 5 1 10 +1 185 5 10e3 10 +1 185 5 40e3 10 +1 185 5 60e3 10 +1 185 5 150e3 10 +1 185 5 250e3 10 +1 185 5 350e3 10 +1 185 5.07 1 10 +1 185 7.5 1 10 +1 185 7.5 10e3 10 +1 185 7.5 40e3 10 +1 185 7.5 60e3 10 +1 185 7.5 150e3 10 +1 185 7.5 250e3 10 +1 185 7.5 350e3 10 +1 185 10 1 10 +1 185 10 10e3 10 +1 185 10 40e3 10 +1 185 10 60e3 10 +1 185 10 150e3 10 +1 185 10 250e3 10 +1 185 10 350e3 10 +1 -184.9 1.2 1 10 +1 -184.9 1.2 10e3 10 +1 -184.9 1.2 40e3 10 +1 -184.9 1.2 60e3 10 +1 -184.9 1.2 150e3 10 +1 -184.9 1.2 250e3 10 +1 -184.9 1.2 350e3 10 +1 175.05 3.15 1 10 +1 175.05 3.15 10e3 10 +1 175.05 3.15 40e3 10 +1 175.05 3.15 60e3 10 +1 175.05 3.15 150e3 10 +1 175.05 3.15 250e3 10 +1 175.05 3.15 350e3 10 +1 175.15 1.05 1 10 +1 175.15 1.05 10e3 10 +1 175.15 1.05 40e3 10 +1 175.15 1.05 60e3 10 +1 175.15 1.05 150e3 10 +1 175.15 1.05 250e3 10 +1 175.15 1.05 350e3 10 +1 -184.85 1.05 1 10 +1 -184.85 1.05 10e3 10 +1 -184.85 1.05 40e3 10 +1 -184.85 1.05 60e3 10 +1 -184.85 1.05 150e3 10 +1 -184.85 1.05 250e3 10 +1 -184.85 1.05 350e3 10 +1 -179.6 8.2 1 10 +1 -179.6 8.2 10e3 10 +1 -179.6 8.2 40e3 10 +1 -179.6 8.2 60e3 10 +1 -179.6 8.2 150e3 10 +1 -179.6 8.2 250e3 10 +1 -179.6 8.2 350e3 10 +1 180.4 8.2 1 10 +1 180.4 8.2 10e3 10 +1 180.4 8.2 40e3 10 +1 180.4 8.2 60e3 10 +1 180.4 8.2 150e3 10 +1 180.4 8.2 250e3 10 +1 180.4 8.2 350e3 10 +1 -175 4.95 1 10 +1 -175 4.95 10e3 10 +1 -175 4.95 40e3 10 +1 -175 4.95 60e3 10 +1 -175 4.95 150e3 10 +1 -175 4.95 250e3 10 +1 -175 4.95 350e3 10 +1 185 4.95 1 10 +1 185 4.95 10e3 10 +1 185 4.95 40e3 10 +1 185 4.95 60e3 10 +1 185 4.95 150e3 10 +1 185 4.95 250e3 10 +1 185 4.95 350e3 10 +1 -179.95 2.55 1 10 +1 -179.95 2.55 10e3 10 +1 -179.95 2.55 40e3 10 +1 -179.95 2.55 60e3 10 +1 -179.95 2.55 150e3 10 +1 -179.95 2.55 250e3 10 +1 -179.95 2.55 350e3 10 +1 180.05 2.55 1 10 +1 180.05 2.55 10e3 10 +1 180.05 2.55 40e3 10 +1 180.05 2.55 60e3 10 +1 180.05 2.55 150e3 10 +1 180.05 2.55 250e3 10 +1 180.05 2.55 350e3 10 \ No newline at end of file diff --git a/tests/app/mantle_layer_min_max_surface_spherical.wb b/tests/app/mantle_layer_min_max_surface_spherical.wb new file mode 100644 index 000000000..8ed3703c8 --- /dev/null +++ b/tests/app/mantle_layer_min_max_surface_spherical.wb @@ -0,0 +1,42 @@ +{ +"version":"0.5", +"coordinate system":{"model":"spherical", "depth method":"begin at end segment"}, +"features":[ + { + "model":"mantle layer", "name":"Var thickness continent", "coordinates":[[0,10],[10,10],[10,0],[0,0]], + "min depth":[[50e3,[[0,5]]],[200e3,[[10,5]]]], "max depth":[[300e3],[200e3,[[0,5],[10,5]]]], + "temperature models":[ + {"model":"uniform", "min depth":[[50e3,[[0,5]]],[200e3,[[10,5]]]], "max depth":[[200e3],[100e3,[[0,5],[10,5],[0,0]]]], "temperature":150}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[0,5],[10,5],[0,0]]]], "max depth":[[300e3],[200e3,[[0,5],[10,5]]]], "temperature":200} + ], + "composition models":[ + {"model":"uniform", "min depth":[[50e3,[[0,5]]],[200e3,[[10,5]]]], "max depth":[[200e3],[100e3,[[0,5],[10,5],[0,0]]]], "compositions":[0]}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[0,5],[10,5],[0,0]]]], "max depth":[[300e3],[200e3,[[0,5],[10,5]]]], "compositions":[1]} + ], + "grains models":[ + {"model":"uniform", "compositions":[0,1],"rotation matrices":[[[1,2,3],[4,5,6],[7,8,9]],[[10,11,12],[13,14,15],[16,17,18]]],"grain sizes":[-1,0.2], + "min depth":[[50e3,[[0,5]]],[200e3,[[10,5]]]], "max depth":[[200e3],[100e3,[[0,5],[10,5],[0,0]]]]}, + {"model":"uniform", "compositions":[0,1],"rotation matrices":[[[19,20,21],[22,23,24],[25,26,27]],[[28,29,30],[31,32,33],[34,35,36]]],"grain sizes":[-1,0.3], + "min depth":[[200e3],[100e3,[[0,5],[10,5],[0,0]]]], "max depth":[[300e3],[200e3,[[0,5],[10,5]]]]} + ] + }, + { + "model":"mantle layer", "name":"Var thickness continent 2", "coordinates":[[175,10],[185,10],[185,0],[175,0]], + "min depth":[[50e3,[[175,5]]],[200e3,[[185,5]]]], "max depth":[[300e3],[200e3,[[175,5],[185,5]]]], + "temperature models":[ + {"model":"uniform", "min depth":[[50e3,[[175,5]]],[200e3,[[185,5]]]], "max depth":[[200e3],[100e3,[[175,5],[185,5],[175,0]]]], "temperature":150}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[175,5],[185,5],[175,0]]]], "max depth":[[300e3],[200e3,[[175,5],[185,5]]]], "temperature":200} + ], + "composition models":[ + {"model":"uniform", "min depth":[[50e3,[[175,5]]],[200e3,[[185,5]]]], "max depth":[[200e3],[100e3,[[175,5],[185,5],[175,0]]]], "compositions":[0]}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[175,5],[185,5],[175,0]]]], "max depth":[[300e3],[200e3,[[175,5],[185,5]]]], "compositions":[1]} + ], + "grains models":[ + {"model":"uniform", "compositions":[175,1],"rotation matrices":[[[1,2,3],[4,5,6],[7,8,9]],[[185,11,12],[13,14,15],[16,17,18]]],"grain sizes":[-1,0.2], + "min depth":[[50e3,[[175,5]]],[200e3,[[185,5]]]], "max depth":[[200e3],[100e3,[[175,5],[185,5],[175,0]]]]}, + {"model":"uniform", "compositions":[175,1],"rotation matrices":[[[19,20,21],[22,23,24],[25,26,27]],[[28,29,30],[31,32,33],[34,35,36]]],"grain sizes":[-1,0.3], + "min depth":[[200e3],[100e3,[[175,5],[185,5],[175,0]]]], "max depth":[[300e3],[200e3,[[175,5],[185,5]]]]} + ] + } +] +} diff --git a/tests/app/mantle_layer_min_max_surface_spherical/screen-output.log b/tests/app/mantle_layer_min_max_surface_spherical/screen-output.log new file mode 100644 index 000000000..efd37999b --- /dev/null +++ b/tests/app/mantle_layer_min_max_surface_spherical/screen-output.log @@ -0,0 +1,285 @@ +# x y z d g T c0 c1 c2 c3 c4 gs0-0 gm0-0[0:0] gm0-0[0:1] gm0-0[0:2] gm0-0[1:0] gm0-0[1:1] gm0-0[1:2] gm0-0[2:0] gm0-0[2:1] gm0-0[2:2] gs0-1 gm0-1[0:0] gm0-1[0:1] gm0-1[0:2] gm0-1[1:0] gm0-1[1:1] gm0-1[1:2] gm0-1[2:0] gm0-1[2:1] gm0-1[2:2] gs1-0 gm1-0[0:0] gm1-0[0:1] gm1-0[0:2] gm1-0[1:0] gm1-0[1:1] gm1-0[1:2] gm1-0[2:0] gm1-0[2:1] gm1-0[2:2] gs1-1 gm1-1[0:0] gm1-1[0:1] gm1-1[0:2] gm1-1[1:0] gm1-1[1:1] gm1-1[1:2] gm1-1[2:0] gm1-1[2:1] gm1-1[2:2] +1 0 0 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 0 10e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 0 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 0 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 0 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 0 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 0 0 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 2.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 2.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 2.5 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 2.5 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 2.5 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 2.5 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 0 2.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 5 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 5 150e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 0 5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 5.07 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 7.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 7.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 7.5 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 7.5 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 7.5 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 0 7.5 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 0 7.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 0 10 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 0 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 0 10e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 0 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 0 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 0 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 0 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 5 0 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 2.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 2.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 2.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 2.5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 2.5 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 2.5 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 5 2.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5 150e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 5 5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 5.07 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 7.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 7.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 7.5 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 7.5 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 7.5 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 5 7.5 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 5 7.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 5 10 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 0 10e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 0 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 0 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 0 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 0 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 10 0 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 2.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 2.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 2.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 2.5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 2.5 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 2.5 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 10 2.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 5.07 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 7.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 7.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 7.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 7.5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 7.5 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 7.5 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 10 7.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 10 10 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 10 10e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 10 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 10 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 10 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1 10 10 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 10 10 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 0 1 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 0 10e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 0 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 0 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 0 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175 0 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175 0 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 2.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 2.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 2.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 2.5 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 2.5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175 2.5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 2.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 5 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175 5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 5.07 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 7.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 7.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 7.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 7.5 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 7.5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175 7.5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 7.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175 10 1 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 10 10e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 10 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 10 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 10 150e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175 10 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175 10 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 0 1 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 0 10e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 0 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 0 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 0 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180 0 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180 0 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 2.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 2.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 2.5 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 2.5 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 2.5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180 2.5 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180 2.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180 5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 5.07 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 7.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 7.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 7.5 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 7.5 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180 7.5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180 7.5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 7.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180 10 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 0 10e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 0 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 0 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 0 150e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 0 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 185 0 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 2.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 2.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 2.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 2.5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 2.5 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 185 2.5 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 185 2.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 5.07 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 7.5 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 7.5 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 7.5 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 7.5 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 7.5 150e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 7.5 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 185 7.5 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 10 1 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 10 10e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 10 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 10 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 10 150e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 185 10 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 185 10 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -184.9 1.2 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -184.9 1.2 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -184.9 1.2 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -184.9 1.2 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -184.9 1.2 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 -184.9 1.2 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 -184.9 1.2 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.05 3.15 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.05 3.15 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.05 3.15 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175.05 3.15 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175.05 3.15 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175.05 3.15 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.05 3.15 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.15 1.05 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.15 1.05 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 175.15 1.05 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175.15 1.05 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 175.15 1.05 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175.15 1.05 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 175.15 1.05 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -184.85 1.05 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -184.85 1.05 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -184.85 1.05 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -184.85 1.05 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -184.85 1.05 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 -184.85 1.05 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 -184.85 1.05 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.6 8.2 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.6 8.2 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.6 8.2 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -179.6 8.2 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -179.6 8.2 150e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -179.6 8.2 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 -179.6 8.2 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.4 8.2 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.4 8.2 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.4 8.2 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180.4 8.2 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180.4 8.2 150e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180.4 8.2 250e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180.4 8.2 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -175 4.95 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 150e3 10 1668.63 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 185 4.95 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.95 2.55 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.95 2.55 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.95 2.55 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -179.95 2.55 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 -179.95 2.55 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 -179.95 2.55 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 -179.95 2.55 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.05 2.55 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.05 2.55 10e3 10 1604.49 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.05 2.55 40e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180.05 2.55 60e3 10 150 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.2 185 11 12 13 14 15 16 17 18 0.2 185 11 12 13 14 15 16 17 18 +1 180.05 2.55 150e3 10 200 0 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +1 180.05 2.55 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1 180.05 2.55 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 From 1615a87cf73f6ae4b6069326147c6e7860be7a4e Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Fri, 25 Mar 2022 17:28:21 -0700 Subject: [PATCH 24/26] Add mantle_layer_min_max_surface test. --- tests/app/mantle_layer_min_max_surface.dat | 62 +++++++++++++++++++ tests/app/mantle_layer_min_max_surface.wb | 24 +++++++ .../screen-output.log | 55 ++++++++++++++++ 3 files changed, 141 insertions(+) create mode 100644 tests/app/mantle_layer_min_max_surface.dat create mode 100644 tests/app/mantle_layer_min_max_surface.wb create mode 100644 tests/app/mantle_layer_min_max_surface/screen-output.log diff --git a/tests/app/mantle_layer_min_max_surface.dat b/tests/app/mantle_layer_min_max_surface.dat new file mode 100644 index 000000000..6db2e291b --- /dev/null +++ b/tests/app/mantle_layer_min_max_surface.dat @@ -0,0 +1,62 @@ +# This is a comment in the data +# file. +# Now define parameters: +# dim = 3 +# compositions = 5 +# grain compositions = 2 +# number of grains = 2 +# x y z d g T c1 c2 c3 c4 c5 +0 0 1 1 10 +0 0 1 40e3 10 +0 0 1 60e3 10 +0 0 1 150e3 10 +0 0 1 250e3 10 +0 0 1 350e3 10 +0 250e3 1 1 10 +0 250e3 1 40e3 10 +0 250e3 1 60e3 10 +0 250e3 1 150e3 10 +0 250e3 1 250e3 10 +0 250e3 1 350e3 10 +0 500e3 1 1 10 +0 500e3 1 40e3 10 +0 500e3 1 60e3 10 +0 500e3 1 150e3 10 +0 500e3 1 250e3 10 +0 500e3 1 350e3 10 +0 750e3 1 1 10 +0 1000e3 1 1 10 +250e3 0 1 1 10 +250e3 0 40e3 1 10 +250e3 0 60e3 1 10 +250e3 0 250e3 1 10 +250e3 0 350e3 1 10 +250e3 250e3 1 1 10 +250e3 250e3 1 40e3 10 +250e3 250e3 1 60e3 10 +250e3 250e3 1 150e3 10 +250e3 250e3 1 250e3 10 +250e3 250e3 1 350e3 10 +250e3 500e3 1 1 10 +250e3 500e3 1 40e3 10 +250e3 500e3 1 60e3 10 +250e3 500e3 1 150e3 10 +250e3 500e3 1 250e3 10 +250e3 500e3 1 350e3 10 +250e3 750e3 1 1 10 +250e3 1000e3 1 1 10 +500e3 0 1 1 10 +500e3 250e3 1 1 10 +500e3 500e3 1 1 10 +500e3 750e3 1 1 10 +500e3 1000e3 1 1 10 +750e3 0 1 1 10 +750e3 250e3 1 1 10 +750e3 500e3 1 1 10 +750e3 750e3 1 1 10 +750e3 1000e3 1 1 10 +1000e3 0 1 1 10 +1000e3 250e3 1 1 10 +1000e3 500e3 1 1 10 +1000e3 750e3 1 1 10 +1000e3 1000e3 1 1 10 diff --git a/tests/app/mantle_layer_min_max_surface.wb b/tests/app/mantle_layer_min_max_surface.wb new file mode 100644 index 000000000..722ad8c10 --- /dev/null +++ b/tests/app/mantle_layer_min_max_surface.wb @@ -0,0 +1,24 @@ +{ +"version":"0.5", +"coordinate system":{"model":"cartesian"}, +"features":[ + { + "model":"mantle layer", "name":"Var thickness continent", "coordinates":[[0,1000e3],[1000e3,1000e3],[1000e3,0],[0,0]], + "min depth":[[50e3,[[0,500e3]]],[200e3,[[1000e3,500e3]]]], "max depth":[[300e3],[200e3,[[0,500e3],[1000e3,500e3]]]], + "temperature models":[ + {"model":"uniform", "min depth":[[50e3,[[0,500e3]]],[200e3,[[1000e3,500e3]]]], "max depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]], "temperature":150}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]], "max depth":[[300e3],[200e3,[[0,500e3],[1000e3,500e3]]]], "temperature":200} + ], + "composition models":[ + {"model":"uniform", "min depth":[[50e3,[[0,500e3]]],[200e3,[[1000e3,500e3]]]], "max depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]], "compositions":[0]}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]], "max depth":[[300e3],[200e3,[[0,500e3],[1000e3,500e3]]]], "compositions":[1]} + ], + "grains models":[ + {"model":"uniform", "compositions":[0,1],"rotation matrices":[[[1,2,3],[4,5,6],[7,8,9]],[[10,11,12],[13,14,15],[16,17,18]]],"grain sizes":[-1,0.2], + "min depth":[[50e3,[[0,500e3]]],[200e3,[[1000e3,500e3]]]], "max depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]]}, + {"model":"uniform", "compositions":[0,1],"rotation matrices":[[[19,20,21],[22,23,24],[25,26,27]],[[28,29,30],[31,32,33],[34,35,36]]],"grain sizes":[-1,0.3], + "min depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]], "max depth":[[300e3],[200e3,[[0,500e3],[1000e3,500e3]]]]} + ] + } +] +} diff --git a/tests/app/mantle_layer_min_max_surface/screen-output.log b/tests/app/mantle_layer_min_max_surface/screen-output.log new file mode 100644 index 000000000..aa384f884 --- /dev/null +++ b/tests/app/mantle_layer_min_max_surface/screen-output.log @@ -0,0 +1,55 @@ +# x y z d g T c0 c1 c2 c3 c4 gs0-0 gm0-0[0:0] gm0-0[0:1] gm0-0[0:2] gm0-0[1:0] gm0-0[1:1] gm0-0[1:2] gm0-0[2:0] gm0-0[2:1] gm0-0[2:2] gs0-1 gm0-1[0:0] gm0-1[0:1] gm0-1[0:2] gm0-1[1:0] gm0-1[1:1] gm0-1[1:2] gm0-1[2:0] gm0-1[2:1] gm0-1[2:2] gs1-0 gm1-0[0:0] gm1-0[0:1] gm1-0[0:2] gm1-0[1:0] gm1-0[1:1] gm1-0[1:2] gm1-0[2:0] gm1-0[2:1] gm1-0[2:2] gs1-1 gm1-1[0:0] gm1-1[0:1] gm1-1[0:2] gm1-1[1:0] gm1-1[1:1] gm1-1[1:2] gm1-1[2:0] gm1-1[2:1] gm1-1[2:2] +0 0 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 0 1 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 0 1 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 0 1 150e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 0 1 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +0 0 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 250e3 1 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 250e3 1 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 250e3 1 150e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +0 250e3 1 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +0 250e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 500e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 500e3 1 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +0 500e3 1 150e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +0 500e3 1 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 500e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +0 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 40e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 60e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 250e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 350e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 250e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 250e3 1 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 250e3 1 150e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +250e3 250e3 1 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +250e3 250e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 500e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 500e3 1 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 500e3 1 150e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +250e3 500e3 1 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 500e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +250e3 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +500e3 0 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +500e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +500e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +500e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +500e3 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +750e3 0 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +750e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +750e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +750e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +750e3 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1000e3 0 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +1000e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1000e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1000e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +1000e3 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 From 6594160c20c4e074a75c2ab554e0fa0fac8a044d Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Fri, 25 Mar 2022 17:29:31 -0700 Subject: [PATCH 25/26] Update world builder declarations markdown files for the min-max surface for the mantle layer . --- tests/app/world_buider_declarations_closed.md | 1046 ++++++++++++++- tests/app/world_buider_declarations_open.md | 1162 ++++++++++++++++- 2 files changed, 2126 insertions(+), 82 deletions(-) diff --git a/tests/app/world_buider_declarations_closed.md b/tests/app/world_buider_declarations_closed.md index f3ffeac4f..0c18e862b 100644 --- a/tests/app/world_buider_declarations_closed.md +++ b/tests/app/world_buider_declarations_closed.md @@ -4406,17 +4406,153 @@ ::::::::::::::::::::{dropdown} /features/items/oneOf/3/min depth :name: closed_features_items_oneOf_3_min-depth +- **documentation**:The depth from which this feature is present +:::::::::::::::::::{dropdown} /features/items/oneOf/3/min depth/oneOf +:name: closed_features_items_oneOf_3_min-depth_oneOf + +::::::::::::::::::{dropdown} /features/items/oneOf/3/min depth/oneOf/1 +:name: closed_features_items_oneOf_3_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth to which this feature is present +- **documentation**: +:::::::::::::::::: + +::::::::::::::::::{dropdown} /features/items/oneOf/3/min depth/oneOf/2 +:name: closed_features_items_oneOf_3_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::::::{dropdown} /features/items/oneOf/3/min depth/oneOf/2/items +:name: closed_features_items_oneOf_3_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::::::{dropdown} /features/items/oneOf/3/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_3_min-depth_oneOf_2_items_items + +:::::::::::::::{dropdown} /features/items/oneOf/3/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf + +::::::::::::::{dropdown} /features/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::::::{dropdown} /features/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::::::{dropdown} /features/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::: + +:::::::::::::::::: + + :::::::::::::::::::: ::::::::::::::::::::{dropdown} /features/items/oneOf/3/max depth :name: closed_features_items_oneOf_3_max-depth +- **documentation**:The depth to which this feature is present +:::::::::::::::::::{dropdown} /features/items/oneOf/3/max depth/oneOf +:name: closed_features_items_oneOf_3_max-depth_oneOf + +::::::::::::::::::{dropdown} /features/items/oneOf/3/max depth/oneOf/1 +:name: closed_features_items_oneOf_3_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth to which this feature is present +- **documentation**: +:::::::::::::::::: + +::::::::::::::::::{dropdown} /features/items/oneOf/3/max depth/oneOf/2 +:name: closed_features_items_oneOf_3_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::::::{dropdown} /features/items/oneOf/3/max depth/oneOf/2/items +:name: closed_features_items_oneOf_3_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::::::{dropdown} /features/items/oneOf/3/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_3_max-depth_oneOf_2_items_items + +:::::::::::::::{dropdown} /features/items/oneOf/3/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf + +::::::::::::::{dropdown} /features/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::::::{dropdown} /features/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::::::{dropdown} /features/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::: + +:::::::::::::::::: + + :::::::::::::::::::: ::::::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models @@ -4460,17 +4596,153 @@ ::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth :name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth/oneOf +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth/oneOf/1 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth/oneOf/2 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth/oneOf/2/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth :name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth/oneOf +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth/oneOf/1 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth/oneOf/2 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth/oneOf/2/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/potential mantle temperature @@ -4530,17 +4802,153 @@ ::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth :name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth/oneOf +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth/oneOf/1 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth/oneOf/2 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth/oneOf/2/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth :name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth/oneOf +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth/oneOf/1 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth/oneOf/2 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth/oneOf/2/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/top temperature @@ -4592,17 +5000,153 @@ ::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth :name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth/oneOf +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth/oneOf/1 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth/oneOf/2 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth/oneOf/2/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth :name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth/oneOf +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth/oneOf/1 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth/oneOf/2 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth/oneOf/2/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/temperature @@ -4615,56 +5159,192 @@ -::::::::::::::::: +::::::::::::::::: + + +::::::::::::::::::: + +:::::::::::::::::::: + +::::::::::::::::::::{dropdown} /features/items/oneOf/3/composition models +:name: closed_features_items_oneOf_3_composition-models + +- **documentation**:A list of composition models. +- **default value**: +- **type**:array +:::::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items +:name: closed_features_items_oneOf_3_composition-models_items + +::::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf +:name: closed_features_items_oneOf_3_composition-models_items_oneOf + +:::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1 +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1 + +- **type**:object +- **documentation**:Uniform compositional model. Sets constant compositional field. +- **additionalProperties**:false +- **required**:[model, compositions] + +::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/model +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_model + +- **default value**: +- **type**:string +- **documentation**:The name of the composition model. +- **enum**:[uniform] +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth + +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth/oneOf +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth/oneOf/1 +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth_oneOf_1 + +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth/oneOf/2 +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth/oneOf/2/items +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth + +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth/oneOf +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth/oneOf/1 +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth_oneOf_1 + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth/oneOf/2 +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth/oneOf/2/items +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf +::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_1 -::::::::::::::::::: +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: -:::::::::::::::::::: +::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2 -::::::::::::::::::::{dropdown} /features/items/oneOf/3/composition models -:name: closed_features_items_oneOf_3_composition-models +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items -- **documentation**:A list of composition models. -- **default value**: - **type**:array -:::::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items -:name: closed_features_items_oneOf_3_composition-models_items +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items_items -::::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf -:name: closed_features_items_oneOf_3_composition-models_items_oneOf +- **type**:number +:::::::: -:::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1 -:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1 +::::::::: -- **type**:object -- **documentation**:Uniform compositional model. Sets constant compositional field. -- **additionalProperties**:false -- **required**:[model, compositions] +:::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/model -:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_model -- **default value**: -- **type**:string -- **documentation**:The name of the composition model. -- **enum**:[uniform] -:::::::::::::::: +:::::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth -:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth +::::::::::::: -- **default value**:0.0 -- **type**:number -- **documentation**:The depth in meters from which the composition of this feature is present. -:::::::::::::::: +:::::::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth -:name: closed_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth -- **default value**:1.7976931348623157e308 -- **type**:number -- **documentation**:The depth in meters to which the composition of this feature is present. :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/compositions @@ -4753,17 +5433,153 @@ ::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth :name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth/oneOf +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth/oneOf/1 +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the composition of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth/oneOf/2 +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth/oneOf/2/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth :name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth/oneOf +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth/oneOf/1 +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the composition of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth/oneOf/2 +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth/oneOf/2/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/compositions @@ -4853,17 +5669,153 @@ ::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth :name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth/oneOf +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth/oneOf/1 +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the composition of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth/oneOf/2 +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth/oneOf/2/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth/oneOf/2/items/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth :name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth/oneOf +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth/oneOf/1 +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the composition of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth/oneOf/2 +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth/oneOf/2/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth/oneOf/2/items/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/1 +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2 +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items/items +:name: closed_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/compositions diff --git a/tests/app/world_buider_declarations_open.md b/tests/app/world_buider_declarations_open.md index 4fef8e547..91677841f 100644 --- a/tests/app/world_buider_declarations_open.md +++ b/tests/app/world_buider_declarations_open.md @@ -4952,18 +4952,174 @@ :open: :name: open_features_items_oneOf_3_min-depth +- **documentation**:The depth from which this feature is present +:::::::::::::::::::{dropdown} /features/items/oneOf/3/min depth/oneOf +:open: +:name: open_features_items_oneOf_3_min-depth_oneOf + +::::::::::::::::::{dropdown} /features/items/oneOf/3/min depth/oneOf/1 +:open: +:name: open_features_items_oneOf_3_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth to which this feature is present +- **documentation**: +:::::::::::::::::: + +::::::::::::::::::{dropdown} /features/items/oneOf/3/min depth/oneOf/2 +:open: +:name: open_features_items_oneOf_3_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::::::{dropdown} /features/items/oneOf/3/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_3_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::::::{dropdown} /features/items/oneOf/3/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_3_min-depth_oneOf_2_items_items + +:::::::::::::::{dropdown} /features/items/oneOf/3/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf + +::::::::::::::{dropdown} /features/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::::::{dropdown} /features/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::::::{dropdown} /features/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::: + +:::::::::::::::::: + + :::::::::::::::::::: ::::::::::::::::::::{dropdown} /features/items/oneOf/3/max depth :open: :name: open_features_items_oneOf_3_max-depth +- **documentation**:The depth to which this feature is present +:::::::::::::::::::{dropdown} /features/items/oneOf/3/max depth/oneOf +:open: +:name: open_features_items_oneOf_3_max-depth_oneOf + +::::::::::::::::::{dropdown} /features/items/oneOf/3/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_3_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth to which this feature is present +- **documentation**: +:::::::::::::::::: + +::::::::::::::::::{dropdown} /features/items/oneOf/3/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_3_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::::::{dropdown} /features/items/oneOf/3/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_3_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::::::{dropdown} /features/items/oneOf/3/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_3_max-depth_oneOf_2_items_items + +:::::::::::::::{dropdown} /features/items/oneOf/3/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf + +::::::::::::::{dropdown} /features/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::::::{dropdown} /features/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::::::{dropdown} /features/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::: + +:::::::::::::::::: + + :::::::::::::::::::: ::::::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models @@ -5014,18 +5170,174 @@ :open: :name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth/oneOf +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth/oneOf/1 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth/oneOf/2 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth :open: :name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth/oneOf +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/1/potential mantle temperature @@ -5092,26 +5404,182 @@ :open: :name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth -- **default value**:0.0 -- **type**:number - **documentation**:The depth in meters from which the temperature of this feature is present. -:::::::::::::::: +:::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth/oneOf +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth_oneOf -::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth/oneOf/1 :open: -:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth_oneOf_1 -- **default value**:1.7976931348623157e308 +- **default value**:0.0 - **type**:number -- **documentation**:The depth in meters to which the temperature of this feature is present. -:::::::::::::::: +- **documentation**: +:::::::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/top temperature +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth/oneOf/2 :open: -:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_top-temperature +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth_oneOf_2 -- **default value**:293.15 -- **type**:number +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth + +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth/oneOf +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth_oneOf_1 + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/2/top temperature +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_2_top-temperature + +- **default value**:293.15 +- **type**:number - **documentation**:The temperature at the top in degree Kelvin of this feature.If the value is below zero, the an adiabatic temperature is used. :::::::::::::::: @@ -5161,18 +5629,174 @@ :open: :name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth +- **documentation**:The depth in meters from which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth/oneOf +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth/oneOf/1 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth/oneOf/2 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/min depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth :open: :name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth +- **documentation**:The depth in meters to which the temperature of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth/oneOf +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the temperature of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_3_temperature-models_items_oneOf_3_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/3/temperature models/items/oneOf/3/temperature @@ -5227,22 +5851,178 @@ - **enum**:[uniform] :::::::::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth -:open: -:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth +::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth + +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth/oneOf +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth/oneOf/1 +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth_oneOf_1 + +- **default value**:0.0 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth/oneOf/2 +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + +:::::::::::::::: + +::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth + +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth/oneOf +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth_oneOf_1 + +- **default value**:1.7976931348623157e308 +- **type**:number +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: -- **default value**:0.0 -- **type**:number -- **documentation**:The depth in meters from which the composition of this feature is present. -:::::::::::::::: +:::::::::::::: -::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/max depth -:open: -:name: open_features_items_oneOf_3_composition-models_items_oneOf_1_max-depth -- **default value**:1.7976931348623157e308 -- **type**:number -- **documentation**:The depth in meters to which the composition of this feature is present. :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/3/composition models/items/oneOf/1/compositions @@ -5342,18 +6122,174 @@ :open: :name: open_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth/oneOf +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth/oneOf/1 +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the composition of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth/oneOf/2 +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/min depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth :open: :name: open_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth/oneOf +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the composition of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_1_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/1/compositions @@ -5453,18 +6389,174 @@ :open: :name: open_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth +- **documentation**:The depth in meters from which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth/oneOf +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth/oneOf/1 +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth_oneOf_1 + - **default value**:0.0 - **type**:number -- **documentation**:The depth in meters from which the composition of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth/oneOf/2 +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:0.0 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/min depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_min-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth :open: :name: open_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth +- **documentation**:The depth in meters to which the composition of this feature is present. +:::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth/oneOf +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth_oneOf + +::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth/oneOf/1 +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth_oneOf_1 + - **default value**:1.7976931348623157e308 - **type**:number -- **documentation**:The depth in meters to which the composition of this feature is present. +- **documentation**: +:::::::::::::: + +::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth/oneOf/2 +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth_oneOf_2 + +- **type**:array +- **minItems**:0 +- **maxItems**:4294967295 +- **uniqueItems**:false +- **documentation**: +:::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth/oneOf/2/items +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth_oneOf_2_items + +- **type**:array +- **additionalProperties**:false +- **minItems**:1 +- **maxItems**:2 +- **documentation**: +::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth/oneOf/2/items/items +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items + +:::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf + +::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/1 +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_1 + +- **type**:number +- **default value**:1.7976931348623157e308 +:::::::::: + +::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2 +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2 + +- **type**:array +- **minItems**:1 +- **maxItems**:4294967295 +:::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items + +- **type**:array +- **minItems**:1 +- **maxItems**:2 +::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/max depth/oneOf/2/items/items/anyOf/2/items/items +:open: +:name: open_features_items_oneOf_3_grains-models_items_oneOf_2_max-depth_oneOf_2_items_items_anyOf_2_items_items + +- **type**:number +:::::::: + +::::::::: + +:::::::::: + + +:::::::::::: + +::::::::::::: + +:::::::::::::: + + :::::::::::::::: ::::::::::::::::{dropdown} /features/items/oneOf/3/grains models/items/oneOf/2/compositions From 55b35cb3cacb5c18d5803ef5574a7b4e15a0b52c Mon Sep 17 00:00:00 2001 From: Menno Fraters Date: Sat, 26 Mar 2022 11:39:24 -0700 Subject: [PATCH 26/26] Expand and improve min max testing. --- tests/app/continental_min_max_surface.dat | 116 +++++++++++++++++- tests/app/continental_min_max_surface.wb | 36 ++++++ .../screen-output.log | 116 +++++++++++++++++- tests/app/mantle_layer_min_max_surface.dat | 116 +++++++++++++++++- tests/app/mantle_layer_min_max_surface.wb | 36 ++++++ .../screen-output.log | 116 +++++++++++++++++- tests/app/oceanic_min_max_surface.dat | 116 +++++++++++++++++- tests/app/oceanic_min_max_surface.wb | 36 ++++++ .../oceanic_min_max_surface/screen-output.log | 116 +++++++++++++++++- 9 files changed, 780 insertions(+), 24 deletions(-) diff --git a/tests/app/continental_min_max_surface.dat b/tests/app/continental_min_max_surface.dat index 6db2e291b..fcc0e852d 100644 --- a/tests/app/continental_min_max_surface.dat +++ b/tests/app/continental_min_max_surface.dat @@ -27,10 +27,10 @@ 0 750e3 1 1 10 0 1000e3 1 1 10 250e3 0 1 1 10 -250e3 0 40e3 1 10 -250e3 0 60e3 1 10 -250e3 0 250e3 1 10 -250e3 0 350e3 1 10 +250e3 0 1 40e3 10 +250e3 0 1 60e3 10 +250e3 0 1 250e3 10 +250e3 0 1 350e3 10 250e3 250e3 1 1 10 250e3 250e3 1 40e3 10 250e3 250e3 1 60e3 10 @@ -60,3 +60,111 @@ 1000e3 500e3 1 1 10 1000e3 750e3 1 1 10 1000e3 1000e3 1 1 10 +-1 0 1 1 10 +-1 0 1 40e3 10 +-1 0 1 60e3 10 +-1 0 1 150e3 10 +-1 0 1 250e3 10 +-1 0 1 350e3 10 +-1 250e3 1 1 10 +-1 250e3 1 40e3 10 +-1 250e3 1 60e3 10 +-1 250e3 1 150e3 10 +-1 250e3 1 250e3 10 +-1 250e3 1 350e3 10 +-1 500e3 1 1 10 +-1 500e3 1 40e3 10 +-1 500e3 1 60e3 10 +-1 500e3 1 150e3 10 +-1 500e3 1 250e3 10 +-1 500e3 1 350e3 10 +-1 750e3 1 1 10 +-1 1000e3 1 1 10 +-250e3 0 1 1 10 +-250e3 0 1 40e3 10 +-250e3 0 1 60e3 10 +-250e3 0 1 250e3 10 +-250e3 0 1 350e3 10 +-250e3 250e3 1 1 10 +-250e3 250e3 1 40e3 10 +-250e3 250e3 1 60e3 10 +-250e3 250e3 1 150e3 10 +-250e3 250e3 1 250e3 10 +-250e3 250e3 1 350e3 10 +-250e3 500e3 1 1 10 +-250e3 500e3 1 40e3 10 +-250e3 500e3 1 60e3 10 +-250e3 500e3 1 150e3 10 +-250e3 500e3 1 250e3 10 +-250e3 500e3 1 350e3 10 +-250e3 750e3 1 1 10 +-250e3 1000e3 1 1 10 +-500e3 0 1 1 10 +-500e3 250e3 1 1 10 +-500e3 500e3 1 1 10 +-500e3 750e3 1 1 10 +-500e3 1000e3 1 1 10 +-750e3 0 1 1 10 +-750e3 250e3 1 1 10 +-750e3 500e3 1 1 10 +-750e3 750e3 1 1 10 +-750e3 1000e3 1 1 10 +-1000e3 0 1 1 10 +-1000e3 250e3 1 1 10 +-1000e3 500e3 1 1 10 +-1000e3 750e3 1 1 10 +-1000e3 1000e3 1 1 10 +-1 -1 1 1 10 +-1 -1 1 40e3 10 +-1 -1 1 60e3 10 +-1 -1 1 150e3 10 +-1 -1 1 250e3 10 +-1 -1 1 350e3 10 +-1 -250e3 1 1 10 +-1 -250e3 1 40e3 10 +-1 -250e3 1 60e3 10 +-1 -250e3 1 150e3 10 +-1 -250e3 1 250e3 10 +-1 -250e3 1 350e3 10 +-1 -500e3 1 1 10 +-1 -500e3 1 40e3 10 +-1 -500e3 1 60e3 10 +-1 -500e3 1 150e3 10 +-1 -500e3 1 250e3 10 +-1 -500e3 1 350e3 10 +-1 -750e3 1 1 10 +-1 -1000e3 1 1 10 +-250e3 -1 1 1 10 +-250e3 -1 1 40e3 10 +-250e3 -1 1 60e3 10 +-250e3 -1 1 250e3 10 +-250e3 -1 1 350e3 10 +-250e3 -250e3 1 1 10 +-250e3 -250e3 1 40e3 10 +-250e3 -250e3 1 60e3 10 +-250e3 -250e3 1 150e3 10 +-250e3 -250e3 1 250e3 10 +-250e3 -250e3 1 350e3 10 +-250e3 -500e3 1 1 10 +-250e3 -500e3 1 40e3 10 +-250e3 -500e3 1 60e3 10 +-250e3 -500e3 1 150e3 10 +-250e3 -500e3 1 250e3 10 +-250e3 -500e3 1 350e3 10 +-250e3 -750e3 1 1 10 +-250e3 -1000e3 1 1 10 +-500e3 -1 1 1 10 +-500e3 -250e3 1 1 10 +-500e3 -500e3 1 1 10 +-500e3 -750e3 1 1 10 +-500e3 -1000e3 1 1 10 +-750e3 -1 1 1 10 +-750e3 -250e3 1 1 10 +-750e3 -500e3 1 1 10 +-750e3 -750e3 1 1 10 +-750e3 -1000e3 1 1 10 +-1000e3 -1 1 1 10 +-1000e3 -250e3 1 1 10 +-1000e3 -500e3 1 1 10 +-1000e3 -750e3 1 1 10 +-1000e3 -1000e3 1 1 10 \ No newline at end of file diff --git a/tests/app/continental_min_max_surface.wb b/tests/app/continental_min_max_surface.wb index 0951685f0..8b675cb0f 100644 --- a/tests/app/continental_min_max_surface.wb +++ b/tests/app/continental_min_max_surface.wb @@ -19,6 +19,42 @@ {"model":"uniform", "compositions":[0,1],"rotation matrices":[[[19,20,21],[22,23,24],[25,26,27]],[[28,29,30],[31,32,33],[34,35,36]]],"grain sizes":[-1,0.3], "min depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]], "max depth":[[300e3],[200e3,[[0,500e3],[1000e3,500e3]]]]} ] + }, + { + "model":"continental plate", "name":"Var thickness continent 2", "coordinates":[[-1,1000e3],[-1000e3,1000e3],[-1000e3,0],[-1,0]], + "min depth":[[50e3,[[-1,500e3]]],[200e3,[[-1000e3,500e3]]]], "max depth":[[300e3],[200e3,[[-1,500e3],[-1000e3,500e3]]]], + "temperature models":[ + {"model":"linear", "min depth":[[50e3,[[-1,500e3]]],[200e3,[[-1000e3,500e3]]]], "max depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,500e3],[-1,0]]]], "top temperature":2, "bottom temperature":5}, + {"model":"linear", "min depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,500e3],[-1,0]]]], "max depth":[[300e3],[200e3,[[-1,500e3],[-1000e3,500e3]]]], "top temperature":10, "bottom temperature":15} + ], + "composition models":[ + {"model":"uniform", "min depth":[[50e3,[[-1,500e3]]],[200e3,[[-1000e3,500e3]]]], "max depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,500e3],[-1,0]]]], "compositions":[0]}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,500e3],[-1,0]]]], "max depth":[[300e3],[200e3,[[-1,500e3],[-1000e3,500e3]]]], "compositions":[1]} + ], + "grains models":[ + {"model":"uniform", "compositions":[0,1],"Euler angles z-x-z":[[10,15,20],[25,30,35]],"grain sizes":[-1,0.2], + "min depth":[[50e3,[[-1,500e3]]],[200e3,[[-1000e3,500e3]]]], "max depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,500e3],[-1,0]]]]}, + {"model":"uniform", "compositions":[0,1],"Euler angles z-x-z":[[40,45,50],[55,60,65]],"grain sizes":[-1,0.3], + "min depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,500e3],[-1,0]]]], "max depth":[[300e3],[200e3,[[-1,500e3],[-1000e3,500e3]]]]} + ] + }, + { + "model":"continental plate", "name":"Var thickness continent 3", "coordinates":[[-1,-1000e3],[-1000e3,-1000e3],[-1000e3,-1],[-1,-1]], + "min depth":[[50e3,[[-1,-500e3]]],[200e3,[[-1000e3,-500e3]]]], "max depth":[[300e3],[200e3,[[-1,-500e3],[-1000e3,-500e3]]]], + "temperature models":[ + {"model":"adiabatic", "min depth":[[50e3,[[-1,-500e3]]],[200e3,[[-1000e3,-500e3]]]], "max depth":[[200e3],[100e3,[[-1,-500e3],[-1000e3,-500e3],[-1,-1]]]], "potential mantle temperature":-1}, + {"model":"adiabatic", "min depth":[[200e3],[100e3,[[-1,-500e3],[-1000e3,-500e3],[-1,0]]]], "max depth":[[300e3],[200e3,[[-1,-500e3],[-1000e3,-500e3]]]], "potential mantle temperature":10} + ], + "composition models":[ + {"model":"uniform", "min depth":[[50e3,[[-1,-500e3]]],[200e3,[[-1000e3,-500e3]]]], "max depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,-500e3],[-1,-1]]]], "compositions":[0,1], "fractions":[0.75,0.25]}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[-1,-500e3],[-1000e3,-500e3],[-1,-1]]]], "max depth":[[300e3],[200e3,[[-1,-500e3],[-1000e3,-500e3]]]], "compositions":[0,1], "fractions":[0.75,0.25]} + ], + "grains models":[ + {"model":"random uniform distribution", "compositions":[0,1],"grain sizes":[-1,0.2], "normalize grain sizes":[true,true], + "min depth":[[50e3,[[-1,-500e3]]],[200e3,[[-1000e3,-500e3]]]], "max depth":[[200e3],[100e3,[[-1,-500e3],[-1000e3,-500e3],[-1,-1]]]]}, + {"model":"random uniform distribution", "compositions":[0,1],"grain sizes":[-1,0.3], "normalize grain sizes":[true,true], + "min depth":[[200e3],[100e3,[[-1,-500e3],[-1000e3,-500e3],[-1,-1]]]], "max depth":[[300e3],[200e3,[[-1,-500e3],[-1000e3,-500e3]]]]} + ] } ] } diff --git a/tests/app/continental_min_max_surface/screen-output.log b/tests/app/continental_min_max_surface/screen-output.log index aa384f884..bf6629d9f 100644 --- a/tests/app/continental_min_max_surface/screen-output.log +++ b/tests/app/continental_min_max_surface/screen-output.log @@ -20,10 +20,10 @@ 0 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 250e3 0 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 -250e3 0 40e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 -250e3 0 60e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 -250e3 0 250e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 -250e3 0 350e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 1 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 1 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 1 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +250e3 0 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 250e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 250e3 250e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 250e3 250e3 1 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 @@ -53,3 +53,111 @@ 1000e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1000e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1000e3 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +-1 0 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 0 1 40e3 10 2.6 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 0 1 60e3 10 2.9 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 0 1 150e3 10 4.25 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 0 1 250e3 10 12.5 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-1 0 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 250e3 1 40e3 10 2.36 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 250e3 1 60e3 10 2.84 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 250e3 1 150e3 10 10 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-1 250e3 1 250e3 10 15 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-1 250e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 500e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 500e3 1 60e3 10 2.6 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 500e3 1 150e3 10 12.5 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-1 500e3 1 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 500e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 1000e3 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-250e3 0 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-250e3 0 1 40e3 10 2.6 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-250e3 0 1 60e3 10 2.9 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-250e3 0 1 250e3 10 12.5 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-250e3 0 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 250e3 1 40e3 10 2.36 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-250e3 250e3 1 60e3 10 2.84 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-250e3 250e3 1 150e3 10 10 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-250e3 250e3 1 250e3 10 15 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-250e3 250e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 500e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 500e3 1 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 500e3 1 150e3 10 12.5 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-250e3 500e3 1 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 500e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 1000e3 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-500e3 0 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-500e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-500e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-500e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-500e3 1000e3 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-750e3 0 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-750e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-750e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-750e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-750e3 1000e3 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1000e3 0 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1000e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1000e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1000e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1000e3 1000e3 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 -1 1 1 10 1600 0.75 0.25 0 0 0 0.366764 -0.958224 -0.0791103 -0.27486 -0.109953 -0.785254 0.609333 -0.264039 0.614099 0.743751 0.633236 -0.212463 0.0702563 0.97464 0.0629808 -0.994354 0.0854066 0.975137 0.0795293 0.206839 0.5 -0.645103 -0.0423676 -0.76292 -0.583559 -0.61723 0.527718 -0.493255 0.785641 0.373453 0.5 0.910219 0.293065 0.292599 0.0563453 0.612334 -0.788588 -0.410276 0.734275 0.540846 +-1 -1 1 40e3 10 1618.02 0.75 0.25 0 0 0 0.471428 0.653596 0.556681 -0.512756 0.32377 0.406715 0.854258 0.684094 -0.724354 0.0855904 0.528572 0.937445 0.158394 -0.310015 0.345346 -0.535581 0.770642 -0.0439732 -0.829496 -0.556778 0.5 -0.923768 -0.374971 -0.0777773 -0.226331 0.698414 -0.678964 0.308912 -0.609602 -0.73004 0.5 -0.478424 0.399673 -0.781903 -0.878125 -0.215159 0.427321 0.00255552 0.891049 0.4539 +-1 -1 1 60e3 10 1627.11 0.75 0.25 0 0 0 0.670828 -0.261308 0.433255 -0.862559 0.729259 -0.496824 -0.470476 -0.632376 -0.751968 -0.186131 0.329172 0.265074 0.868384 0.419101 -0.545959 0.493433 -0.677091 -0.794773 -0.0493322 0.604898 0.5 -0.233697 0.953611 0.189768 -0.935883 -0.167694 -0.309843 -0.263647 -0.25001 0.931657 0.5 0.596199 0.210762 -0.774678 -0.775251 0.401906 -0.487296 0.208645 0.891095 0.403009 +-1 -1 1 150e3 10 1668.63 0.75 0.25 0 0 0 0.185461 0.80071 -0.308533 0.513489 0.306795 0.947428 0.0908669 -0.514529 0.0847777 0.853272 0.814539 0.246757 -0.909064 0.335729 -0.871943 -0.0570955 0.486267 -0.422879 -0.412726 -0.80674 0.5 -0.0780425 -0.955365 -0.284933 -0.865531 -0.0769022 0.494916 -0.494737 0.285243 -0.820897 0.5 -0.255637 -0.826636 -0.50132 0.000833022 0.518362 -0.855161 0.966772 -0.219029 -0.131824 +-1 -1 1 250e3 10 10.7251 0.75 0.25 0 0 0 0.477004 0.636889 0.733656 -0.236899 -0.236373 0.478302 0.845787 0.733825 -0.482676 0.478042 0.522996 -0.494037 -0.864667 -0.0909884 -0.765255 0.482122 -0.426549 0.41269 -0.141102 -0.899876 0.5 -0.0198408 0.980595 0.19504 -0.731338 -0.147251 0.665929 0.681726 -0.129428 0.720068 0.5 0.0644779 0.990725 0.119612 0.765223 -0.126021 0.63131 0.640528 0.0508246 -0.766251 +-1 -1 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -250e3 1 40e3 10 1618.02 0.75 0.25 0 0 0 0.387507 0.6519 0.731675 0.199192 0.676992 -0.443217 -0.587572 -0.341626 0.517889 -0.784272 0.612493 0.454256 -0.861273 -0.22773 -0.377598 0.0453874 -0.924856 0.80689 0.506112 -0.304598 0.5 0.71902 -0.219773 0.659326 -0.691763 -0.317625 0.64852 0.0668913 -0.922396 -0.380409 0.5 -0.567546 0.4711 0.675245 0.0919775 0.851271 -0.516602 -0.818188 -0.231088 -0.526466 +-1 -250e3 1 60e3 10 1627.11 0.75 0.25 0 0 0 0.924717 -0.448684 0.616845 -0.646672 0.802953 0.595934 0.0113307 0.392364 -0.514164 -0.762684 0.0752831 -0.997164 -0.0750011 0.00621204 0.0606959 -0.850275 -0.522827 0.0444946 -0.520968 0.852416 0.5 0.754866 -0.556638 -0.346889 0.421981 0.00728989 0.906575 -0.502105 -0.830723 0.240393 0.5 -0.113624 0.400412 -0.909263 -0.992265 0.000318587 0.124136 0.0499954 0.916335 0.397279 +-1 -250e3 1 150e3 10 1668.63 0.75 0.25 0 0 0 0.620618 0.506152 0.297525 0.809499 -0.53662 -0.626148 0.565666 0.675166 -0.720707 -0.157268 0.379382 -0.132605 0.224537 -0.965401 0.284427 -0.924418 -0.254073 -0.949482 -0.308278 0.0587184 0.5 0.48776 -0.105887 -0.866532 0.785075 -0.380882 0.488452 -0.381768 -0.91854 -0.10265 0.5 -0.757477 -0.635292 0.150439 -0.416003 0.292083 -0.861179 0.503159 -0.714907 -0.48553 +-1 -250e3 1 250e3 10 10.7251 0.75 0.25 0 0 0 0.750733 -0.25523 -0.948573 0.187259 0.489464 -0.293782 -0.821047 0.833836 -0.1179 0.539274 0.249267 0.907976 0.0225353 0.418416 -0.0759522 0.990863 0.111452 -0.412081 -0.132976 0.901392 0.5 0.177323 -0.76066 0.624462 -0.166191 0.602261 0.780809 -0.970019 -0.242235 -0.0196206 0.5 -0.386433 -0.424036 0.819062 0.495681 -0.84438 -0.20328 0.777798 0.32744 0.536483 +-1 -250e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -500e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -500e3 1 60e3 10 1627.11 0.75 0.25 0 0 0 0.31151 -0.552558 0.030718 0.832908 -0.278521 -0.948678 -0.149786 0.785561 -0.314748 0.532755 0.68849 -0.886998 -0.191095 -0.420378 0.442269 -0.0897767 -0.892378 0.132788 -0.977457 0.164147 0.5 -0.279919 0.109342 -0.953776 0.859415 0.4713 -0.198195 0.427844 -0.875169 -0.225896 0.5 0.133985 -0.0550239 -0.989455 0.452239 0.891821 0.0116447 0.881776 -0.44903 0.144375 +-1 -500e3 1 150e3 10 10.4289 0.75 0.25 0 0 0 0.944814 0.805553 -0.221124 0.549716 0.515393 0.719204 -0.465956 -0.292325 0.658673 0.693323 0.0551861 -0.82104 -0.392988 -0.414069 -0.560653 0.418478 0.714524 -0.107521 0.818802 -0.563917 0.5 0.63145 0.401201 0.663557 -0.762661 0.16676 0.624932 0.140069 -0.900682 0.411281 0.5 0.566032 -0.641977 0.517178 0.778999 0.621807 -0.0807313 -0.269757 0.448577 0.852062 +-1 -500e3 1 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -500e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -1000e3 1 1 10 1600 0.75 0.25 0 0 0 0.593752 -0.481887 0.775642 0.407631 0.875767 0.411177 0.252913 0.0285614 0.478866 -0.877423 0.406248 0.276603 -0.922022 0.270862 -0.546888 0.0807346 0.833304 -0.790193 -0.378626 -0.481911 0.5 -0.493083 -0.688079 -0.532368 -0.743128 0.0149396 0.668982 -0.452359 0.725482 -0.518698 0.5 0.840893 0.505968 0.192084 0.203281 -0.624217 0.754341 0.501574 -0.595273 -0.627753 +-250e3 -1 1 1 10 1600 0.75 0.25 0 0 0 0.190488 -0.354951 0.892992 0.276724 -0.0404353 0.281057 -0.958839 -0.93401 -0.35153 -0.0636529 0.809512 -0.588493 0.152485 0.793993 0.775541 -0.171082 0.607673 0.228499 0.973385 -0.0175775 0.5 -0.0178915 -0.778758 0.627069 -0.667684 0.476139 0.572267 -0.74423 -0.408445 -0.528483 0.5 -0.297635 -0.91736 0.264316 0.842432 -0.122122 0.52478 -0.449134 0.378862 0.809162 +-250e3 -1 1 40e3 10 1618.02 0.75 0.25 0 0 0 0.573945 -0.383618 -0.800363 0.460712 0.740638 -0.564635 -0.3642 0.551627 0.201507 0.809384 0.426055 -0.15071 -0.897226 -0.415056 -0.233802 -0.375591 0.89681 -0.960533 0.232199 -0.153168 0.5 -0.138834 -0.0414727 -0.989447 0.810327 0.5696 -0.137575 0.569294 -0.820875 -0.0454732 0.5 0.596569 -0.0707409 0.799438 -0.694477 -0.544763 0.470037 0.402254 -0.835601 -0.374117 +-250e3 -1 1 60e3 10 1627.11 0.75 0.25 0 0 0 0.00856497 -0.524315 0.0349976 -0.850805 0.251286 0.961018 -0.115326 0.813602 -0.274262 -0.512671 0.991435 0.831897 -0.418296 -0.364659 0.53727 0.442653 0.717913 -0.138883 -0.79315 0.592979 0.5 0.246022 -0.932076 0.26591 0.943885 0.292757 0.152889 -0.220351 0.213374 0.951797 0.5 0.414952 0.129083 -0.90064 0.504307 0.791281 0.345758 0.757291 -0.597672 0.263246 +-250e3 -1 1 250e3 10 10.7251 0.75 0.25 0 0 0 0.323427 0.843057 0.49605 0.207819 -0.3218 0.155644 0.933927 0.430929 -0.85423 0.290846 0.676573 -0.865032 -0.455681 -0.209937 0.479445 -0.874072 -0.0782975 -0.147822 -0.168383 0.974575 0.5 0.532658 -0.839518 0.107167 0.705179 0.370232 -0.604691 0.467972 0.397665 0.789217 0.5 0.526857 0.539846 -0.656497 0.521849 0.404214 0.751189 0.670891 -0.738361 -0.0687547 +-250e3 -1 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -250e3 1 40e3 10 1618.02 0.75 0.25 0 0 0 0.553899 0.825741 0.291637 0.482805 0.495032 -0.784981 -0.372488 0.270362 0.546582 -0.79256 0.446101 -0.336252 -0.9402 0.0543991 -0.871751 0.332588 0.359771 -0.356349 0.073551 -0.931454 0.5 0.470279 -0.825891 0.311034 -0.872403 -0.381852 0.305126 -0.133232 -0.414841 -0.900087 0.5 0.487013 -0.839393 -0.241325 0.600617 0.121269 0.790286 -0.634096 -0.529824 0.563214 +-250e3 -250e3 1 60e3 10 1627.11 0.75 0.25 0 0 0 0.924429 0.226959 -0.733612 -0.640549 0.795801 -0.23945 0.556206 -0.561419 -0.635986 0.529463 0.0755707 -0.294476 0.931342 -0.214212 -0.552703 -0.348836 -0.756857 -0.779617 -0.10448 0.617479 0.5 -0.943233 0.140378 0.301008 0.259975 -0.251967 0.932162 0.206699 0.9575 0.201169 0.5 -0.239657 0.758139 -0.606457 0.559433 0.618369 0.551955 0.793473 -0.206993 -0.572324 +-250e3 -250e3 1 150e3 10 1668.63 0.75 0.25 0 0 0 0.50085 -0.108212 -0.926568 0.360226 0.757185 0.157978 0.633809 -0.644175 0.341343 0.684488 0.49915 0.0811971 -0.877571 0.472521 0.385021 -0.409668 -0.827001 0.919329 0.249081 0.30462 0.5 -0.977162 -0.104136 0.185231 0.086434 0.601539 0.794154 -0.194123 0.792027 -0.5788 0.5 -0.801543 0.597379 0.0258339 -0.263644 -0.391867 0.881438 0.536675 0.699699 0.471593 +-250e3 -250e3 1 250e3 10 10.7251 0.75 0.25 0 0 0 0.769871 0.747281 0.0855458 0.658979 0.394841 0.740474 -0.543874 -0.534483 0.666619 0.519565 0.230129 -0.986676 -0.093663 -0.133036 0.158685 -0.734535 -0.659756 -0.0359251 -0.672076 0.739611 0.5 0.379057 -0.432912 -0.817865 0.258081 0.89821 -0.355827 0.888656 -0.0761962 0.452199 0.5 -0.937242 -0.0471275 0.345481 0.0744371 -0.995026 0.0662048 0.340642 0.0877665 0.936088 +-250e3 -250e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -500e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -500e3 1 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -500e3 1 150e3 10 10.4289 0.75 0.25 0 0 0 0.822857 -0.0866308 -0.183832 -0.979133 -0.567716 -0.798522 0.200152 -0.818653 0.573209 -0.035188 0.177143 0.0151364 -0.311297 0.950192 -0.216451 -0.928788 -0.300836 0.976176 -0.201117 -0.0814391 0.5 -0.924893 -0.264805 0.272858 0.292676 -0.0377146 0.955468 -0.242722 0.963564 0.112384 0.5 -0.79662 0.513067 0.319621 0.558651 0.422933 0.713468 0.230879 0.74692 -0.623543 +-250e3 -500e3 1 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -500e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -1000e3 1 1 10 1600 0.75 0.25 0 0 0 0.922061 -0.401583 -0.157987 -0.902093 -0.602671 0.787261 0.130414 0.689579 0.596037 -0.411364 0.0779389 -0.219381 -0.943671 0.247705 0.489954 0.112993 0.864395 -0.843693 0.310996 0.437566 0.5 0.370903 -0.105414 0.922669 -0.913173 0.139357 0.383007 -0.168954 -0.984615 -0.0445731 0.5 -0.937156 0.330466 0.11194 0.156716 0.685324 -0.711176 -0.311735 -0.64894 -0.694045 +-500e3 -1 1 1 10 1600 0.75 0.25 0 0 0 0.59034 0.258755 0.589603 0.765124 -0.19042 -0.745421 0.638817 0.946988 -0.310992 -0.0806091 0.40966 0.114091 -0.196659 0.973811 0.0329795 0.980421 0.19413 -0.992923 0.00996723 0.118343 0.5 -0.999434 -0.00977119 -0.0322004 0.0268172 0.346753 -0.937573 0.0203268 -0.937906 -0.346295 0.5 -0.334307 0.469142 0.817401 0.738818 -0.408019 0.536347 0.585138 0.783215 -0.210206 +-500e3 -250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-500e3 -500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-500e3 -750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-500e3 -1000e3 1 1 10 1600 0.75 0.25 0 0 0 0.234356 0.856057 -0.0022717 -0.516876 0.377946 -0.6794 0.628945 -0.352594 -0.733764 -0.580747 0.765644 -0.343182 0.30797 0.887345 0.93381 0.213574 0.287028 -0.101118 0.927114 -0.36088 0.5 -0.933719 0.117114 0.338308 -0.0254921 -0.964331 0.263469 0.357097 0.237382 0.9034 0.5 -0.25133 0.347452 -0.903388 -0.469855 -0.859796 -0.199968 -0.846209 0.374204 0.379344 +-750e3 -1 1 1 10 1600 0.75 0.25 0 0 0 0.660401 0.465625 -0.753394 0.464318 0.0539687 0.54786 0.834827 -0.883335 -0.363658 0.295757 0.339599 -0.801917 0.195168 -0.564658 0.205351 -0.797507 -0.567286 -0.561034 -0.570869 0.599457 0.5 0.382407 0.378019 -0.843129 0.519073 -0.842779 -0.142433 -0.764414 -0.383178 -0.518504 0.5 -0.240455 -0.221544 -0.94504 0.238945 0.930134 -0.278846 0.94079 -0.292863 -0.170718 +-750e3 -250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-750e3 -500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-750e3 -750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-750e3 -1000e3 1 1 10 1600 0.75 0.25 0 0 0 0.454517 -0.471007 -0.109032 0.875365 -0.369899 -0.876463 -0.3082 0.800829 -0.468961 0.372489 0.545483 -0.606357 0.308116 -0.733073 0.745445 0.541202 -0.389118 0.276847 -0.78241 -0.557844 0.5 -0.582494 -0.804381 0.116923 -0.786278 0.521134 -0.331942 0.206076 -0.285288 -0.936025 0.5 0.377829 -0.86593 -0.327735 0.0432579 0.370096 -0.927986 0.924864 0.336443 0.177291 +-1000e3 -1 1 1 10 1600 0.75 0.25 0 0 0 0.624319 0.916255 0.366602 0.161495 0.363564 -0.930276 0.0490634 0.168222 0.0137592 -0.985653 0.375681 -0.150366 0.339183 -0.928625 -0.572883 0.735633 0.361455 0.805726 0.586344 0.0836982 0.5 0.621804 0.633868 -0.459968 -0.00631371 0.591351 0.806389 0.783147 -0.498512 0.371707 0.5 -0.281107 0.195127 -0.93963 -0.833082 0.436428 0.339861 0.476397 0.878326 0.0398741 +-1000e3 -250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1000e3 -500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1000e3 -750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1000e3 -1000e3 1 1 10 1600 0.75 0.25 0 0 0 0.258433 0.255748 0.488309 -0.834354 0.557641 0.630489 0.539926 0.789702 -0.603355 -0.111055 0.741567 0.169503 -0.982719 0.0743723 0.454303 0.0109459 -0.89078 0.874572 0.184778 0.448308 0.5 0.767092 0.168414 0.619037 0.0541544 -0.978482 0.199098 0.639247 -0.119203 -0.759706 0.5 0.379731 -0.178727 -0.907668 0.118511 0.982474 -0.143877 0.917474 -0.0529345 0.394257 diff --git a/tests/app/mantle_layer_min_max_surface.dat b/tests/app/mantle_layer_min_max_surface.dat index 6db2e291b..fcc0e852d 100644 --- a/tests/app/mantle_layer_min_max_surface.dat +++ b/tests/app/mantle_layer_min_max_surface.dat @@ -27,10 +27,10 @@ 0 750e3 1 1 10 0 1000e3 1 1 10 250e3 0 1 1 10 -250e3 0 40e3 1 10 -250e3 0 60e3 1 10 -250e3 0 250e3 1 10 -250e3 0 350e3 1 10 +250e3 0 1 40e3 10 +250e3 0 1 60e3 10 +250e3 0 1 250e3 10 +250e3 0 1 350e3 10 250e3 250e3 1 1 10 250e3 250e3 1 40e3 10 250e3 250e3 1 60e3 10 @@ -60,3 +60,111 @@ 1000e3 500e3 1 1 10 1000e3 750e3 1 1 10 1000e3 1000e3 1 1 10 +-1 0 1 1 10 +-1 0 1 40e3 10 +-1 0 1 60e3 10 +-1 0 1 150e3 10 +-1 0 1 250e3 10 +-1 0 1 350e3 10 +-1 250e3 1 1 10 +-1 250e3 1 40e3 10 +-1 250e3 1 60e3 10 +-1 250e3 1 150e3 10 +-1 250e3 1 250e3 10 +-1 250e3 1 350e3 10 +-1 500e3 1 1 10 +-1 500e3 1 40e3 10 +-1 500e3 1 60e3 10 +-1 500e3 1 150e3 10 +-1 500e3 1 250e3 10 +-1 500e3 1 350e3 10 +-1 750e3 1 1 10 +-1 1000e3 1 1 10 +-250e3 0 1 1 10 +-250e3 0 1 40e3 10 +-250e3 0 1 60e3 10 +-250e3 0 1 250e3 10 +-250e3 0 1 350e3 10 +-250e3 250e3 1 1 10 +-250e3 250e3 1 40e3 10 +-250e3 250e3 1 60e3 10 +-250e3 250e3 1 150e3 10 +-250e3 250e3 1 250e3 10 +-250e3 250e3 1 350e3 10 +-250e3 500e3 1 1 10 +-250e3 500e3 1 40e3 10 +-250e3 500e3 1 60e3 10 +-250e3 500e3 1 150e3 10 +-250e3 500e3 1 250e3 10 +-250e3 500e3 1 350e3 10 +-250e3 750e3 1 1 10 +-250e3 1000e3 1 1 10 +-500e3 0 1 1 10 +-500e3 250e3 1 1 10 +-500e3 500e3 1 1 10 +-500e3 750e3 1 1 10 +-500e3 1000e3 1 1 10 +-750e3 0 1 1 10 +-750e3 250e3 1 1 10 +-750e3 500e3 1 1 10 +-750e3 750e3 1 1 10 +-750e3 1000e3 1 1 10 +-1000e3 0 1 1 10 +-1000e3 250e3 1 1 10 +-1000e3 500e3 1 1 10 +-1000e3 750e3 1 1 10 +-1000e3 1000e3 1 1 10 +-1 -1 1 1 10 +-1 -1 1 40e3 10 +-1 -1 1 60e3 10 +-1 -1 1 150e3 10 +-1 -1 1 250e3 10 +-1 -1 1 350e3 10 +-1 -250e3 1 1 10 +-1 -250e3 1 40e3 10 +-1 -250e3 1 60e3 10 +-1 -250e3 1 150e3 10 +-1 -250e3 1 250e3 10 +-1 -250e3 1 350e3 10 +-1 -500e3 1 1 10 +-1 -500e3 1 40e3 10 +-1 -500e3 1 60e3 10 +-1 -500e3 1 150e3 10 +-1 -500e3 1 250e3 10 +-1 -500e3 1 350e3 10 +-1 -750e3 1 1 10 +-1 -1000e3 1 1 10 +-250e3 -1 1 1 10 +-250e3 -1 1 40e3 10 +-250e3 -1 1 60e3 10 +-250e3 -1 1 250e3 10 +-250e3 -1 1 350e3 10 +-250e3 -250e3 1 1 10 +-250e3 -250e3 1 40e3 10 +-250e3 -250e3 1 60e3 10 +-250e3 -250e3 1 150e3 10 +-250e3 -250e3 1 250e3 10 +-250e3 -250e3 1 350e3 10 +-250e3 -500e3 1 1 10 +-250e3 -500e3 1 40e3 10 +-250e3 -500e3 1 60e3 10 +-250e3 -500e3 1 150e3 10 +-250e3 -500e3 1 250e3 10 +-250e3 -500e3 1 350e3 10 +-250e3 -750e3 1 1 10 +-250e3 -1000e3 1 1 10 +-500e3 -1 1 1 10 +-500e3 -250e3 1 1 10 +-500e3 -500e3 1 1 10 +-500e3 -750e3 1 1 10 +-500e3 -1000e3 1 1 10 +-750e3 -1 1 1 10 +-750e3 -250e3 1 1 10 +-750e3 -500e3 1 1 10 +-750e3 -750e3 1 1 10 +-750e3 -1000e3 1 1 10 +-1000e3 -1 1 1 10 +-1000e3 -250e3 1 1 10 +-1000e3 -500e3 1 1 10 +-1000e3 -750e3 1 1 10 +-1000e3 -1000e3 1 1 10 \ No newline at end of file diff --git a/tests/app/mantle_layer_min_max_surface.wb b/tests/app/mantle_layer_min_max_surface.wb index 722ad8c10..461f13b34 100644 --- a/tests/app/mantle_layer_min_max_surface.wb +++ b/tests/app/mantle_layer_min_max_surface.wb @@ -19,6 +19,42 @@ {"model":"uniform", "compositions":[0,1],"rotation matrices":[[[19,20,21],[22,23,24],[25,26,27]],[[28,29,30],[31,32,33],[34,35,36]]],"grain sizes":[-1,0.3], "min depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]], "max depth":[[300e3],[200e3,[[0,500e3],[1000e3,500e3]]]]} ] + }, + { + "model":"mantle layer", "name":"Var thickness continent 2", "coordinates":[[-1,1000e3],[-1000e3,1000e3],[-1000e3,0],[-1,0]], + "min depth":[[50e3,[[-1,500e3]]],[200e3,[[-1000e3,500e3]]]], "max depth":[[300e3],[200e3,[[-1,500e3],[-1000e3,500e3]]]], + "temperature models":[ + {"model":"linear", "min depth":[[50e3,[[-1,500e3]]],[200e3,[[-1000e3,500e3]]]], "max depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,500e3],[-1,0]]]], "top temperature":2, "bottom temperature":5}, + {"model":"linear", "min depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,500e3],[-1,0]]]], "max depth":[[300e3],[200e3,[[-1,500e3],[-1000e3,500e3]]]], "top temperature":10, "bottom temperature":15} + ], + "composition models":[ + {"model":"uniform", "min depth":[[50e3,[[-1,500e3]]],[200e3,[[-1000e3,500e3]]]], "max depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,500e3],[-1,0]]]], "compositions":[0]}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,500e3],[-1,0]]]], "max depth":[[300e3],[200e3,[[-1,500e3],[-1000e3,500e3]]]], "compositions":[1]} + ], + "grains models":[ + {"model":"uniform", "compositions":[0,1],"Euler angles z-x-z":[[10,15,20],[25,30,35]],"grain sizes":[-1,0.2], + "min depth":[[50e3,[[-1,500e3]]],[200e3,[[-1000e3,500e3]]]], "max depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,500e3],[-1,0]]]]}, + {"model":"uniform", "compositions":[0,1],"Euler angles z-x-z":[[40,45,50],[55,60,65]],"grain sizes":[-1,0.3], + "min depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,500e3],[-1,0]]]], "max depth":[[300e3],[200e3,[[-1,500e3],[-1000e3,500e3]]]]} + ] + }, + { + "model":"mantle layer", "name":"Var thickness continent 3", "coordinates":[[-1,-1000e3],[-1000e3,-1000e3],[-1000e3,-1],[-1,-1]], + "min depth":[[50e3,[[-1,-500e3]]],[200e3,[[-1000e3,-500e3]]]], "max depth":[[300e3],[200e3,[[-1,-500e3],[-1000e3,-500e3]]]], + "temperature models":[ + {"model":"adiabatic", "min depth":[[50e3,[[-1,-500e3]]],[200e3,[[-1000e3,-500e3]]]], "max depth":[[200e3],[100e3,[[-1,-500e3],[-1000e3,-500e3],[-1,-1]]]], "potential mantle temperature":-1}, + {"model":"adiabatic", "min depth":[[200e3],[100e3,[[-1,-500e3],[-1000e3,-500e3],[-1,0]]]], "max depth":[[300e3],[200e3,[[-1,-500e3],[-1000e3,-500e3]]]], "potential mantle temperature":10} + ], + "composition models":[ + {"model":"uniform", "min depth":[[50e3,[[-1,-500e3]]],[200e3,[[-1000e3,-500e3]]]], "max depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,-500e3],[-1,-1]]]], "compositions":[0,1], "fractions":[0.75,0.25]}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[-1,-500e3],[-1000e3,-500e3],[-1,-1]]]], "max depth":[[300e3],[200e3,[[-1,-500e3],[-1000e3,-500e3]]]], "compositions":[0,1], "fractions":[0.75,0.25]} + ], + "grains models":[ + {"model":"random uniform distribution", "compositions":[0,1],"grain sizes":[-1,0.2], "normalize grain sizes":[true,true], + "min depth":[[50e3,[[-1,-500e3]]],[200e3,[[-1000e3,-500e3]]]], "max depth":[[200e3],[100e3,[[-1,-500e3],[-1000e3,-500e3],[-1,-1]]]]}, + {"model":"random uniform distribution", "compositions":[0,1],"grain sizes":[-1,0.3], "normalize grain sizes":[true,true], + "min depth":[[200e3],[100e3,[[-1,-500e3],[-1000e3,-500e3],[-1,-1]]]], "max depth":[[300e3],[200e3,[[-1,-500e3],[-1000e3,-500e3]]]]} + ] } ] } diff --git a/tests/app/mantle_layer_min_max_surface/screen-output.log b/tests/app/mantle_layer_min_max_surface/screen-output.log index aa384f884..bf6629d9f 100644 --- a/tests/app/mantle_layer_min_max_surface/screen-output.log +++ b/tests/app/mantle_layer_min_max_surface/screen-output.log @@ -20,10 +20,10 @@ 0 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 250e3 0 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 -250e3 0 40e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 -250e3 0 60e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 -250e3 0 250e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 -250e3 0 350e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 1 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 1 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 1 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +250e3 0 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 250e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 250e3 250e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 250e3 250e3 1 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 @@ -53,3 +53,111 @@ 1000e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1000e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1000e3 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +-1 0 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 0 1 40e3 10 2.6 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 0 1 60e3 10 2.9 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 0 1 150e3 10 4.25 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 0 1 250e3 10 12.5 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-1 0 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 250e3 1 40e3 10 2.36 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 250e3 1 60e3 10 2.84 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 250e3 1 150e3 10 10 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-1 250e3 1 250e3 10 15 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-1 250e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 500e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 500e3 1 60e3 10 2.6 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 500e3 1 150e3 10 12.5 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-1 500e3 1 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 500e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 1000e3 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-250e3 0 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-250e3 0 1 40e3 10 2.6 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-250e3 0 1 60e3 10 2.9 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-250e3 0 1 250e3 10 12.5 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-250e3 0 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 250e3 1 40e3 10 2.36 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-250e3 250e3 1 60e3 10 2.84 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-250e3 250e3 1 150e3 10 10 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-250e3 250e3 1 250e3 10 15 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-250e3 250e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 500e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 500e3 1 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 500e3 1 150e3 10 12.5 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-250e3 500e3 1 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 500e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 1000e3 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-500e3 0 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-500e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-500e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-500e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-500e3 1000e3 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-750e3 0 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-750e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-750e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-750e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-750e3 1000e3 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1000e3 0 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1000e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1000e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1000e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1000e3 1000e3 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 -1 1 1 10 1600 0.75 0.25 0 0 0 0.366764 -0.958224 -0.0791103 -0.27486 -0.109953 -0.785254 0.609333 -0.264039 0.614099 0.743751 0.633236 -0.212463 0.0702563 0.97464 0.0629808 -0.994354 0.0854066 0.975137 0.0795293 0.206839 0.5 -0.645103 -0.0423676 -0.76292 -0.583559 -0.61723 0.527718 -0.493255 0.785641 0.373453 0.5 0.910219 0.293065 0.292599 0.0563453 0.612334 -0.788588 -0.410276 0.734275 0.540846 +-1 -1 1 40e3 10 1618.02 0.75 0.25 0 0 0 0.471428 0.653596 0.556681 -0.512756 0.32377 0.406715 0.854258 0.684094 -0.724354 0.0855904 0.528572 0.937445 0.158394 -0.310015 0.345346 -0.535581 0.770642 -0.0439732 -0.829496 -0.556778 0.5 -0.923768 -0.374971 -0.0777773 -0.226331 0.698414 -0.678964 0.308912 -0.609602 -0.73004 0.5 -0.478424 0.399673 -0.781903 -0.878125 -0.215159 0.427321 0.00255552 0.891049 0.4539 +-1 -1 1 60e3 10 1627.11 0.75 0.25 0 0 0 0.670828 -0.261308 0.433255 -0.862559 0.729259 -0.496824 -0.470476 -0.632376 -0.751968 -0.186131 0.329172 0.265074 0.868384 0.419101 -0.545959 0.493433 -0.677091 -0.794773 -0.0493322 0.604898 0.5 -0.233697 0.953611 0.189768 -0.935883 -0.167694 -0.309843 -0.263647 -0.25001 0.931657 0.5 0.596199 0.210762 -0.774678 -0.775251 0.401906 -0.487296 0.208645 0.891095 0.403009 +-1 -1 1 150e3 10 1668.63 0.75 0.25 0 0 0 0.185461 0.80071 -0.308533 0.513489 0.306795 0.947428 0.0908669 -0.514529 0.0847777 0.853272 0.814539 0.246757 -0.909064 0.335729 -0.871943 -0.0570955 0.486267 -0.422879 -0.412726 -0.80674 0.5 -0.0780425 -0.955365 -0.284933 -0.865531 -0.0769022 0.494916 -0.494737 0.285243 -0.820897 0.5 -0.255637 -0.826636 -0.50132 0.000833022 0.518362 -0.855161 0.966772 -0.219029 -0.131824 +-1 -1 1 250e3 10 10.7251 0.75 0.25 0 0 0 0.477004 0.636889 0.733656 -0.236899 -0.236373 0.478302 0.845787 0.733825 -0.482676 0.478042 0.522996 -0.494037 -0.864667 -0.0909884 -0.765255 0.482122 -0.426549 0.41269 -0.141102 -0.899876 0.5 -0.0198408 0.980595 0.19504 -0.731338 -0.147251 0.665929 0.681726 -0.129428 0.720068 0.5 0.0644779 0.990725 0.119612 0.765223 -0.126021 0.63131 0.640528 0.0508246 -0.766251 +-1 -1 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -250e3 1 40e3 10 1618.02 0.75 0.25 0 0 0 0.387507 0.6519 0.731675 0.199192 0.676992 -0.443217 -0.587572 -0.341626 0.517889 -0.784272 0.612493 0.454256 -0.861273 -0.22773 -0.377598 0.0453874 -0.924856 0.80689 0.506112 -0.304598 0.5 0.71902 -0.219773 0.659326 -0.691763 -0.317625 0.64852 0.0668913 -0.922396 -0.380409 0.5 -0.567546 0.4711 0.675245 0.0919775 0.851271 -0.516602 -0.818188 -0.231088 -0.526466 +-1 -250e3 1 60e3 10 1627.11 0.75 0.25 0 0 0 0.924717 -0.448684 0.616845 -0.646672 0.802953 0.595934 0.0113307 0.392364 -0.514164 -0.762684 0.0752831 -0.997164 -0.0750011 0.00621204 0.0606959 -0.850275 -0.522827 0.0444946 -0.520968 0.852416 0.5 0.754866 -0.556638 -0.346889 0.421981 0.00728989 0.906575 -0.502105 -0.830723 0.240393 0.5 -0.113624 0.400412 -0.909263 -0.992265 0.000318587 0.124136 0.0499954 0.916335 0.397279 +-1 -250e3 1 150e3 10 1668.63 0.75 0.25 0 0 0 0.620618 0.506152 0.297525 0.809499 -0.53662 -0.626148 0.565666 0.675166 -0.720707 -0.157268 0.379382 -0.132605 0.224537 -0.965401 0.284427 -0.924418 -0.254073 -0.949482 -0.308278 0.0587184 0.5 0.48776 -0.105887 -0.866532 0.785075 -0.380882 0.488452 -0.381768 -0.91854 -0.10265 0.5 -0.757477 -0.635292 0.150439 -0.416003 0.292083 -0.861179 0.503159 -0.714907 -0.48553 +-1 -250e3 1 250e3 10 10.7251 0.75 0.25 0 0 0 0.750733 -0.25523 -0.948573 0.187259 0.489464 -0.293782 -0.821047 0.833836 -0.1179 0.539274 0.249267 0.907976 0.0225353 0.418416 -0.0759522 0.990863 0.111452 -0.412081 -0.132976 0.901392 0.5 0.177323 -0.76066 0.624462 -0.166191 0.602261 0.780809 -0.970019 -0.242235 -0.0196206 0.5 -0.386433 -0.424036 0.819062 0.495681 -0.84438 -0.20328 0.777798 0.32744 0.536483 +-1 -250e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -500e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -500e3 1 60e3 10 1627.11 0.75 0.25 0 0 0 0.31151 -0.552558 0.030718 0.832908 -0.278521 -0.948678 -0.149786 0.785561 -0.314748 0.532755 0.68849 -0.886998 -0.191095 -0.420378 0.442269 -0.0897767 -0.892378 0.132788 -0.977457 0.164147 0.5 -0.279919 0.109342 -0.953776 0.859415 0.4713 -0.198195 0.427844 -0.875169 -0.225896 0.5 0.133985 -0.0550239 -0.989455 0.452239 0.891821 0.0116447 0.881776 -0.44903 0.144375 +-1 -500e3 1 150e3 10 10.4289 0.75 0.25 0 0 0 0.944814 0.805553 -0.221124 0.549716 0.515393 0.719204 -0.465956 -0.292325 0.658673 0.693323 0.0551861 -0.82104 -0.392988 -0.414069 -0.560653 0.418478 0.714524 -0.107521 0.818802 -0.563917 0.5 0.63145 0.401201 0.663557 -0.762661 0.16676 0.624932 0.140069 -0.900682 0.411281 0.5 0.566032 -0.641977 0.517178 0.778999 0.621807 -0.0807313 -0.269757 0.448577 0.852062 +-1 -500e3 1 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -500e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -1000e3 1 1 10 1600 0.75 0.25 0 0 0 0.593752 -0.481887 0.775642 0.407631 0.875767 0.411177 0.252913 0.0285614 0.478866 -0.877423 0.406248 0.276603 -0.922022 0.270862 -0.546888 0.0807346 0.833304 -0.790193 -0.378626 -0.481911 0.5 -0.493083 -0.688079 -0.532368 -0.743128 0.0149396 0.668982 -0.452359 0.725482 -0.518698 0.5 0.840893 0.505968 0.192084 0.203281 -0.624217 0.754341 0.501574 -0.595273 -0.627753 +-250e3 -1 1 1 10 1600 0.75 0.25 0 0 0 0.190488 -0.354951 0.892992 0.276724 -0.0404353 0.281057 -0.958839 -0.93401 -0.35153 -0.0636529 0.809512 -0.588493 0.152485 0.793993 0.775541 -0.171082 0.607673 0.228499 0.973385 -0.0175775 0.5 -0.0178915 -0.778758 0.627069 -0.667684 0.476139 0.572267 -0.74423 -0.408445 -0.528483 0.5 -0.297635 -0.91736 0.264316 0.842432 -0.122122 0.52478 -0.449134 0.378862 0.809162 +-250e3 -1 1 40e3 10 1618.02 0.75 0.25 0 0 0 0.573945 -0.383618 -0.800363 0.460712 0.740638 -0.564635 -0.3642 0.551627 0.201507 0.809384 0.426055 -0.15071 -0.897226 -0.415056 -0.233802 -0.375591 0.89681 -0.960533 0.232199 -0.153168 0.5 -0.138834 -0.0414727 -0.989447 0.810327 0.5696 -0.137575 0.569294 -0.820875 -0.0454732 0.5 0.596569 -0.0707409 0.799438 -0.694477 -0.544763 0.470037 0.402254 -0.835601 -0.374117 +-250e3 -1 1 60e3 10 1627.11 0.75 0.25 0 0 0 0.00856497 -0.524315 0.0349976 -0.850805 0.251286 0.961018 -0.115326 0.813602 -0.274262 -0.512671 0.991435 0.831897 -0.418296 -0.364659 0.53727 0.442653 0.717913 -0.138883 -0.79315 0.592979 0.5 0.246022 -0.932076 0.26591 0.943885 0.292757 0.152889 -0.220351 0.213374 0.951797 0.5 0.414952 0.129083 -0.90064 0.504307 0.791281 0.345758 0.757291 -0.597672 0.263246 +-250e3 -1 1 250e3 10 10.7251 0.75 0.25 0 0 0 0.323427 0.843057 0.49605 0.207819 -0.3218 0.155644 0.933927 0.430929 -0.85423 0.290846 0.676573 -0.865032 -0.455681 -0.209937 0.479445 -0.874072 -0.0782975 -0.147822 -0.168383 0.974575 0.5 0.532658 -0.839518 0.107167 0.705179 0.370232 -0.604691 0.467972 0.397665 0.789217 0.5 0.526857 0.539846 -0.656497 0.521849 0.404214 0.751189 0.670891 -0.738361 -0.0687547 +-250e3 -1 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -250e3 1 40e3 10 1618.02 0.75 0.25 0 0 0 0.553899 0.825741 0.291637 0.482805 0.495032 -0.784981 -0.372488 0.270362 0.546582 -0.79256 0.446101 -0.336252 -0.9402 0.0543991 -0.871751 0.332588 0.359771 -0.356349 0.073551 -0.931454 0.5 0.470279 -0.825891 0.311034 -0.872403 -0.381852 0.305126 -0.133232 -0.414841 -0.900087 0.5 0.487013 -0.839393 -0.241325 0.600617 0.121269 0.790286 -0.634096 -0.529824 0.563214 +-250e3 -250e3 1 60e3 10 1627.11 0.75 0.25 0 0 0 0.924429 0.226959 -0.733612 -0.640549 0.795801 -0.23945 0.556206 -0.561419 -0.635986 0.529463 0.0755707 -0.294476 0.931342 -0.214212 -0.552703 -0.348836 -0.756857 -0.779617 -0.10448 0.617479 0.5 -0.943233 0.140378 0.301008 0.259975 -0.251967 0.932162 0.206699 0.9575 0.201169 0.5 -0.239657 0.758139 -0.606457 0.559433 0.618369 0.551955 0.793473 -0.206993 -0.572324 +-250e3 -250e3 1 150e3 10 1668.63 0.75 0.25 0 0 0 0.50085 -0.108212 -0.926568 0.360226 0.757185 0.157978 0.633809 -0.644175 0.341343 0.684488 0.49915 0.0811971 -0.877571 0.472521 0.385021 -0.409668 -0.827001 0.919329 0.249081 0.30462 0.5 -0.977162 -0.104136 0.185231 0.086434 0.601539 0.794154 -0.194123 0.792027 -0.5788 0.5 -0.801543 0.597379 0.0258339 -0.263644 -0.391867 0.881438 0.536675 0.699699 0.471593 +-250e3 -250e3 1 250e3 10 10.7251 0.75 0.25 0 0 0 0.769871 0.747281 0.0855458 0.658979 0.394841 0.740474 -0.543874 -0.534483 0.666619 0.519565 0.230129 -0.986676 -0.093663 -0.133036 0.158685 -0.734535 -0.659756 -0.0359251 -0.672076 0.739611 0.5 0.379057 -0.432912 -0.817865 0.258081 0.89821 -0.355827 0.888656 -0.0761962 0.452199 0.5 -0.937242 -0.0471275 0.345481 0.0744371 -0.995026 0.0662048 0.340642 0.0877665 0.936088 +-250e3 -250e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -500e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -500e3 1 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -500e3 1 150e3 10 10.4289 0.75 0.25 0 0 0 0.822857 -0.0866308 -0.183832 -0.979133 -0.567716 -0.798522 0.200152 -0.818653 0.573209 -0.035188 0.177143 0.0151364 -0.311297 0.950192 -0.216451 -0.928788 -0.300836 0.976176 -0.201117 -0.0814391 0.5 -0.924893 -0.264805 0.272858 0.292676 -0.0377146 0.955468 -0.242722 0.963564 0.112384 0.5 -0.79662 0.513067 0.319621 0.558651 0.422933 0.713468 0.230879 0.74692 -0.623543 +-250e3 -500e3 1 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -500e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -1000e3 1 1 10 1600 0.75 0.25 0 0 0 0.922061 -0.401583 -0.157987 -0.902093 -0.602671 0.787261 0.130414 0.689579 0.596037 -0.411364 0.0779389 -0.219381 -0.943671 0.247705 0.489954 0.112993 0.864395 -0.843693 0.310996 0.437566 0.5 0.370903 -0.105414 0.922669 -0.913173 0.139357 0.383007 -0.168954 -0.984615 -0.0445731 0.5 -0.937156 0.330466 0.11194 0.156716 0.685324 -0.711176 -0.311735 -0.64894 -0.694045 +-500e3 -1 1 1 10 1600 0.75 0.25 0 0 0 0.59034 0.258755 0.589603 0.765124 -0.19042 -0.745421 0.638817 0.946988 -0.310992 -0.0806091 0.40966 0.114091 -0.196659 0.973811 0.0329795 0.980421 0.19413 -0.992923 0.00996723 0.118343 0.5 -0.999434 -0.00977119 -0.0322004 0.0268172 0.346753 -0.937573 0.0203268 -0.937906 -0.346295 0.5 -0.334307 0.469142 0.817401 0.738818 -0.408019 0.536347 0.585138 0.783215 -0.210206 +-500e3 -250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-500e3 -500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-500e3 -750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-500e3 -1000e3 1 1 10 1600 0.75 0.25 0 0 0 0.234356 0.856057 -0.0022717 -0.516876 0.377946 -0.6794 0.628945 -0.352594 -0.733764 -0.580747 0.765644 -0.343182 0.30797 0.887345 0.93381 0.213574 0.287028 -0.101118 0.927114 -0.36088 0.5 -0.933719 0.117114 0.338308 -0.0254921 -0.964331 0.263469 0.357097 0.237382 0.9034 0.5 -0.25133 0.347452 -0.903388 -0.469855 -0.859796 -0.199968 -0.846209 0.374204 0.379344 +-750e3 -1 1 1 10 1600 0.75 0.25 0 0 0 0.660401 0.465625 -0.753394 0.464318 0.0539687 0.54786 0.834827 -0.883335 -0.363658 0.295757 0.339599 -0.801917 0.195168 -0.564658 0.205351 -0.797507 -0.567286 -0.561034 -0.570869 0.599457 0.5 0.382407 0.378019 -0.843129 0.519073 -0.842779 -0.142433 -0.764414 -0.383178 -0.518504 0.5 -0.240455 -0.221544 -0.94504 0.238945 0.930134 -0.278846 0.94079 -0.292863 -0.170718 +-750e3 -250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-750e3 -500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-750e3 -750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-750e3 -1000e3 1 1 10 1600 0.75 0.25 0 0 0 0.454517 -0.471007 -0.109032 0.875365 -0.369899 -0.876463 -0.3082 0.800829 -0.468961 0.372489 0.545483 -0.606357 0.308116 -0.733073 0.745445 0.541202 -0.389118 0.276847 -0.78241 -0.557844 0.5 -0.582494 -0.804381 0.116923 -0.786278 0.521134 -0.331942 0.206076 -0.285288 -0.936025 0.5 0.377829 -0.86593 -0.327735 0.0432579 0.370096 -0.927986 0.924864 0.336443 0.177291 +-1000e3 -1 1 1 10 1600 0.75 0.25 0 0 0 0.624319 0.916255 0.366602 0.161495 0.363564 -0.930276 0.0490634 0.168222 0.0137592 -0.985653 0.375681 -0.150366 0.339183 -0.928625 -0.572883 0.735633 0.361455 0.805726 0.586344 0.0836982 0.5 0.621804 0.633868 -0.459968 -0.00631371 0.591351 0.806389 0.783147 -0.498512 0.371707 0.5 -0.281107 0.195127 -0.93963 -0.833082 0.436428 0.339861 0.476397 0.878326 0.0398741 +-1000e3 -250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1000e3 -500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1000e3 -750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1000e3 -1000e3 1 1 10 1600 0.75 0.25 0 0 0 0.258433 0.255748 0.488309 -0.834354 0.557641 0.630489 0.539926 0.789702 -0.603355 -0.111055 0.741567 0.169503 -0.982719 0.0743723 0.454303 0.0109459 -0.89078 0.874572 0.184778 0.448308 0.5 0.767092 0.168414 0.619037 0.0541544 -0.978482 0.199098 0.639247 -0.119203 -0.759706 0.5 0.379731 -0.178727 -0.907668 0.118511 0.982474 -0.143877 0.917474 -0.0529345 0.394257 diff --git a/tests/app/oceanic_min_max_surface.dat b/tests/app/oceanic_min_max_surface.dat index 6db2e291b..fcc0e852d 100644 --- a/tests/app/oceanic_min_max_surface.dat +++ b/tests/app/oceanic_min_max_surface.dat @@ -27,10 +27,10 @@ 0 750e3 1 1 10 0 1000e3 1 1 10 250e3 0 1 1 10 -250e3 0 40e3 1 10 -250e3 0 60e3 1 10 -250e3 0 250e3 1 10 -250e3 0 350e3 1 10 +250e3 0 1 40e3 10 +250e3 0 1 60e3 10 +250e3 0 1 250e3 10 +250e3 0 1 350e3 10 250e3 250e3 1 1 10 250e3 250e3 1 40e3 10 250e3 250e3 1 60e3 10 @@ -60,3 +60,111 @@ 1000e3 500e3 1 1 10 1000e3 750e3 1 1 10 1000e3 1000e3 1 1 10 +-1 0 1 1 10 +-1 0 1 40e3 10 +-1 0 1 60e3 10 +-1 0 1 150e3 10 +-1 0 1 250e3 10 +-1 0 1 350e3 10 +-1 250e3 1 1 10 +-1 250e3 1 40e3 10 +-1 250e3 1 60e3 10 +-1 250e3 1 150e3 10 +-1 250e3 1 250e3 10 +-1 250e3 1 350e3 10 +-1 500e3 1 1 10 +-1 500e3 1 40e3 10 +-1 500e3 1 60e3 10 +-1 500e3 1 150e3 10 +-1 500e3 1 250e3 10 +-1 500e3 1 350e3 10 +-1 750e3 1 1 10 +-1 1000e3 1 1 10 +-250e3 0 1 1 10 +-250e3 0 1 40e3 10 +-250e3 0 1 60e3 10 +-250e3 0 1 250e3 10 +-250e3 0 1 350e3 10 +-250e3 250e3 1 1 10 +-250e3 250e3 1 40e3 10 +-250e3 250e3 1 60e3 10 +-250e3 250e3 1 150e3 10 +-250e3 250e3 1 250e3 10 +-250e3 250e3 1 350e3 10 +-250e3 500e3 1 1 10 +-250e3 500e3 1 40e3 10 +-250e3 500e3 1 60e3 10 +-250e3 500e3 1 150e3 10 +-250e3 500e3 1 250e3 10 +-250e3 500e3 1 350e3 10 +-250e3 750e3 1 1 10 +-250e3 1000e3 1 1 10 +-500e3 0 1 1 10 +-500e3 250e3 1 1 10 +-500e3 500e3 1 1 10 +-500e3 750e3 1 1 10 +-500e3 1000e3 1 1 10 +-750e3 0 1 1 10 +-750e3 250e3 1 1 10 +-750e3 500e3 1 1 10 +-750e3 750e3 1 1 10 +-750e3 1000e3 1 1 10 +-1000e3 0 1 1 10 +-1000e3 250e3 1 1 10 +-1000e3 500e3 1 1 10 +-1000e3 750e3 1 1 10 +-1000e3 1000e3 1 1 10 +-1 -1 1 1 10 +-1 -1 1 40e3 10 +-1 -1 1 60e3 10 +-1 -1 1 150e3 10 +-1 -1 1 250e3 10 +-1 -1 1 350e3 10 +-1 -250e3 1 1 10 +-1 -250e3 1 40e3 10 +-1 -250e3 1 60e3 10 +-1 -250e3 1 150e3 10 +-1 -250e3 1 250e3 10 +-1 -250e3 1 350e3 10 +-1 -500e3 1 1 10 +-1 -500e3 1 40e3 10 +-1 -500e3 1 60e3 10 +-1 -500e3 1 150e3 10 +-1 -500e3 1 250e3 10 +-1 -500e3 1 350e3 10 +-1 -750e3 1 1 10 +-1 -1000e3 1 1 10 +-250e3 -1 1 1 10 +-250e3 -1 1 40e3 10 +-250e3 -1 1 60e3 10 +-250e3 -1 1 250e3 10 +-250e3 -1 1 350e3 10 +-250e3 -250e3 1 1 10 +-250e3 -250e3 1 40e3 10 +-250e3 -250e3 1 60e3 10 +-250e3 -250e3 1 150e3 10 +-250e3 -250e3 1 250e3 10 +-250e3 -250e3 1 350e3 10 +-250e3 -500e3 1 1 10 +-250e3 -500e3 1 40e3 10 +-250e3 -500e3 1 60e3 10 +-250e3 -500e3 1 150e3 10 +-250e3 -500e3 1 250e3 10 +-250e3 -500e3 1 350e3 10 +-250e3 -750e3 1 1 10 +-250e3 -1000e3 1 1 10 +-500e3 -1 1 1 10 +-500e3 -250e3 1 1 10 +-500e3 -500e3 1 1 10 +-500e3 -750e3 1 1 10 +-500e3 -1000e3 1 1 10 +-750e3 -1 1 1 10 +-750e3 -250e3 1 1 10 +-750e3 -500e3 1 1 10 +-750e3 -750e3 1 1 10 +-750e3 -1000e3 1 1 10 +-1000e3 -1 1 1 10 +-1000e3 -250e3 1 1 10 +-1000e3 -500e3 1 1 10 +-1000e3 -750e3 1 1 10 +-1000e3 -1000e3 1 1 10 \ No newline at end of file diff --git a/tests/app/oceanic_min_max_surface.wb b/tests/app/oceanic_min_max_surface.wb index ef62ef2c6..125b57214 100644 --- a/tests/app/oceanic_min_max_surface.wb +++ b/tests/app/oceanic_min_max_surface.wb @@ -19,6 +19,42 @@ {"model":"uniform", "compositions":[0,1],"rotation matrices":[[[19,20,21],[22,23,24],[25,26,27]],[[28,29,30],[31,32,33],[34,35,36]]],"grain sizes":[-1,0.3], "min depth":[[200e3],[100e3,[[0,500e3],[1000e3,500e3],[0,0]]]], "max depth":[[300e3],[200e3,[[0,500e3],[1000e3,500e3]]]]} ] + }, + { + "model":"oceanic plate", "name":"Var thickness continent 2", "coordinates":[[-1,1000e3],[-1000e3,1000e3],[-1000e3,0],[-1,0]], + "min depth":[[50e3,[[-1,500e3]]],[200e3,[[-1000e3,500e3]]]], "max depth":[[300e3],[200e3,[[-1,500e3],[-1000e3,500e3]]]], + "temperature models":[ + {"model":"linear", "min depth":[[50e3,[[-1,500e3]]],[200e3,[[-1000e3,500e3]]]], "max depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,500e3],[-1,0]]]], "top temperature":2, "bottom temperature":5}, + {"model":"linear", "min depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,500e3],[-1,0]]]], "max depth":[[300e3],[200e3,[[-1,500e3],[-1000e3,500e3]]]], "top temperature":10, "bottom temperature":15} + ], + "composition models":[ + {"model":"uniform", "min depth":[[50e3,[[-1,500e3]]],[200e3,[[-1000e3,500e3]]]], "max depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,500e3],[-1,0]]]], "compositions":[0]}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,500e3],[-1,0]]]], "max depth":[[300e3],[200e3,[[-1,500e3],[-1000e3,500e3]]]], "compositions":[1]} + ], + "grains models":[ + {"model":"uniform", "compositions":[0,1],"Euler angles z-x-z":[[10,15,20],[25,30,35]],"grain sizes":[-1,0.2], + "min depth":[[50e3,[[-1,500e3]]],[200e3,[[-1000e3,500e3]]]], "max depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,500e3],[-1,0]]]]}, + {"model":"uniform", "compositions":[0,1],"Euler angles z-x-z":[[40,45,50],[55,60,65]],"grain sizes":[-1,0.3], + "min depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,500e3],[-1,0]]]], "max depth":[[300e3],[200e3,[[-1,500e3],[-1000e3,500e3]]]]} + ] + }, + { + "model":"oceanic plate", "name":"Var thickness continent 3", "coordinates":[[-1,-1000e3],[-1000e3,-1000e3],[-1000e3,-1],[-1,-1]], + "min depth":[[50e3,[[-1,-500e3]]],[200e3,[[-1000e3,-500e3]]]], "max depth":[[300e3],[200e3,[[-1,-500e3],[-1000e3,-500e3]]]], + "temperature models":[ + {"model":"adiabatic", "min depth":[[50e3,[[-1,-500e3]]],[200e3,[[-1000e3,-500e3]]]], "max depth":[[200e3],[100e3,[[-1,-500e3],[-1000e3,-500e3],[-1,-1]]]], "potential mantle temperature":-1}, + {"model":"adiabatic", "min depth":[[200e3],[100e3,[[-1,-500e3],[-1000e3,-500e3],[-1,0]]]], "max depth":[[300e3],[200e3,[[-1,-500e3],[-1000e3,-500e3]]]], "potential mantle temperature":10} + ], + "composition models":[ + {"model":"uniform", "min depth":[[50e3,[[-1,-500e3]]],[200e3,[[-1000e3,-500e3]]]], "max depth":[[200e3],[100e3,[[-1,500e3],[-1000e3,-500e3],[-1,-1]]]], "compositions":[0,1], "fractions":[0.75,0.25]}, + {"model":"uniform", "min depth":[[200e3],[100e3,[[-1,-500e3],[-1000e3,-500e3],[-1,-1]]]], "max depth":[[300e3],[200e3,[[-1,-500e3],[-1000e3,-500e3]]]], "compositions":[0,1], "fractions":[0.75,0.25]} + ], + "grains models":[ + {"model":"random uniform distribution", "compositions":[0,1],"grain sizes":[-1,0.2], "normalize grain sizes":[true,true], + "min depth":[[50e3,[[-1,-500e3]]],[200e3,[[-1000e3,-500e3]]]], "max depth":[[200e3],[100e3,[[-1,-500e3],[-1000e3,-500e3],[-1,-1]]]]}, + {"model":"random uniform distribution", "compositions":[0,1],"grain sizes":[-1,0.3], "normalize grain sizes":[true,true], + "min depth":[[200e3],[100e3,[[-1,-500e3],[-1000e3,-500e3],[-1,-1]]]], "max depth":[[300e3],[200e3,[[-1,-500e3],[-1000e3,-500e3]]]]} + ] } ] } diff --git a/tests/app/oceanic_min_max_surface/screen-output.log b/tests/app/oceanic_min_max_surface/screen-output.log index aa384f884..bf6629d9f 100644 --- a/tests/app/oceanic_min_max_surface/screen-output.log +++ b/tests/app/oceanic_min_max_surface/screen-output.log @@ -20,10 +20,10 @@ 0 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 250e3 0 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 -250e3 0 40e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 -250e3 0 60e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 -250e3 0 250e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 -250e3 0 350e3 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 1 40e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 1 60e3 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +250e3 0 1 250e3 10 200 0 1 0 0 0 0.5 19 20 21 22 23 24 25 26 27 0.5 19 20 21 22 23 24 25 26 27 0.3 28 29 30 31 32 33 34 35 36 0.3 28 29 30 31 32 33 34 35 36 +250e3 0 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 250e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 250e3 250e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 250e3 250e3 1 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 @@ -53,3 +53,111 @@ 1000e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1000e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1000e3 1000e3 1 1 10 150 1 0 0 0 0 0.5 1 2 3 4 5 6 7 8 9 0.5 1 2 3 4 5 6 7 8 9 0.2 10 11 12 13 14 15 16 17 18 0.2 10 11 12 13 14 15 16 17 18 +-1 0 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 0 1 40e3 10 2.6 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 0 1 60e3 10 2.9 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 0 1 150e3 10 4.25 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 0 1 250e3 10 12.5 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-1 0 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 250e3 1 40e3 10 2.36 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 250e3 1 60e3 10 2.84 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 250e3 1 150e3 10 10 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-1 250e3 1 250e3 10 15 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-1 250e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 500e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 500e3 1 60e3 10 2.6 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 500e3 1 150e3 10 12.5 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-1 500e3 1 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 500e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 1000e3 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-250e3 0 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-250e3 0 1 40e3 10 2.6 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-250e3 0 1 60e3 10 2.9 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-250e3 0 1 250e3 10 12.5 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-250e3 0 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 250e3 1 40e3 10 2.36 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-250e3 250e3 1 60e3 10 2.84 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-250e3 250e3 1 150e3 10 10 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-250e3 250e3 1 250e3 10 15 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-250e3 250e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 500e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 500e3 1 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 500e3 1 150e3 10 12.5 0 1 0 0 0 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.5 0.144222 -0.828123 -0.541675 0.878984 -0.144222 0.454519 -0.454519 -0.541675 0.707107 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 0.3 -0.128798 -0.606107 -0.784886 0.692931 -0.621202 0.365998 -0.709406 -0.496732 0.5 +-250e3 500e3 1 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 500e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 1000e3 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-500e3 0 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-500e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-500e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-500e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-500e3 1000e3 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-750e3 0 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-750e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-750e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-750e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-750e3 1000e3 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1000e3 0 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1000e3 250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1000e3 500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1000e3 750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1000e3 1000e3 1 1 10 2.00001 1 0 0 0 0 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.5 0.868049 -0.488523 -0.0885213 0.49444 0.834493 0.24321 -0.0449435 -0.254887 0.965926 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 0.2 0.532476 -0.79638 -0.286788 0.819645 0.400537 0.409576 -0.211309 -0.453154 0.866025 +-1 -1 1 1 10 1600 0.75 0.25 0 0 0 0.366764 -0.958224 -0.0791103 -0.27486 -0.109953 -0.785254 0.609333 -0.264039 0.614099 0.743751 0.633236 -0.212463 0.0702563 0.97464 0.0629808 -0.994354 0.0854066 0.975137 0.0795293 0.206839 0.5 -0.645103 -0.0423676 -0.76292 -0.583559 -0.61723 0.527718 -0.493255 0.785641 0.373453 0.5 0.910219 0.293065 0.292599 0.0563453 0.612334 -0.788588 -0.410276 0.734275 0.540846 +-1 -1 1 40e3 10 1618.02 0.75 0.25 0 0 0 0.471428 0.653596 0.556681 -0.512756 0.32377 0.406715 0.854258 0.684094 -0.724354 0.0855904 0.528572 0.937445 0.158394 -0.310015 0.345346 -0.535581 0.770642 -0.0439732 -0.829496 -0.556778 0.5 -0.923768 -0.374971 -0.0777773 -0.226331 0.698414 -0.678964 0.308912 -0.609602 -0.73004 0.5 -0.478424 0.399673 -0.781903 -0.878125 -0.215159 0.427321 0.00255552 0.891049 0.4539 +-1 -1 1 60e3 10 1627.11 0.75 0.25 0 0 0 0.670828 -0.261308 0.433255 -0.862559 0.729259 -0.496824 -0.470476 -0.632376 -0.751968 -0.186131 0.329172 0.265074 0.868384 0.419101 -0.545959 0.493433 -0.677091 -0.794773 -0.0493322 0.604898 0.5 -0.233697 0.953611 0.189768 -0.935883 -0.167694 -0.309843 -0.263647 -0.25001 0.931657 0.5 0.596199 0.210762 -0.774678 -0.775251 0.401906 -0.487296 0.208645 0.891095 0.403009 +-1 -1 1 150e3 10 1668.63 0.75 0.25 0 0 0 0.185461 0.80071 -0.308533 0.513489 0.306795 0.947428 0.0908669 -0.514529 0.0847777 0.853272 0.814539 0.246757 -0.909064 0.335729 -0.871943 -0.0570955 0.486267 -0.422879 -0.412726 -0.80674 0.5 -0.0780425 -0.955365 -0.284933 -0.865531 -0.0769022 0.494916 -0.494737 0.285243 -0.820897 0.5 -0.255637 -0.826636 -0.50132 0.000833022 0.518362 -0.855161 0.966772 -0.219029 -0.131824 +-1 -1 1 250e3 10 10.7251 0.75 0.25 0 0 0 0.477004 0.636889 0.733656 -0.236899 -0.236373 0.478302 0.845787 0.733825 -0.482676 0.478042 0.522996 -0.494037 -0.864667 -0.0909884 -0.765255 0.482122 -0.426549 0.41269 -0.141102 -0.899876 0.5 -0.0198408 0.980595 0.19504 -0.731338 -0.147251 0.665929 0.681726 -0.129428 0.720068 0.5 0.0644779 0.990725 0.119612 0.765223 -0.126021 0.63131 0.640528 0.0508246 -0.766251 +-1 -1 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -250e3 1 40e3 10 1618.02 0.75 0.25 0 0 0 0.387507 0.6519 0.731675 0.199192 0.676992 -0.443217 -0.587572 -0.341626 0.517889 -0.784272 0.612493 0.454256 -0.861273 -0.22773 -0.377598 0.0453874 -0.924856 0.80689 0.506112 -0.304598 0.5 0.71902 -0.219773 0.659326 -0.691763 -0.317625 0.64852 0.0668913 -0.922396 -0.380409 0.5 -0.567546 0.4711 0.675245 0.0919775 0.851271 -0.516602 -0.818188 -0.231088 -0.526466 +-1 -250e3 1 60e3 10 1627.11 0.75 0.25 0 0 0 0.924717 -0.448684 0.616845 -0.646672 0.802953 0.595934 0.0113307 0.392364 -0.514164 -0.762684 0.0752831 -0.997164 -0.0750011 0.00621204 0.0606959 -0.850275 -0.522827 0.0444946 -0.520968 0.852416 0.5 0.754866 -0.556638 -0.346889 0.421981 0.00728989 0.906575 -0.502105 -0.830723 0.240393 0.5 -0.113624 0.400412 -0.909263 -0.992265 0.000318587 0.124136 0.0499954 0.916335 0.397279 +-1 -250e3 1 150e3 10 1668.63 0.75 0.25 0 0 0 0.620618 0.506152 0.297525 0.809499 -0.53662 -0.626148 0.565666 0.675166 -0.720707 -0.157268 0.379382 -0.132605 0.224537 -0.965401 0.284427 -0.924418 -0.254073 -0.949482 -0.308278 0.0587184 0.5 0.48776 -0.105887 -0.866532 0.785075 -0.380882 0.488452 -0.381768 -0.91854 -0.10265 0.5 -0.757477 -0.635292 0.150439 -0.416003 0.292083 -0.861179 0.503159 -0.714907 -0.48553 +-1 -250e3 1 250e3 10 10.7251 0.75 0.25 0 0 0 0.750733 -0.25523 -0.948573 0.187259 0.489464 -0.293782 -0.821047 0.833836 -0.1179 0.539274 0.249267 0.907976 0.0225353 0.418416 -0.0759522 0.990863 0.111452 -0.412081 -0.132976 0.901392 0.5 0.177323 -0.76066 0.624462 -0.166191 0.602261 0.780809 -0.970019 -0.242235 -0.0196206 0.5 -0.386433 -0.424036 0.819062 0.495681 -0.84438 -0.20328 0.777798 0.32744 0.536483 +-1 -250e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -500e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -500e3 1 60e3 10 1627.11 0.75 0.25 0 0 0 0.31151 -0.552558 0.030718 0.832908 -0.278521 -0.948678 -0.149786 0.785561 -0.314748 0.532755 0.68849 -0.886998 -0.191095 -0.420378 0.442269 -0.0897767 -0.892378 0.132788 -0.977457 0.164147 0.5 -0.279919 0.109342 -0.953776 0.859415 0.4713 -0.198195 0.427844 -0.875169 -0.225896 0.5 0.133985 -0.0550239 -0.989455 0.452239 0.891821 0.0116447 0.881776 -0.44903 0.144375 +-1 -500e3 1 150e3 10 10.4289 0.75 0.25 0 0 0 0.944814 0.805553 -0.221124 0.549716 0.515393 0.719204 -0.465956 -0.292325 0.658673 0.693323 0.0551861 -0.82104 -0.392988 -0.414069 -0.560653 0.418478 0.714524 -0.107521 0.818802 -0.563917 0.5 0.63145 0.401201 0.663557 -0.762661 0.16676 0.624932 0.140069 -0.900682 0.411281 0.5 0.566032 -0.641977 0.517178 0.778999 0.621807 -0.0807313 -0.269757 0.448577 0.852062 +-1 -500e3 1 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -500e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1 -1000e3 1 1 10 1600 0.75 0.25 0 0 0 0.593752 -0.481887 0.775642 0.407631 0.875767 0.411177 0.252913 0.0285614 0.478866 -0.877423 0.406248 0.276603 -0.922022 0.270862 -0.546888 0.0807346 0.833304 -0.790193 -0.378626 -0.481911 0.5 -0.493083 -0.688079 -0.532368 -0.743128 0.0149396 0.668982 -0.452359 0.725482 -0.518698 0.5 0.840893 0.505968 0.192084 0.203281 -0.624217 0.754341 0.501574 -0.595273 -0.627753 +-250e3 -1 1 1 10 1600 0.75 0.25 0 0 0 0.190488 -0.354951 0.892992 0.276724 -0.0404353 0.281057 -0.958839 -0.93401 -0.35153 -0.0636529 0.809512 -0.588493 0.152485 0.793993 0.775541 -0.171082 0.607673 0.228499 0.973385 -0.0175775 0.5 -0.0178915 -0.778758 0.627069 -0.667684 0.476139 0.572267 -0.74423 -0.408445 -0.528483 0.5 -0.297635 -0.91736 0.264316 0.842432 -0.122122 0.52478 -0.449134 0.378862 0.809162 +-250e3 -1 1 40e3 10 1618.02 0.75 0.25 0 0 0 0.573945 -0.383618 -0.800363 0.460712 0.740638 -0.564635 -0.3642 0.551627 0.201507 0.809384 0.426055 -0.15071 -0.897226 -0.415056 -0.233802 -0.375591 0.89681 -0.960533 0.232199 -0.153168 0.5 -0.138834 -0.0414727 -0.989447 0.810327 0.5696 -0.137575 0.569294 -0.820875 -0.0454732 0.5 0.596569 -0.0707409 0.799438 -0.694477 -0.544763 0.470037 0.402254 -0.835601 -0.374117 +-250e3 -1 1 60e3 10 1627.11 0.75 0.25 0 0 0 0.00856497 -0.524315 0.0349976 -0.850805 0.251286 0.961018 -0.115326 0.813602 -0.274262 -0.512671 0.991435 0.831897 -0.418296 -0.364659 0.53727 0.442653 0.717913 -0.138883 -0.79315 0.592979 0.5 0.246022 -0.932076 0.26591 0.943885 0.292757 0.152889 -0.220351 0.213374 0.951797 0.5 0.414952 0.129083 -0.90064 0.504307 0.791281 0.345758 0.757291 -0.597672 0.263246 +-250e3 -1 1 250e3 10 10.7251 0.75 0.25 0 0 0 0.323427 0.843057 0.49605 0.207819 -0.3218 0.155644 0.933927 0.430929 -0.85423 0.290846 0.676573 -0.865032 -0.455681 -0.209937 0.479445 -0.874072 -0.0782975 -0.147822 -0.168383 0.974575 0.5 0.532658 -0.839518 0.107167 0.705179 0.370232 -0.604691 0.467972 0.397665 0.789217 0.5 0.526857 0.539846 -0.656497 0.521849 0.404214 0.751189 0.670891 -0.738361 -0.0687547 +-250e3 -1 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -250e3 1 40e3 10 1618.02 0.75 0.25 0 0 0 0.553899 0.825741 0.291637 0.482805 0.495032 -0.784981 -0.372488 0.270362 0.546582 -0.79256 0.446101 -0.336252 -0.9402 0.0543991 -0.871751 0.332588 0.359771 -0.356349 0.073551 -0.931454 0.5 0.470279 -0.825891 0.311034 -0.872403 -0.381852 0.305126 -0.133232 -0.414841 -0.900087 0.5 0.487013 -0.839393 -0.241325 0.600617 0.121269 0.790286 -0.634096 -0.529824 0.563214 +-250e3 -250e3 1 60e3 10 1627.11 0.75 0.25 0 0 0 0.924429 0.226959 -0.733612 -0.640549 0.795801 -0.23945 0.556206 -0.561419 -0.635986 0.529463 0.0755707 -0.294476 0.931342 -0.214212 -0.552703 -0.348836 -0.756857 -0.779617 -0.10448 0.617479 0.5 -0.943233 0.140378 0.301008 0.259975 -0.251967 0.932162 0.206699 0.9575 0.201169 0.5 -0.239657 0.758139 -0.606457 0.559433 0.618369 0.551955 0.793473 -0.206993 -0.572324 +-250e3 -250e3 1 150e3 10 1668.63 0.75 0.25 0 0 0 0.50085 -0.108212 -0.926568 0.360226 0.757185 0.157978 0.633809 -0.644175 0.341343 0.684488 0.49915 0.0811971 -0.877571 0.472521 0.385021 -0.409668 -0.827001 0.919329 0.249081 0.30462 0.5 -0.977162 -0.104136 0.185231 0.086434 0.601539 0.794154 -0.194123 0.792027 -0.5788 0.5 -0.801543 0.597379 0.0258339 -0.263644 -0.391867 0.881438 0.536675 0.699699 0.471593 +-250e3 -250e3 1 250e3 10 10.7251 0.75 0.25 0 0 0 0.769871 0.747281 0.0855458 0.658979 0.394841 0.740474 -0.543874 -0.534483 0.666619 0.519565 0.230129 -0.986676 -0.093663 -0.133036 0.158685 -0.734535 -0.659756 -0.0359251 -0.672076 0.739611 0.5 0.379057 -0.432912 -0.817865 0.258081 0.89821 -0.355827 0.888656 -0.0761962 0.452199 0.5 -0.937242 -0.0471275 0.345481 0.0744371 -0.995026 0.0662048 0.340642 0.0877665 0.936088 +-250e3 -250e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -500e3 1 40e3 10 1618.02 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -500e3 1 60e3 10 1627.11 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -500e3 1 150e3 10 10.4289 0.75 0.25 0 0 0 0.822857 -0.0866308 -0.183832 -0.979133 -0.567716 -0.798522 0.200152 -0.818653 0.573209 -0.035188 0.177143 0.0151364 -0.311297 0.950192 -0.216451 -0.928788 -0.300836 0.976176 -0.201117 -0.0814391 0.5 -0.924893 -0.264805 0.272858 0.292676 -0.0377146 0.955468 -0.242722 0.963564 0.112384 0.5 -0.79662 0.513067 0.319621 0.558651 0.422933 0.713468 0.230879 0.74692 -0.623543 +-250e3 -500e3 1 250e3 10 1716.01 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -500e3 1 350e3 10 1764.74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-250e3 -1000e3 1 1 10 1600 0.75 0.25 0 0 0 0.922061 -0.401583 -0.157987 -0.902093 -0.602671 0.787261 0.130414 0.689579 0.596037 -0.411364 0.0779389 -0.219381 -0.943671 0.247705 0.489954 0.112993 0.864395 -0.843693 0.310996 0.437566 0.5 0.370903 -0.105414 0.922669 -0.913173 0.139357 0.383007 -0.168954 -0.984615 -0.0445731 0.5 -0.937156 0.330466 0.11194 0.156716 0.685324 -0.711176 -0.311735 -0.64894 -0.694045 +-500e3 -1 1 1 10 1600 0.75 0.25 0 0 0 0.59034 0.258755 0.589603 0.765124 -0.19042 -0.745421 0.638817 0.946988 -0.310992 -0.0806091 0.40966 0.114091 -0.196659 0.973811 0.0329795 0.980421 0.19413 -0.992923 0.00996723 0.118343 0.5 -0.999434 -0.00977119 -0.0322004 0.0268172 0.346753 -0.937573 0.0203268 -0.937906 -0.346295 0.5 -0.334307 0.469142 0.817401 0.738818 -0.408019 0.536347 0.585138 0.783215 -0.210206 +-500e3 -250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-500e3 -500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-500e3 -750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-500e3 -1000e3 1 1 10 1600 0.75 0.25 0 0 0 0.234356 0.856057 -0.0022717 -0.516876 0.377946 -0.6794 0.628945 -0.352594 -0.733764 -0.580747 0.765644 -0.343182 0.30797 0.887345 0.93381 0.213574 0.287028 -0.101118 0.927114 -0.36088 0.5 -0.933719 0.117114 0.338308 -0.0254921 -0.964331 0.263469 0.357097 0.237382 0.9034 0.5 -0.25133 0.347452 -0.903388 -0.469855 -0.859796 -0.199968 -0.846209 0.374204 0.379344 +-750e3 -1 1 1 10 1600 0.75 0.25 0 0 0 0.660401 0.465625 -0.753394 0.464318 0.0539687 0.54786 0.834827 -0.883335 -0.363658 0.295757 0.339599 -0.801917 0.195168 -0.564658 0.205351 -0.797507 -0.567286 -0.561034 -0.570869 0.599457 0.5 0.382407 0.378019 -0.843129 0.519073 -0.842779 -0.142433 -0.764414 -0.383178 -0.518504 0.5 -0.240455 -0.221544 -0.94504 0.238945 0.930134 -0.278846 0.94079 -0.292863 -0.170718 +-750e3 -250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-750e3 -500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-750e3 -750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-750e3 -1000e3 1 1 10 1600 0.75 0.25 0 0 0 0.454517 -0.471007 -0.109032 0.875365 -0.369899 -0.876463 -0.3082 0.800829 -0.468961 0.372489 0.545483 -0.606357 0.308116 -0.733073 0.745445 0.541202 -0.389118 0.276847 -0.78241 -0.557844 0.5 -0.582494 -0.804381 0.116923 -0.786278 0.521134 -0.331942 0.206076 -0.285288 -0.936025 0.5 0.377829 -0.86593 -0.327735 0.0432579 0.370096 -0.927986 0.924864 0.336443 0.177291 +-1000e3 -1 1 1 10 1600 0.75 0.25 0 0 0 0.624319 0.916255 0.366602 0.161495 0.363564 -0.930276 0.0490634 0.168222 0.0137592 -0.985653 0.375681 -0.150366 0.339183 -0.928625 -0.572883 0.735633 0.361455 0.805726 0.586344 0.0836982 0.5 0.621804 0.633868 -0.459968 -0.00631371 0.591351 0.806389 0.783147 -0.498512 0.371707 0.5 -0.281107 0.195127 -0.93963 -0.833082 0.436428 0.339861 0.476397 0.878326 0.0398741 +-1000e3 -250e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1000e3 -500e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1000e3 -750e3 1 1 10 1600 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 +-1000e3 -1000e3 1 1 10 1600 0.75 0.25 0 0 0 0.258433 0.255748 0.488309 -0.834354 0.557641 0.630489 0.539926 0.789702 -0.603355 -0.111055 0.741567 0.169503 -0.982719 0.0743723 0.454303 0.0109459 -0.89078 0.874572 0.184778 0.448308 0.5 0.767092 0.168414 0.619037 0.0541544 -0.978482 0.199098 0.639247 -0.119203 -0.759706 0.5 0.379731 -0.178727 -0.907668 0.118511 0.982474 -0.143877 0.917474 -0.0529345 0.394257