From 806d2dcc74b0f5c1fbca3a707b222b9dc4f61000 Mon Sep 17 00:00:00 2001 From: Philipp Nuske <philipp.nuske@mailbox.org> Date: Fri, 27 Jul 2012 12:24:15 +0000 Subject: [PATCH] - boxdarcyfluxvariables: access function to velocity without all the upstream weighting decisions . - boxdarcyfluxvariables: access function to velocity (Vector). - boxdarcyfluxvariables: upstream decision based on kGrdpNormal instead of velocity - boxdarcyfluxvariables: (correctly) rename velocity to volume flux (also in the models that are already restructured) - mpnc model & test: use the new velocity calculation - update the reference solution (actually the change in the reference was due to a change in order of multiplication in the residual that could not be avoided). - increased the LinearSolver.ResidualReduction to 1e-11 (i.e. until the solution does not change any more) - (the old velocity calculation and the new one give the identical result with LinearSolver.ResidualReductionsolver set to 1e-11 for both cases) git-svn-id: svn://svn.iws.uni-stuttgart.de/DUMUX/dumux/trunk@8758 2fb0f335-1f38-0410-981e-8018bf24f1b0 --- dumux/boxmodels/2p/2plocalresidual.hh | 2 +- dumux/boxmodels/2p/2pmodel.hh | 2 +- dumux/boxmodels/2pni/2pnilocalresidual.hh | 2 +- .../boxmodels/common/boxdarcyfluxvariables.hh | 105 ++- .../mpnc/mass/mpnclocalresidualmass.hh | 92 +- dumux/boxmodels/mpnc/mpncfluxvariables.hh | 190 +--- dumux/boxmodels/mpnc/mpncproperties.hh | 5 + dumux/boxmodels/mpnc/mpncpropertydefaults.hh | 10 +- dumux/boxmodels/mpnc/mpncvtkwritercommon.hh | 4 +- .../richards/richardslocalresidual.hh | 2 +- .../spatialparams/boxspatialparams1p.hh | 4 +- test/boxmodels/2p2c/injectionproblem.hh | 12 +- test/boxmodels/mpnc/obstacle-reference.vtu | 814 ------------------ test/boxmodels/mpnc/obstacleproblem.hh | 21 +- test/boxmodels/mpnc/test_mpnc.input | 4 + 15 files changed, 174 insertions(+), 1095 deletions(-) delete mode 100644 test/boxmodels/mpnc/obstacle-reference.vtu diff --git a/dumux/boxmodels/2p/2plocalresidual.hh b/dumux/boxmodels/2p/2plocalresidual.hh index 8f38e12799..e5d69590c5 100644 --- a/dumux/boxmodels/2p/2plocalresidual.hh +++ b/dumux/boxmodels/2p/2plocalresidual.hh @@ -153,7 +153,7 @@ public: // add advective flux of current phase int eqIdx = (phaseIdx == wPhaseIdx) ? contiWEqIdx : contiNEqIdx; flux[eqIdx] += - fluxVars.normalVelocity(phaseIdx) + fluxVars.volumeFlux(phaseIdx) * (( massUpwindWeight_)*up.density(phaseIdx) + diff --git a/dumux/boxmodels/2p/2pmodel.hh b/dumux/boxmodels/2p/2pmodel.hh index 3a11daab59..2ee4dbd233 100644 --- a/dumux/boxmodels/2p/2pmodel.hh +++ b/dumux/boxmodels/2p/2pmodel.hh @@ -290,7 +290,7 @@ public: // Get the Darcy velocities. The Darcy velocities are divided by the area of the subcontrolvolumeface // in the reference element. PhasesVector q; - q[phaseIdx] = fluxVars.normalVelocity(phaseIdx) / localArea; + q[phaseIdx] = fluxVars.volumeFlux(phaseIdx) / localArea; // transform the normal Darcy velocity into a vector tmpVelocity[phaseIdx] = localNormal; diff --git a/dumux/boxmodels/2pni/2pnilocalresidual.hh b/dumux/boxmodels/2pni/2pnilocalresidual.hh index 96c050573a..0a9c711190 100644 --- a/dumux/boxmodels/2pni/2pnilocalresidual.hh +++ b/dumux/boxmodels/2pni/2pnilocalresidual.hh @@ -147,7 +147,7 @@ public: // add advective energy flux in current phase flux[energyEqIdx] += - fluxVars.normalVelocity(phaseIdx) + fluxVars.volumeFlux(phaseIdx) * (( massUpwindWeight_)* up.density(phaseIdx)* diff --git a/dumux/boxmodels/common/boxdarcyfluxvariables.hh b/dumux/boxmodels/common/boxdarcyfluxvariables.hh index 6f730a02d0..a10c5e37ad 100644 --- a/dumux/boxmodels/common/boxdarcyfluxvariables.hh +++ b/dumux/boxmodels/common/boxdarcyfluxvariables.hh @@ -65,15 +65,14 @@ class BoxDarcyFluxVariables typedef typename GET_PROP_TYPE(TypeTag, GridView) GridView; typedef typename GridView::template Codim<0>::Entity Element; - enum { - dim = GridView::dimension, - dimWorld = GridView::dimensionworld, - numPhases = GET_PROP_VALUE(TypeTag, NumPhases) - }; + + enum { dim = GridView::dimension} ; + enum { dimWorld = GridView::dimensionworld} ; + enum { numPhases = GET_PROP_VALUE(TypeTag, NumPhases)} ; typedef typename GET_PROP_TYPE(TypeTag, Scalar) Scalar; typedef Dune::FieldMatrix<Scalar, dimWorld, dimWorld> Tensor; - typedef Dune::FieldVector<Scalar, dimWorld> Vector; + typedef Dune::FieldVector<Scalar, dimWorld> DimVector; typedef typename GET_PROP_TYPE(TypeTag, FVElementGeometry) FVElementGeometry; typedef typename FVElementGeometry::SubControlVolumeFace SCVFace; @@ -99,27 +98,54 @@ public: : fvGeometry_(fvGeometry), faceIdx_(faceIdx), onBoundary_(onBoundary) { mobilityUpwindWeight_ = GET_PARAM(TypeTag, Scalar, MobilityUpwindWeight); - + calculateNormalVelocity_(problem, element, elemVolVars); } public: /*! - * \brief Return the normal velocity for a given phase. + * \brief Return the volumetric flux over a face of a given phase. + * + * This is the Darcy velocity multiplied by the unit normal + * and the area of the face. + * face().normal + * has already the magnitude of the area. * * \param phaseIdx index of the phase */ - Scalar normalVelocity(int phaseIdx) const - { return normalVelocity_[phaseIdx]; } + Scalar volumeFlux(const unsigned int phaseIdx) const + { return volumeFlux_[phaseIdx]; } + /*! + * \brief Return the velocity of a given phase. + * + * This is the full velocity vector on the + * face (without being multiplied with normal). + * + * \param phaseIdx index of the phase + */ + DimVector velocity(const unsigned int phaseIdx) const + { return velocity_[phaseIdx] ; } + + /*! + * \brief Return intrinsic permeability multiplied with potential + * gradient multiplied with normal. + * + * I.e. everything that does not need upwind decisions. + * + * \param phaseIdx index of the phase + */ + Scalar kGradpNormal(const unsigned int phaseIdx) const + { return kGradpNormal_[phaseIdx] ; } + /*! * \brief Return the local index of the downstream control volume * for a given phase. * * \param phaseIdx index of the phase */ - int downstreamIdx(int phaseIdx) const - { return (normalVelocity_[phaseIdx] >= 0) ? face().j : face().i; } + const unsigned int downstreamIdx(const unsigned phaseIdx) const + { return downstreamIdx_[phaseIdx]; } /*! * \brief Return the local index of the upstream control volume @@ -127,8 +153,8 @@ public: * * \param phaseIdx index of the phase */ - int upstreamIdx(int phaseIdx) const - { return (normalVelocity_[phaseIdx] > 0) ? face().i : face().j; } + const unsigned int upstreamIdx(const unsigned phaseIdx) const + { return upstreamIdx_[phaseIdx]; } /*! * \brief Return the SCV (sub-control-volume) face @@ -143,9 +169,12 @@ public: protected: const FVElementGeometry &fvGeometry_; - int faceIdx_; + unsigned int faceIdx_; const bool onBoundary_; - Scalar normalVelocity_[numPhases]; + unsigned int upstreamIdx_[numPhases] , downstreamIdx_[numPhases]; + Scalar volumeFlux_[numPhases] ; + DimVector velocity_[numPhases] ; + Scalar kGradpNormal_[numPhases] ; Scalar mobilityUpwindWeight_; private: @@ -168,19 +197,19 @@ private: for (int phaseIdx = 0; phaseIdx < numPhases; phaseIdx++) { // calculate the phase pressure gradient - Vector gradPotential(0.0); + DimVector gradPotential(0.0); for (int idx = 0; idx < fvGeometry_.numFAP; idx++) // loop over adjacent vertices { // FE gradient at vertex idx - const Vector &feGrad = face().grad[idx]; + const DimVector &feGrad = face().grad[idx]; // index for the element volume variables int volVarsIdx = face().fapIndices[idx]; // the pressure gradient - Vector tmp(feGrad); + DimVector tmp(feGrad); tmp *= elemVolVars[volVarsIdx].fluidState().pressure(phaseIdx); gradPotential += tmp; } @@ -190,7 +219,7 @@ private: { // estimate the gravitational acceleration at a given SCV face // using the arithmetic mean - Vector g(problem.boxGravity(element, fvGeometry_, face().i)); + DimVector g(problem.boxGravity(element, fvGeometry_, face().i)); g += problem.boxGravity(element, fvGeometry_, face().j); g /= 2; @@ -206,10 +235,10 @@ private: // doesn't matter because no wetting phase is present in // both cells! fI = fJ = 0.5; - Scalar density = (fI*rhoI + fJ*rhoJ)/(fI + fJ); + const Scalar density = (fI*rhoI + fJ*rhoJ)/(fI + fJ); // make gravity acceleration a force - Vector f(g); + DimVector f(g); f *= density; // calculate the final potential gradient @@ -221,33 +250,37 @@ private: // // v = - (K grad phi) * n // - // (the minus comes from the Darcy law which states that + // Mind, that the normal has the length of it's area. + // This means that we are actually calculating + // Q = - (K grad phi) * n * A + // + // (the minus comes from the Darcy relation which states that // the flux is from high to low potentials.) - Vector kGradPotential; + DimVector kGradPotential; K.mv(gradPotential, kGradPotential); - Scalar normalFlux = -(kGradPotential*face().normal); + kGradpNormal_[phaseIdx] = -(kGradPotential*face().normal); // determine the upwind direction - int upstreamIdx, downstreamIdx; - if (normalFlux > 0) + if (kGradpNormal_[phaseIdx] > 0) { - upstreamIdx = face().i; - downstreamIdx = face().j; + upstreamIdx_[phaseIdx] = face().i; + downstreamIdx_[phaseIdx] = face().j; } - else + else { - upstreamIdx = face().j; - downstreamIdx = face().i; + upstreamIdx_[phaseIdx] = face().j; + downstreamIdx_[phaseIdx] = face().i; } // obtain the upwind volume variables - const VolumeVariables& upVolVars = elemVolVars[upstreamIdx]; - const VolumeVariables& downVolVars = elemVolVars[downstreamIdx]; - + const VolumeVariables& upVolVars = elemVolVars[ upstreamIdx(phaseIdx) ]; + const VolumeVariables& downVolVars = elemVolVars[ downstreamIdx(phaseIdx) ]; + // set the normal velocity - normalVelocity_[phaseIdx] = normalFlux + volumeFlux_[phaseIdx] = kGradpNormal_[phaseIdx] *( mobilityUpwindWeight_*upVolVars.mobility(phaseIdx) + (1.0 - mobilityUpwindWeight_)*downVolVars.mobility(phaseIdx)); + } // loop over all phases } }; diff --git a/dumux/boxmodels/mpnc/mass/mpnclocalresidualmass.hh b/dumux/boxmodels/mpnc/mass/mpnclocalresidualmass.hh index 7b8dec804e..4b9559a52c 100644 --- a/dumux/boxmodels/mpnc/mass/mpnclocalresidualmass.hh +++ b/dumux/boxmodels/mpnc/mass/mpnclocalresidualmass.hh @@ -93,88 +93,95 @@ public: const FluxVariables &fluxVars, const unsigned int phaseIdx) { - static bool enableSmoothUpwinding_ = GET_PARAM(TypeTag, bool, EnableSmoothUpwinding); - DimVector tmpVec; - fluxVars.intrinsicPermeability().mv(fluxVars.potentialGrad(phaseIdx), - tmpVec); + const Scalar volumeFlux = fluxVars.volumeFlux(phaseIdx) ; + #ifndef NDEBUG + if (!std::isfinite(volumeFlux)) + DUNE_THROW(NumericalProblem, "Calculated non-finite normal flux in smooth upwinding"); + #endif + + // retrieve the upwind weight for the mass conservation equations. Use the value + // specified via the property system as default, and overwrite + // it by the run-time parameter from the Dune::ParameterTree + const Scalar massUpwindWeight = GET_PARAM(TypeTag, Scalar, MassUpwindWeight); - // advective part is flux over face, therefore needs to be multiplied by normal vector - // (length: area of face) - Scalar normalFlux = - (tmpVec*fluxVars.face().normal); + static bool enableSmoothUpwinding_ = GET_PARAM(TypeTag, bool, EnableSmoothUpwinding); // data attached to upstream and the downstream vertices // of the current phase - int upIdx = fluxVars.face().i; - int dnIdx = fluxVars.face().j; -#ifndef NDEBUG - if (!std::isfinite(normalFlux)) - DUNE_THROW(NumericalProblem, "Calculated non-finite normal flux"); -#endif + unsigned int upIdx = fluxVars.upstreamIdx(phaseIdx); + unsigned int dnIdx = fluxVars.downstreamIdx(phaseIdx); - if (normalFlux < 0) std::swap(upIdx, dnIdx); const VolumeVariables &up = fluxVars.volVars(upIdx); const VolumeVariables &dn = fluxVars.volVars(dnIdx); //////// // advective fluxes of all components in the phase //////// - for (int compIdx = 0; compIdx < numComponents; ++compIdx) { + for (unsigned int compIdx = 0; compIdx < numComponents; ++compIdx) { // add advective flux of current component in current // phase. we use full upwinding. - if (enableSmoothUpwinding_) { - Scalar mobUp = up.mobility(phaseIdx); - Scalar cUp = up.fluidState().molarity(phaseIdx, compIdx); + const Scalar kGradpNormal = fluxVars.kGradpNormal(phaseIdx); + const Scalar mobUp = up.mobility(phaseIdx); + const Scalar conUp = up.fluidState().molarity(phaseIdx, compIdx); - Scalar mobDn = dn.mobility(phaseIdx); - Scalar cDn = dn.fluidState().molarity(phaseIdx, compIdx); + const Scalar mobDn = dn.mobility(phaseIdx); + const Scalar conDn = dn.fluidState().molarity(phaseIdx, compIdx); - Scalar mUp = mobUp*cUp; - Scalar mDn = mobDn*cDn; - Scalar m0 = Dumux::harmonicMean(mUp, mDn); + const Scalar mobConUp = mobUp*conUp; + const Scalar mobConDn = mobDn*conDn; + const Scalar meanMobCon = Dumux::harmonicMean(mobConUp, mobConDn); - Scalar x = std::abs(normalFlux); - Scalar sign = (normalFlux < 0)?-1:1; + const Scalar x = std::abs(kGradpNormal); + const Scalar sign = (kGradpNormal < 0)?-1:1; // the direction from upstream to downstream //GlobalPosition delta = this->curElement_().geometry().corner(upIdx); //delta -= this->curElement_().geometry().corner(dnIdx); // approximate the mean viscosity at the face - Scalar meanVisc = (up.fluidState().viscosity(phaseIdx) + + const Scalar meanVisc = (up.fluidState().viscosity(phaseIdx) + dn.fluidState().viscosity(phaseIdx))/2; // put the mean viscosity and permeanbility in // relation to the viscosity of water at // approximatly 20 degrees Celsius. - const Scalar pGradRef = 10; // [Pa/m] - const Scalar muRef = 1e-3; // [Ns/m^2] - const Scalar Kref = 1e-12; // [m^2] = approx 1 Darcy + const Scalar pGradRef = 10; // [Pa/m] + const Scalar muRef = 1e-3; // [Ns/m^2] + const Scalar Kref = 1e-12; // [m^2] = approx 1 Darcy - Scalar faceArea = fluxVars.face().normal.two_norm(); - Scalar eps = pGradRef * Kref * faceArea * meanVisc/muRef; // * (1e3/18e-3)/meanC; + const Scalar faceArea = fluxVars.face().normal.two_norm(); + const Scalar eps = pGradRef * Kref * faceArea * meanVisc/muRef; // * (1e3/18e-3)/meanC; Scalar compFlux; if (x >= eps) { // we only do tricks if x is below the epsilon // value - compFlux = x*mUp; + compFlux = x*mobConUp; } else { - Scalar xPos[] = { 0, eps }; - Scalar yPos[] = { 0, eps*mUp }; - Spline<Scalar> sp2(xPos, yPos, m0, mUp); + const Scalar xPos[] = { 0, eps }; + const Scalar yPos[] = { 0, eps*mobConUp }; + const Spline<Scalar> sp2(xPos, yPos, meanMobCon, mobConUp); compFlux = sp2.eval(x); } + #ifndef NDEBUG + if (!std::isfinite(compFlux)) + DUNE_THROW(NumericalProblem, "Calculated non-finite normal flux in smooth upwinding"); + #endif flux[compIdx] = sign*compFlux; } - else {// !use smooth upwinding + else + {// not use smooth upwinding flux[compIdx] = - up.mobility(phaseIdx) * - up.fluidState().molarity(phaseIdx, compIdx) * - normalFlux; + volumeFlux * + (( massUpwindWeight)*up.fluidState().molarity(phaseIdx, compIdx) + + + ( 1. - massUpwindWeight)*dn.fluidState().molarity(phaseIdx, compIdx) ); + + } } } @@ -337,10 +344,9 @@ public: static void computeSource(PrimaryVariables &source, const VolumeVariables &volVars) { - static_assert(not enableKineticEnergy, - "In the case of kinetic energy transfer the advective energy transport between the phases has to be considered. " - "It is hard (technically) to say how much mass got transfered in the case of chemical equilibrium. " - "Therefore, kineticEnergy and no kinetic mass does not fit (yet)."); +#warning In the case of kinetic energy transfer the advective energy transport between the phases has to be considered. \ + It is hard (technically) to say how much mass got transfered in the case of chemical equilibrium. \ + Therefore, kineticEnergy and no kinetic mass does not fit (yet).; // mass transfer is not considered in this mass module for (int compIdx = 0; compIdx < numComponents; ++compIdx) diff --git a/dumux/boxmodels/mpnc/mpncfluxvariables.hh b/dumux/boxmodels/mpnc/mpncfluxvariables.hh index a6cdd05660..8b9e3aa5fa 100644 --- a/dumux/boxmodels/mpnc/mpncfluxvariables.hh +++ b/dumux/boxmodels/mpnc/mpncfluxvariables.hh @@ -37,6 +37,7 @@ #include "diffusion/fluxvariables.hh" #include "energy/mpncfluxvariablesenergy.hh" +#include <dumux/boxmodels/common/boxdarcyfluxvariables.hh> namespace Dumux { @@ -53,6 +54,8 @@ namespace Dumux */ template <class TypeTag> class MPNCFluxVariables + : public BoxDarcyFluxVariables<TypeTag> + { typedef typename GET_PROP_TYPE(TypeTag, Problem) Problem; typedef typename GET_PROP_TYPE(TypeTag, SpatialParams) SpatialParams; @@ -95,84 +98,29 @@ public: const unsigned int faceIdx, const ElementVolumeVariables &elemVolVars, const bool onBoundary = false) - : fvGeometry_(fvGeometry), faceIdx_(faceIdx), elemVolVars_(elemVolVars), onBoundary_(onBoundary) + : BoxDarcyFluxVariables<TypeTag>(problem, element, fvGeometry, faceIdx, elemVolVars, onBoundary), + fvGeometry_(fvGeometry), faceIdx_(faceIdx), elemVolVars_(elemVolVars), onBoundary_(onBoundary) { - // update the base module (i.e. advection) - calculateGradients_(problem, element, elemVolVars); - calculateVelocities_(problem, element, elemVolVars); + // velocities can be obtained from the Parent class. // update the flux data of the energy module (i.e. isothermal // or non-isothermal) - fluxVarsEnergy_.update(problem, element, fvGeometry, face(), *this, elemVolVars); + fluxVarsEnergy_.update(problem, element, fvGeometry, this->face(), *this, elemVolVars); // update the flux data of the diffusion module (i.e. with or // without diffusion) - fluxVarsDiffusion_.update(problem, element, fvGeometry, face(), elemVolVars); + fluxVarsDiffusion_.update(problem, element, fvGeometry, this->face(), elemVolVars); extrusionFactor_ = - (elemVolVars[face().i].extrusionFactor() - + elemVolVars[face().j].extrusionFactor()) / 2; - } - - - /*! - * \brief Calculate a phase's darcy velocity [m/s] at a - * sub-control volume face. - * - * So far, this method only exists in the Mp-Nc model! - * - * Of course, in the setting of a finite volume scheme, the velocities are - * on the faces rather than in the volume. Therefore, the velocity - * - * \param vDarcy the resulting Darcy velocity - * \param elemVolVars element volume variables - * \param phaseIdx phase index - */ - void computeDarcy(DimVector & vDarcy, - const ElementVolumeVariables &elemVolVars, - const unsigned int phaseIdx) const - { - intrinsicPermeability().mv(potentialGrad(phaseIdx), - vDarcy); - // darcy velocity is along *negative* potential gradient - // (i.e. from high to low pressures), this means that we need - // to negate the product of the intrinsic permeability and the - // potential gradient! - vDarcy *= -1; - - // JUST for upstream decision - Scalar normalFlux = vDarcy * face().normal; - // data attached to upstream and the downstream vertices - // of the current phase - int upIdx = face().i; - int dnIdx = face().j; - - if (!std::isfinite(normalFlux)) - DUNE_THROW(NumericalProblem, "Calculated non-finite normal flux"); - - if (normalFlux < 0) - std::swap(upIdx, dnIdx); - - const VolumeVariables &up = elemVolVars[upIdx]; - - //////// - // Jipie this is a velocity now, finally deserves the name - //////// - vDarcy *= up.mobility(phaseIdx); + (elemVolVars[this->face().i].extrusionFactor() + + elemVolVars[this->face().j].extrusionFactor()) / 2; } /*! - * \brief The face of the current sub-control volume. This may be either - * an inner sub-control-volume face or a face on the boundary. + * \brief Returns a reference to the volume + * variables of the i-th sub-control volume of the current + * element. */ - const SCVFace &face() const - { - if (onBoundary_) - return fvGeometry_.boundaryFace[faceIdx_]; - else - return fvGeometry_.subContVolFace[faceIdx_]; - } - const VolumeVariables &volVars(const unsigned int idx) const { return elemVolVars_[idx]; } @@ -182,18 +130,6 @@ public: Scalar extrusionFactor() const { return extrusionFactor_; } - /*! - * \brief Return the intrinsic permeability. - */ - const DimMatrix &intrinsicPermeability() const - { return K_; } - - /*! - * \brief Return the pressure potential gradient. - */ - const DimVector &potentialGrad(const unsigned int phaseIdx) const - { return potentialGrad_[phaseIdx]; } - //////////////////////////////////////////////// // forward calls to the diffusion module Scalar porousDiffCoeffL(const unsigned int compIdx) const @@ -212,7 +148,6 @@ public: const unsigned int compIdx) const { return fluxVarsDiffusion_.moleFraction(phaseIdx, compIdx); } - const DimVector &moleFractionGrad(const unsigned int phaseIdx, const unsigned int compIdx) const { return fluxVarsDiffusion_.moleFractionGrad(phaseIdx, compIdx); } @@ -227,7 +162,7 @@ public: //////////////////////////////////////////////// // forward calls to the temperature module const DimVector &temperatureGrad() const - { return fluxVarsEnergy_.temperatureGrad(); }; + { return fluxVarsEnergy_.temperatureGrad(); } DUNE_DEPRECATED_MSG("use fluxVariablesEnergy() instead") const FluxVariablesEnergy &energyData() const @@ -239,97 +174,6 @@ public: //////////////////////////////////////////////// private: - void calculateGradients_(const Problem &problem, - const Element &element, - const ElementVolumeVariables &elemVolVars) - { - for (int phaseIdx=0; phaseIdx < numPhases; phaseIdx++){ - potentialGrad_[phaseIdx] = Scalar(0); - } - - // calculate pressure gradients using finite element gradients - DimVector tmp(0.0); - for (int idx = 0; - idx < fvGeometry_.numFAP; - idx++) // loop over adjacent vertices - { - // FE gradient at vertex idx - const DimVector &feGrad = face().grad[idx]; - - // index for the element volume variables - int volVarsIdx = face().fapIndices[idx]; - - // TODO: only calculate the gradients for the present - // phases. - // - // compute sum of pressure gradients for each phase - for (int phaseIdx = 0; phaseIdx < numPhases; phaseIdx++) - { - // the pressure gradient - tmp = feGrad; - tmp *= elemVolVars[volVarsIdx].fluidState().pressure(phaseIdx); - potentialGrad_[phaseIdx] += tmp; - } - } - - /////////////// - // correct the pressure gradients by the gravitational acceleration - /////////////// - if (enableGravity) { - // estimate the gravitational acceleration at a given SCV face - // using the arithmetic mean - DimVector g(problem.boxGravity(element, fvGeometry_, face().i)); - g += problem.boxGravity(element, fvGeometry_, face().j); - g /= 2; - - for (int phaseIdx=0; phaseIdx < numPhases; phaseIdx++) - { - // calculate the phase density at the integration point. we - // only do this if the wetting phase is present in both cells - Scalar SI = elemVolVars[face().i].fluidState().saturation(phaseIdx); - Scalar SJ = elemVolVars[face().j].fluidState().saturation(phaseIdx); - Scalar rhoI = elemVolVars[face().i].fluidState().density(phaseIdx); - Scalar rhoJ = elemVolVars[face().j].fluidState().density(phaseIdx); - Scalar fI = std::max(0.0, std::min(SI/1e-5, 0.5)); - Scalar fJ = std::max(0.0, std::min(SJ/1e-5, 0.5)); - if (fI + fJ == 0) - // doesn't matter because no wetting phase is present in - // both cells! - fI = fJ = 0.5; - Scalar density = (fI*rhoI + fJ*rhoJ)/(fI + fJ); - - // make gravity acceleration a force - DimVector f(g); - f *= density; - - // calculate the final potential gradient - potentialGrad_[phaseIdx] -= f; - } - } - } - - void calculateVelocities_(const Problem &problem, - const Element &element, - const ElementVolumeVariables &elemVolVars) - { - // multiply the pressure potential with the intrinsic - // permeability - const SpatialParams &sp = problem.spatialParams(); - for (int phaseIdx=0; phaseIdx < numPhases; phaseIdx++) - { - sp.meanK(K_, - sp.intrinsicPermeability(element, - fvGeometry_, - face().i), - sp.intrinsicPermeability(element, - fvGeometry_, - face().j)); - } - } - - - - const FVElementGeometry &fvGeometry_; const unsigned int faceIdx_; const ElementVolumeVariables &elemVolVars_; @@ -338,12 +182,6 @@ private: // The extrusion factor for the sub-control volume face Scalar extrusionFactor_; - // pressure potential gradients - DimVector potentialGrad_[numPhases]; - - // intrinsic permeability - DimMatrix K_; - FluxVariablesDiffusion fluxVarsDiffusion_; FluxVariablesEnergy fluxVarsEnergy_; }; diff --git a/dumux/boxmodels/mpnc/mpncproperties.hh b/dumux/boxmodels/mpnc/mpncproperties.hh index 00b16d2e02..6f74963f21 100644 --- a/dumux/boxmodels/mpnc/mpncproperties.hh +++ b/dumux/boxmodels/mpnc/mpncproperties.hh @@ -80,6 +80,8 @@ NEW_PROP_TAG(MPNCVtkAddTemperatures); NEW_PROP_TAG(MPNCVtkAddEnthalpies); NEW_PROP_TAG(MPNCVtkAddInternalEnergies); +NEW_PROP_TAG(MPNCVtkAddxEquil); + NEW_PROP_TAG(MPNCVtkAddReynolds); NEW_PROP_TAG(MPNCVtkAddPrandtl); NEW_PROP_TAG(MPNCVtkAddNusselt); @@ -116,6 +118,9 @@ NEW_PROP_TAG(EnableGravity); //! Use the smooth upwinding method? NEW_PROP_TAG(EnableSmoothUpwinding); +NEW_PROP_TAG(MassUpwindWeight); //!< The value of the weight of the upwind direction in the mass conservation equations +NEW_PROP_TAG(MobilityUpwindWeight); //!< Weight for the upwind mobility in the velocity calculation + //! Chop the Newton update at the beginning of the non-linear solver? NEW_PROP_TAG(NewtonEnableChop); diff --git a/dumux/boxmodels/mpnc/mpncpropertydefaults.hh b/dumux/boxmodels/mpnc/mpncpropertydefaults.hh index 8eb02a0b44..c43304e8ff 100644 --- a/dumux/boxmodels/mpnc/mpncpropertydefaults.hh +++ b/dumux/boxmodels/mpnc/mpncpropertydefaults.hh @@ -150,7 +150,7 @@ SET_BOOL_PROP(BoxMPNC, EnableKinetic, false); SET_BOOL_PROP(BoxMPNC, EnableKineticEnergy, false); //! enable smooth upwinding by default -SET_BOOL_PROP(BoxMPNC, EnableSmoothUpwinding, true); +SET_BOOL_PROP(BoxMPNC, EnableSmoothUpwinding, false); //! the VolumeVariables property SET_TYPE_PROP(BoxMPNC, VolumeVariables, MPNCVolumeVariables<TypeTag>); @@ -167,6 +167,12 @@ SET_PROP(BoxMPNC, Indices) typedef MPNCIndices<TypeTag, 0> type; }; +//! the upwind weight for the mass conservation equations. +SET_SCALAR_PROP(BoxMPNC, MassUpwindWeight, 1.0); + +//! weight for the upwind mobility in the velocity calculation +SET_SCALAR_PROP(BoxMPNC, MobilityUpwindWeight, 1.0); + //! DEPRECATED MPNCIndices property SET_TYPE_PROP(BoxMPNC, MPNCIndices, typename GET_PROP_TYPE(TypeTag, Indices)); @@ -242,6 +248,8 @@ SET_BOOL_PROP(BoxMPNC, MPNCVtkAddReynolds, false); SET_BOOL_PROP(BoxMPNC, MPNCVtkAddPrandtl, false); SET_BOOL_PROP(BoxMPNC, MPNCVtkAddNusselt, false); SET_BOOL_PROP(BoxMPNC, MPNCVtkAddInterfacialArea, false); +SET_BOOL_PROP(BoxMPNC, MPNCVtkAddxEquil, false); + } } diff --git a/dumux/boxmodels/mpnc/mpncvtkwritercommon.hh b/dumux/boxmodels/mpnc/mpncvtkwritercommon.hh index 13172aab21..e35b315d6d 100644 --- a/dumux/boxmodels/mpnc/mpncvtkwritercommon.hh +++ b/dumux/boxmodels/mpnc/mpncvtkwritercommon.hh @@ -177,9 +177,7 @@ public: for (int phaseIdx = 0; phaseIdx < numPhases; ++phaseIdx) { Dune::FieldVector<Scalar, dim> darcyVelocity; - fluxVars.computeDarcy(darcyVelocity, - elemVolVars, - phaseIdx); + darcyVelocity = fluxVars.velocity(phaseIdx); darcyVelocity *= scvfArea; velocity_[phaseIdx][I] += darcyVelocity; velocity_[phaseIdx][J] += darcyVelocity; diff --git a/dumux/boxmodels/richards/richardslocalresidual.hh b/dumux/boxmodels/richards/richardslocalresidual.hh index 643fa49c94..0ee5ac2551 100644 --- a/dumux/boxmodels/richards/richardslocalresidual.hh +++ b/dumux/boxmodels/richards/richardslocalresidual.hh @@ -130,7 +130,7 @@ public: const VolumeVariables &dn = this->curVolVars_(fluxVars.downstreamIdx(wPhaseIdx)); flux[contiEqIdx] = - fluxVars.normalVelocity(wPhaseIdx) + fluxVars.volumeFlux(wPhaseIdx) * (( massUpwindWeight_)*up.density(wPhaseIdx) + diff --git a/dumux/material/spatialparams/boxspatialparams1p.hh b/dumux/material/spatialparams/boxspatialparams1p.hh index a1a1d8037f..bc8800290a 100644 --- a/dumux/material/spatialparams/boxspatialparams1p.hh +++ b/dumux/material/spatialparams/boxspatialparams1p.hh @@ -58,9 +58,7 @@ class BoxSpatialParamsOneP typedef typename GET_PROP_TYPE(TypeTag, GridView) GridView; typedef typename GET_PROP_TYPE(TypeTag, SpatialParams) Implementation; - enum { - dimWorld = GridView::dimensionworld - }; + enum { dimWorld = GridView::dimensionworld }; typedef typename GridView::template Codim<0>::Entity Element; typedef typename GET_PROP_TYPE(TypeTag, FVElementGeometry) FVElementGeometry; diff --git a/test/boxmodels/2p2c/injectionproblem.hh b/test/boxmodels/2p2c/injectionproblem.hh index d859939335..0df7795f42 100644 --- a/test/boxmodels/2p2c/injectionproblem.hh +++ b/test/boxmodels/2p2c/injectionproblem.hh @@ -115,11 +115,11 @@ class InjectionProblem : public PorousMediaBoxProblem<TypeTag> nPhaseIdx = Indices::nPhaseIdx, - H2OIdx = FluidSystem::H2OIdx, - N2Idx = FluidSystem::N2Idx, + wCompIdx = FluidSystem::wCompIdx, + nCompIdx = FluidSystem::nCompIdx, conti0EqIdx = Indices::conti0EqIdx, - contiN2EqIdx = conti0EqIdx + N2Idx + contiN2EqIdx = conti0EqIdx + nCompIdx }; @@ -359,10 +359,10 @@ private: Scalar moleFracLiquidH2O = 1.0 - moleFracLiquidN2; Scalar meanM = - FluidSystem::molarMass(H2OIdx)*moleFracLiquidH2O + - FluidSystem::molarMass(N2Idx)*moleFracLiquidN2; + FluidSystem::molarMass(wCompIdx)*moleFracLiquidH2O + + FluidSystem::molarMass(nCompIdx)*moleFracLiquidN2; - Scalar massFracLiquidN2 = moleFracLiquidN2*FluidSystem::molarMass(N2Idx)/meanM; + Scalar massFracLiquidN2 = moleFracLiquidN2*FluidSystem::molarMass(nCompIdx)/meanM; values[Indices::pressureIdx] = pl; values[Indices::switchIdx] = massFracLiquidN2; diff --git a/test/boxmodels/mpnc/obstacle-reference.vtu b/test/boxmodels/mpnc/obstacle-reference.vtu deleted file mode 100644 index 55f461fe58..0000000000 --- a/test/boxmodels/mpnc/obstacle-reference.vtu +++ /dev/null @@ -1,814 +0,0 @@ -<?xml version="1.0"?> -<VTKFile type="UnstructuredGrid" version="0.1" byte_order="LittleEndian"> - <UnstructuredGrid> - <Piece NumberOfCells="384" NumberOfPoints="425"> - <PointData Scalars="S_l"> - <DataArray type="Float32" Name="S_l" 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.00707434 0.00536761 0.640718 0.553335 - 1 1 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0.00464816 0.557593 1 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0.00249539 0.560397 1 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0.473788 1 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0.00782007 0.291675 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 - </DataArray> - <DataArray type="Float32" Name="S_g" NumberOfComponents="1" format="ascii"> - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 0.992926 0.994632 0.359282 0.446665 - 0 0 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 0.995352 0.442407 0 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 0.997505 0.439603 0 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 0.526212 0 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 0.99218 0.708325 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 1 - </DataArray> - <DataArray type="Float32" Name="p_l" NumberOfComponents="1" format="ascii"> - 100000 100043 100000 100023 100062 100039 100072 100046 100005 100002 100002 100000 - 100002 100000 100002 100000 100018 100016 100576 100544 100605 100575 100668 100637 - 100767 100736 100907 100875 101096 101062 101342 101305 101656 101615 102053 102006 - 102550 102495 103170 103102 103947 103857 104931 104807 106118 106066 110663 109552 - 200000 200000 100000 100013 100023 100028 100001 100000 100000 100000 100014 100511 - 100541 100602 100698 100833 101014 101249 101548 101924 102390 102962 103658 104500 - 105540 108679 200000 100000 100007 100013 100016 100001 100000 100000 100000 100013 - 100475 100504 100562 100654 100782 100954 101177 101459 101811 102244 102770 103395 - 104101 104767 106970 200000 100000 100002 100005 100007 100000 100000 100000 100000 - 100011 100437 100464 100519 100605 100725 100885 101091 101351 101673 102067 102542 - 103106 103752 104403 102560 200000 99997.2 99997.8 99999 99999.8 100000 100000 100000 - 100000 100010 100397 100422 100473 100552 100662 100808 100994 101229 101517 101867 - 102288 102792 103413 104313 107911 97964 99992.1 99992.3 99992.8 99993.2 99999.9 100000 - 100000 100000 100009 100357 100379 100425 100496 100595 100725 100891 101097 101349 - 101652 102011 102436 102949 103614 103562 103078 99985.9 99986 99986.3 99986.5 99999.7 - 100000 100000 100000 100008 100315 100335 100376 100439 100527 100641 100785 100962 - 101176 101429 101721 102051 102405 102687 102770 102752 99978.8 99978.8 99979 99979.1 - 99999.4 100000 100000 100000 100007 100273 100291 100327 100382 100458 100556 100679 - 100829 101006 101210 101439 101683 101916 102097 102193 102219 99970.5 99970.5 99970.7 - 99970.8 99999.1 100000 100000 100000 100005 100232 100248 100279 100326 100391 100474 - 100577 100701 100844 101007 101182 101360 101524 101652 101730 101755 99960.9 99961 - 99961.1 99961.3 99998.8 100000 100000 100000 100004 100192 100205 100232 100272 100327 - 100397 100482 100583 100698 100825 100958 101089 101208 101301 101360 101380 99949.9 - 99949.9 99950.1 99950.3 99998.4 100000 100000 100000 100003 100152 100164 100187 100221 - 100267 100325 100395 100477 100569 100668 100769 100868 100955 101024 101067 101082 - 99937 99937.1 99937.3 99937.6 99997.8 100000 100000 100000 100002 100114 100124 100144 - 100173 100213 100261 100319 100385 100459 100536 100615 100690 100755 100807 100840 - 100851 99922.2 99922.4 99922.8 99923 99997.2 99999.9 100000 100000 100001 100075 100085 - 100103 100130 100163 100205 100253 100308 100368 100430 100492 100551 100601 100641 - 100666 100675 99904.8 99905.5 99907.3 99906 99994.8 99997.8 99998.3 99998.6 99998.6 100036 - 100048 100066 100090 100120 100156 100198 100245 100295 100347 100399 100446 100488 - 100519 100540 100546 99884 99885.2 99889.4 99901.4 99909.4 99926 99941.2 99956.9 99975.2 - 99994 100012 100032 100055 100083 100116 100154 100196 100241 100287 100332 100374 - 100410 100437 100455 100460 99858.8 99860.3 99865.6 99874.2 99885.2 99898.7 99913.6 99929.3 - 99946.2 99963.9 99982 100002 100025 100052 100084 100121 100162 100205 100249 100292 - 100332 100366 100392 100408 100414 - </DataArray> - <DataArray type="Float32" Name="p_g" NumberOfComponents="1" format="ascii"> - 100000 100043 100000 100023 100062 100039 100072 100046 100005 100002 100002 100000 - 100002 100000 100002 100000 100018 100016 100576 100544 100605 100575 100668 100637 - 100767 100736 100907 100875 101096 101062 101342 101305 101656 101615 102053 102006 - 102550 102495 103170 103102 103947 103857 104931 104807 106118 106066 110663 109552 - 200000 200000 100000 100013 100023 100028 100001 100000 100000 100000 100014 100511 - 100541 100602 100698 100833 101014 101249 101548 101924 102390 102962 103658 104500 - 105540 108679 200000 100000 100007 100013 100016 100001 100000 100000 100000 100013 - 100475 100504 100562 100654 100782 100954 101177 101459 101811 102244 102770 103395 - 104101 104767 106970 200000 100000 100002 100005 100007 100000 100000 100000 100000 - 100011 100437 100464 100519 100605 100725 100885 101091 101351 101673 102067 102542 - 103106 103752 104403 102560 200000 99997.2 99997.8 99999 99999.8 100000 100000 100000 - 100000 100010 100397 100422 100473 100552 100662 100808 100994 101229 101517 101867 - 102288 102792 103413 104313 107911 97964 99992.1 99992.3 99992.8 99993.2 99999.9 100000 - 100000 100000 100009 100357 100379 100425 100496 100595 100725 100891 101097 101349 - 101652 102011 102436 102949 103614 103562 103078 99985.9 99986 99986.3 99986.5 99999.7 - 100000 100000 100000 100008 100315 100335 100376 100439 100527 100641 100785 100962 - 101176 101429 101721 102051 102405 102687 102770 102752 99978.8 99978.8 99979 99979.1 - 99999.4 100000 100000 100000 100007 100273 100291 100327 100382 100458 100556 100679 - 100829 101006 101210 101439 101683 101916 102097 102193 102219 99970.5 99970.5 99970.7 - 99970.8 99999.1 100000 100000 100000 100005 100232 100248 100279 100326 100391 100474 - 100577 100701 100844 101007 101182 101360 101524 101652 101730 101755 99960.9 99961 - 99961.1 99961.3 99998.8 100000 100000 100000 100004 100192 100205 100232 100272 100327 - 100397 100482 100583 100698 100825 100958 101089 101208 101301 101360 101380 99949.9 - 99949.9 99950.1 99950.3 99998.4 100000 100000 100000 100003 100152 100164 100187 100221 - 100267 100325 100395 100477 100569 100668 100769 100868 100955 101024 101067 101082 - 99937 99937.1 99937.3 99937.6 99997.8 100000 100000 100000 100002 100114 100124 100144 - 100173 100213 100261 100319 100385 100459 100536 100615 100690 100755 100807 100840 - 100851 99922.2 99922.4 99922.8 99923 99997.2 99999.9 100000 100000 100001 100075 100085 - 100103 100130 100163 100205 100253 100308 100368 100430 100492 100551 100601 100641 - 100666 100675 99904.8 99905.5 99907.3 99906 99994.8 99997.8 99998.3 99998.6 99998.6 100036 - 100048 100066 100090 100120 100156 100198 100245 100295 100347 100399 100446 100488 - 100519 100540 100546 99884 99885.2 99889.4 99901.4 99909.4 99926 99941.2 99956.9 99975.2 - 99994 100012 100032 100055 100083 100116 100154 100196 100241 100287 100332 100374 - 100410 100437 100455 100460 99858.8 99860.3 99865.6 99874.2 99885.2 99898.7 99913.6 99929.3 - 99946.2 99963.9 99982 100002 100025 100052 100084 100121 100162 100205 100249 100292 - 100332 100366 100392 100408 100414 - </DataArray> - <DataArray type="Float32" Name="rho_l" 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.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.049 997.049 - 997.049 997.049 997.049 997.049 997.049 997.049 997.05 997.05 997.05 997.05 997.052 997.052 - 997.093 997.093 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.049 997.049 997.049 997.049 997.05 - 997.05 997.052 997.093 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.049 997.049 997.049 - 997.049 997.05 997.051 997.093 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.049 997.049 - 997.049 997.049 997.05 997.049 997.093 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.049 - 997.049 997.049 997.049 997.05 997.051 997.047 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.048 997.049 997.049 997.049 997.049 997.049 997.049 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.048 997.048 997.049 997.049 997.049 997.049 997.049 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.048 997.048 997.048 997.049 997.049 997.049 997.049 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.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.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.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.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.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.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.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.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.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.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.048 997.048 - </DataArray> - <DataArray type="Float32" Name="rho_g" NumberOfComponents="1" format="ascii"> - 1.12601 1.12649 1.12601 1.12627 1.12671 1.12645 1.12682 1.12653 1.12607 1.12604 1.12603 1.12601 - 1.12603 1.12601 1.12603 1.12602 1.12622 1.12619 1.1325 1.13214 1.13282 1.13248 1.13353 1.13319 - 1.13465 1.1343 1.13623 1.13586 1.13836 1.13797 1.14113 1.1407 1.14466 1.1442 1.14913 1.1486 - 1.15472 1.1541 1.16167 1.16091 1.17008 1.1691 1.17868 1.17753 1.1864 1.18581 1.23776 1.22521 - 1.45345 1.45345 1.12601 1.12616 1.12627 1.12633 1.12603 1.12601 1.12601 1.12602 1.12617 1.13176 - 1.1321 1.13279 1.13387 1.13539 1.13743 1.14008 1.14345 1.14767 1.15292 1.15935 1.16695 1.17452 - 1.17986 1.21534 1.45345 1.12601 1.12609 1.12616 1.12619 1.12602 1.12601 1.12601 1.12602 1.12616 - 1.13136 1.13169 1.13235 1.13338 1.13482 1.13676 1.13926 1.14244 1.1464 1.15128 1.15719 1.1641 - 1.17081 1.17113 1.19603 1.45345 1.12601 1.12604 1.12607 1.12609 1.12602 1.12601 1.12601 1.12601 - 1.12614 1.13093 1.13124 1.13186 1.13282 1.13418 1.13598 1.1383 1.14122 1.14485 1.14929 1.15464 - 1.16096 1.16802 1.17352 1.14619 1.45345 1.12598 1.12599 1.126 1.12601 1.12601 1.12601 1.12601 - 1.12601 1.12613 1.13049 1.13077 1.13134 1.13223 1.13347 1.13511 1.13721 1.13985 1.1431 1.14704 - 1.15177 1.15739 1.16362 1.1687 1.20666 1.09425 1.12592 1.12593 1.12593 1.12594 1.12601 1.12601 - 1.12601 1.12601 1.12611 1.13003 1.13028 1.1308 1.1316 1.13271 1.13418 1.13605 1.13837 1.1412 - 1.14461 1.14865 1.15343 1.15906 1.16538 1.16144 1.15857 1.12586 1.12586 1.12586 1.12586 1.12601 - 1.12601 1.12601 1.12601 1.1261 1.12956 1.12979 1.13025 1.13096 1.13194 1.13323 1.13485 1.13685 - 1.13926 1.1421 1.14539 1.14911 1.15308 1.15611 1.15658 1.15685 1.12577 1.12577 1.12578 1.12578 - 1.12601 1.12601 1.12601 1.12601 1.12609 1.12909 1.12929 1.1297 1.13032 1.13117 1.13228 1.13366 - 1.13534 1.13734 1.13964 1.14222 1.14496 1.14759 1.14961 1.15066 1.15099 1.12568 1.12568 1.12568 - 1.12568 1.126 1.12601 1.12601 1.12601 1.12607 1.12863 1.1288 1.12915 1.12969 1.13041 1.13135 - 1.13251 1.1339 1.13552 1.13735 1.13932 1.14133 1.14317 1.14461 1.14549 1.14578 1.12557 1.12557 - 1.12558 1.12558 1.126 1.12601 1.12601 1.12601 1.12606 1.12817 1.12832 1.12862 1.12908 1.12969 - 1.13048 1.13144 1.13257 1.13387 1.1353 1.1368 1.13828 1.13961 1.14066 1.14133 1.14155 1.12545 - 1.12545 1.12545 1.12545 1.12599 1.12601 1.12601 1.12601 1.12605 1.12773 1.12786 1.12812 1.1285 - 1.12902 1.12968 1.13047 1.13138 1.13242 1.13353 1.13468 1.13578 1.13677 1.13754 1.13803 1.1382 - 1.1253 1.12531 1.12531 1.12531 1.12599 1.12601 1.12601 1.12601 1.12603 1.12729 1.12741 1.12763 - 1.12797 1.12841 1.12895 1.1296 1.13035 1.13118 1.13205 1.13294 1.13378 1.13452 1.1351 1.13547 - 1.13559 1.12514 1.12514 1.12514 1.12515 1.12598 1.12601 1.12601 1.12601 1.12602 1.12686 1.12697 - 1.12718 1.12747 1.12785 1.12832 1.12886 1.12948 1.13015 1.13085 1.13155 1.13221 1.13279 1.13323 - 1.13351 1.13361 1.12494 1.12495 1.12497 1.12496 1.12596 1.12599 1.12599 1.126 1.126 1.12642 - 1.12655 1.12675 1.12703 1.12737 1.12777 1.12825 1.12877 1.12934 1.12992 1.1305 1.13104 1.1315 - 1.13186 1.13209 1.13217 1.12471 1.12472 1.12477 1.1249 1.12499 1.12518 1.12535 1.12553 1.12573 - 1.12595 1.12615 1.12637 1.12663 1.12695 1.12732 1.12775 1.12822 1.12873 1.12925 1.12976 1.13022 - 1.13063 1.13094 1.13113 1.1312 1.12442 1.12444 1.1245 1.1246 1.12472 1.12487 1.12504 1.12522 - 1.12541 1.12561 1.12581 1.12603 1.12629 1.1266 1.12696 1.12738 1.12783 1.12832 1.12882 1.1293 - 1.12975 1.13013 1.13042 1.13061 1.13067 - </DataArray> - <DataArray type="Float32" Name="lambda_l" 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.508666 0.291607 728.675 625.04 - 1123.58 1123.58 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0.218287 630.089 1123.58 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0.0625786 633.415 1123.58 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 530.696 1123.58 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0.622697 314.713 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 - </DataArray> - <DataArray type="Float32" Name="lambda_g" NumberOfComponents="1" format="ascii"> - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56721 56732 19944.4 25178.6 - 0 0 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56735.7 24923.6 0 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56743.6 24755.6 0 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 29943.5 0 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56715.3 40851.9 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 56746.7 - 56746.7 56746.7 56746.7 56746.7 56746.7 - </DataArray> - <DataArray type="Float32" Name="porosity" NumberOfComponents="1" format="ascii"> - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 0.3 - 0.3 0.3 0.3 0.3 0.3 - </DataArray> - <DataArray type="Float32" Name="x_l^H2O" NumberOfComponents="1" format="ascii"> - 0.315483 0.315617 0.315483 0.315555 0.315678 0.315604 0.31571 0.315627 0.315498 0.31549 0.315488 0.315483 - 0.315488 0.315483 0.315488 0.315483 0.31554 0.315532 0.317299 0.317199 0.31739 0.317295 0.317589 0.317493 - 0.317902 0.317803 0.318345 0.318242 0.318941 0.318832 0.319717 0.319598 0.320708 0.320578 0.321967 0.321818 - 0.323692 0.323496 0.32812 0.327589 0.357804 0.354514 0.553887 0.534525 0.999988 0.999988 0.999988 0.999988 - 1 1 0.315483 0.315524 0.315555 0.315571 0.315487 0.315483 0.315483 0.315483 0.315527 0.317093 - 0.317188 0.317382 0.317684 0.31811 0.318681 0.319423 0.320367 0.321555 0.323114 0.326417 0.346932 0.498548 - 0.999988 0.999988 1 0.315483 0.315505 0.315523 0.315532 0.315485 0.315483 0.315483 0.315483 0.315523 - 0.316981 0.317072 0.317257 0.317545 0.317951 0.318493 0.319195 0.320084 0.321196 0.322603 0.324997 0.337042 - 0.436752 0.999988 0.999988 1 0.315483 0.31549 0.315499 0.315504 0.315484 0.315483 0.315483 0.315483 - 0.315519 0.316861 0.316947 0.317121 0.317391 0.31777 0.318274 0.318924 0.319744 0.320761 0.322009 0.323611 - 0.326937 0.34629 0.491527 0.999988 1 0.315474 0.315476 0.315479 0.315482 0.315483 0.315483 0.315483 - 0.315483 0.315515 0.316736 0.316815 0.316976 0.317224 0.317571 0.318031 0.31862 0.319359 0.320269 0.321386 - 0.322995 0.329493 0.39073 0.78931 0.999988 0.999989 0.315458 0.315458 0.31546 0.315461 0.315482 0.315483 - 0.315483 0.315483 0.315511 0.316607 0.316679 0.316824 0.317048 0.31736 0.317771 0.318294 0.318945 0.319739 - 0.320695 0.321873 0.324091 0.337455 0.431224 0.693563 0.490148 0.315438 0.315439 0.315439 0.31544 0.315482 - 0.315483 0.315483 0.315483 0.315507 0.316476 0.316541 0.31667 0.316869 0.317144 0.317504 0.317959 0.318519 - 0.319193 0.31999 0.320917 0.322034 0.324289 0.336073 0.37348 0.335475 0.315416 0.315416 0.315416 0.315417 - 0.315481 0.315483 0.315483 0.315483 0.315503 0.316345 0.316402 0.316515 0.316688 0.316927 0.317237 0.317625 - 0.318096 0.318655 0.319301 0.320023 0.320796 0.321602 0.322904 0.326102 0.323195 0.31539 0.31539 0.31539 - 0.315391 0.31548 0.315483 0.315483 0.315483 0.3155 0.316215 0.316264 0.316362 0.316512 0.316716 0.316978 - 0.317303 0.317693 0.318147 0.318658 0.319211 0.319773 0.320292 0.32073 0.321125 0.321054 0.315359 0.31536 - 0.31536 0.315361 0.315479 0.315483 0.315483 0.315483 0.315496 0.316088 0.31613 0.316214 0.316341 0.316514 - 0.316734 0.317003 0.317321 0.317684 0.318084 0.318504 0.318919 0.319293 0.319588 0.319779 0.319837 0.315324 - 0.315325 0.315325 0.315326 0.315477 0.315483 0.315483 0.315483 0.315492 0.315963 0.316 0.316072 0.31618 - 0.316326 0.316509 0.31673 0.316988 0.317277 0.317589 0.31791 0.31822 0.318496 0.318712 0.31885 0.318897 - 0.315284 0.315284 0.315285 0.315286 0.315476 0.315483 0.315483 0.315483 0.315489 0.315841 0.315873 0.315936 - 0.31603 0.316153 0.316306 0.316489 0.316698 0.316929 0.317174 0.317422 0.317659 0.317866 0.318028 0.318131 - 0.318166 0.315237 0.315238 0.315239 0.31524 0.315474 0.315482 0.315483 0.315483 0.315485 0.315721 0.315751 - 0.315809 0.315891 0.315998 0.316128 0.316281 0.316454 0.316642 0.316839 0.317035 0.31722 0.31738 0.317505 - 0.317584 0.317611 0.315182 0.315184 0.31519 0.315186 0.315466 0.315476 0.315477 0.315478 0.315478 0.315596 - 0.315633 0.31569 0.315766 0.315861 0.315976 0.316108 0.316255 0.316414 0.316578 0.31674 0.316891 0.317021 - 0.317121 0.317185 0.317206 0.315117 0.315121 0.315134 0.315172 0.315197 0.315249 0.315297 0.315347 0.315405 - 0.315464 0.315522 0.315582 0.315656 0.315744 0.315849 0.315969 0.316102 0.316244 0.316389 0.316531 0.316662 - 0.316775 0.316862 0.316917 0.316935 0.315037 0.315042 0.315058 0.315086 0.31512 0.315163 0.31521 0.31526 - 0.315313 0.315369 0.315426 0.315488 0.315561 0.315647 0.315749 0.315865 0.315993 0.316129 0.316268 0.316403 - 0.316529 0.316636 0.316718 0.31677 0.316788 - </DataArray> - <DataArray type="Float32" Name="x_l^N2" NumberOfComponents="1" format="ascii"> - 1.14721e-05 1.1477e-05 1.14721e-05 1.14747e-05 1.14792e-05 1.14765e-05 1.14804e-05 1.14774e-05 1.14727e-05 1.14724e-05 1.14723e-05 1.14721e-05 - 1.14723e-05 1.14721e-05 1.14723e-05 1.14721e-05 1.14742e-05 1.14739e-05 1.15382e-05 1.15345e-05 1.15415e-05 1.1538e-05 1.15487e-05 1.15452e-05 - 1.15601e-05 1.15565e-05 1.15762e-05 1.15725e-05 1.15979e-05 1.15939e-05 1.16261e-05 1.16218e-05 1.16621e-05 1.16574e-05 1.17076e-05 1.17022e-05 - 1.17646e-05 1.17582e-05 1.18348e-05 1.18271e-05 1.1914e-05 1.19047e-05 1.19559e-05 1.19487e-05 1.19296e-05 1.19236e-05 1.24563e-05 1.23276e-05 - 0 0 1.14721e-05 1.14736e-05 1.14747e-05 1.14753e-05 1.14723e-05 1.14721e-05 1.14721e-05 1.14721e-05 1.14737e-05 1.15307e-05 - 1.15341e-05 1.15412e-05 1.15522e-05 1.15677e-05 1.15884e-05 1.16154e-05 1.16497e-05 1.16928e-05 1.17462e-05 1.18113e-05 1.18845e-05 1.19263e-05 - 1.18626e-05 1.22264e-05 0 1.14721e-05 1.14729e-05 1.14736e-05 1.14739e-05 1.14722e-05 1.14721e-05 1.14721e-05 1.14721e-05 1.14736e-05 - 1.15266e-05 1.15299e-05 1.15366e-05 1.15471e-05 1.15619e-05 1.15816e-05 1.16071e-05 1.16394e-05 1.16798e-05 1.17295e-05 1.17896e-05 1.18576e-05 - 1.19028e-05 1.17731e-05 1.20284e-05 0 1.14721e-05 1.14724e-05 1.14727e-05 1.14729e-05 1.14722e-05 1.14721e-05 1.14721e-05 1.14721e-05 - 1.14734e-05 1.15222e-05 1.15254e-05 1.15317e-05 1.15415e-05 1.15553e-05 1.15736e-05 1.15972e-05 1.16271e-05 1.1664e-05 1.17092e-05 1.17637e-05 - 1.18278e-05 1.18956e-05 1.19177e-05 1.15173e-05 0 1.14718e-05 1.14719e-05 1.1472e-05 1.14721e-05 1.14721e-05 1.14721e-05 1.14721e-05 - 1.14721e-05 1.14733e-05 1.15177e-05 1.15206e-05 1.15264e-05 1.15354e-05 1.1548e-05 1.15648e-05 1.15862e-05 1.16131e-05 1.16461e-05 1.16863e-05 - 1.17345e-05 1.17905e-05 1.18399e-05 1.17979e-05 1.21374e-05 1.09848e-05 1.14712e-05 1.14712e-05 1.14713e-05 1.14713e-05 1.14721e-05 1.14721e-05 - 1.14721e-05 1.14721e-05 1.14731e-05 1.1513e-05 1.15156e-05 1.15209e-05 1.1529e-05 1.15404e-05 1.15553e-05 1.15744e-05 1.1598e-05 1.16269e-05 - 1.16616e-05 1.17028e-05 1.17512e-05 1.18058e-05 1.18484e-05 1.1746e-05 1.17647e-05 1.14705e-05 1.14705e-05 1.14705e-05 1.14706e-05 1.14721e-05 - 1.14721e-05 1.14721e-05 1.14721e-05 1.1473e-05 1.15083e-05 1.15106e-05 1.15153e-05 1.15225e-05 1.15325e-05 1.15456e-05 1.15621e-05 1.15825e-05 - 1.1607e-05 1.1636e-05 1.16696e-05 1.17074e-05 1.17476e-05 1.17759e-05 1.17718e-05 1.17836e-05 1.14697e-05 1.14697e-05 1.14697e-05 1.14697e-05 - 1.1472e-05 1.14721e-05 1.14721e-05 1.14721e-05 1.14729e-05 1.15035e-05 1.15055e-05 1.15096e-05 1.1516e-05 1.15246e-05 1.15359e-05 1.155e-05 - 1.15672e-05 1.15875e-05 1.1611e-05 1.16372e-05 1.16652e-05 1.16919e-05 1.17124e-05 1.17223e-05 1.17264e-05 1.14687e-05 1.14687e-05 1.14687e-05 - 1.14688e-05 1.1472e-05 1.14721e-05 1.14721e-05 1.14721e-05 1.14727e-05 1.14987e-05 1.15005e-05 1.15041e-05 1.15095e-05 1.15169e-05 1.15265e-05 - 1.15383e-05 1.15525e-05 1.1569e-05 1.15876e-05 1.16077e-05 1.16281e-05 1.16469e-05 1.16616e-05 1.16705e-05 1.16735e-05 1.14676e-05 1.14676e-05 - 1.14676e-05 1.14677e-05 1.1472e-05 1.14721e-05 1.14721e-05 1.14721e-05 1.14726e-05 1.14941e-05 1.14956e-05 1.14987e-05 1.15033e-05 1.15096e-05 - 1.15176e-05 1.15274e-05 1.1539e-05 1.15522e-05 1.15667e-05 1.1582e-05 1.15971e-05 1.16107e-05 1.16214e-05 1.16281e-05 1.16304e-05 1.14664e-05 - 1.14664e-05 1.14664e-05 1.14664e-05 1.14719e-05 1.14721e-05 1.14721e-05 1.14721e-05 1.14725e-05 1.14896e-05 1.14909e-05 1.14935e-05 1.14975e-05 - 1.15028e-05 1.15094e-05 1.15175e-05 1.15268e-05 1.15373e-05 1.15487e-05 1.15604e-05 1.15716e-05 1.15817e-05 1.15895e-05 1.15946e-05 1.15963e-05 - 1.14649e-05 1.14649e-05 1.14649e-05 1.14649e-05 1.14719e-05 1.14721e-05 1.14721e-05 1.14721e-05 1.14723e-05 1.14851e-05 1.14863e-05 1.14886e-05 - 1.1492e-05 1.14965e-05 1.15021e-05 1.15087e-05 1.15163e-05 1.15247e-05 1.15336e-05 1.15426e-05 1.15512e-05 1.15588e-05 1.15647e-05 1.15684e-05 - 1.15697e-05 1.14632e-05 1.14632e-05 1.14633e-05 1.14633e-05 1.14718e-05 1.14721e-05 1.14721e-05 1.14721e-05 1.14722e-05 1.14808e-05 1.14819e-05 - 1.1484e-05 1.1487e-05 1.14909e-05 1.14956e-05 1.15011e-05 1.15074e-05 1.15143e-05 1.15214e-05 1.15286e-05 1.15353e-05 1.15411e-05 1.15456e-05 - 1.15485e-05 1.15495e-05 1.14612e-05 1.14613e-05 1.14615e-05 1.14613e-05 1.14715e-05 1.14719e-05 1.14719e-05 1.14719e-05 1.14719e-05 1.14763e-05 - 1.14776e-05 1.14797e-05 1.14824e-05 1.14859e-05 1.149e-05 1.14948e-05 1.15002e-05 1.1506e-05 1.1512e-05 1.15178e-05 1.15233e-05 1.1528e-05 - 1.15317e-05 1.1534e-05 1.15348e-05 1.14588e-05 1.14589e-05 1.14594e-05 1.14608e-05 1.14617e-05 1.14636e-05 1.14654e-05 1.14672e-05 1.14693e-05 - 1.14714e-05 1.14735e-05 1.14757e-05 1.14784e-05 1.14816e-05 1.14854e-05 1.14898e-05 1.14946e-05 1.14998e-05 1.15051e-05 1.15102e-05 1.1515e-05 - 1.15191e-05 1.15223e-05 1.15243e-05 1.15249e-05 1.14559e-05 1.14561e-05 1.14567e-05 1.14577e-05 1.14589e-05 1.14605e-05 1.14622e-05 1.1464e-05 - 1.14659e-05 1.1468e-05 1.147e-05 1.14723e-05 1.14749e-05 1.14781e-05 1.14818e-05 1.1486e-05 1.14907e-05 1.14956e-05 1.15007e-05 1.15056e-05 - 1.15101e-05 1.1514e-05 1.1517e-05 1.15189e-05 1.15196e-05 - </DataArray> - <DataArray type="Float32" Name="x_g^H2O" NumberOfComponents="1" format="ascii"> - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.0100002 0.0100002 - 0.0100051 0.0100044 0.010081 0.0100713 0.0109108 0.0108199 0.0167318 0.016166 0.0298697 0.0298843 0.0286429 0.0289332 - 0.0158487 0.0158487 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.0100001 0.0100029 0.0100489 0.0106088 0.0151223 - 0.0300333 0.0291657 0.0158487 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.0100001 0.0100013 0.010024 0.0103326 - 0.0132985 0.0302548 0.0296318 0.0158487 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.0100002 0.0100033 - 0.0100509 0.0105795 0.0149231 0.030906 0.0158487 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.0100004 - 0.0100091 0.0101604 0.0119764 0.0239847 0.0293735 0.0323559 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.0100001 0.0100015 0.0100286 0.0103901 0.0131919 0.021228 0.0150725 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.0100001 0.0100025 0.0100377 0.0103739 0.0115193 0.0103489 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.0100001 0.0100023 0.0100251 0.0101148 0.0100221 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.0100001 0.0100011 0.0100058 0.010001 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.0100002 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 0.01 - 0.01 0.01 0.01 0.01 0.01 - </DataArray> - <DataArray type="Float32" Name="x_g^N2" NumberOfComponents="1" format="ascii"> - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.989995 0.989996 0.989919 0.989929 0.989089 0.98918 0.983268 0.983834 0.97013 0.970116 0.971357 0.971067 - 0 0 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.989997 0.989951 0.989391 0.984878 - 0.969967 0.970834 0 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.989999 0.989976 0.989667 - 0.986701 0.969745 0.970368 0 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.989997 - 0.989949 0.98942 0.985077 0.969094 0 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.989991 0.98984 0.988024 0.976015 0.970627 0.967644 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.989999 0.989971 0.98961 0.986808 0.978772 0.984928 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.989998 0.989962 0.989626 0.988481 0.989651 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.989998 0.989975 0.989885 0.989978 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.989999 0.989994 0.989999 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 0.99 - 0.99 0.99 0.99 0.99 0.99 - </DataArray> - </PointData> - <Points> - <DataArray type="Float32" Name="Coordinates" NumberOfComponents="3" format="ascii"> - 0 0 0 2.5 0 0 0 2.5 0 2.5 2.5 0 - 5 0 0 5 2.5 0 7.5 0 0 7.5 2.5 0 - 10 0 0 10 2.5 0 12.5 0 0 12.5 2.5 0 - 15 0 0 15 2.5 0 17.5 0 0 17.5 2.5 0 - 20 0 0 20 2.5 0 22.5 0 0 22.5 2.5 0 - 25 0 0 25 2.5 0 27.5 0 0 27.5 2.5 0 - 30 0 0 30 2.5 0 32.5 0 0 32.5 2.5 0 - 35 0 0 35 2.5 0 37.5 0 0 37.5 2.5 0 - 40 0 0 40 2.5 0 42.5 0 0 42.5 2.5 0 - 45 0 0 45 2.5 0 47.5 0 0 47.5 2.5 0 - 50 0 0 50 2.5 0 52.5 0 0 52.5 2.5 0 - 55 0 0 55 2.5 0 57.5 0 0 57.5 2.5 0 - 60 0 0 60 2.5 0 0 5 0 2.5 5 0 - 5 5 0 7.5 5 0 10 5 0 12.5 5 0 - 15 5 0 17.5 5 0 20 5 0 22.5 5 0 - 25 5 0 27.5 5 0 30 5 0 32.5 5 0 - 35 5 0 37.5 5 0 40 5 0 42.5 5 0 - 45 5 0 47.5 5 0 50 5 0 52.5 5 0 - 55 5 0 57.5 5 0 60 5 0 0 7.5 0 - 2.5 7.5 0 5 7.5 0 7.5 7.5 0 10 7.5 0 - 12.5 7.5 0 15 7.5 0 17.5 7.5 0 20 7.5 0 - 22.5 7.5 0 25 7.5 0 27.5 7.5 0 30 7.5 0 - 32.5 7.5 0 35 7.5 0 37.5 7.5 0 40 7.5 0 - 42.5 7.5 0 45 7.5 0 47.5 7.5 0 50 7.5 0 - 52.5 7.5 0 55 7.5 0 57.5 7.5 0 60 7.5 0 - 0 10 0 2.5 10 0 5 10 0 7.5 10 0 - 10 10 0 12.5 10 0 15 10 0 17.5 10 0 - 20 10 0 22.5 10 0 25 10 0 27.5 10 0 - 30 10 0 32.5 10 0 35 10 0 37.5 10 0 - 40 10 0 42.5 10 0 45 10 0 47.5 10 0 - 50 10 0 52.5 10 0 55 10 0 57.5 10 0 - 60 10 0 0 12.5 0 2.5 12.5 0 5 12.5 0 - 7.5 12.5 0 10 12.5 0 12.5 12.5 0 15 12.5 0 - 17.5 12.5 0 20 12.5 0 22.5 12.5 0 25 12.5 0 - 27.5 12.5 0 30 12.5 0 32.5 12.5 0 35 12.5 0 - 37.5 12.5 0 40 12.5 0 42.5 12.5 0 45 12.5 0 - 47.5 12.5 0 50 12.5 0 52.5 12.5 0 55 12.5 0 - 57.5 12.5 0 60 12.5 0 0 15 0 2.5 15 0 - 5 15 0 7.5 15 0 10 15 0 12.5 15 0 - 15 15 0 17.5 15 0 20 15 0 22.5 15 0 - 25 15 0 27.5 15 0 30 15 0 32.5 15 0 - 35 15 0 37.5 15 0 40 15 0 42.5 15 0 - 45 15 0 47.5 15 0 50 15 0 52.5 15 0 - 55 15 0 57.5 15 0 60 15 0 0 17.5 0 - 2.5 17.5 0 5 17.5 0 7.5 17.5 0 10 17.5 0 - 12.5 17.5 0 15 17.5 0 17.5 17.5 0 20 17.5 0 - 22.5 17.5 0 25 17.5 0 27.5 17.5 0 30 17.5 0 - 32.5 17.5 0 35 17.5 0 37.5 17.5 0 40 17.5 0 - 42.5 17.5 0 45 17.5 0 47.5 17.5 0 50 17.5 0 - 52.5 17.5 0 55 17.5 0 57.5 17.5 0 60 17.5 0 - 0 20 0 2.5 20 0 5 20 0 7.5 20 0 - 10 20 0 12.5 20 0 15 20 0 17.5 20 0 - 20 20 0 22.5 20 0 25 20 0 27.5 20 0 - 30 20 0 32.5 20 0 35 20 0 37.5 20 0 - 40 20 0 42.5 20 0 45 20 0 47.5 20 0 - 50 20 0 52.5 20 0 55 20 0 57.5 20 0 - 60 20 0 0 22.5 0 2.5 22.5 0 5 22.5 0 - 7.5 22.5 0 10 22.5 0 12.5 22.5 0 15 22.5 0 - 17.5 22.5 0 20 22.5 0 22.5 22.5 0 25 22.5 0 - 27.5 22.5 0 30 22.5 0 32.5 22.5 0 35 22.5 0 - 37.5 22.5 0 40 22.5 0 42.5 22.5 0 45 22.5 0 - 47.5 22.5 0 50 22.5 0 52.5 22.5 0 55 22.5 0 - 57.5 22.5 0 60 22.5 0 0 25 0 2.5 25 0 - 5 25 0 7.5 25 0 10 25 0 12.5 25 0 - 15 25 0 17.5 25 0 20 25 0 22.5 25 0 - 25 25 0 27.5 25 0 30 25 0 32.5 25 0 - 35 25 0 37.5 25 0 40 25 0 42.5 25 0 - 45 25 0 47.5 25 0 50 25 0 52.5 25 0 - 55 25 0 57.5 25 0 60 25 0 0 27.5 0 - 2.5 27.5 0 5 27.5 0 7.5 27.5 0 10 27.5 0 - 12.5 27.5 0 15 27.5 0 17.5 27.5 0 20 27.5 0 - 22.5 27.5 0 25 27.5 0 27.5 27.5 0 30 27.5 0 - 32.5 27.5 0 35 27.5 0 37.5 27.5 0 40 27.5 0 - 42.5 27.5 0 45 27.5 0 47.5 27.5 0 50 27.5 0 - 52.5 27.5 0 55 27.5 0 57.5 27.5 0 60 27.5 0 - 0 30 0 2.5 30 0 5 30 0 7.5 30 0 - 10 30 0 12.5 30 0 15 30 0 17.5 30 0 - 20 30 0 22.5 30 0 25 30 0 27.5 30 0 - 30 30 0 32.5 30 0 35 30 0 37.5 30 0 - 40 30 0 42.5 30 0 45 30 0 47.5 30 0 - 50 30 0 52.5 30 0 55 30 0 57.5 30 0 - 60 30 0 0 32.5 0 2.5 32.5 0 5 32.5 0 - 7.5 32.5 0 10 32.5 0 12.5 32.5 0 15 32.5 0 - 17.5 32.5 0 20 32.5 0 22.5 32.5 0 25 32.5 0 - 27.5 32.5 0 30 32.5 0 32.5 32.5 0 35 32.5 0 - 37.5 32.5 0 40 32.5 0 42.5 32.5 0 45 32.5 0 - 47.5 32.5 0 50 32.5 0 52.5 32.5 0 55 32.5 0 - 57.5 32.5 0 60 32.5 0 0 35 0 2.5 35 0 - 5 35 0 7.5 35 0 10 35 0 12.5 35 0 - 15 35 0 17.5 35 0 20 35 0 22.5 35 0 - 25 35 0 27.5 35 0 30 35 0 32.5 35 0 - 35 35 0 37.5 35 0 40 35 0 42.5 35 0 - 45 35 0 47.5 35 0 50 35 0 52.5 35 0 - 55 35 0 57.5 35 0 60 35 0 0 37.5 0 - 2.5 37.5 0 5 37.5 0 7.5 37.5 0 10 37.5 0 - 12.5 37.5 0 15 37.5 0 17.5 37.5 0 20 37.5 0 - 22.5 37.5 0 25 37.5 0 27.5 37.5 0 30 37.5 0 - 32.5 37.5 0 35 37.5 0 37.5 37.5 0 40 37.5 0 - 42.5 37.5 0 45 37.5 0 47.5 37.5 0 50 37.5 0 - 52.5 37.5 0 55 37.5 0 57.5 37.5 0 60 37.5 0 - 0 40 0 2.5 40 0 5 40 0 7.5 40 0 - 10 40 0 12.5 40 0 15 40 0 17.5 40 0 - 20 40 0 22.5 40 0 25 40 0 27.5 40 0 - 30 40 0 32.5 40 0 35 40 0 37.5 40 0 - 40 40 0 42.5 40 0 45 40 0 47.5 40 0 - 50 40 0 52.5 40 0 55 40 0 57.5 40 0 - 60 40 0 - </DataArray> - </Points> - <Cells> - <DataArray type="Int32" Name="connectivity" NumberOfComponents="1" format="ascii"> - 0 1 3 2 1 4 5 3 4 6 7 5 - 6 8 9 7 8 10 11 9 10 12 13 11 - 12 14 15 13 14 16 17 15 16 18 19 17 - 18 20 21 19 20 22 23 21 22 24 25 23 - 24 26 27 25 26 28 29 27 28 30 31 29 - 30 32 33 31 32 34 35 33 34 36 37 35 - 36 38 39 37 38 40 41 39 40 42 43 41 - 42 44 45 43 44 46 47 45 46 48 49 47 - 2 3 51 50 3 5 52 51 5 7 53 52 - 7 9 54 53 9 11 55 54 11 13 56 55 - 13 15 57 56 15 17 58 57 17 19 59 58 - 19 21 60 59 21 23 61 60 23 25 62 61 - 25 27 63 62 27 29 64 63 29 31 65 64 - 31 33 66 65 33 35 67 66 35 37 68 67 - 37 39 69 68 39 41 70 69 41 43 71 70 - 43 45 72 71 45 47 73 72 47 49 74 73 - 50 51 76 75 51 52 77 76 52 53 78 77 - 53 54 79 78 54 55 80 79 55 56 81 80 - 56 57 82 81 57 58 83 82 58 59 84 83 - 59 60 85 84 60 61 86 85 61 62 87 86 - 62 63 88 87 63 64 89 88 64 65 90 89 - 65 66 91 90 66 67 92 91 67 68 93 92 - 68 69 94 93 69 70 95 94 70 71 96 95 - 71 72 97 96 72 73 98 97 73 74 99 98 - 75 76 101 100 76 77 102 101 77 78 103 102 - 78 79 104 103 79 80 105 104 80 81 106 105 - 81 82 107 106 82 83 108 107 83 84 109 108 - 84 85 110 109 85 86 111 110 86 87 112 111 - 87 88 113 112 88 89 114 113 89 90 115 114 - 90 91 116 115 91 92 117 116 92 93 118 117 - 93 94 119 118 94 95 120 119 95 96 121 120 - 96 97 122 121 97 98 123 122 98 99 124 123 - 100 101 126 125 101 102 127 126 102 103 128 127 - 103 104 129 128 104 105 130 129 105 106 131 130 - 106 107 132 131 107 108 133 132 108 109 134 133 - 109 110 135 134 110 111 136 135 111 112 137 136 - 112 113 138 137 113 114 139 138 114 115 140 139 - 115 116 141 140 116 117 142 141 117 118 143 142 - 118 119 144 143 119 120 145 144 120 121 146 145 - 121 122 147 146 122 123 148 147 123 124 149 148 - 125 126 151 150 126 127 152 151 127 128 153 152 - 128 129 154 153 129 130 155 154 130 131 156 155 - 131 132 157 156 132 133 158 157 133 134 159 158 - 134 135 160 159 135 136 161 160 136 137 162 161 - 137 138 163 162 138 139 164 163 139 140 165 164 - 140 141 166 165 141 142 167 166 142 143 168 167 - 143 144 169 168 144 145 170 169 145 146 171 170 - 146 147 172 171 147 148 173 172 148 149 174 173 - 150 151 176 175 151 152 177 176 152 153 178 177 - 153 154 179 178 154 155 180 179 155 156 181 180 - 156 157 182 181 157 158 183 182 158 159 184 183 - 159 160 185 184 160 161 186 185 161 162 187 186 - 162 163 188 187 163 164 189 188 164 165 190 189 - 165 166 191 190 166 167 192 191 167 168 193 192 - 168 169 194 193 169 170 195 194 170 171 196 195 - 171 172 197 196 172 173 198 197 173 174 199 198 - 175 176 201 200 176 177 202 201 177 178 203 202 - 178 179 204 203 179 180 205 204 180 181 206 205 - 181 182 207 206 182 183 208 207 183 184 209 208 - 184 185 210 209 185 186 211 210 186 187 212 211 - 187 188 213 212 188 189 214 213 189 190 215 214 - 190 191 216 215 191 192 217 216 192 193 218 217 - 193 194 219 218 194 195 220 219 195 196 221 220 - 196 197 222 221 197 198 223 222 198 199 224 223 - 200 201 226 225 201 202 227 226 202 203 228 227 - 203 204 229 228 204 205 230 229 205 206 231 230 - 206 207 232 231 207 208 233 232 208 209 234 233 - 209 210 235 234 210 211 236 235 211 212 237 236 - 212 213 238 237 213 214 239 238 214 215 240 239 - 215 216 241 240 216 217 242 241 217 218 243 242 - 218 219 244 243 219 220 245 244 220 221 246 245 - 221 222 247 246 222 223 248 247 223 224 249 248 - 225 226 251 250 226 227 252 251 227 228 253 252 - 228 229 254 253 229 230 255 254 230 231 256 255 - 231 232 257 256 232 233 258 257 233 234 259 258 - 234 235 260 259 235 236 261 260 236 237 262 261 - 237 238 263 262 238 239 264 263 239 240 265 264 - 240 241 266 265 241 242 267 266 242 243 268 267 - 243 244 269 268 244 245 270 269 245 246 271 270 - 246 247 272 271 247 248 273 272 248 249 274 273 - 250 251 276 275 251 252 277 276 252 253 278 277 - 253 254 279 278 254 255 280 279 255 256 281 280 - 256 257 282 281 257 258 283 282 258 259 284 283 - 259 260 285 284 260 261 286 285 261 262 287 286 - 262 263 288 287 263 264 289 288 264 265 290 289 - 265 266 291 290 266 267 292 291 267 268 293 292 - 268 269 294 293 269 270 295 294 270 271 296 295 - 271 272 297 296 272 273 298 297 273 274 299 298 - 275 276 301 300 276 277 302 301 277 278 303 302 - 278 279 304 303 279 280 305 304 280 281 306 305 - 281 282 307 306 282 283 308 307 283 284 309 308 - 284 285 310 309 285 286 311 310 286 287 312 311 - 287 288 313 312 288 289 314 313 289 290 315 314 - 290 291 316 315 291 292 317 316 292 293 318 317 - 293 294 319 318 294 295 320 319 295 296 321 320 - 296 297 322 321 297 298 323 322 298 299 324 323 - 300 301 326 325 301 302 327 326 302 303 328 327 - 303 304 329 328 304 305 330 329 305 306 331 330 - 306 307 332 331 307 308 333 332 308 309 334 333 - 309 310 335 334 310 311 336 335 311 312 337 336 - 312 313 338 337 313 314 339 338 314 315 340 339 - 315 316 341 340 316 317 342 341 317 318 343 342 - 318 319 344 343 319 320 345 344 320 321 346 345 - 321 322 347 346 322 323 348 347 323 324 349 348 - 325 326 351 350 326 327 352 351 327 328 353 352 - 328 329 354 353 329 330 355 354 330 331 356 355 - 331 332 357 356 332 333 358 357 333 334 359 358 - 334 335 360 359 335 336 361 360 336 337 362 361 - 337 338 363 362 338 339 364 363 339 340 365 364 - 340 341 366 365 341 342 367 366 342 343 368 367 - 343 344 369 368 344 345 370 369 345 346 371 370 - 346 347 372 371 347 348 373 372 348 349 374 373 - 350 351 376 375 351 352 377 376 352 353 378 377 - 353 354 379 378 354 355 380 379 355 356 381 380 - 356 357 382 381 357 358 383 382 358 359 384 383 - 359 360 385 384 360 361 386 385 361 362 387 386 - 362 363 388 387 363 364 389 388 364 365 390 389 - 365 366 391 390 366 367 392 391 367 368 393 392 - 368 369 394 393 369 370 395 394 370 371 396 395 - 371 372 397 396 372 373 398 397 373 374 399 398 - 375 376 401 400 376 377 402 401 377 378 403 402 - 378 379 404 403 379 380 405 404 380 381 406 405 - 381 382 407 406 382 383 408 407 383 384 409 408 - 384 385 410 409 385 386 411 410 386 387 412 411 - 387 388 413 412 388 389 414 413 389 390 415 414 - 390 391 416 415 391 392 417 416 392 393 418 417 - 393 394 419 418 394 395 420 419 395 396 421 420 - 396 397 422 421 397 398 423 422 398 399 424 423 - </DataArray> - <DataArray type="Int32" Name="offsets" NumberOfComponents="1" format="ascii"> - 4 8 12 16 20 24 28 32 36 40 44 48 - 52 56 60 64 68 72 76 80 84 88 92 96 - 100 104 108 112 116 120 124 128 132 136 140 144 - 148 152 156 160 164 168 172 176 180 184 188 192 - 196 200 204 208 212 216 220 224 228 232 236 240 - 244 248 252 256 260 264 268 272 276 280 284 288 - 292 296 300 304 308 312 316 320 324 328 332 336 - 340 344 348 352 356 360 364 368 372 376 380 384 - 388 392 396 400 404 408 412 416 420 424 428 432 - 436 440 444 448 452 456 460 464 468 472 476 480 - 484 488 492 496 500 504 508 512 516 520 524 528 - 532 536 540 544 548 552 556 560 564 568 572 576 - 580 584 588 592 596 600 604 608 612 616 620 624 - 628 632 636 640 644 648 652 656 660 664 668 672 - 676 680 684 688 692 696 700 704 708 712 716 720 - 724 728 732 736 740 744 748 752 756 760 764 768 - 772 776 780 784 788 792 796 800 804 808 812 816 - 820 824 828 832 836 840 844 848 852 856 860 864 - 868 872 876 880 884 888 892 896 900 904 908 912 - 916 920 924 928 932 936 940 944 948 952 956 960 - 964 968 972 976 980 984 988 992 996 1000 1004 1008 - 1012 1016 1020 1024 1028 1032 1036 1040 1044 1048 1052 1056 - 1060 1064 1068 1072 1076 1080 1084 1088 1092 1096 1100 1104 - 1108 1112 1116 1120 1124 1128 1132 1136 1140 1144 1148 1152 - 1156 1160 1164 1168 1172 1176 1180 1184 1188 1192 1196 1200 - 1204 1208 1212 1216 1220 1224 1228 1232 1236 1240 1244 1248 - 1252 1256 1260 1264 1268 1272 1276 1280 1284 1288 1292 1296 - 1300 1304 1308 1312 1316 1320 1324 1328 1332 1336 1340 1344 - 1348 1352 1356 1360 1364 1368 1372 1376 1380 1384 1388 1392 - 1396 1400 1404 1408 1412 1416 1420 1424 1428 1432 1436 1440 - 1444 1448 1452 1456 1460 1464 1468 1472 1476 1480 1484 1488 - 1492 1496 1500 1504 1508 1512 1516 1520 1524 1528 1532 1536 - </DataArray> - <DataArray type="UInt8" Name="types" NumberOfComponents="1" format="ascii"> - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - 9 9 9 9 9 9 9 9 9 9 9 9 - </DataArray> - </Cells> - </Piece> - </UnstructuredGrid> -</VTKFile> diff --git a/test/boxmodels/mpnc/obstacleproblem.hh b/test/boxmodels/mpnc/obstacleproblem.hh index 4abe598663..53edb504f6 100644 --- a/test/boxmodels/mpnc/obstacleproblem.hh +++ b/test/boxmodels/mpnc/obstacleproblem.hh @@ -101,6 +101,9 @@ SET_BOOL_PROP(ObstacleProblem, EnablePartialReassemble, true); // use forward diffferences to approximate the partial derivatives SET_INT_PROP(ObstacleProblem, NumericDifferenceMethod, +1); + +// decide which type to use for floating values (double / quad) +SET_TYPE_PROP(ObstacleProblem, Scalar, double); } @@ -151,8 +154,8 @@ class ObstacleProblem enum {numComponents = GET_PROP_VALUE(TypeTag, NumComponents)}; enum {nPhaseIdx = FluidSystem::nPhaseIdx}; enum {wPhaseIdx = FluidSystem::wPhaseIdx}; - enum {H2OIdx = FluidSystem::H2OIdx}; - enum {N2Idx = FluidSystem::N2Idx}; + enum {wCompIdx = FluidSystem::wCompIdx}; + enum {nCompIdx = FluidSystem::nCompIdx}; enum {fug0Idx = Indices::fug0Idx}; enum {S0Idx = Indices::S0Idx}; enum {p0Idx = Indices::p0Idx}; @@ -290,7 +293,7 @@ public: const Intersection &is, const unsigned int scvIdx, const unsigned int boundaryFaceIdx) const - { values = 0; } + { values = 0.; } // \} @@ -368,8 +371,8 @@ private: fs.setPressure(wPhaseIdx, 2e5); // set the liquid composition to pure water - fs.setMoleFraction(wPhaseIdx, N2Idx, 0.0); - fs.setMoleFraction(wPhaseIdx, H2OIdx, 1.0); + fs.setMoleFraction(wPhaseIdx, nCompIdx, 0.0); + fs.setMoleFraction(wPhaseIdx, wCompIdx, 1.0); } else { // elsewhere, only gas @@ -383,8 +386,8 @@ private: fs.setPressure(nPhaseIdx, 1e5); // set the gas composition to 99% nitrogen and 1% steam - fs.setMoleFraction(nPhaseIdx, N2Idx, 0.99); - fs.setMoleFraction(nPhaseIdx, H2OIdx, 0.01); + fs.setMoleFraction(nPhaseIdx, nCompIdx, 0.99); + fs.setMoleFraction(nPhaseIdx, wCompIdx, 0.01); } // set the other saturation @@ -431,14 +434,14 @@ private: Scalar x = globalPos[0]; Scalar y = globalPos[1]; return x >= 60 - eps_ && y <= 10; - }; + } bool onOutlet_(const GlobalPosition &globalPos) const { Scalar x = globalPos[0]; Scalar y = globalPos[1]; return x < eps_ && y <= 10; - }; + } Scalar temperature_; Scalar eps_; diff --git a/test/boxmodels/mpnc/test_mpnc.input b/test/boxmodels/mpnc/test_mpnc.input index 46ec21058d..3d01030cb1 100644 --- a/test/boxmodels/mpnc/test_mpnc.input +++ b/test/boxmodels/mpnc/test_mpnc.input @@ -12,6 +12,9 @@ dtInitial = 250 # seconds tEnd = 1e4 # seconds gridFile = ./grids/obstacle_24x16.dgf +[ LinearSolver ] +ResidualReduction = 1e-12 + #################################################################### # Simulation restart # @@ -21,4 +24,5 @@ gridFile = ./grids/obstacle_24x16.dgf # name_time = 27184.1_rank = 0.drs # Please comment in the below value, if restart is desired. #################################################################### +# [] # restart = ... \ No newline at end of file -- GitLab