diff --git a/dumux/porousmediumflow/nonequilibrium/gridvariables.hh b/dumux/porousmediumflow/nonequilibrium/gridvariables.hh index 82ba10ce60c798ecd2c043f0ddf2a2e030bc29c1..28f5b6861af1d4d36cd9a3a737834fb59b146d4e 100644 --- a/dumux/porousmediumflow/nonequilibrium/gridvariables.hh +++ b/dumux/porousmediumflow/nonequilibrium/gridvariables.hh @@ -25,12 +25,14 @@ #ifndef DUMUX_NONEQUILIBRIUM_GRID_VARIABLES_HH #define DUMUX_NONEQUILIBRIUM_GRID_VARIABLES_HH +#include <memory> #include <dune/common/fvector.hh> #include <dune/grid/common/partitionset.hh> #include <dumux/common/properties.hh> #include <dumux/discretization/method.hh> #include <dumux/discretization/fvgridvariables.hh> +#include <dumux/porousmediumflow/velocity.hh> namespace Dumux { @@ -45,41 +47,38 @@ class NonEquilibriumGridVariables GetPropType<TypeTag, Properties::GridVolumeVariables>, GetPropType<TypeTag, Properties::GridFluxVariablesCache>> { + using ThisType = NonEquilibriumGridVariables<TypeTag>; using ParentType = FVGridVariables<GetPropType<TypeTag, Properties::FVGridGeometry>, GetPropType<TypeTag, Properties::GridVolumeVariables>, GetPropType<TypeTag, Properties::GridFluxVariablesCache>>; - using Problem = GetPropType<TypeTag, Properties::Problem>; - using FVGridGeometry = GetPropType<TypeTag, Properties::FVGridGeometry>; - using GridView = typename FVGridGeometry::GridView; + using VelocityBackend = PorousMediumFlowVelocity<ThisType, PorousMediumFluxVariables<TypeTag>>; - static constexpr auto dim = GridView::dimension; // Grid and world dimension - static constexpr auto dimWorld = GridView::dimensionworld; - - static constexpr int numPhases = GetPropType<TypeTag, Properties::ModelTraits>::numFluidPhases(); - static constexpr bool isBox = FVGridGeometry::discMethod == DiscretizationMethod::box; + static constexpr auto dim = ParentType::GridGeometry::GridView::dimension; // Grid and world dimension + static constexpr auto dimWorld = ParentType::GridGeometry::GridView::dimensionworld; + static constexpr int numPhases = ParentType::VolumeVariables::numFluidPhases(); + static constexpr bool isBox = ParentType::GridGeometry::discMethod == DiscretizationMethod::box; public: //! Export the type used for scalar values using typename ParentType::Scalar; + using typename ParentType::GridGeometry; //! Constructor + template<class Problem> NonEquilibriumGridVariables(std::shared_ptr<Problem> problem, - std::shared_ptr<FVGridGeometry> fvGridGeometry) - : ParentType(problem, fvGridGeometry) - , problem_(problem) + std::shared_ptr<const GridGeometry> gridGeometry) + : ParentType(problem, gridGeometry) { for (int phaseIdx = 0; phaseIdx < numPhases; ++phaseIdx) - velocityNorm_[phaseIdx].assign(fvGridGeometry->numDofs(), 0.0); + velocityNorm_[phaseIdx].assign(gridGeometry->numDofs(), 0.0); + + velocityBackend_ = std::make_unique<VelocityBackend>(*this); } template<class SolutionVector> void calcVelocityAverage(const SolutionVector& curSol) { - // instatiate the velocity output - using VelocityOutput = GetPropType<TypeTag, Properties::VelocityOutput>; - VelocityOutput velocityOutput(*this); - using Scalar = typename SolutionVector::field_type; using VelocityVector = typename Dune::FieldVector<Scalar, dimWorld>; @@ -106,7 +105,7 @@ public: for (int phaseIdx = 0; phaseIdx < numPhases; ++phaseIdx) { - velocityOutput.calculateVelocity(velocity[phaseIdx], element, fvGeometry, elemVolVars, elemFluxVarsCache, phaseIdx); + velocityBackend_->calculateVelocity(velocity[phaseIdx], element, fvGeometry, elemVolVars, elemFluxVarsCache, phaseIdx); for (auto&& scv : scvs(fvGeometry)) { @@ -131,8 +130,8 @@ public: { return velocityNorm_[phaseIdx][dofIdxGlobal]; } private: - std::shared_ptr<const Problem> problem_; std::array<std::vector<Dune::FieldVector<Scalar, 1> > , numPhases> velocityNorm_; + std::unique_ptr<VelocityBackend> velocityBackend_; }; } // end namespace Dumux diff --git a/dumux/porousmediumflow/velocity.hh b/dumux/porousmediumflow/velocity.hh new file mode 100644 index 0000000000000000000000000000000000000000..83f3f69cad603faf3c3088db565273acf3bfa4cd --- /dev/null +++ b/dumux/porousmediumflow/velocity.hh @@ -0,0 +1,431 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 3 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 General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * \ingroup PorousmediumflowModels + * \brief Velocity computation for implicit (porous media) models. + */ + +#ifndef DUMUX_POROUSMEDIUMFLOW_VELOCITY_HH +#define DUMUX_POROUSMEDIUMFLOW_VELOCITY_HH + +#include <vector> + +#include <dune/common/fvector.hh> +#include <dune/common/float_cmp.hh> +#include <dune/geometry/referenceelements.hh> + +#include <dumux/common/parameters.hh> +#include <dumux/common/deprecated.hh> +#include <dumux/discretization/method.hh> +#include <dumux/discretization/elementsolution.hh> + +namespace Dumux { + +/*! + * \ingroup PorousmediumflowModels + * \brief Velocity computation for implicit (porous media) models. + */ +template<class GridVariables, class FluxVariables> +class PorousMediumFlowVelocity +{ + using FVGridGeometry = typename GridVariables::GridGeometry; + using FVElementGeometry = typename FVGridGeometry::LocalView; + using SubControlVolume = typename FVGridGeometry::SubControlVolume; + using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; + using GridView = typename FVGridGeometry::GridView; + using Element = typename GridView::template Codim<0>::Entity; + using GridVolumeVariables = typename GridVariables::GridVolumeVariables; + using ElementFluxVarsCache = typename GridVariables::GridFluxVariablesCache::LocalView; + using VolumeVariables = typename GridVariables::VolumeVariables; + using ElementVolumeVariables = typename GridVolumeVariables::LocalView; + using FluidSystem = typename VolumeVariables::FluidSystem; + using Scalar = typename GridVariables::Scalar; + + static constexpr int dim = GridView::dimension; + static constexpr int dimWorld = GridView::dimensionworld; + static constexpr bool isBox = FVGridGeometry::discMethod == DiscretizationMethod::box; + static constexpr int dofCodim = isBox ? dim : 0; + + using GlobalPosition = typename Element::Geometry::GlobalCoordinate; + using ReferenceElements = Dune::ReferenceElements<typename GridView::ctype, dim>; + + using Problem = typename GridVolumeVariables::Problem; + using BoundaryTypes = typename Problem::Traits::BoundaryTypes; + +public: + static constexpr int numFluidPhases = VolumeVariables::numFluidPhases(); + using VelocityVector = std::vector<Dune::FieldVector<Scalar, dimWorld>>; + + /*! + * \brief Constructor initializes the static data with the initial solution. + * + * \param gridVariables The grid variables + */ + PorousMediumFlowVelocity(const GridVariables& gridVariables) + : problem_(gridVariables.curGridVolVars().problem()) + , fvGridGeometry_(gridVariables.fvGridGeometry()) + , gridVariables_(gridVariables) + { + // set the number of scvs the vertices are connected to + if (isBox && dim > 1) + { + // resize to the number of vertices of the grid + cellNum_.assign(fvGridGeometry_.gridView().size(dim), 0); + + for (const auto& element : elements(fvGridGeometry_.gridView())) + for (unsigned int vIdx = 0; vIdx < element.subEntities(dim); ++vIdx) + ++cellNum_[fvGridGeometry_.vertexMapper().subIndex(element, vIdx, dim)]; + } + } + + //! Calculates the velocities for the scvs in the element. + //! We assume the local containers to be bound to the complete stencil. + void calculateVelocity(VelocityVector& velocity, + const Element& element, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const ElementFluxVarsCache& elemFluxVarsCache, + int phaseIdx) const + { + using Velocity = typename VelocityVector::value_type; + + const auto geometry = element.geometry(); + const Dune::GeometryType geomType = geometry.type(); + + // the upwind term to be used for the volume flux evaluation + auto upwindTerm = [phaseIdx](const auto& volVars) { return volVars.mobility(phaseIdx); }; + + if(isBox && dim == 1) + { + Velocity tmpVelocity(0.0); + tmpVelocity = (geometry.corner(1) - geometry.corner(0)); + tmpVelocity /= tmpVelocity.two_norm(); + + for (auto&& scvf : scvfs(fvGeometry)) + { + if (scvf.boundary()) + continue; + + // insantiate the flux variables + FluxVariables fluxVars; + fluxVars.init(problem_, element, fvGeometry, elemVolVars, scvf, elemFluxVarsCache); + + // get the volume flux divided by the area of the + // subcontrolvolume face in the reference element + Scalar localArea = scvfReferenceArea_(geomType, scvf.index()); + Scalar flux = fluxVars.advectiveFlux(phaseIdx, upwindTerm) / localArea; + const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; + flux /= insideVolVars.extrusionFactor(); + tmpVelocity *= flux; + + const int eIdxGlobal = fvGridGeometry_.elementMapper().index(element); + velocity[eIdxGlobal] = tmpVelocity; + } + return; + } + + // get the transposed Jacobian of the element mapping + const auto referenceElement = ReferenceElements::general(geomType); + const auto& localPos = referenceElement.position(0, 0); + const auto jacobianT2 = geometry.jacobianTransposed(localPos); + + if(isBox) + { + using ScvVelocities = Dune::BlockVector<Velocity>; + ScvVelocities scvVelocities(fvGeometry.numScv()); + scvVelocities = 0; + + for (auto&& scvf : scvfs(fvGeometry)) + { + if (scvf.boundary()) + continue; + + // local position of integration point + const auto localPosIP = geometry.local(scvf.ipGlobal()); + + // Transformation of the global normal vector to normal vector in the reference element + const auto jacobianT1 = geometry.jacobianTransposed(localPosIP); + const auto globalNormal = scvf.unitOuterNormal(); + GlobalPosition localNormal(0); + jacobianT1.mv(globalNormal, localNormal); + localNormal /= localNormal.two_norm(); + + // instantiate the flux variables + FluxVariables fluxVars; + fluxVars.init(problem_, element, fvGeometry, elemVolVars, scvf, elemFluxVarsCache); + + // get the volume flux divided by the area of the + // subcontrolvolume face in the reference element + Scalar localArea = scvfReferenceArea_(geomType, scvf.index()); + Scalar flux = fluxVars.advectiveFlux(phaseIdx, upwindTerm) / localArea; + const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; + flux /= insideVolVars.extrusionFactor(); + + // transform the volume flux into a velocity vector + Velocity tmpVelocity = localNormal; + tmpVelocity *= flux; + + scvVelocities[scvf.insideScvIdx()] += tmpVelocity; + scvVelocities[scvf.outsideScvIdx()] += tmpVelocity; + } + + // transform vertex velocities from local to global coordinates + for (auto&& scv : scvs(fvGeometry)) + { + int vIdxGlobal = scv.dofIndex(); + + // calculate the subcontrolvolume velocity by the Piola transformation + Velocity scvVelocity(0); + + jacobianT2.mtv(scvVelocities[scv.indexInElement()], scvVelocity); + scvVelocity /= geometry.integrationElement(localPos)*cellNum_[vIdxGlobal]; + // add up the wetting phase subcontrolvolume velocities for each vertex + velocity[vIdxGlobal] += scvVelocity; + } + } + else + { + // For the number of scvfs per facet (mpfa) we simply obtain the number of + // corners of the first facet as prisms/pyramids are not supported here anyway + // -> for prisms/pyramids the number of scvfs would differ from facet to facet + static constexpr bool isMpfa = FVGridGeometry::discMethod == DiscretizationMethod::ccmpfa; + const int numScvfsPerFace = isMpfa ? element.template subEntity<1>(0).geometry().corners() : 1; + + if (fvGeometry.numScvf() != element.subEntities(1)*numScvfsPerFace) + DUNE_THROW(Dune::NotImplemented, "Velocity output for non-conforming grids"); + + if (!geomType.isCube() && !geomType.isSimplex()) + DUNE_THROW(Dune::NotImplemented, "Velocity output for other geometry types than cube and simplex"); + + // first we extract the corner indices for each scv for the CIV method + // for network grids there might be multiple intersection with the same geometryInInside + // we identify those by the indexInInside for now (assumes conforming grids at branching facets) + // here we keep track of them + std::vector<bool> handledScvf; + if (dim < dimWorld) + handledScvf.resize(element.subEntities(1), false); + + // find the local face indices of the scvfs (for conforming meshes) + std::vector<unsigned int> scvfIndexInInside(fvGeometry.numScvf()); + int localScvfIdx = 0; + for (const auto& intersection : intersections(fvGridGeometry_.gridView(), element)) + { + if (dim < dimWorld) + if (handledScvf[intersection.indexInInside()]) + continue; + + if (intersection.neighbor() || intersection.boundary()) + { + for (int i = 0; i < numScvfsPerFace; ++i) + scvfIndexInInside[localScvfIdx++] = intersection.indexInInside(); + + // for surface and network grids mark that we handled this face + if (dim < dimWorld) + handledScvf[intersection.indexInInside()] = true; + } + } + + std::vector<Scalar> scvfFluxes(element.subEntities(1), 0.0); + localScvfIdx = 0; + for (auto&& scvf : scvfs(fvGeometry)) + { + const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; + if (!scvf.boundary()) + { + FluxVariables fluxVars; + fluxVars.init(problem_, element, fvGeometry, elemVolVars, scvf, elemFluxVarsCache); + scvfFluxes[scvfIndexInInside[localScvfIdx]] += fluxVars.advectiveFlux(phaseIdx, upwindTerm)/insideVolVars.extrusionFactor(); + } + else + { + auto bcTypes = problemBoundaryTypes_(element, scvf); + if (bcTypes.hasOnlyDirichlet()) + { + FluxVariables fluxVars; + fluxVars.init(problem_, element, fvGeometry, elemVolVars, scvf, elemFluxVarsCache); + scvfFluxes[scvfIndexInInside[localScvfIdx]] += fluxVars.advectiveFlux(phaseIdx, upwindTerm)/insideVolVars.extrusionFactor(); + } + } + + // increment scvf counter + localScvfIdx++; + } + + // Correct boundary fluxes in case of Neumann conditions. + // In this general setting, it would be very difficult to + // calculate correct phase, i.e., volume, fluxes from arbitrary + // Neumann conditions. We approximate the Neumann flux by the + // flux on the opposite face. For extremely distorted grids this can + // lead to unexpected results (but then TPFA also leads to unexpected results). + localScvfIdx = 0; + for (auto&& scvf : scvfs(fvGeometry)) + { + if (scvf.boundary()) + { + auto bcTypes = problemBoundaryTypes_(element, scvf); + if (bcTypes.hasNeumann()) + { + // check if we have Neumann no flow, we can just use 0 + const auto neumannFlux = Deprecated::neumann(problem_, element, fvGeometry, elemVolVars, elemFluxVarsCache, scvf); + using NumEqVector = std::decay_t<decltype(neumannFlux)>; + if (Dune::FloatCmp::eq<NumEqVector, Dune::FloatCmp::CmpStyle::absolute>(neumannFlux, NumEqVector(0.0), 1e-30)) + scvfFluxes[scvfIndexInInside[localScvfIdx]] = 0; + // cubes + else if (dim == 1 || geomType.isCube()) + { + const auto fIdx = scvfIndexInInside[localScvfIdx]; + const auto fIdxOpposite = fIdx%2 ? fIdx-1 : fIdx+1; + scvfFluxes[fIdx] = -scvfFluxes[fIdxOpposite]; + } + // simplices + else if (geomType.isSimplex()) + scvfFluxes[scvfIndexInInside[localScvfIdx]] = 0; + } + } + + // increment scvf counter + localScvfIdx++; + } + + Velocity refVelocity; + // cubes: On the reference element simply average over opposite fluxes + // note that this is equal to a corner velocity interpolation method + if (dim == 1 || geomType.isCube()) + { + for (int i = 0; i < dim; i++) + refVelocity[i] = 0.5 * (scvfFluxes[2*i + 1] - scvfFluxes[2*i]); + } + // simplices: Raviart-Thomas-0 interpolation evaluated at the cell center + else if (geomType.isSimplex()) + { + for (int dimIdx = 0; dimIdx < dim; dimIdx++) + { + refVelocity[dimIdx] = -scvfFluxes[dim - 1 - dimIdx]; + for (int fIdx = 0; fIdx < dim + 1; fIdx++) + refVelocity[dimIdx] += scvfFluxes[fIdx]/(dim + 1); + } + } + // 3D prism and pyramids + else + DUNE_THROW(Dune::NotImplemented, "velocity output for cell-centered and prism/pyramid"); + + Velocity scvVelocity(0); + jacobianT2.mtv(refVelocity, scvVelocity); + + scvVelocity /= geometry.integrationElement(localPos); + + int eIdxGlobal = fvGridGeometry_.elementMapper().index(element); + + velocity[eIdxGlobal] = scvVelocity; + + } // cell-centered + } + +private: + // The area of a subcontrolvolume face in a reference element. + // The 3d non-cube values have been calculated with quadrilateralArea3D + // of boxfvelementgeometry.hh. + static Scalar scvfReferenceArea_(Dune::GeometryType geomType, int fIdx) + { + if (dim == 1 || geomType.isCube()) + { + return 1.0/(1 << (dim-1)); + } + else if (geomType.isTriangle()) + { + static const Scalar faceToArea[] = {0.372677996249965, + 0.372677996249965, + 0.235702260395516}; + return faceToArea[fIdx]; + } + else if (geomType.isTetrahedron()) + { + static const Scalar faceToArea[] = {0.102062072615966, + 0.102062072615966, + 0.058925565098879, + 0.102062072615966, + 0.058925565098879, + 0.058925565098879}; + return faceToArea[fIdx]; + } + else if (geomType.isPyramid()) + { + static const Scalar faceToArea[] = {0.130437298687488, + 0.130437298687488, + 0.130437298687488, + 0.130437298687488, + 0.150923085635624, + 0.1092906420717, + 0.1092906420717, + 0.0781735959970571}; + return faceToArea[fIdx]; + } + else if (geomType.isPrism()) + { + static const Scalar faceToArea[] = {0.166666666666667, + 0.166666666666667, + 0.166666666666667, + 0.186338998124982, + 0.186338998124982, + 0.117851130197758, + 0.186338998124982, + 0.186338998124982, + 0.117851130197758}; + return faceToArea[fIdx]; + } + else { + DUNE_THROW(Dune::NotImplemented, "scvf area for unknown GeometryType"); + } + } + +private: + // The following SFINAE enable_if usage allows compilation, even if only a + // + // boundaryTypes(const Element&, const scv&) + // + // is provided in the problem file. In that case, the compiler cannot detect + // (without additional measures like "using...") the signature + // + // boundaryTypes(const Element&, const scvf&) + // + // in the problem base class. Therefore, calls to this method trigger a + // compiler error. However, that call is needed for calculating velocities + // if the cell-centered discretization is used. By proceeding as in the + // following lines, that call will only be compiled if cell-centered + // actually is used. + template <bool enable = isBox, typename std::enable_if_t<!enable, int> = 0> + BoundaryTypes problemBoundaryTypes_(const Element& element, const SubControlVolumeFace& scvf) const + { return problem_.boundaryTypes(element, scvf); } + + //! we should never call this method for box models + template <bool enable = isBox, typename std::enable_if_t<enable, int> = 0> + BoundaryTypes problemBoundaryTypes_(const Element& element, const SubControlVolumeFace& scvf) const + { return BoundaryTypes(); } + + const Problem& problem_; + const FVGridGeometry& fvGridGeometry_; + const GridVariables& gridVariables_; + + std::vector<int> cellNum_; +}; + +} // end namespace Dumux + +#endif diff --git a/dumux/porousmediumflow/velocityoutput.hh b/dumux/porousmediumflow/velocityoutput.hh index a825ed8192d13b45cc2c347d8acef848c76bd953..0d04c5b57890d34f34a92432774437909750406d 100644 --- a/dumux/porousmediumflow/velocityoutput.hh +++ b/dumux/porousmediumflow/velocityoutput.hh @@ -25,6 +25,7 @@ #ifndef DUMUX_POROUSMEDIUMFLOW_VELOCITYOUTPUT_HH #define DUMUX_POROUSMEDIUMFLOW_VELOCITYOUTPUT_HH +#include <memory> #include <dune/common/float_cmp.hh> #include <dune/geometry/referenceelements.hh> @@ -33,6 +34,7 @@ #include <dumux/io/velocityoutput.hh> #include <dumux/discretization/method.hh> #include <dumux/discretization/elementsolution.hh> +#include <dumux/porousmediumflow/velocity.hh> namespace Dumux { @@ -67,6 +69,7 @@ class PorousMediumFlowVelocityOutput : public VelocityOutput<GridVariables> using Problem = typename GridVolumeVariables::Problem; using BoundaryTypes = typename Problem::Traits::BoundaryTypes; + using VelocityBackend = PorousMediumFlowVelocity<GridVariables, FluxVariables>; public: using VelocityVector = typename ParentType::VelocityVector; @@ -77,25 +80,12 @@ public: * \param gridVariables The grid variables */ PorousMediumFlowVelocityOutput(const GridVariables& gridVariables) - : problem_(gridVariables.curGridVolVars().problem()) - , fvGridGeometry_(gridVariables.fvGridGeometry()) - , gridVariables_(gridVariables) + : gridVariables_(gridVariables) // TODO: can be removed after the deprecated calculateVelocity interface is removed { // check, if velocity output can be used (works only for cubes so far) - enableOutput_ = getParamFromGroup<bool>(problem_.paramGroup(), "Vtk.AddVelocity"); + enableOutput_ = getParamFromGroup<bool>(gridVariables.curGridVolVars().problem().paramGroup(), "Vtk.AddVelocity"); if (enableOutput_) - { - // set the number of scvs the vertices are connected to - if (isBox && dim > 1) - { - // resize to the number of vertices of the grid - cellNum_.assign(fvGridGeometry_.gridView().size(dim), 0); - - for (const auto& element : elements(fvGridGeometry_.gridView())) - for (unsigned int vIdx = 0; vIdx < element.subEntities(dim); ++vIdx) - ++cellNum_[fvGridGeometry_.vertexMapper().subIndex(element, vIdx, dim)]; - } - } + velocityBackend = std::make_unique<VelocityBackend>(gridVariables); } //! Returns whether or not velocity output is enabled. @@ -130,329 +120,14 @@ public: const ElementFluxVarsCache& elemFluxVarsCache, int phaseIdx) const override { - using Velocity = typename VelocityVector::value_type; - - if (!enableOutput_) return; - - const auto geometry = element.geometry(); - const Dune::GeometryType geomType = geometry.type(); - - // the upwind term to be used for the volume flux evaluation - auto upwindTerm = [phaseIdx](const auto& volVars) { return volVars.mobility(phaseIdx); }; - - if(isBox && dim == 1) - { - Velocity tmpVelocity(0.0); - tmpVelocity = (geometry.corner(1) - geometry.corner(0)); - tmpVelocity /= tmpVelocity.two_norm(); - - for (auto&& scvf : scvfs(fvGeometry)) - { - if (scvf.boundary()) - continue; - - // insantiate the flux variables - FluxVariables fluxVars; - fluxVars.init(problem_, element, fvGeometry, elemVolVars, scvf, elemFluxVarsCache); - - // get the volume flux divided by the area of the - // subcontrolvolume face in the reference element - Scalar localArea = scvfReferenceArea_(geomType, scvf.index()); - Scalar flux = fluxVars.advectiveFlux(phaseIdx, upwindTerm) / localArea; - const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; - flux /= insideVolVars.extrusionFactor(); - tmpVelocity *= flux; - - const int eIdxGlobal = fvGridGeometry_.elementMapper().index(element); - velocity[eIdxGlobal] = tmpVelocity; - } - return; - } - - // get the transposed Jacobian of the element mapping - const auto referenceElement = ReferenceElements::general(geomType); - const auto& localPos = referenceElement.position(0, 0); - const auto jacobianT2 = geometry.jacobianTransposed(localPos); - - if(isBox) - { - using ScvVelocities = Dune::BlockVector<Velocity>; - ScvVelocities scvVelocities(fvGeometry.numScv()); - scvVelocities = 0; - - for (auto&& scvf : scvfs(fvGeometry)) - { - if (scvf.boundary()) - continue; - - // local position of integration point - const auto localPosIP = geometry.local(scvf.ipGlobal()); - - // Transformation of the global normal vector to normal vector in the reference element - const auto jacobianT1 = geometry.jacobianTransposed(localPosIP); - const auto globalNormal = scvf.unitOuterNormal(); - GlobalPosition localNormal(0); - jacobianT1.mv(globalNormal, localNormal); - localNormal /= localNormal.two_norm(); - - // instantiate the flux variables - FluxVariables fluxVars; - fluxVars.init(problem_, element, fvGeometry, elemVolVars, scvf, elemFluxVarsCache); - - // get the volume flux divided by the area of the - // subcontrolvolume face in the reference element - Scalar localArea = scvfReferenceArea_(geomType, scvf.index()); - Scalar flux = fluxVars.advectiveFlux(phaseIdx, upwindTerm) / localArea; - const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; - flux /= insideVolVars.extrusionFactor(); - - // transform the volume flux into a velocity vector - Velocity tmpVelocity = localNormal; - tmpVelocity *= flux; - - scvVelocities[scvf.insideScvIdx()] += tmpVelocity; - scvVelocities[scvf.outsideScvIdx()] += tmpVelocity; - } - - // transform vertex velocities from local to global coordinates - for (auto&& scv : scvs(fvGeometry)) - { - int vIdxGlobal = scv.dofIndex(); - - // calculate the subcontrolvolume velocity by the Piola transformation - Velocity scvVelocity(0); - - jacobianT2.mtv(scvVelocities[scv.indexInElement()], scvVelocity); - scvVelocity /= geometry.integrationElement(localPos)*cellNum_[vIdxGlobal]; - // add up the wetting phase subcontrolvolume velocities for each vertex - velocity[vIdxGlobal] += scvVelocity; - } - } - else - { - // For the number of scvfs per facet (mpfa) we simply obtain the number of - // corners of the first facet as prisms/pyramids are not supported here anyway - // -> for prisms/pyramids the number of scvfs would differ from facet to facet - static constexpr bool isMpfa = FVGridGeometry::discMethod == DiscretizationMethod::ccmpfa; - const int numScvfsPerFace = isMpfa ? element.template subEntity<1>(0).geometry().corners() : 1; - - if (fvGeometry.numScvf() != element.subEntities(1)*numScvfsPerFace) - DUNE_THROW(Dune::NotImplemented, "Velocity output for non-conforming grids"); - - if (!geomType.isCube() && !geomType.isSimplex()) - DUNE_THROW(Dune::NotImplemented, "Velocity output for other geometry types than cube and simplex"); - - // first we extract the corner indices for each scv for the CIV method - // for network grids there might be multiple intersection with the same geometryInInside - // we identify those by the indexInInside for now (assumes conforming grids at branching facets) - // here we keep track of them - std::vector<bool> handledScvf; - if (dim < dimWorld) - handledScvf.resize(element.subEntities(1), false); - - // find the local face indices of the scvfs (for conforming meshes) - std::vector<unsigned int> scvfIndexInInside(fvGeometry.numScvf()); - int localScvfIdx = 0; - for (const auto& intersection : intersections(fvGridGeometry_.gridView(), element)) - { - if (dim < dimWorld) - if (handledScvf[intersection.indexInInside()]) - continue; - - if (intersection.neighbor() || intersection.boundary()) - { - for (int i = 0; i < numScvfsPerFace; ++i) - scvfIndexInInside[localScvfIdx++] = intersection.indexInInside(); - - // for surface and network grids mark that we handled this face - if (dim < dimWorld) - handledScvf[intersection.indexInInside()] = true; - } - } - - std::vector<Scalar> scvfFluxes(element.subEntities(1), 0.0); - localScvfIdx = 0; - for (auto&& scvf : scvfs(fvGeometry)) - { - const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; - if (!scvf.boundary()) - { - FluxVariables fluxVars; - fluxVars.init(problem_, element, fvGeometry, elemVolVars, scvf, elemFluxVarsCache); - scvfFluxes[scvfIndexInInside[localScvfIdx]] += fluxVars.advectiveFlux(phaseIdx, upwindTerm)/insideVolVars.extrusionFactor(); - } - else - { - auto bcTypes = problemBoundaryTypes_(element, scvf); - if (bcTypes.hasOnlyDirichlet()) - { - FluxVariables fluxVars; - fluxVars.init(problem_, element, fvGeometry, elemVolVars, scvf, elemFluxVarsCache); - scvfFluxes[scvfIndexInInside[localScvfIdx]] += fluxVars.advectiveFlux(phaseIdx, upwindTerm)/insideVolVars.extrusionFactor(); - } - } - - // increment scvf counter - localScvfIdx++; - } - - // Correct boundary fluxes in case of Neumann conditions. - // In this general setting, it would be very difficult to - // calculate correct phase, i.e., volume, fluxes from arbitrary - // Neumann conditions. We approximate the Neumann flux by the - // flux on the opposite face. For extremely distorted grids this can - // lead to unexpected results (but then TPFA also leads to unexpected results). - localScvfIdx = 0; - for (auto&& scvf : scvfs(fvGeometry)) - { - if (scvf.boundary()) - { - auto bcTypes = problemBoundaryTypes_(element, scvf); - if (bcTypes.hasNeumann()) - { - // check if we have Neumann no flow, we can just use 0 - const auto neumannFlux = Deprecated::neumann(problem_, element, fvGeometry, elemVolVars, elemFluxVarsCache, scvf); - using NumEqVector = std::decay_t<decltype(neumannFlux)>; - if (Dune::FloatCmp::eq<NumEqVector, Dune::FloatCmp::CmpStyle::absolute>(neumannFlux, NumEqVector(0.0), 1e-30)) - scvfFluxes[scvfIndexInInside[localScvfIdx]] = 0; - // cubes - else if (dim == 1 || geomType.isCube()) - { - const auto fIdx = scvfIndexInInside[localScvfIdx]; - const auto fIdxOpposite = fIdx%2 ? fIdx-1 : fIdx+1; - scvfFluxes[fIdx] = -scvfFluxes[fIdxOpposite]; - } - // simplices - else if (geomType.isSimplex()) - scvfFluxes[scvfIndexInInside[localScvfIdx]] = 0; - } - } - - // increment scvf counter - localScvfIdx++; - } - - Velocity refVelocity; - // cubes: On the reference element simply average over opposite fluxes - // note that this is equal to a corner velocity interpolation method - if (dim == 1 || geomType.isCube()) - { - for (int i = 0; i < dim; i++) - refVelocity[i] = 0.5 * (scvfFluxes[2*i + 1] - scvfFluxes[2*i]); - } - // simplices: Raviart-Thomas-0 interpolation evaluated at the cell center - else if (geomType.isSimplex()) - { - for (int dimIdx = 0; dimIdx < dim; dimIdx++) - { - refVelocity[dimIdx] = -scvfFluxes[dim - 1 - dimIdx]; - for (int fIdx = 0; fIdx < dim + 1; fIdx++) - refVelocity[dimIdx] += scvfFluxes[fIdx]/(dim + 1); - } - } - // 3D prism and pyramids - else - DUNE_THROW(Dune::NotImplemented, "velocity output for cell-centered and prism/pyramid"); - - Velocity scvVelocity(0); - jacobianT2.mtv(refVelocity, scvVelocity); - - scvVelocity /= geometry.integrationElement(localPos); - - int eIdxGlobal = fvGridGeometry_.elementMapper().index(element); - - velocity[eIdxGlobal] = scvVelocity; - - } // cell-centered - } - -private: - // The area of a subcontrolvolume face in a reference element. - // The 3d non-cube values have been calculated with quadrilateralArea3D - // of boxfvelementgeometry.hh. - static Scalar scvfReferenceArea_(Dune::GeometryType geomType, int fIdx) - { - if (dim == 1 || geomType.isCube()) - { - return 1.0/(1 << (dim-1)); - } - else if (geomType.isTriangle()) - { - static const Scalar faceToArea[] = {0.372677996249965, - 0.372677996249965, - 0.235702260395516}; - return faceToArea[fIdx]; - } - else if (geomType.isTetrahedron()) - { - static const Scalar faceToArea[] = {0.102062072615966, - 0.102062072615966, - 0.058925565098879, - 0.102062072615966, - 0.058925565098879, - 0.058925565098879}; - return faceToArea[fIdx]; - } - else if (geomType.isPyramid()) - { - static const Scalar faceToArea[] = {0.130437298687488, - 0.130437298687488, - 0.130437298687488, - 0.130437298687488, - 0.150923085635624, - 0.1092906420717, - 0.1092906420717, - 0.0781735959970571}; - return faceToArea[fIdx]; - } - else if (geomType.isPrism()) - { - static const Scalar faceToArea[] = {0.166666666666667, - 0.166666666666667, - 0.166666666666667, - 0.186338998124982, - 0.186338998124982, - 0.117851130197758, - 0.186338998124982, - 0.186338998124982, - 0.117851130197758}; - return faceToArea[fIdx]; - } - else { - DUNE_THROW(Dune::NotImplemented, "scvf area for unknown GeometryType"); - } + if (enableOutput_) + velocityBackend->calculateVelocity(velocity, element, fvGeometry, elemVolVars, elemFluxVarsCache, phaseIdx); } private: - // The following SFINAE enable_if usage allows compilation, even if only a - // - // boundaryTypes(const Element&, const scv&) - // - // is provided in the problem file. In that case, the compiler cannot detect - // (without additional measures like "using...") the signature - // - // boundaryTypes(const Element&, const scvf&) - // - // in the problem base class. Therefore, calls to this method trigger a - // compiler error. However, that call is needed for calculating velocities - // if the cell-centered discretization is used. By proceeding as in the - // following lines, that call will only be compiled if cell-centered - // actually is used. - template <bool enable = isBox, typename std::enable_if_t<!enable, int> = 0> - BoundaryTypes problemBoundaryTypes_(const Element& element, const SubControlVolumeFace& scvf) const - { return problem_.boundaryTypes(element, scvf); } - - //! we should never call this method for box models - template <bool enable = isBox, typename std::enable_if_t<enable, int> = 0> - BoundaryTypes problemBoundaryTypes_(const Element& element, const SubControlVolumeFace& scvf) const - { return BoundaryTypes(); } - - const Problem& problem_; - const FVGridGeometry& fvGridGeometry_; - const GridVariables& gridVariables_; - + const GridVariables& gridVariables_; // TODO: can be removed after the deprecated calculateVelocity interface is removed bool enableOutput_; - std::vector<int> cellNum_; + std::unique_ptr<VelocityBackend> velocityBackend; }; } // end namespace Dumux diff --git a/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/main.cc b/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/main.cc index 7d4ee721c8a5f7825273cbf5ca389f12b9c425bf..bd072471c3c6e10d26a1c5200ceabd833373d9e8 100644 --- a/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/main.cc +++ b/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/main.cc @@ -38,7 +38,7 @@ #include <dumux/common/defaultusagemessage.hh> #include <dumux/linear/amgbackend.hh> -#include <dumux/nonlinear/newtonsolver.hh> +#include <dumux/porousmediumflow/nonequilibrium/newtonsolver.hh> #include <dumux/assembly/fvassembler.hh> #include <dumux/assembly/diffmethod.hh> @@ -156,7 +156,7 @@ int main(int argc, char** argv) try auto linearSolver = std::make_shared<LinearSolver>(leafGridView, fvGridGeometry->dofMapper()); // the non-linear solver - using NewtonSolver = NewtonSolver<Assembler, LinearSolver>; + using NewtonSolver = Dumux::NonEquilibriumNewtonSolver<Assembler, LinearSolver>; NewtonSolver nonLinearSolver(assembler, linearSolver); // time loop diff --git a/test/references/test_2p2c_nonequilibrium_box-reference.vtu b/test/references/test_2p2c_nonequilibrium_box-reference.vtu index 8f9bfbfc74c83fbfa85e4a61a36e8e2b673dc4d3..d5e9cb0a4320dc09a9c8318031f1646d92ec4806 100644 --- a/test/references/test_2p2c_nonequilibrium_box-reference.vtu +++ b/test/references/test_2p2c_nonequilibrium_box-reference.vtu @@ -510,26 +510,26 @@ 0 0 0 </DataArray> <DataArray type="Float32" Name="reynoldsNumber_gas" NumberOfComponents="1" format="ascii"> - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 + 1.68666e-05 1.68717e-05 1.68666e-05 1.68717e-05 1.68932e-05 1.68932e-05 1.68918e-05 1.68918e-05 1.68899e-05 1.68899e-05 1.68874e-05 1.68874e-05 + 1.68843e-05 1.68843e-05 1.68807e-05 1.68807e-05 1.68766e-05 1.68766e-05 1.68719e-05 1.68719e-05 1.68666e-05 1.68666e-05 1.68608e-05 1.68608e-05 + 1.68544e-05 1.68544e-05 1.68475e-05 1.68475e-05 1.684e-05 1.684e-05 1.68319e-05 1.68319e-05 1.68233e-05 1.68233e-05 1.68141e-05 1.68141e-05 + 1.68005e-05 1.68005e-05 1.65223e-05 1.65223e-05 1.67162e-05 1.67162e-05 1.68666e-05 1.68717e-05 1.68932e-05 1.68918e-05 1.68899e-05 1.68874e-05 + 1.68843e-05 1.68807e-05 1.68766e-05 1.68719e-05 1.68666e-05 1.68608e-05 1.68544e-05 1.68475e-05 1.684e-05 1.68319e-05 1.68233e-05 1.68141e-05 + 1.68005e-05 1.65223e-05 1.67162e-05 1.68666e-05 1.68717e-05 1.68932e-05 1.68918e-05 1.68899e-05 1.68874e-05 1.68843e-05 1.68807e-05 1.68766e-05 + 1.68719e-05 1.68666e-05 1.68608e-05 1.68544e-05 1.68475e-05 1.684e-05 1.68319e-05 1.68233e-05 1.68141e-05 1.68005e-05 1.65223e-05 1.67162e-05 + 1.68666e-05 1.68717e-05 1.68932e-05 1.68918e-05 1.68899e-05 1.68874e-05 1.68843e-05 1.68807e-05 1.68766e-05 1.68719e-05 1.68666e-05 1.68608e-05 + 1.68544e-05 1.68475e-05 1.684e-05 1.68319e-05 1.68233e-05 1.68141e-05 1.68005e-05 1.65223e-05 1.67162e-05 1.68666e-05 1.68717e-05 1.68932e-05 + 1.68918e-05 1.68899e-05 1.68874e-05 1.68843e-05 1.68807e-05 1.68766e-05 1.68719e-05 1.68666e-05 1.68608e-05 1.68544e-05 1.68475e-05 1.684e-05 + 1.68319e-05 1.68233e-05 1.68141e-05 1.68005e-05 1.65223e-05 1.67162e-05 1.68666e-05 1.68717e-05 1.68932e-05 1.68918e-05 1.68899e-05 1.68874e-05 + 1.68843e-05 1.68807e-05 1.68766e-05 1.68719e-05 1.68666e-05 1.68608e-05 1.68544e-05 1.68475e-05 1.684e-05 1.68319e-05 1.68233e-05 1.68141e-05 + 1.68005e-05 1.65223e-05 1.67162e-05 1.68666e-05 1.68717e-05 1.68932e-05 1.68918e-05 1.68899e-05 1.68874e-05 1.68843e-05 1.68807e-05 1.68766e-05 + 1.68719e-05 1.68666e-05 1.68608e-05 1.68544e-05 1.68475e-05 1.684e-05 1.68319e-05 1.68233e-05 1.68141e-05 1.68005e-05 1.65223e-05 1.67162e-05 + 1.68666e-05 1.68717e-05 1.68932e-05 1.68918e-05 1.68899e-05 1.68874e-05 1.68843e-05 1.68807e-05 1.68766e-05 1.68719e-05 1.68666e-05 1.68608e-05 + 1.68544e-05 1.68475e-05 1.684e-05 1.68319e-05 1.68233e-05 1.68141e-05 1.68005e-05 1.65223e-05 1.67162e-05 1.68666e-05 1.68717e-05 1.68932e-05 + 1.68918e-05 1.68899e-05 1.68874e-05 1.68843e-05 1.68807e-05 1.68766e-05 1.68719e-05 1.68666e-05 1.68608e-05 1.68544e-05 1.68475e-05 1.684e-05 + 1.68319e-05 1.68233e-05 1.68141e-05 1.68005e-05 1.65223e-05 1.67162e-05 1.68666e-05 1.68717e-05 1.68932e-05 1.68918e-05 1.68899e-05 1.68874e-05 + 1.68843e-05 1.68807e-05 1.68766e-05 1.68719e-05 1.68666e-05 1.68608e-05 1.68544e-05 1.68475e-05 1.684e-05 1.68319e-05 1.68233e-05 1.68141e-05 + 1.68005e-05 1.65223e-05 1.67162e-05 </DataArray> <DataArray type="Float32" Name="xEquil^Air_liq" NumberOfComponents="1" format="ascii"> 3.41676e-05 3.41684e-05 3.41676e-05 3.41684e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41683e-05 diff --git a/test/references/test_2p2c_nonequilibrium_tpfa-reference.vtu b/test/references/test_2p2c_nonequilibrium_tpfa-reference.vtu index 65a6805e483c9a120057e945dd3a6588933c6539..9c18708ca49c9ff3d5f287d959fcf3227fbc4990 100644 --- a/test/references/test_2p2c_nonequilibrium_tpfa-reference.vtu +++ b/test/references/test_2p2c_nonequilibrium_tpfa-reference.vtu @@ -5,60 +5,60 @@ <CellData Scalars="S_liq"> <DataArray type="Float32" Name="S_liq" NumberOfComponents="1" format="ascii"> 0.1999 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 - 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199899 0.193337 0.1999 0.199902 0.199902 0.199902 + 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199899 0.193361 0.1999 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 - 0.199902 0.199902 0.199899 0.193337 0.1999 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 - 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199899 0.193337 + 0.199902 0.199902 0.199899 0.193361 0.1999 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 + 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199899 0.193361 0.1999 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 - 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199899 0.193337 0.1999 0.199902 0.199902 0.199902 + 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199899 0.193361 0.1999 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 - 0.199902 0.199902 0.199899 0.193337 0.1999 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 - 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199899 0.193337 + 0.199902 0.199902 0.199899 0.193361 0.1999 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 + 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199899 0.193361 0.1999 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 - 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199899 0.193337 0.1999 0.199902 0.199902 0.199902 + 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199899 0.193361 0.1999 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 - 0.199902 0.199902 0.199899 0.193337 0.1999 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 - 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199899 0.193337 + 0.199902 0.199902 0.199899 0.193361 0.1999 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 + 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199899 0.193361 0.1999 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 - 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199899 0.193337 + 0.199902 0.199902 0.199902 0.199902 0.199902 0.199902 0.199899 0.193361 </DataArray> <DataArray type="Float32" Name="p_liq" NumberOfComponents="1" format="ascii"> - 99287.4 99297.2 99296.9 99296.7 99296.4 99296.2 99296 99295.7 99295.5 99295.2 99295 99294.7 - 99294.5 99294.2 99293.9 99293.7 99293.4 99293 99276.3 52401.9 99287.4 99297.2 99296.9 99296.7 - 99296.4 99296.2 99296 99295.7 99295.5 99295.2 99295 99294.7 99294.5 99294.2 99293.9 99293.7 - 99293.4 99293 99276.3 52401.9 99287.4 99297.2 99296.9 99296.7 99296.4 99296.2 99296 99295.7 - 99295.5 99295.2 99295 99294.7 99294.5 99294.2 99293.9 99293.7 99293.4 99293 99276.3 52401.9 - 99287.4 99297.2 99296.9 99296.7 99296.4 99296.2 99296 99295.7 99295.5 99295.2 99295 99294.7 - 99294.5 99294.2 99293.9 99293.7 99293.4 99293 99276.3 52401.9 99287.4 99297.2 99296.9 99296.7 - 99296.4 99296.2 99296 99295.7 99295.5 99295.2 99295 99294.7 99294.5 99294.2 99293.9 99293.7 - 99293.4 99293 99276.3 52401.9 99287.4 99297.2 99296.9 99296.7 99296.4 99296.2 99296 99295.7 - 99295.5 99295.2 99295 99294.7 99294.5 99294.2 99293.9 99293.7 99293.4 99293 99276.3 52401.9 - 99287.4 99297.2 99296.9 99296.7 99296.4 99296.2 99296 99295.7 99295.5 99295.2 99295 99294.7 - 99294.5 99294.2 99293.9 99293.7 99293.4 99293 99276.3 52401.9 99287.4 99297.2 99296.9 99296.7 - 99296.4 99296.2 99296 99295.7 99295.5 99295.2 99295 99294.7 99294.5 99294.2 99293.9 99293.7 - 99293.4 99293 99276.3 52401.9 99287.4 99297.2 99296.9 99296.7 99296.4 99296.2 99296 99295.7 - 99295.5 99295.2 99295 99294.7 99294.5 99294.2 99293.9 99293.7 99293.4 99293 99276.3 52401.9 - 99287.4 99297.2 99296.9 99296.7 99296.4 99296.2 99296 99295.7 99295.5 99295.2 99295 99294.7 - 99294.5 99294.2 99293.9 99293.7 99293.4 99293 99276.3 52401.9 + 99287.4 99297.2 99296.9 99296.7 99296.4 99296.2 99295.9 99295.7 99295.4 99295.2 99294.9 99294.7 + 99294.4 99294.2 99293.9 99293.7 99293.4 99293 99275.8 52575.4 99287.4 99297.2 99296.9 99296.7 + 99296.4 99296.2 99295.9 99295.7 99295.4 99295.2 99294.9 99294.7 99294.4 99294.2 99293.9 99293.7 + 99293.4 99293 99275.8 52575.4 99287.4 99297.2 99296.9 99296.7 99296.4 99296.2 99295.9 99295.7 + 99295.4 99295.2 99294.9 99294.7 99294.4 99294.2 99293.9 99293.7 99293.4 99293 99275.8 52575.4 + 99287.4 99297.2 99296.9 99296.7 99296.4 99296.2 99295.9 99295.7 99295.4 99295.2 99294.9 99294.7 + 99294.4 99294.2 99293.9 99293.7 99293.4 99293 99275.8 52575.4 99287.4 99297.2 99296.9 99296.7 + 99296.4 99296.2 99295.9 99295.7 99295.4 99295.2 99294.9 99294.7 99294.4 99294.2 99293.9 99293.7 + 99293.4 99293 99275.8 52575.4 99287.4 99297.2 99296.9 99296.7 99296.4 99296.2 99295.9 99295.7 + 99295.4 99295.2 99294.9 99294.7 99294.4 99294.2 99293.9 99293.7 99293.4 99293 99275.8 52575.4 + 99287.4 99297.2 99296.9 99296.7 99296.4 99296.2 99295.9 99295.7 99295.4 99295.2 99294.9 99294.7 + 99294.4 99294.2 99293.9 99293.7 99293.4 99293 99275.8 52575.4 99287.4 99297.2 99296.9 99296.7 + 99296.4 99296.2 99295.9 99295.7 99295.4 99295.2 99294.9 99294.7 99294.4 99294.2 99293.9 99293.7 + 99293.4 99293 99275.8 52575.4 99287.4 99297.2 99296.9 99296.7 99296.4 99296.2 99295.9 99295.7 + 99295.4 99295.2 99294.9 99294.7 99294.4 99294.2 99293.9 99293.7 99293.4 99293 99275.8 52575.4 + 99287.4 99297.2 99296.9 99296.7 99296.4 99296.2 99295.9 99295.7 99295.4 99295.2 99294.9 99294.7 + 99294.4 99294.2 99293.9 99293.7 99293.4 99293 99275.8 52575.4 </DataArray> <DataArray type="Float32" Name="rho_liq" NumberOfComponents="1" format="ascii"> 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 - 997.048 997.048 997.048 997.048 997.048 997.048 997.058 997.753 997.048 997.048 997.048 997.048 + 997.048 997.048 997.048 997.048 997.048 997.048 997.058 997.746 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 - 997.048 997.048 997.058 997.753 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 - 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.058 997.753 + 997.048 997.048 997.058 997.746 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 + 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.058 997.746 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 - 997.048 997.048 997.048 997.048 997.048 997.048 997.058 997.753 997.048 997.048 997.048 997.048 + 997.048 997.048 997.048 997.048 997.048 997.048 997.058 997.746 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 - 997.048 997.048 997.058 997.753 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 - 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.058 997.753 + 997.048 997.048 997.058 997.746 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 + 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.058 997.746 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 - 997.048 997.048 997.048 997.048 997.048 997.048 997.058 997.753 997.048 997.048 997.048 997.048 + 997.048 997.048 997.048 997.048 997.048 997.048 997.058 997.746 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 - 997.048 997.048 997.058 997.753 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 - 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.058 997.753 + 997.048 997.048 997.058 997.746 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 + 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.058 997.746 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 997.048 - 997.048 997.048 997.048 997.048 997.048 997.048 997.058 997.753 + 997.048 997.048 997.048 997.048 997.048 997.048 997.058 997.746 </DataArray> <DataArray type="Float32" Name="mob_liq" NumberOfComponents="1" format="ascii"> 0 0 0 0 0 0 0 0 0 0 0 0 @@ -81,22 +81,22 @@ </DataArray> <DataArray type="Float32" Name="S_gas" NumberOfComponents="1" format="ascii"> 0.8001 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 - 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800101 0.806663 0.8001 0.800098 0.800098 0.800098 + 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800101 0.806639 0.8001 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 - 0.800098 0.800098 0.800101 0.806663 0.8001 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 - 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800101 0.806663 + 0.800098 0.800098 0.800101 0.806639 0.8001 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 + 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800101 0.806639 0.8001 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 - 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800101 0.806663 0.8001 0.800098 0.800098 0.800098 + 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800101 0.806639 0.8001 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 - 0.800098 0.800098 0.800101 0.806663 0.8001 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 - 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800101 0.806663 + 0.800098 0.800098 0.800101 0.806639 0.8001 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 + 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800101 0.806639 0.8001 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 - 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800101 0.806663 0.8001 0.800098 0.800098 0.800098 + 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800101 0.806639 0.8001 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 - 0.800098 0.800098 0.800101 0.806663 0.8001 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 - 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800101 0.806663 + 0.800098 0.800098 0.800101 0.806639 0.8001 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 + 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800101 0.806639 0.8001 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 - 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800101 0.806663 + 0.800098 0.800098 0.800098 0.800098 0.800098 0.800098 0.800101 0.806639 </DataArray> <DataArray type="Float32" Name="p_gas" NumberOfComponents="1" format="ascii"> 250000 250000 249999 249999 249999 249999 249998 249998 249998 249998 249997 249997 @@ -119,60 +119,60 @@ </DataArray> <DataArray type="Float32" Name="rho_gas" NumberOfComponents="1" format="ascii"> 2.9066 2.9066 2.90659 2.90659 2.90659 2.90658 2.90658 2.90658 2.90658 2.90657 2.90657 2.90657 - 2.90656 2.90656 2.90656 2.90655 2.90655 2.90655 2.90697 2.93853 2.9066 2.9066 2.90659 2.90659 + 2.90656 2.90656 2.90656 2.90655 2.90655 2.90655 2.90698 2.93815 2.9066 2.9066 2.90659 2.90659 2.90659 2.90658 2.90658 2.90658 2.90658 2.90657 2.90657 2.90657 2.90656 2.90656 2.90656 2.90655 - 2.90655 2.90655 2.90697 2.93853 2.9066 2.9066 2.90659 2.90659 2.90659 2.90658 2.90658 2.90658 - 2.90658 2.90657 2.90657 2.90657 2.90656 2.90656 2.90656 2.90655 2.90655 2.90655 2.90697 2.93853 + 2.90655 2.90655 2.90698 2.93815 2.9066 2.9066 2.90659 2.90659 2.90659 2.90658 2.90658 2.90658 + 2.90658 2.90657 2.90657 2.90657 2.90656 2.90656 2.90656 2.90655 2.90655 2.90655 2.90698 2.93815 2.9066 2.9066 2.90659 2.90659 2.90659 2.90658 2.90658 2.90658 2.90658 2.90657 2.90657 2.90657 - 2.90656 2.90656 2.90656 2.90655 2.90655 2.90655 2.90697 2.93853 2.9066 2.9066 2.90659 2.90659 + 2.90656 2.90656 2.90656 2.90655 2.90655 2.90655 2.90698 2.93815 2.9066 2.9066 2.90659 2.90659 2.90659 2.90658 2.90658 2.90658 2.90658 2.90657 2.90657 2.90657 2.90656 2.90656 2.90656 2.90655 - 2.90655 2.90655 2.90697 2.93853 2.9066 2.9066 2.90659 2.90659 2.90659 2.90658 2.90658 2.90658 - 2.90658 2.90657 2.90657 2.90657 2.90656 2.90656 2.90656 2.90655 2.90655 2.90655 2.90697 2.93853 + 2.90655 2.90655 2.90698 2.93815 2.9066 2.9066 2.90659 2.90659 2.90659 2.90658 2.90658 2.90658 + 2.90658 2.90657 2.90657 2.90657 2.90656 2.90656 2.90656 2.90655 2.90655 2.90655 2.90698 2.93815 2.9066 2.9066 2.90659 2.90659 2.90659 2.90658 2.90658 2.90658 2.90658 2.90657 2.90657 2.90657 - 2.90656 2.90656 2.90656 2.90655 2.90655 2.90655 2.90697 2.93853 2.9066 2.9066 2.90659 2.90659 + 2.90656 2.90656 2.90656 2.90655 2.90655 2.90655 2.90698 2.93815 2.9066 2.9066 2.90659 2.90659 2.90659 2.90658 2.90658 2.90658 2.90658 2.90657 2.90657 2.90657 2.90656 2.90656 2.90656 2.90655 - 2.90655 2.90655 2.90697 2.93853 2.9066 2.9066 2.90659 2.90659 2.90659 2.90658 2.90658 2.90658 - 2.90658 2.90657 2.90657 2.90657 2.90656 2.90656 2.90656 2.90655 2.90655 2.90655 2.90697 2.93853 + 2.90655 2.90655 2.90698 2.93815 2.9066 2.9066 2.90659 2.90659 2.90659 2.90658 2.90658 2.90658 + 2.90658 2.90657 2.90657 2.90657 2.90656 2.90656 2.90656 2.90655 2.90655 2.90655 2.90698 2.93815 2.9066 2.9066 2.90659 2.90659 2.90659 2.90658 2.90658 2.90658 2.90658 2.90657 2.90657 2.90657 - 2.90656 2.90656 2.90656 2.90655 2.90655 2.90655 2.90697 2.93853 + 2.90656 2.90656 2.90656 2.90655 2.90655 2.90655 2.90698 2.93815 </DataArray> <DataArray type="Float32" Name="mob_gas" NumberOfComponents="1" format="ascii"> 54216.5 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 - 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54222.3 54650.5 54216.5 54216.6 54216.6 54216.6 + 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54222.4 54645.4 54216.5 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 - 54216.6 54216.6 54222.3 54650.5 54216.5 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 - 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54222.3 54650.5 + 54216.6 54216.6 54222.4 54645.4 54216.5 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 + 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54222.4 54645.4 54216.5 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 - 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54222.3 54650.5 54216.5 54216.6 54216.6 54216.6 + 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54222.4 54645.4 54216.5 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 - 54216.6 54216.6 54222.3 54650.5 54216.5 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 - 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54222.3 54650.5 + 54216.6 54216.6 54222.4 54645.4 54216.5 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 + 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54222.4 54645.4 54216.5 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 - 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54222.3 54650.5 54216.5 54216.6 54216.6 54216.6 + 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54222.4 54645.4 54216.5 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 - 54216.6 54216.6 54222.3 54650.5 54216.5 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 - 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54222.3 54650.5 + 54216.6 54216.6 54222.4 54645.4 54216.5 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 + 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54222.4 54645.4 54216.5 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 - 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54222.3 54650.5 + 54216.6 54216.6 54216.6 54216.6 54216.6 54216.6 54222.4 54645.4 </DataArray> <DataArray type="Float32" Name="pc" NumberOfComponents="1" format="ascii"> 150713 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 - 150702 150702 150702 150702 150702 150702 150719 197593 150713 150702 150702 150702 + 150702 150702 150702 150702 150702 150702 150719 197420 150713 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 - 150702 150702 150719 197593 150713 150702 150702 150702 150702 150702 150702 150702 - 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150719 197593 + 150702 150702 150719 197420 150713 150702 150702 150702 150702 150702 150702 150702 + 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150719 197420 150713 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 - 150702 150702 150702 150702 150702 150702 150719 197593 150713 150702 150702 150702 + 150702 150702 150702 150702 150702 150702 150719 197420 150713 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 - 150702 150702 150719 197593 150713 150702 150702 150702 150702 150702 150702 150702 - 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150719 197593 + 150702 150702 150719 197420 150713 150702 150702 150702 150702 150702 150702 150702 + 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150719 197420 150713 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 - 150702 150702 150702 150702 150702 150702 150719 197593 150713 150702 150702 150702 + 150702 150702 150702 150702 150702 150702 150719 197420 150713 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 - 150702 150702 150719 197593 150713 150702 150702 150702 150702 150702 150702 150702 - 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150719 197593 + 150702 150702 150719 197420 150713 150702 150702 150702 150702 150702 150702 150702 + 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150719 197420 150713 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 150702 - 150702 150702 150702 150702 150702 150702 150719 197593 + 150702 150702 150702 150702 150702 150702 150719 197420 </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 @@ -233,155 +233,155 @@ </DataArray> <DataArray type="Float32" Name="x^Air_liq" NumberOfComponents="1" format="ascii"> 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 - 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41901e-05 3.59544e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 + 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41908e-05 3.59325e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 - 3.41678e-05 3.4168e-05 3.41901e-05 3.59544e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 - 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41901e-05 3.59544e-05 + 3.41678e-05 3.4168e-05 3.41908e-05 3.59325e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 + 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41908e-05 3.59325e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 - 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41901e-05 3.59544e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 + 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41908e-05 3.59325e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 - 3.41678e-05 3.4168e-05 3.41901e-05 3.59544e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 - 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41901e-05 3.59544e-05 + 3.41678e-05 3.4168e-05 3.41908e-05 3.59325e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 + 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41908e-05 3.59325e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 - 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41901e-05 3.59544e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 + 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41908e-05 3.59325e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 - 3.41678e-05 3.4168e-05 3.41901e-05 3.59544e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 - 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41901e-05 3.59544e-05 + 3.41678e-05 3.4168e-05 3.41908e-05 3.59325e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 + 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41908e-05 3.59325e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 - 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41901e-05 3.59544e-05 + 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41908e-05 3.59325e-05 </DataArray> <DataArray type="Float32" Name="X^Air_liq" NumberOfComponents="1" format="ascii"> - 5.49257e-05 5.49257e-05 5.49256e-05 5.49255e-05 5.49255e-05 5.49254e-05 5.49254e-05 5.49253e-05 5.49253e-05 5.49252e-05 5.49251e-05 5.49251e-05 - 5.4925e-05 5.4925e-05 5.49249e-05 5.49248e-05 5.49248e-05 5.49251e-05 5.49606e-05 5.77966e-05 5.49257e-05 5.49257e-05 5.49256e-05 5.49255e-05 - 5.49255e-05 5.49254e-05 5.49254e-05 5.49253e-05 5.49253e-05 5.49252e-05 5.49251e-05 5.49251e-05 5.4925e-05 5.4925e-05 5.49249e-05 5.49248e-05 - 5.49248e-05 5.49251e-05 5.49606e-05 5.77966e-05 5.49257e-05 5.49257e-05 5.49256e-05 5.49255e-05 5.49255e-05 5.49254e-05 5.49254e-05 5.49253e-05 - 5.49253e-05 5.49252e-05 5.49251e-05 5.49251e-05 5.4925e-05 5.4925e-05 5.49249e-05 5.49248e-05 5.49248e-05 5.49251e-05 5.49606e-05 5.77966e-05 - 5.49257e-05 5.49257e-05 5.49256e-05 5.49255e-05 5.49255e-05 5.49254e-05 5.49254e-05 5.49253e-05 5.49253e-05 5.49252e-05 5.49251e-05 5.49251e-05 - 5.4925e-05 5.4925e-05 5.49249e-05 5.49248e-05 5.49248e-05 5.49251e-05 5.49606e-05 5.77966e-05 5.49257e-05 5.49257e-05 5.49256e-05 5.49255e-05 - 5.49255e-05 5.49254e-05 5.49254e-05 5.49253e-05 5.49253e-05 5.49252e-05 5.49251e-05 5.49251e-05 5.4925e-05 5.4925e-05 5.49249e-05 5.49248e-05 - 5.49248e-05 5.49251e-05 5.49606e-05 5.77966e-05 5.49257e-05 5.49257e-05 5.49256e-05 5.49255e-05 5.49255e-05 5.49254e-05 5.49254e-05 5.49253e-05 - 5.49253e-05 5.49252e-05 5.49251e-05 5.49251e-05 5.4925e-05 5.4925e-05 5.49249e-05 5.49248e-05 5.49248e-05 5.49251e-05 5.49606e-05 5.77966e-05 - 5.49257e-05 5.49257e-05 5.49256e-05 5.49255e-05 5.49255e-05 5.49254e-05 5.49254e-05 5.49253e-05 5.49253e-05 5.49252e-05 5.49251e-05 5.49251e-05 - 5.4925e-05 5.4925e-05 5.49249e-05 5.49248e-05 5.49248e-05 5.49251e-05 5.49606e-05 5.77966e-05 5.49257e-05 5.49257e-05 5.49256e-05 5.49255e-05 - 5.49255e-05 5.49254e-05 5.49254e-05 5.49253e-05 5.49253e-05 5.49252e-05 5.49251e-05 5.49251e-05 5.4925e-05 5.4925e-05 5.49249e-05 5.49248e-05 - 5.49248e-05 5.49251e-05 5.49606e-05 5.77966e-05 5.49257e-05 5.49257e-05 5.49256e-05 5.49255e-05 5.49255e-05 5.49254e-05 5.49254e-05 5.49253e-05 - 5.49253e-05 5.49252e-05 5.49251e-05 5.49251e-05 5.4925e-05 5.4925e-05 5.49249e-05 5.49248e-05 5.49248e-05 5.49251e-05 5.49606e-05 5.77966e-05 - 5.49257e-05 5.49257e-05 5.49256e-05 5.49255e-05 5.49255e-05 5.49254e-05 5.49254e-05 5.49253e-05 5.49253e-05 5.49252e-05 5.49251e-05 5.49251e-05 - 5.4925e-05 5.4925e-05 5.49249e-05 5.49248e-05 5.49248e-05 5.49251e-05 5.49606e-05 5.77966e-05 + 5.49257e-05 5.49257e-05 5.49256e-05 5.49255e-05 5.49255e-05 5.49254e-05 5.49254e-05 5.49253e-05 5.49252e-05 5.49252e-05 5.49251e-05 5.49251e-05 + 5.4925e-05 5.4925e-05 5.49249e-05 5.49248e-05 5.49248e-05 5.49251e-05 5.49617e-05 5.77614e-05 5.49257e-05 5.49257e-05 5.49256e-05 5.49255e-05 + 5.49255e-05 5.49254e-05 5.49254e-05 5.49253e-05 5.49252e-05 5.49252e-05 5.49251e-05 5.49251e-05 5.4925e-05 5.4925e-05 5.49249e-05 5.49248e-05 + 5.49248e-05 5.49251e-05 5.49617e-05 5.77614e-05 5.49257e-05 5.49257e-05 5.49256e-05 5.49255e-05 5.49255e-05 5.49254e-05 5.49254e-05 5.49253e-05 + 5.49252e-05 5.49252e-05 5.49251e-05 5.49251e-05 5.4925e-05 5.4925e-05 5.49249e-05 5.49248e-05 5.49248e-05 5.49251e-05 5.49617e-05 5.77614e-05 + 5.49257e-05 5.49257e-05 5.49256e-05 5.49255e-05 5.49255e-05 5.49254e-05 5.49254e-05 5.49253e-05 5.49252e-05 5.49252e-05 5.49251e-05 5.49251e-05 + 5.4925e-05 5.4925e-05 5.49249e-05 5.49248e-05 5.49248e-05 5.49251e-05 5.49617e-05 5.77614e-05 5.49257e-05 5.49257e-05 5.49256e-05 5.49255e-05 + 5.49255e-05 5.49254e-05 5.49254e-05 5.49253e-05 5.49252e-05 5.49252e-05 5.49251e-05 5.49251e-05 5.4925e-05 5.4925e-05 5.49249e-05 5.49248e-05 + 5.49248e-05 5.49251e-05 5.49617e-05 5.77614e-05 5.49257e-05 5.49257e-05 5.49256e-05 5.49255e-05 5.49255e-05 5.49254e-05 5.49254e-05 5.49253e-05 + 5.49252e-05 5.49252e-05 5.49251e-05 5.49251e-05 5.4925e-05 5.4925e-05 5.49249e-05 5.49248e-05 5.49248e-05 5.49251e-05 5.49617e-05 5.77614e-05 + 5.49257e-05 5.49257e-05 5.49256e-05 5.49255e-05 5.49255e-05 5.49254e-05 5.49254e-05 5.49253e-05 5.49252e-05 5.49252e-05 5.49251e-05 5.49251e-05 + 5.4925e-05 5.4925e-05 5.49249e-05 5.49248e-05 5.49248e-05 5.49251e-05 5.49617e-05 5.77614e-05 5.49257e-05 5.49257e-05 5.49256e-05 5.49255e-05 + 5.49255e-05 5.49254e-05 5.49254e-05 5.49253e-05 5.49252e-05 5.49252e-05 5.49251e-05 5.49251e-05 5.4925e-05 5.4925e-05 5.49249e-05 5.49248e-05 + 5.49248e-05 5.49251e-05 5.49617e-05 5.77614e-05 5.49257e-05 5.49257e-05 5.49256e-05 5.49255e-05 5.49255e-05 5.49254e-05 5.49254e-05 5.49253e-05 + 5.49252e-05 5.49252e-05 5.49251e-05 5.49251e-05 5.4925e-05 5.4925e-05 5.49249e-05 5.49248e-05 5.49248e-05 5.49251e-05 5.49617e-05 5.77614e-05 + 5.49257e-05 5.49257e-05 5.49256e-05 5.49255e-05 5.49255e-05 5.49254e-05 5.49254e-05 5.49253e-05 5.49252e-05 5.49252e-05 5.49251e-05 5.49251e-05 + 5.4925e-05 5.4925e-05 5.49249e-05 5.49248e-05 5.49248e-05 5.49251e-05 5.49617e-05 5.77614e-05 </DataArray> <DataArray type="Float32" Name="rhoMolar_liq" NumberOfComponents="1" format="ascii"> 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 - 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55345.4 55384 55344.9 55344.9 55344.9 55344.9 + 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55345.4 55383.6 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 - 55344.9 55344.9 55345.4 55384 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 - 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55345.4 55384 + 55344.9 55344.9 55345.4 55383.6 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 + 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55345.4 55383.6 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 - 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55345.4 55384 55344.9 55344.9 55344.9 55344.9 + 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55345.4 55383.6 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 - 55344.9 55344.9 55345.4 55384 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 - 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55345.4 55384 + 55344.9 55344.9 55345.4 55383.6 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 + 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55345.4 55383.6 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 - 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55345.4 55384 55344.9 55344.9 55344.9 55344.9 + 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55345.4 55383.6 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 - 55344.9 55344.9 55345.4 55384 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 - 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55345.4 55384 + 55344.9 55344.9 55345.4 55383.6 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 + 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55345.4 55383.6 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 - 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55345.4 55384 + 55344.9 55344.9 55344.9 55344.9 55344.9 55344.9 55345.4 55383.6 </DataArray> <DataArray type="Float32" Name="x^H2O_gas" NumberOfComponents="1" format="ascii"> 0.0126775 0.0126775 0.0126775 0.0126775 0.0126775 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 - 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126482 0.0105736 0.0126775 0.0126775 0.0126775 0.0126775 - 0.0126775 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 - 0.0126777 0.0126774 0.0126482 0.0105736 0.0126775 0.0126775 0.0126775 0.0126775 0.0126775 0.0126776 0.0126776 0.0126776 - 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126482 0.0105736 + 0.0126777 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126473 0.0105961 0.0126775 0.0126775 0.0126775 0.0126775 + 0.0126775 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 + 0.0126777 0.0126774 0.0126473 0.0105961 0.0126775 0.0126775 0.0126775 0.0126775 0.0126775 0.0126776 0.0126776 0.0126776 + 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126473 0.0105961 0.0126775 0.0126775 0.0126775 0.0126775 0.0126775 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 - 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126482 0.0105736 0.0126775 0.0126775 0.0126775 0.0126775 - 0.0126775 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 - 0.0126777 0.0126774 0.0126482 0.0105736 0.0126775 0.0126775 0.0126775 0.0126775 0.0126775 0.0126776 0.0126776 0.0126776 - 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126482 0.0105736 + 0.0126777 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126473 0.0105961 0.0126775 0.0126775 0.0126775 0.0126775 + 0.0126775 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 + 0.0126777 0.0126774 0.0126473 0.0105961 0.0126775 0.0126775 0.0126775 0.0126775 0.0126775 0.0126776 0.0126776 0.0126776 + 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126473 0.0105961 0.0126775 0.0126775 0.0126775 0.0126775 0.0126775 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 - 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126482 0.0105736 0.0126775 0.0126775 0.0126775 0.0126775 - 0.0126775 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 - 0.0126777 0.0126774 0.0126482 0.0105736 0.0126775 0.0126775 0.0126775 0.0126775 0.0126775 0.0126776 0.0126776 0.0126776 - 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126482 0.0105736 + 0.0126777 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126473 0.0105961 0.0126775 0.0126775 0.0126775 0.0126775 + 0.0126775 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 + 0.0126777 0.0126774 0.0126473 0.0105961 0.0126775 0.0126775 0.0126775 0.0126775 0.0126775 0.0126776 0.0126776 0.0126776 + 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126473 0.0105961 0.0126775 0.0126775 0.0126775 0.0126775 0.0126775 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 - 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126482 0.0105736 + 0.0126777 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126473 0.0105961 </DataArray> <DataArray type="Float32" Name="X^H2O_gas" NumberOfComponents="1" format="ascii"> 0.0079243 0.00792427 0.00792428 0.00792429 0.0079243 0.00792431 0.00792432 0.00792432 0.00792433 0.00792434 0.00792435 0.00792436 - 0.00792437 0.00792438 0.00792438 0.00792439 0.0079244 0.00792423 0.00790586 0.00660394 0.0079243 0.00792427 0.00792428 0.00792429 + 0.00792437 0.00792438 0.00792438 0.00792439 0.0079244 0.00792421 0.00790531 0.006618 0.0079243 0.00792427 0.00792428 0.00792429 0.0079243 0.00792431 0.00792432 0.00792432 0.00792433 0.00792434 0.00792435 0.00792436 0.00792437 0.00792438 0.00792438 0.00792439 - 0.0079244 0.00792423 0.00790586 0.00660394 0.0079243 0.00792427 0.00792428 0.00792429 0.0079243 0.00792431 0.00792432 0.00792432 - 0.00792433 0.00792434 0.00792435 0.00792436 0.00792437 0.00792438 0.00792438 0.00792439 0.0079244 0.00792423 0.00790586 0.00660394 + 0.0079244 0.00792421 0.00790531 0.006618 0.0079243 0.00792427 0.00792428 0.00792429 0.0079243 0.00792431 0.00792432 0.00792432 + 0.00792433 0.00792434 0.00792435 0.00792436 0.00792437 0.00792438 0.00792438 0.00792439 0.0079244 0.00792421 0.00790531 0.006618 0.0079243 0.00792427 0.00792428 0.00792429 0.0079243 0.00792431 0.00792432 0.00792432 0.00792433 0.00792434 0.00792435 0.00792436 - 0.00792437 0.00792438 0.00792438 0.00792439 0.0079244 0.00792423 0.00790586 0.00660394 0.0079243 0.00792427 0.00792428 0.00792429 + 0.00792437 0.00792438 0.00792438 0.00792439 0.0079244 0.00792421 0.00790531 0.006618 0.0079243 0.00792427 0.00792428 0.00792429 0.0079243 0.00792431 0.00792432 0.00792432 0.00792433 0.00792434 0.00792435 0.00792436 0.00792437 0.00792438 0.00792438 0.00792439 - 0.0079244 0.00792423 0.00790586 0.00660394 0.0079243 0.00792427 0.00792428 0.00792429 0.0079243 0.00792431 0.00792432 0.00792432 - 0.00792433 0.00792434 0.00792435 0.00792436 0.00792437 0.00792438 0.00792438 0.00792439 0.0079244 0.00792423 0.00790586 0.00660394 + 0.0079244 0.00792421 0.00790531 0.006618 0.0079243 0.00792427 0.00792428 0.00792429 0.0079243 0.00792431 0.00792432 0.00792432 + 0.00792433 0.00792434 0.00792435 0.00792436 0.00792437 0.00792438 0.00792438 0.00792439 0.0079244 0.00792421 0.00790531 0.006618 0.0079243 0.00792427 0.00792428 0.00792429 0.0079243 0.00792431 0.00792432 0.00792432 0.00792433 0.00792434 0.00792435 0.00792436 - 0.00792437 0.00792438 0.00792438 0.00792439 0.0079244 0.00792423 0.00790586 0.00660394 0.0079243 0.00792427 0.00792428 0.00792429 + 0.00792437 0.00792438 0.00792438 0.00792439 0.0079244 0.00792421 0.00790531 0.006618 0.0079243 0.00792427 0.00792428 0.00792429 0.0079243 0.00792431 0.00792432 0.00792432 0.00792433 0.00792434 0.00792435 0.00792436 0.00792437 0.00792438 0.00792438 0.00792439 - 0.0079244 0.00792423 0.00790586 0.00660394 0.0079243 0.00792427 0.00792428 0.00792429 0.0079243 0.00792431 0.00792432 0.00792432 - 0.00792433 0.00792434 0.00792435 0.00792436 0.00792437 0.00792438 0.00792438 0.00792439 0.0079244 0.00792423 0.00790586 0.00660394 + 0.0079244 0.00792421 0.00790531 0.006618 0.0079243 0.00792427 0.00792428 0.00792429 0.0079243 0.00792431 0.00792432 0.00792432 + 0.00792433 0.00792434 0.00792435 0.00792436 0.00792437 0.00792438 0.00792438 0.00792439 0.0079244 0.00792421 0.00790531 0.006618 0.0079243 0.00792427 0.00792428 0.00792429 0.0079243 0.00792431 0.00792432 0.00792432 0.00792433 0.00792434 0.00792435 0.00792436 - 0.00792437 0.00792438 0.00792438 0.00792439 0.0079244 0.00792423 0.00790586 0.00660394 + 0.00792437 0.00792438 0.00792438 0.00792439 0.0079244 0.00792421 0.00790531 0.006618 </DataArray> <DataArray type="Float32" Name="x^Air_gas" NumberOfComponents="1" format="ascii"> 0.987322 0.987323 0.987323 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 - 0.987322 0.987322 0.987322 0.987322 0.987322 0.987323 0.987352 0.989426 0.987322 0.987323 0.987323 0.987322 + 0.987322 0.987322 0.987322 0.987322 0.987322 0.987323 0.987353 0.989404 0.987322 0.987323 0.987323 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 - 0.987322 0.987323 0.987352 0.989426 0.987322 0.987323 0.987323 0.987322 0.987322 0.987322 0.987322 0.987322 - 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987323 0.987352 0.989426 + 0.987322 0.987323 0.987353 0.989404 0.987322 0.987323 0.987323 0.987322 0.987322 0.987322 0.987322 0.987322 + 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987323 0.987353 0.989404 0.987322 0.987323 0.987323 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 - 0.987322 0.987322 0.987322 0.987322 0.987322 0.987323 0.987352 0.989426 0.987322 0.987323 0.987323 0.987322 + 0.987322 0.987322 0.987322 0.987322 0.987322 0.987323 0.987353 0.989404 0.987322 0.987323 0.987323 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 - 0.987322 0.987323 0.987352 0.989426 0.987322 0.987323 0.987323 0.987322 0.987322 0.987322 0.987322 0.987322 - 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987323 0.987352 0.989426 + 0.987322 0.987323 0.987353 0.989404 0.987322 0.987323 0.987323 0.987322 0.987322 0.987322 0.987322 0.987322 + 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987323 0.987353 0.989404 0.987322 0.987323 0.987323 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 - 0.987322 0.987322 0.987322 0.987322 0.987322 0.987323 0.987352 0.989426 0.987322 0.987323 0.987323 0.987322 + 0.987322 0.987322 0.987322 0.987322 0.987322 0.987323 0.987353 0.989404 0.987322 0.987323 0.987323 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 - 0.987322 0.987323 0.987352 0.989426 0.987322 0.987323 0.987323 0.987322 0.987322 0.987322 0.987322 0.987322 - 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987323 0.987352 0.989426 + 0.987322 0.987323 0.987353 0.989404 0.987322 0.987323 0.987323 0.987322 0.987322 0.987322 0.987322 0.987322 + 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987323 0.987353 0.989404 0.987322 0.987323 0.987323 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 0.987322 - 0.987322 0.987322 0.987322 0.987322 0.987322 0.987323 0.987352 0.989426 + 0.987322 0.987322 0.987322 0.987322 0.987322 0.987323 0.987353 0.989404 </DataArray> <DataArray type="Float32" Name="X^Air_gas" NumberOfComponents="1" format="ascii"> 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 - 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992094 0.993396 0.992076 0.992076 0.992076 0.992076 + 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992095 0.993382 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 - 0.992076 0.992076 0.992094 0.993396 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 - 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992094 0.993396 + 0.992076 0.992076 0.992095 0.993382 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 + 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992095 0.993382 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 - 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992094 0.993396 0.992076 0.992076 0.992076 0.992076 + 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992095 0.993382 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 - 0.992076 0.992076 0.992094 0.993396 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 - 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992094 0.993396 + 0.992076 0.992076 0.992095 0.993382 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 + 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992095 0.993382 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 - 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992094 0.993396 0.992076 0.992076 0.992076 0.992076 + 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992095 0.993382 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 - 0.992076 0.992076 0.992094 0.993396 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 - 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992094 0.993396 + 0.992076 0.992076 0.992095 0.993382 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 + 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992095 0.993382 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 - 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992094 0.993396 + 0.992076 0.992076 0.992076 0.992076 0.992076 0.992076 0.992095 0.993382 </DataArray> <DataArray type="Float32" Name="rhoMolar_gas" NumberOfComponents="1" format="ascii"> 100.849 100.849 100.849 100.849 100.849 100.849 100.849 100.848 100.848 100.848 100.848 100.848 - 100.848 100.848 100.848 100.848 100.848 100.848 100.861 101.876 100.849 100.849 100.849 100.849 + 100.848 100.848 100.848 100.848 100.848 100.848 100.861 101.864 100.849 100.849 100.849 100.849 100.849 100.849 100.849 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 - 100.848 100.848 100.861 101.876 100.849 100.849 100.849 100.849 100.849 100.849 100.849 100.848 - 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.861 101.876 + 100.848 100.848 100.861 101.864 100.849 100.849 100.849 100.849 100.849 100.849 100.849 100.848 + 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.861 101.864 100.849 100.849 100.849 100.849 100.849 100.849 100.849 100.848 100.848 100.848 100.848 100.848 - 100.848 100.848 100.848 100.848 100.848 100.848 100.861 101.876 100.849 100.849 100.849 100.849 + 100.848 100.848 100.848 100.848 100.848 100.848 100.861 101.864 100.849 100.849 100.849 100.849 100.849 100.849 100.849 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 - 100.848 100.848 100.861 101.876 100.849 100.849 100.849 100.849 100.849 100.849 100.849 100.848 - 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.861 101.876 + 100.848 100.848 100.861 101.864 100.849 100.849 100.849 100.849 100.849 100.849 100.849 100.848 + 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.861 101.864 100.849 100.849 100.849 100.849 100.849 100.849 100.849 100.848 100.848 100.848 100.848 100.848 - 100.848 100.848 100.848 100.848 100.848 100.848 100.861 101.876 100.849 100.849 100.849 100.849 + 100.848 100.848 100.848 100.848 100.848 100.848 100.861 101.864 100.849 100.849 100.849 100.849 100.849 100.849 100.849 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 - 100.848 100.848 100.861 101.876 100.849 100.849 100.849 100.849 100.849 100.849 100.849 100.848 - 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.861 101.876 + 100.848 100.848 100.861 101.864 100.849 100.849 100.849 100.849 100.849 100.849 100.849 100.848 + 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.848 100.861 101.864 100.849 100.849 100.849 100.849 100.849 100.849 100.849 100.848 100.848 100.848 100.848 100.848 - 100.848 100.848 100.848 100.848 100.848 100.848 100.861 101.876 + 100.848 100.848 100.848 100.848 100.848 100.848 100.861 101.864 </DataArray> <DataArray type="Float32" Name="phase presence" NumberOfComponents="1" format="ascii"> 3 3 3 3 3 3 3 3 3 3 3 3 @@ -404,22 +404,22 @@ </DataArray> <DataArray type="Float32" Name="T" NumberOfComponents="1" format="ascii"> 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 - 298.149 298.149 298.149 298.149 298.149 298.148 298.108 295.139 298.149 298.149 298.149 298.149 + 298.149 298.149 298.149 298.149 298.149 298.148 298.107 295.174 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 - 298.149 298.148 298.108 295.139 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 - 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.148 298.108 295.139 + 298.149 298.148 298.107 295.174 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 + 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.148 298.107 295.174 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 - 298.149 298.149 298.149 298.149 298.149 298.148 298.108 295.139 298.149 298.149 298.149 298.149 + 298.149 298.149 298.149 298.149 298.149 298.148 298.107 295.174 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 - 298.149 298.148 298.108 295.139 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 - 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.148 298.108 295.139 + 298.149 298.148 298.107 295.174 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 + 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.148 298.107 295.174 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 - 298.149 298.149 298.149 298.149 298.149 298.148 298.108 295.139 298.149 298.149 298.149 298.149 + 298.149 298.149 298.149 298.149 298.149 298.148 298.107 295.174 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 - 298.149 298.148 298.108 295.139 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 - 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.148 298.108 295.139 + 298.149 298.148 298.107 295.174 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 + 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.148 298.107 295.174 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 298.149 - 298.149 298.149 298.149 298.149 298.149 298.148 298.108 295.139 + 298.149 298.149 298.149 298.149 298.149 298.148 298.107 295.174 </DataArray> <DataArray type="Float32" Name="reynoldsNumber_liq" NumberOfComponents="1" format="ascii"> 0 0 0 0 0 0 0 0 0 0 0 0 @@ -441,23 +441,23 @@ 0 0 0 0 0 0 0 0 </DataArray> <DataArray type="Float32" Name="reynoldsNumber_gas" NumberOfComponents="1" format="ascii"> - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 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.21993e-05 2.2228e-05 2.2227e-05 2.22256e-05 2.22236e-05 2.22212e-05 2.22183e-05 2.22149e-05 2.2211e-05 2.22066e-05 2.22018e-05 2.21964e-05 + 2.21906e-05 2.21843e-05 2.21775e-05 2.21702e-05 2.21624e-05 2.21517e-05 2.19695e-05 2.21939e-05 2.21993e-05 2.2228e-05 2.2227e-05 2.22256e-05 + 2.22236e-05 2.22212e-05 2.22183e-05 2.22149e-05 2.2211e-05 2.22066e-05 2.22018e-05 2.21964e-05 2.21906e-05 2.21843e-05 2.21775e-05 2.21702e-05 + 2.21624e-05 2.21517e-05 2.19695e-05 2.21939e-05 2.21993e-05 2.2228e-05 2.2227e-05 2.22256e-05 2.22236e-05 2.22212e-05 2.22183e-05 2.22149e-05 + 2.2211e-05 2.22066e-05 2.22018e-05 2.21964e-05 2.21906e-05 2.21843e-05 2.21775e-05 2.21702e-05 2.21624e-05 2.21517e-05 2.19695e-05 2.21939e-05 + 2.21993e-05 2.2228e-05 2.2227e-05 2.22256e-05 2.22236e-05 2.22212e-05 2.22183e-05 2.22149e-05 2.2211e-05 2.22066e-05 2.22018e-05 2.21964e-05 + 2.21906e-05 2.21843e-05 2.21775e-05 2.21702e-05 2.21624e-05 2.21517e-05 2.19695e-05 2.21939e-05 2.21993e-05 2.2228e-05 2.2227e-05 2.22256e-05 + 2.22236e-05 2.22212e-05 2.22183e-05 2.22149e-05 2.2211e-05 2.22066e-05 2.22018e-05 2.21964e-05 2.21906e-05 2.21843e-05 2.21775e-05 2.21702e-05 + 2.21624e-05 2.21517e-05 2.19695e-05 2.21939e-05 2.21993e-05 2.2228e-05 2.2227e-05 2.22256e-05 2.22236e-05 2.22212e-05 2.22183e-05 2.22149e-05 + 2.2211e-05 2.22066e-05 2.22018e-05 2.21964e-05 2.21906e-05 2.21843e-05 2.21775e-05 2.21702e-05 2.21624e-05 2.21517e-05 2.19695e-05 2.21939e-05 + 2.21993e-05 2.2228e-05 2.2227e-05 2.22256e-05 2.22236e-05 2.22212e-05 2.22183e-05 2.22149e-05 2.2211e-05 2.22066e-05 2.22018e-05 2.21964e-05 + 2.21906e-05 2.21843e-05 2.21775e-05 2.21702e-05 2.21624e-05 2.21517e-05 2.19695e-05 2.21939e-05 2.21993e-05 2.2228e-05 2.2227e-05 2.22256e-05 + 2.22236e-05 2.22212e-05 2.22183e-05 2.22149e-05 2.2211e-05 2.22066e-05 2.22018e-05 2.21964e-05 2.21906e-05 2.21843e-05 2.21775e-05 2.21702e-05 + 2.21624e-05 2.21517e-05 2.19695e-05 2.21939e-05 2.21993e-05 2.2228e-05 2.2227e-05 2.22256e-05 2.22236e-05 2.22212e-05 2.22183e-05 2.22149e-05 + 2.2211e-05 2.22066e-05 2.22018e-05 2.21964e-05 2.21906e-05 2.21843e-05 2.21775e-05 2.21702e-05 2.21624e-05 2.21517e-05 2.19695e-05 2.21939e-05 + 2.21993e-05 2.2228e-05 2.2227e-05 2.22256e-05 2.22236e-05 2.22212e-05 2.22183e-05 2.22149e-05 2.2211e-05 2.22066e-05 2.22018e-05 2.21964e-05 + 2.21906e-05 2.21843e-05 2.21775e-05 2.21702e-05 2.21624e-05 2.21517e-05 2.19695e-05 2.21939e-05 </DataArray> <DataArray type="Float32" Name="process rank" NumberOfComponents="1" format="ascii"> 0 0 0 0 0 0 0 0 0 0 0 0 @@ -480,41 +480,41 @@ </DataArray> <DataArray type="Float32" Name="xEquil^Air_liq" NumberOfComponents="1" format="ascii"> 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 - 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41901e-05 3.59544e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 + 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41908e-05 3.59325e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 - 3.41678e-05 3.4168e-05 3.41901e-05 3.59544e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 - 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41901e-05 3.59544e-05 + 3.41678e-05 3.4168e-05 3.41908e-05 3.59325e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 + 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41908e-05 3.59325e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 - 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41901e-05 3.59544e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 + 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41908e-05 3.59325e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 - 3.41678e-05 3.4168e-05 3.41901e-05 3.59544e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 - 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41901e-05 3.59544e-05 + 3.41678e-05 3.4168e-05 3.41908e-05 3.59325e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 + 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41908e-05 3.59325e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 - 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41901e-05 3.59544e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 + 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41908e-05 3.59325e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 - 3.41678e-05 3.4168e-05 3.41901e-05 3.59544e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 - 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41901e-05 3.59544e-05 + 3.41678e-05 3.4168e-05 3.41908e-05 3.59325e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 + 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41908e-05 3.59325e-05 3.41684e-05 3.41684e-05 3.41683e-05 3.41683e-05 3.41683e-05 3.41682e-05 3.41682e-05 3.41682e-05 3.41681e-05 3.41681e-05 3.4168e-05 3.4168e-05 - 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41901e-05 3.59544e-05 + 3.4168e-05 3.41679e-05 3.41679e-05 3.41679e-05 3.41678e-05 3.4168e-05 3.41908e-05 3.59325e-05 </DataArray> <DataArray type="Float32" Name="xEquil^H2O_gas" NumberOfComponents="1" format="ascii"> 0.0126775 0.0126775 0.0126775 0.0126775 0.0126775 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 - 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126482 0.0105736 0.0126775 0.0126775 0.0126775 0.0126775 - 0.0126775 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 - 0.0126777 0.0126774 0.0126482 0.0105736 0.0126775 0.0126775 0.0126775 0.0126775 0.0126775 0.0126776 0.0126776 0.0126776 - 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126482 0.0105736 + 0.0126777 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126473 0.0105961 0.0126775 0.0126775 0.0126775 0.0126775 + 0.0126775 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 + 0.0126777 0.0126774 0.0126473 0.0105961 0.0126775 0.0126775 0.0126775 0.0126775 0.0126775 0.0126776 0.0126776 0.0126776 + 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126473 0.0105961 0.0126775 0.0126775 0.0126775 0.0126775 0.0126775 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 - 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126482 0.0105736 0.0126775 0.0126775 0.0126775 0.0126775 - 0.0126775 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 - 0.0126777 0.0126774 0.0126482 0.0105736 0.0126775 0.0126775 0.0126775 0.0126775 0.0126775 0.0126776 0.0126776 0.0126776 - 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126482 0.0105736 + 0.0126777 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126473 0.0105961 0.0126775 0.0126775 0.0126775 0.0126775 + 0.0126775 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 + 0.0126777 0.0126774 0.0126473 0.0105961 0.0126775 0.0126775 0.0126775 0.0126775 0.0126775 0.0126776 0.0126776 0.0126776 + 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126473 0.0105961 0.0126775 0.0126775 0.0126775 0.0126775 0.0126775 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 - 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126482 0.0105736 0.0126775 0.0126775 0.0126775 0.0126775 - 0.0126775 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 - 0.0126777 0.0126774 0.0126482 0.0105736 0.0126775 0.0126775 0.0126775 0.0126775 0.0126775 0.0126776 0.0126776 0.0126776 - 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126482 0.0105736 + 0.0126777 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126473 0.0105961 0.0126775 0.0126775 0.0126775 0.0126775 + 0.0126775 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 + 0.0126777 0.0126774 0.0126473 0.0105961 0.0126775 0.0126775 0.0126775 0.0126775 0.0126775 0.0126776 0.0126776 0.0126776 + 0.0126776 0.0126776 0.0126776 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126473 0.0105961 0.0126775 0.0126775 0.0126775 0.0126775 0.0126775 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 0.0126776 - 0.0126776 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126482 0.0105736 + 0.0126777 0.0126777 0.0126777 0.0126777 0.0126777 0.0126774 0.0126473 0.0105961 </DataArray> </CellData> <Points>