diff --git a/dumux/assembly/boxlocalassembler.hh b/dumux/assembly/boxlocalassembler.hh index ad9baffa0b12dc2f97380cbe7eed5fa25bea9a34..c8ebb3d836e70d7686bc0936c4afab4ca0ec7bb8 100644 --- a/dumux/assembly/boxlocalassembler.hh +++ b/dumux/assembly/boxlocalassembler.hh @@ -88,12 +88,42 @@ public: for (const auto& scv : scvs(this->fvGeometry())) res[scv.dofIndex()] += residual[scv.localDofIndex()]; } - else + else if (!this->elementIsGhost()) { const auto residual = this->asImp_().assembleJacobianAndResidualImpl(jac, gridVariables, partialReassembler); // forward to the internal implementation for (const auto& scv : scvs(this->fvGeometry())) res[scv.dofIndex()] += residual[scv.localDofIndex()]; } + else + { + using GridGeometry = typename GridVariables::GridGeometry; + using GridView = typename GridGeometry::GridView; + static constexpr auto dim = GridView::dimension; + + int numVerticesLocal = this->element().subEntities(dim); + + for (int i = 0; i < numVerticesLocal; ++i) { + auto vertex = this->element().template subEntity<dim>(i); + + if (vertex.partitionType() == Dune::InteriorEntity || + vertex.partitionType() == Dune::BorderEntity) + { + // do not change the non-ghost vertices + continue; + } + + // set main diagonal entries for the vertex + int vIdx = this->assembler().fvGridGeometry().vertexMapper().index(vertex); + + typedef typename JacobianMatrix::block_type BlockType; + BlockType &J = jac[vIdx][vIdx]; + for (int j = 0; j < BlockType::rows; ++j) + J[j][j] = 1.0; + + // set residual for the vertex + res[vIdx] = 0; + } + } auto applyDirichlet = [&] (const auto& scvI, const auto& dirichletValues, diff --git a/dumux/linear/amgbackend.hh b/dumux/linear/amgbackend.hh index 7d87c2fdfb23915186aa08a5b8197aa49ef949b0..16caed8869880fdbabebd1ecbd3fc7d1641afeb9 100644 --- a/dumux/linear/amgbackend.hh +++ b/dumux/linear/amgbackend.hh @@ -134,7 +134,7 @@ public: std::shared_ptr<LinearOperator> fop; std::shared_ptr<ScalarProduct> sp; static const int dofCodim = AmgTraits::dofCodim; - static const bool isParallel = Dune::Capabilities::canCommunicate<Grid, dofCodim>::v; + static const bool isParallel = AmgTraits::isParallel; prepareLinearAlgebra_<Matrix, Vector, isParallel>(A, b, rank, comm, fop, sp); using SmootherArgs = typename Dune::Amg::SmootherTraits<Smoother>::Arguments; diff --git a/dumux/linear/amgtraits.hh b/dumux/linear/amgtraits.hh index ea0f779c9b109a2b44c3880d849b12bf516fa050..82fce6fb5f1a38e00f9915e5fafd9dad89452979 100644 --- a/dumux/linear/amgtraits.hh +++ b/dumux/linear/amgtraits.hh @@ -34,6 +34,38 @@ #include <dumux/discretization/methods.hh> +// TODO: The following is a temporary solution to make the parallel AMG work +// for UGGrid. Once it is resolved upstream +// (https://gitlab.dune-project.org/core/dune-grid/issues/78), +// it should be guarded by a DUNE_VERSION macro and removed later. + +#if HAVE_UG +#include <dune/grid/uggrid.hh> +#endif // HAVE_UG + +namespace Dumux { +namespace Temp { +namespace Capabilities { + +template<class Grid, int codim> +struct canCommunicate +{ + static const bool v = false; +}; + +#if HAVE_UG +template<int dim, int codim> +struct canCommunicate<Dune::UGGrid<dim>, codim> +{ + static const bool v = true; +}; +#endif // HAVE_UG + +} // namespace Capabilities +} // namespace Temp +} // namespace Dumux +// end workaround + namespace Dumux { //! The implementation is specialized for the different discretizations @@ -74,7 +106,9 @@ struct AmgTraitsImpl<Matrix, Vector, FVGridGeometry, DiscretizationMethod::box> enum { dofCodim = Grid::dimension, isNonOverlapping = true, + // TODO: see above for description of this workaround, remove second line if fixed upstream isParallel = Dune::Capabilities::canCommunicate<Grid, dofCodim>::v + || Dumux::Temp::Capabilities::canCommunicate<Grid, dofCodim>::v }; using MType = Matrix; using VType = Dune::BlockVector<Dune::FieldVector<typename Vector::block_type::value_type, Vector::block_type::dimension>>; @@ -118,7 +152,9 @@ struct AmgTraitsImpl<Matrix, Vector, FVGridGeometry, DiscretizationMethod::cctpf enum { dofCodim = 0, isNonOverlapping = false, + // TODO: see above for description of this workaround, remove second line if fixed upstream isParallel = Dune::Capabilities::canCommunicate<Grid, dofCodim>::v + || Dumux::Temp::Capabilities::canCommunicate<Grid, dofCodim>::v }; using MType = Matrix; using VType = Dune::BlockVector<Dune::FieldVector<typename Vector::block_type::value_type, Vector::block_type::dimension>>; diff --git a/test/porousmediumflow/richards/implicit/CMakeLists.txt b/test/porousmediumflow/richards/implicit/CMakeLists.txt index 435ff34dd10c2272f28e2cc3e3b71bffb361e80b..64b581b0b9f157800947f52e4548ac9fff4e664a 100644 --- a/test/porousmediumflow/richards/implicit/CMakeLists.txt +++ b/test/porousmediumflow/richards/implicit/CMakeLists.txt @@ -1,48 +1,88 @@ add_input_file_links() +# isothermal tests add_executable(test_richards_tpfa EXCLUDE_FROM_ALL test_richardslens_fv.cc) target_compile_definitions(test_richards_tpfa PUBLIC TYPETAG=RichardsLensCCTypeTag) add_executable(test_richards_box EXCLUDE_FROM_ALL test_richardslens_fv.cc) target_compile_definitions(test_richards_box PUBLIC TYPETAG=RichardsLensBoxTypeTag) -dune_add_test(NAME test_richards_box_parallel +dune_add_test(TARGET test_richards_box + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/richardslensbox-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/test_richards_box-00007.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_richards_box test_richardslens.input -Problem.Name test_richards_box") + +dune_add_test(TARGET test_richards_tpfa + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/richardslenscc-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/test_richards_tpfa-00007.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_richards_tpfa test_richardslens.input -Problem.Name test_richards_tpfa") + +dune_add_test(NAME test_richards_box_parallel_yasp TARGET test_richards_box CMAKE_GUARD MPI_FOUND COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py CMD_ARGS --script fuzzy --zeroThreshold {"process rank":100} --files ${CMAKE_SOURCE_DIR}/test/references/richardslensbox-reference-parallel.vtu - ${CMAKE_CURRENT_BINARY_DIR}/s0002-p0000-test_richards_box_parallel-00008.vtu + ${CMAKE_CURRENT_BINARY_DIR}/s0002-p0000-test_richards_box_parallel_yasp-00007.vtu ${CMAKE_SOURCE_DIR}/test/references/richardslensbox-reference.vtu - ${CMAKE_CURRENT_BINARY_DIR}/s0002-test_richards_box_parallel-00008.pvtu - --command "${MPIEXEC} -np 2 ${CMAKE_CURRENT_BINARY_DIR}/test_richards_box test_richardslens.input -Problem.Name test_richards_box_parallel -Grid.Overlap 0") + ${CMAKE_CURRENT_BINARY_DIR}/s0002-test_richards_box_parallel_yasp-00007.pvtu + --command "${MPIEXEC} -np 2 ${CMAKE_CURRENT_BINARY_DIR}/test_richards_box test_richardslens.input -Problem.Name test_richards_box_parallel_yasp -Grid.Overlap 0") -dune_add_test(NAME test_richards_tpfa_parallel +dune_add_test(NAME test_richards_tpfa_parallel_yasp TARGET test_richards_tpfa CMAKE_GUARD MPI_FOUND COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py CMD_ARGS --script fuzzy --zeroThreshold {"process rank":100} --files ${CMAKE_SOURCE_DIR}/test/references/richardslenscc-reference-parallel.vtu - ${CMAKE_CURRENT_BINARY_DIR}/s0002-p0000-test_richards_tpfa_parallel-00007.vtu + ${CMAKE_CURRENT_BINARY_DIR}/s0002-p0000-test_richards_tpfa_parallel_yasp-00007.vtu ${CMAKE_SOURCE_DIR}/test/references/richardslenscc-reference.vtu - ${CMAKE_CURRENT_BINARY_DIR}/s0002-test_richards_tpfa_parallel-00007.pvtu - --command "${MPIEXEC} -np 2 ${CMAKE_CURRENT_BINARY_DIR}/test_richards_tpfa test_richardslens.input -Problem.Name test_richards_tpfa_parallel -Grid.Overlap 1") + ${CMAKE_CURRENT_BINARY_DIR}/s0002-test_richards_tpfa_parallel_yasp-00007.pvtu + --command "${MPIEXEC} -np 2 ${CMAKE_CURRENT_BINARY_DIR}/test_richards_tpfa test_richardslens.input -Problem.Name test_richards_tpfa_parallel_yasp -Grid.Overlap 1") -# isothermal tests -dune_add_test(TARGET test_richards_box +dune_add_test(NAME test_richards_box_parallel_ug + SOURCES test_richardslens_fv.cc + CMAKE_GUARD "( MPI_FOUND AND HAVE_UG )" + COMPILE_DEFINITIONS TYPETAG=RichardsLensBoxTypeTag GRIDTYPE=Dune::UGGrid<2> COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py - CMD_ARGS --script fuzzy + CMD_ARGS --script fuzzy --zeroThreshold {"process rank":100} --files ${CMAKE_SOURCE_DIR}/test/references/richardslensbox-reference.vtu - ${CMAKE_CURRENT_BINARY_DIR}/test_richards_box-00008.vtu - --command "${CMAKE_CURRENT_BINARY_DIR}/test_richards_box test_richardslens.input -Problem.Name test_richards_box") + ${CMAKE_CURRENT_BINARY_DIR}/s0002-test_richards_box_parallel_ug-00007.pvtu + --command "${MPIEXEC} -np 2 ${CMAKE_CURRENT_BINARY_DIR}/test_richards_box_parallel_ug test_richardslens.input -Problem.Name test_richards_box_parallel_ug") -dune_add_test(TARGET test_richards_tpfa +dune_add_test(NAME test_richards_tpfa_parallel_ug + SOURCES test_richardslens_fv.cc + CMAKE_GUARD "( MPI_FOUND AND HAVE_UG )" + COMPILE_DEFINITIONS TYPETAG=RichardsLensCCTypeTag GRIDTYPE=Dune::UGGrid<2> COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py - CMD_ARGS --script fuzzy + CMD_ARGS --script fuzzy --zeroThreshold {"process rank":100} --files ${CMAKE_SOURCE_DIR}/test/references/richardslenscc-reference.vtu - ${CMAKE_CURRENT_BINARY_DIR}/test_richards_tpfa-00007.vtu - --command "${CMAKE_CURRENT_BINARY_DIR}/test_richards_tpfa test_richardslens.input -Problem.Name test_richards_tpfa") + ${CMAKE_CURRENT_BINARY_DIR}/s0002-test_richards_tpfa_parallel_ug-00007.pvtu + --command "${MPIEXEC} -np 2 ${CMAKE_CURRENT_BINARY_DIR}/test_richards_tpfa_parallel_ug test_richardslens.input -Problem.Name test_richards_tpfa_parallel_ug") + +dune_add_test(NAME test_richards_box_parallel_alu + SOURCES test_richardslens_fv.cc + CMAKE_GUARD "( MPI_FOUND AND dune-alugrid_FOUND )" + COMPILE_DEFINITIONS TYPETAG=RichardsLensBoxTypeTag GRIDTYPE=Dune::ALUGrid<2,2,Dune::cube,Dune::nonconforming> + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy --zeroThreshold {"process rank":100} + --files ${CMAKE_SOURCE_DIR}/test/references/richardslensbox-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/s0002-test_richards_box_parallel_alu-00007.pvtu + --command "${MPIEXEC} -np 2 ${CMAKE_CURRENT_BINARY_DIR}/test_richards_box_parallel_alu test_richardslens.input -Problem.Name test_richards_box_parallel_alu") + +dune_add_test(NAME test_richards_tpfa_parallel_alu + SOURCES test_richardslens_fv.cc + CMAKE_GUARD "( MPI_FOUND AND dune-alugrid_FOUND )" + COMPILE_DEFINITIONS TYPETAG=RichardsLensCCTypeTag GRIDTYPE=Dune::ALUGrid<2,2,Dune::cube,Dune::nonconforming> + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy --zeroThreshold {"process rank":100} + --files ${CMAKE_SOURCE_DIR}/test/references/richardslenscc-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/s0002-test_richards_tpfa_parallel_alu-00007.pvtu + --command "${MPIEXEC} -np 2 ${CMAKE_CURRENT_BINARY_DIR}/test_richards_tpfa_parallel_alu test_richardslens.input -Problem.Name test_richards_tpfa_parallel_alu") # comparison to analytical solution - only with cc dune_add_test(SOURCES test_ccrichardsanalytical.cc diff --git a/test/porousmediumflow/richards/implicit/richardslensproblem.hh b/test/porousmediumflow/richards/implicit/richardslensproblem.hh index 034d0634c6c4c97f5003586e8d66796fc3281d34..bb2d1c3210edfe262c0bb15657fca119fbf8af26 100644 --- a/test/porousmediumflow/richards/implicit/richardslensproblem.hh +++ b/test/porousmediumflow/richards/implicit/richardslensproblem.hh @@ -27,6 +27,12 @@ #define DUMUX_RICHARDS_LENSPROBLEM_HH #include <dune/grid/yaspgrid.hh> +#if HAVE_DUNE_ALUGRID +#include <dune/alugrid/grid.hh> +#endif +#if HAVE_UG +#include <dune/grid/uggrid.hh> +#endif #include <dumux/discretization/cellcentered/tpfa/properties.hh> #include <dumux/discretization/box/properties.hh> @@ -55,8 +61,13 @@ NEW_TYPE_TAG(RichardsLensTypeTag, INHERITS_FROM(Richards)); NEW_TYPE_TAG(RichardsLensBoxTypeTag, INHERITS_FROM(BoxModel, RichardsLensTypeTag)); NEW_TYPE_TAG(RichardsLensCCTypeTag, INHERITS_FROM(CCTpfaModel, RichardsLensTypeTag)); +#ifndef GRIDTYPE // Use 2d YaspGrid SET_TYPE_PROP(RichardsLensTypeTag, Grid, Dune::YaspGrid<2>); +#else +// Use GRIDTYPE from CMakeLists.txt +SET_TYPE_PROP(RichardsLensTypeTag, Grid, GRIDTYPE); +#endif // Set the physical problem to be solved SET_TYPE_PROP(RichardsLensTypeTag, Problem, RichardsLensProblem<TypeTag>); @@ -193,15 +204,7 @@ public: */ PrimaryVariables dirichletAtPos(const GlobalPosition &globalPos) const { - // use initial values as boundary conditions - if (!onInlet_(globalPos)) - return initial_(globalPos); - else - { - PrimaryVariables values(0.0); - values.setState(bothPhases); - return values; - } + return initial_(globalPos); } /*! diff --git a/test/porousmediumflow/richards/implicit/richardslensspatialparams.hh b/test/porousmediumflow/richards/implicit/richardslensspatialparams.hh index 87cc492cd838b7c3f9291d783e962d49bbada89d..a49efbc290cd2408e38fedbbc2f80c5f682e0a66 100644 --- a/test/porousmediumflow/richards/implicit/richardslensspatialparams.hh +++ b/test/porousmediumflow/richards/implicit/richardslensspatialparams.hh @@ -44,6 +44,8 @@ class RichardsLensSpatialParams using ThisType = RichardsLensSpatialParams<FVGridGeometry, Scalar>; using ParentType = FVSpatialParams<FVGridGeometry, Scalar, ThisType>; using GridView = typename FVGridGeometry::GridView; + using FVElementGeometry = typename FVGridGeometry::LocalView; + using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -60,7 +62,7 @@ public: { lensLowerLeft_ = {1.0, 2.0}; - lensUpperRight_ = {4.1, 3.1}; + lensUpperRight_ = {4.0, 3.0}; // residual saturations lensMaterialParams_.setSwr(0.18); @@ -107,7 +109,17 @@ public: * * \param globalPos A global coordinate vector */ - const MaterialLawParams& materialLawParamsAtPos(const GlobalPosition &globalPos) const + template<class ElementSolution> + const MaterialLawParams& materialLawParams(const Element& element, + const SubControlVolume& scv, + const ElementSolution& elemSol) const + { + const auto& globalPos = scv.dofPosition(); + + return materialLawParamsAtPos(globalPos); + } + + const MaterialLawParams& materialLawParamsAtPos(const GlobalPosition& globalPos) const { if (isInLens_(globalPos)) return lensMaterialParams_; @@ -124,7 +136,7 @@ private: return true; } - static constexpr Scalar eps_ = 1.5e-7; + static constexpr Scalar eps_ = 1e-6; GlobalPosition lensLowerLeft_; GlobalPosition lensUpperRight_; diff --git a/test/porousmediumflow/richards/implicit/test_richardslens.input b/test/porousmediumflow/richards/implicit/test_richardslens.input index e0ea32dc4394503de6694bf5a941a48f2816619e..89b7a2d41f943580bcf5085462907168b2912c96 100644 --- a/test/porousmediumflow/richards/implicit/test_richardslens.input +++ b/test/porousmediumflow/richards/implicit/test_richardslens.input @@ -11,5 +11,5 @@ Name = richardslens EnableGravity = 1 # enable gravity [Newton] -TargetSteps = 18 # set the "desireable" number of newton iterations of a time step +TargetSteps = 18 # set the "desirable" number of Newton iterations of a time step EnableChop = true # chop for better convergence diff --git a/test/references/richardslensbox-reference-parallel.vtu b/test/references/richardslensbox-reference-parallel.vtu index 44574f7de93f8aee23b11ec4d357ecf65563705c..02ed3bbbc3cd341ce6ff5383b869a0fb6a77dfc2 100644 --- a/test/references/richardslensbox-reference-parallel.vtu +++ b/test/references/richardslensbox-reference-parallel.vtu @@ -4,25 +4,25 @@ <Piece NumberOfCells="192" NumberOfPoints="221"> <PointData Scalars="S_w"> <DataArray type="Float32" Name="S_w" NumberOfComponents="1" format="ascii"> - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 - -4.36236e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 1.64268e-05 2.5133e-05 - 1.64268e-05 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 0.00265965 0.0896917 - 0.0941071 0.0896917 0.00265965 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 0.00107807 0.228323 - 0.614878 0.636093 0.614878 0.228323 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 3.42956e-06 0.0806844 - 0.713938 0.933379 0.936951 0.933379 0.713938 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 + -5.55112e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 2.42731e-05 3.56558e-05 + 2.42731e-05 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 0.0024663 0.0900827 + 0.0946392 0.0900827 0.0024663 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 0.00099992 0.228153 + 0.615224 0.63579 0.615224 0.228153 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 3.93768e-06 0.0814728 + 0.713034 0.932869 0.936509 0.932869 0.713034 </DataArray> <DataArray type="Float32" Name="S_n" NumberOfComponents="1" format="ascii"> 1 1 1 1 1 1 1 1 1 1 1 1 @@ -39,11 +39,11 @@ 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 0.999984 0.999975 - 0.999984 1 1 1 1 1 1 1 1 1 0.99734 0.910308 - 0.905893 0.910308 0.99734 1 1 1 1 1 1 1 0.998922 0.771677 - 0.385122 0.363907 0.385122 0.771677 1 1 1 1 1 1 0.999997 0.919316 - 0.286062 0.066621 0.0630491 0.066621 0.286062 + 1 1 1 1 1 1 1 1 1 1 0.999976 0.999964 + 0.999976 1 1 1 1 1 1 1 1 1 0.997534 0.909917 + 0.905361 0.909917 0.997534 1 1 1 1 1 1 1 0.999 0.771847 + 0.384776 0.36421 0.384776 0.771847 1 1 1 1 1 1 0.999996 0.918527 + 0.286966 0.0671314 0.0634913 0.0671314 0.286966 </DataArray> <DataArray type="Float32" Name="p_w" NumberOfComponents="1" format="ascii"> 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 @@ -60,11 +60,11 @@ 97470.4 97470.4 78501.4 78501.4 78501.4 78501.4 78501.4 78501.4 78501.4 78501.4 78501.4 97470.4 97470.4 97470.4 97470.4 78501.4 78501.4 78501.4 78501.4 78501.4 78501.4 78501.4 78501.4 78501.4 97470.4 97470.4 97470.4 97470.4 78501.4 78501.4 78501.4 78501.4 78501.4 78501.4 78501.4 78501.4 - 78501.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.8 97471.1 - 97470.8 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97541.5 99364.9 - 99383.1 99364.9 97541.5 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97499.2 99586.6 - 99733.5 99739.1 99733.5 99586.6 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.5 99318.4 - 99759.6 99835.6 99837.6 99835.6 99759.6 + 78501.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97471 97471.3 + 97471 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97536.4 99366.6 + 99385.1 99366.6 97536.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97497.1 99586.5 + 99733.6 99739 99733.6 99586.5 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.5 99323.1 + 99759.4 99835.3 99837.4 99835.3 99759.4 </DataArray> <DataArray type="Float32" Name="p_n" NumberOfComponents="1" format="ascii"> 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 @@ -102,11 +102,11 @@ 2529.62 2529.62 21498.6 21498.6 21498.6 21498.6 21498.6 21498.6 21498.6 21498.6 21498.6 2529.62 2529.62 2529.62 2529.62 21498.6 21498.6 21498.6 21498.6 21498.6 21498.6 21498.6 21498.6 21498.6 2529.62 2529.62 2529.62 2529.62 21498.6 21498.6 21498.6 21498.6 21498.6 21498.6 21498.6 21498.6 - 21498.6 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.18 2528.95 - 2529.18 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2458.46 635.12 - 616.93 635.12 2458.46 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2500.78 413.429 - 266.462 260.883 266.462 413.429 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.53 681.602 - 240.369 164.432 162.357 164.432 240.369 + 21498.6 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2528.97 2528.67 + 2528.97 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2463.64 633.409 + 614.893 633.409 2463.64 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2502.87 413.55 + 266.37 260.962 266.37 413.55 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.52 676.884 + 240.611 164.722 162.618 164.722 240.611 </DataArray> <DataArray type="Float32" Name="density" NumberOfComponents="1" format="ascii"> 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 @@ -145,10 +145,10 @@ 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0.0398913 - 0.0550044 0.0398913 0 0 0 0 0 0 0 0 0 3.9331 - 146.456 165.264 146.456 3.9331 0 0 0 0 0 0 0 0.0182195 - 250.229 736.45 755.59 736.45 250.229 + 0 0 0 0 0 0 0 0 0 0 0 0.0411001 + 0.0570506 0.0411001 0 0 0 0 0 0 0 0 0 3.92159 + 146.749 164.984 146.749 3.92159 0 0 0 0 0 0 0 0.0196823 + 249.082 733.751 753.199 733.751 249.082 </DataArray> <DataArray type="Float32" Name="kr" NumberOfComponents="1" format="ascii"> 0 0 0 0 0 0 0 0 0 0 0 0 @@ -166,10 +166,10 @@ 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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.98913e-05 - 5.50044e-05 3.98913e-05 0 0 0 0 0 0 0 0 0 0.0039331 - 0.146456 0.165264 0.146456 0.0039331 0 0 0 0 0 0 0 1.82195e-05 - 0.250229 0.73645 0.75559 0.73645 0.250229 + 0 0 0 0 0 0 0 0 0 0 0 4.11001e-05 + 5.70506e-05 4.11001e-05 0 0 0 0 0 0 0 0 0 0.00392159 + 0.146749 0.164984 0.146749 0.00392159 0 0 0 0 0 0 0 1.96823e-05 + 0.249082 0.733751 0.753199 0.733751 0.249082 </DataArray> <DataArray type="Float32" Name="porosity" NumberOfComponents="1" format="ascii"> 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 @@ -207,32 +207,32 @@ -25.7861 -25.7861 -219.149 -219.149 -219.149 -219.149 -219.149 -219.149 -219.149 -219.149 -219.149 -25.7861 -25.7861 -25.7861 -25.7861 -219.149 -219.149 -219.149 -219.149 -219.149 -219.149 -219.149 -219.149 -219.149 -25.7861 -25.7861 -25.7861 -25.7861 -219.149 -219.149 -219.149 -219.149 -219.149 -219.149 -219.149 -219.149 - -219.149 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7817 -25.7793 - -25.7817 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.0608 -6.47421 - -6.28879 -6.47421 -25.0608 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.4921 -4.21437 - -2.71622 -2.65936 -2.71622 -4.21437 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7852 -6.94804 - -2.45024 -1.67617 -1.65501 -1.67617 -2.45024 + -219.149 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7795 -25.7764 + -25.7795 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.1135 -6.45677 + -6.26802 -6.45677 -25.1135 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.5134 -4.2156 + -2.7153 -2.66017 -2.7153 -4.2156 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7851 -6.89994 + -2.45271 -1.67913 -1.65768 -1.67913 -2.45271 </DataArray> <DataArray type="Float32" Name="water content" NumberOfComponents="1" format="ascii"> - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 - -1.74495e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 6.5707e-06 1.00532e-05 - 6.5707e-06 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 0.00106386 0.0358767 - 0.0376428 0.0358767 0.00106386 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 0.000431228 0.0913292 - 0.245951 0.254437 0.245951 0.0913292 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 1.37182e-06 0.0322738 - 0.285575 0.373352 0.37478 0.373352 0.285575 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 + -2.22045e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 9.70923e-06 1.42623e-05 + 9.70923e-06 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 0.000986521 0.0360331 + 0.0378557 0.0360331 0.000986521 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 0.000399968 0.0912612 + 0.24609 0.254316 0.24609 0.0912612 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 1.57507e-06 0.0325891 + 0.285214 0.373147 0.374603 0.373147 0.285214 </DataArray> <DataArray type="Float32" Name="phasePresence" NumberOfComponents="1" format="ascii"> 3 3 3 3 3 3 3 3 3 3 3 3 diff --git a/test/references/richardslensbox-reference.vtu b/test/references/richardslensbox-reference.vtu index 0b74a7c245ce9a8f3244f63ef6c1a260c88b7fa8..be2f29b326237fd79a23fe09360920db6497fa30 100644 --- a/test/references/richardslensbox-reference.vtu +++ b/test/references/richardslensbox-reference.vtu @@ -4,42 +4,42 @@ <Piece NumberOfCells="384" NumberOfPoints="425"> <PointData Scalars="S_w"> <DataArray type="Float32" Name="S_w" NumberOfComponents="1" format="ascii"> - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 - -4.36236e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 - -4.36236e-17 -4.36236e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 - -4.36236e-17 -4.36236e-17 -4.36236e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 - -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 - -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 -4.36236e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 1.64268e-05 2.5133e-05 - 1.64268e-05 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 0.00265965 0.0896917 - 0.0941071 0.0896917 0.00265965 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 0.00107807 0.228323 - 0.614878 0.636093 0.614878 0.228323 0.00107807 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 3.42956e-06 0.0806844 - 0.713938 0.933379 0.936951 0.933379 0.713938 0.0806844 3.42956e-06 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 - 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 9.35838e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 + -5.55112e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 + -5.55112e-17 -5.55112e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 + -5.55112e-17 -5.55112e-17 -5.55112e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 + -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 + -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 -5.55112e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 2.42731e-05 3.56558e-05 + 2.42731e-05 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 0.0024663 0.0900827 + 0.0946392 0.0900827 0.0024663 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 0.00099992 0.228153 + 0.615224 0.63579 0.615224 0.228153 0.00099992 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 3.93768e-06 0.0814728 + 0.713034 0.932869 0.936509 0.932869 0.713034 0.0814728 3.93768e-06 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 + 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 9.02056e-17 </DataArray> <DataArray type="Float32" Name="S_n" NumberOfComponents="1" format="ascii"> 1 1 1 1 1 1 1 1 1 1 1 1 @@ -69,14 +69,14 @@ 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 0.999984 0.999975 - 0.999984 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 0.99734 0.910308 - 0.905893 0.910308 0.99734 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 0.998922 0.771677 - 0.385122 0.363907 0.385122 0.771677 0.998922 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 0.999997 0.919316 - 0.286062 0.066621 0.0630491 0.066621 0.286062 0.919316 0.999997 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 0.999976 0.999964 + 0.999976 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 0.997534 0.909917 + 0.905361 0.909917 0.997534 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 0.999 0.771847 + 0.384776 0.36421 0.384776 0.771847 0.999 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 0.999996 0.918527 + 0.286966 0.0671314 0.0634913 0.0671314 0.286966 0.918527 0.999996 1 1 1 1 1 1 1 1 1 1 </DataArray> <DataArray type="Float32" Name="p_w" NumberOfComponents="1" format="ascii"> @@ -107,14 +107,14 @@ 78501.4 78501.4 78501.4 78501.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 78501.4 78501.4 78501.4 78501.4 78501.4 78501.4 78501.4 78501.4 78501.4 78501.4 78501.4 78501.4 78501.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 - 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.8 97471.1 - 97470.8 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 - 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97541.5 99364.9 - 99383.1 99364.9 97541.5 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 - 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97499.2 99586.6 - 99733.5 99739.1 99733.5 99586.6 97499.2 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 - 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.5 99318.4 - 99759.6 99835.6 99837.6 99835.6 99759.6 99318.4 97470.5 97470.4 97470.4 97470.4 97470.4 97470.4 + 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97471 97471.3 + 97471 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 + 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97536.4 99366.6 + 99385.1 99366.6 97536.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 + 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97497.1 99586.5 + 99733.6 99739 99733.6 99586.5 97497.1 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 + 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.5 99323.1 + 99759.4 99835.3 99837.4 99835.3 99759.4 99323.1 97470.5 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 97470.4 </DataArray> <DataArray type="Float32" Name="p_n" NumberOfComponents="1" format="ascii"> @@ -183,14 +183,14 @@ 21498.6 21498.6 21498.6 21498.6 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 21498.6 21498.6 21498.6 21498.6 21498.6 21498.6 21498.6 21498.6 21498.6 21498.6 21498.6 21498.6 21498.6 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 - 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.18 2528.95 - 2529.18 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 - 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2458.46 635.12 - 616.93 635.12 2458.46 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 - 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2500.78 413.429 - 266.462 260.883 266.462 413.429 2500.78 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 - 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.53 681.602 - 240.369 164.432 162.357 164.432 240.369 681.602 2529.53 2529.62 2529.62 2529.62 2529.62 2529.62 + 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2528.97 2528.67 + 2528.97 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 + 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2463.64 633.409 + 614.893 633.409 2463.64 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 + 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2502.87 413.55 + 266.37 260.962 266.37 413.55 2502.87 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 + 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.52 676.884 + 240.611 164.722 162.618 164.722 240.611 676.884 2529.52 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 2529.62 </DataArray> <DataArray type="Float32" Name="density" NumberOfComponents="1" format="ascii"> @@ -261,12 +261,12 @@ 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0.0398913 - 0.0550044 0.0398913 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 3.9331 - 146.456 165.264 146.456 3.9331 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0.0182195 - 250.229 736.45 755.59 736.45 250.229 0.0182195 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0.0411001 + 0.0570506 0.0411001 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 3.92159 + 146.749 164.984 146.749 3.92159 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0.0196823 + 249.082 733.751 753.199 733.751 249.082 0.0196823 0 0 0 0 0 0 0 0 0 0 0 </DataArray> <DataArray type="Float32" Name="kr" NumberOfComponents="1" format="ascii"> @@ -299,12 +299,12 @@ 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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.98913e-05 - 5.50044e-05 3.98913e-05 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0.0039331 - 0.146456 0.165264 0.146456 0.0039331 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 1.82195e-05 - 0.250229 0.73645 0.75559 0.73645 0.250229 1.82195e-05 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 4.11001e-05 + 5.70506e-05 4.11001e-05 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0.00392159 + 0.146749 0.164984 0.146749 0.00392159 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1.96823e-05 + 0.249082 0.733751 0.753199 0.733751 0.249082 1.96823e-05 0 0 0 0 0 0 0 0 0 0 0 </DataArray> <DataArray type="Float32" Name="porosity" NumberOfComponents="1" format="ascii"> @@ -373,55 +373,55 @@ -219.149 -219.149 -219.149 -219.149 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -219.149 -219.149 -219.149 -219.149 -219.149 -219.149 -219.149 -219.149 -219.149 -219.149 -219.149 -219.149 -219.149 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 - -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7817 -25.7793 - -25.7817 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 - -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.0608 -6.47421 - -6.28879 -6.47421 -25.0608 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 - -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.4921 -4.21437 - -2.71622 -2.65936 -2.71622 -4.21437 -25.4921 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 - -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7852 -6.94804 - -2.45024 -1.67617 -1.65501 -1.67617 -2.45024 -6.94804 -25.7852 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 + -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7795 -25.7764 + -25.7795 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 + -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.1135 -6.45677 + -6.26802 -6.45677 -25.1135 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 + -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.5134 -4.2156 + -2.7153 -2.66017 -2.7153 -4.2156 -25.5134 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 + -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7851 -6.89994 + -2.45271 -1.67913 -1.65768 -1.67913 -2.45271 -6.89994 -25.7851 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 -25.7861 </DataArray> <DataArray type="Float32" Name="water content" NumberOfComponents="1" format="ascii"> - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 - -1.74495e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 - -1.74495e-17 -1.74495e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 - -1.74495e-17 -1.74495e-17 -1.74495e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 - -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 - -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 -1.74495e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 6.5707e-06 1.00532e-05 - 6.5707e-06 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 0.00106386 0.0358767 - 0.0376428 0.0358767 0.00106386 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 0.000431228 0.0913292 - 0.245951 0.254437 0.245951 0.0913292 0.000431228 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 1.37182e-06 0.0322738 - 0.285575 0.373352 0.37478 0.373352 0.285575 0.0322738 1.37182e-06 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 - 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 3.74335e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 + -2.22045e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 + -2.22045e-17 -2.22045e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 + -2.22045e-17 -2.22045e-17 -2.22045e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 + -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 + -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 -2.22045e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 9.70923e-06 1.42623e-05 + 9.70923e-06 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 0.000986521 0.0360331 + 0.0378557 0.0360331 0.000986521 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 0.000399968 0.0912612 + 0.24609 0.254316 0.24609 0.0912612 0.000399968 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 1.57507e-06 0.0325891 + 0.285214 0.373147 0.374603 0.373147 0.285214 0.0325891 1.57507e-06 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 + 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 3.60822e-17 </DataArray> - <DataArray type="Float32" Name="phase presence" NumberOfComponents="1" format="ascii"> + <DataArray type="Float32" Name="phasePresence" NumberOfComponents="1" format="ascii"> 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3