diff --git a/dumux/material/binarycoefficients/CMakeLists.txt b/dumux/material/binarycoefficients/CMakeLists.txt index b0dfe4b88f43b0feaaad2e233282e04bb77f9700..d18463edee2790acd1ed6e63666ce71143a28584 100644 --- a/dumux/material/binarycoefficients/CMakeLists.txt +++ b/dumux/material/binarycoefficients/CMakeLists.txt @@ -1,7 +1,6 @@ install(FILES air_mesitylene.hh air_xylene.hh -brine_air.hh brine_co2.hh fullermethod.hh h2o_air.hh diff --git a/dumux/material/binarycoefficients/brine_air.hh b/dumux/material/binarycoefficients/brine_air.hh deleted file mode 100644 index 6e8632db1b539ab010bb7c984ab7c99f2a3221f7..0000000000000000000000000000000000000000 --- a/dumux/material/binarycoefficients/brine_air.hh +++ /dev/null @@ -1,636 +0,0 @@ -// -*- 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 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU 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 Binarycoefficients - * \brief Binary coefficients for Brine and Air. - */ -#ifndef DUMUX_BINARY_COEFF_BRINE_Air_HH -#define DUMUX_BINARY_COEFF_BRINE_Air_HH - -#include <dumux/material/components/brine.hh> -#include <dumux/material/components/h2o.hh> -#include <dumux/material/components/air.hh> -#include <dumux/material/idealgas.hh> - -namespace Dumux { -namespace BinaryCoeff { -/*! - * \ingroup Binarycoefficients - * \brief Binary coefficients for Brine and Air. - */ -template<class Scalar, class Air, bool verbose = true> -class Brine_Air { - using H2O = Dumux::Components::H2O<Scalar>; - // using Air = Dumux::Components::Air<Scalar>; - using Brine = Dumux::Components::Brine<Scalar,H2O>; - using IdealGas = Dumux::IdealGas<Scalar>; - static const int wPhaseIdx = 0; // index of the liquid phase - static const int nPhaseIdx = 1; // index of the gas phase - -public: - /*! - * \brief Binary diffusion coefficient \f$\mathrm{[m^2/s]}\f$ of water in the Air phase. - * - * According to B. Xu et al. (2003) \cite xu2003 <BR> - * \param temperature the temperature \f$\mathrm{[K]}\f$ - * \param pressure the phase pressure \f$\mathrm{[Pa]}\f$ - */ - static Scalar gasDiffCoeff(Scalar temperature, Scalar pressure) { - //Diffusion coefficient of water in the Air phase - const Scalar Theta=1.8; - const Scalar Daw=2.13e-5; /* reference value */ - const Scalar pg0=1.e5; /* reference pressure */ - const Scalar T0=273.15; /* reference temperature */ - Scalar Dgaw; - Dgaw=Daw*(pg0/pressure)*pow((temperature/T0),Theta); - return Dgaw; - } - ; - - /*! - * Lacking better data on water-air diffusion in liquids, we use at the - * moment the diffusion coefficient of the air's main component nitrogen!! - * \brief Diffusion coefficient \f$\mathrm{[m^2/s]}\f$ for molecular nitrogen in liquid water. - * - * The empirical equations for estimating the diffusion coefficient in - * infinite solution which are presented in Reid, 1987 all show a - * linear dependency on temperature. We thus simply scale the - * experimentally obtained diffusion coefficient of Ferrell and - * Himmelblau by the temperature. - * \param temperature The temperature \f$\mathrm{[K]}\f$ - * \param pressure The pressure \f$\mathrm{[Pa]}\f$ - * - * See: - * - * R. Reid et al. (1987, pp. 599) \cite reid1987 <BR> - * - * R. Ferrell, D. Himmelblau (1967, pp. 111-115) \cite ferrell1967 - */ - static Scalar liquidDiffCoeff(Scalar temperature, Scalar pressure) { - //Diffusion coefficient of Air in the H2O phase - const Scalar Texp = 273.15 + 25; // [K] - const Scalar Dexp = 2.01e-9; // [m^2/s] - return Dexp * temperature/Texp; - }; - - /*! - * \brief Returns the _mol_ (!) fraction of Air in the liquid - * phase and the mol_ (!) fraction of H2O in the gas phase - * for a given temperature, pressure, Air density and brine - * XwNaCl. - * - * Implemented according to Spycher and Pruess (2005) \cite spycher2005 <BR> - * applying the activity coefficient expression of Duan and Sun (2003) \cite duan2003 <BR> - * and the correlations for pure water given in Spycher, Pruess and Ennis-King (2003) \cite spycher2003 <BR> - * - * \param temperature the temperature \f$\mathrm{[K]}\f$ - * \param pg the gas phase pressure \f$\mathrm{[Pa]}\f$ - * \param XwNaCl the XwNaCl \f$\mathrm{[kg NaCl / kg solution]}\f$ - * \param knownPhaseIdx indicates which phases are present - * \param xwAir mole fraction of Air in brine \f$\mathrm{[mol/mol]}\f$ - * \param xnH2O mole fraction of water in the gas phase \f$\mathrm{[mol/mol]}\f$ - * \param xwNaCl the xwNaCl - */ - static void calculateMoleFractions(const Scalar temperature, - const Scalar pg, - const Scalar XwNaCl, - const int knownPhaseIdx, - Scalar &xwAir, - Scalar &xnH2O, - Scalar &xwNaCl) { - DUNE_THROW(Dune::InvalidStateException, "Function: " << "calculateMoleFractions" << " is invalid."); -// Scalar A = computeA_(temperature, pg); -// -// /* XwNaCl: conversion from mass fraction to mol fraction */ -// xwNaCl = massTomoleFrac_(XwNaCl); -// -// // if both phases are present the mole fractions in each phase can be calculate -// // with the mutual solubility function -// if (knownPhaseIdx < 0) { -// Scalar molalityNaCl = molFracToMolality_(xwNaCl); // molality of NaCl //CHANGED -// Scalar m0_Air = molalityAirinPureWater_(temperature, pg); // molality of Air in pure water -// Scalar gammaStar = activityCoefficient_(temperature, pg, molalityNaCl);// activity coefficient of Air in brine -// Scalar m_Air = m0_Air / gammaStar; // molality of Air in brine -// xwAir = m_Air / (molalityNaCl + 55.508 + m_Air); // mole fraction of Air in brine -// xnH2O = A * (1 - xwAir - xwNaCl); // mole fraction of water in the gas phase -// } -// -// // if only liquid phase is present the mole fraction of Air in brine is given and -// // and the virtual equilibrium mole fraction of water in the non-existing gas phase can be estimated -// // with the mutual solubility function -// if (knownPhaseIdx == wPhaseIdx) { -//// xnH2O = A * (1 - xwAir - xwNaCl); -// DUNE_THROW(Dune::InvalidStateException, "phase index: " << "wPhaseIdx" << " is invalid."); -// -// } -// -// // if only gas phase is present the mole fraction of water in the gas phase is given and -// // and the virtual equilibrium mole fraction of Air in the non-existing liquid phase can be estimated -// // with the mutual solubility function -// if (knownPhaseIdx == nPhaseIdx) { -// //y_H2o = fluidstate. -//// xwAir = 1 - xwNaCl - xnH2O / A; -// DUNE_THROW(Dune::InvalidStateException, "phase index: " << "nPhaseIdx" << " is invalid."); -// } - } - - /*! - * \brief Returns the fugacity coefficient \f$\mathrm{[-]}\f$ of the Air component in a water-Air mixture - * (given in Spycher, Pruess and Ennis-King (2003) \cite spycher2003 ) - * - * \param T the temperature \f$\mathrm{[K]}\f$ - * \param pg the gas phase pressure \f$\mathrm{[Pa]}\f$ - */ - static Scalar fugacityCoefficientAir(Scalar T, Scalar pg) { - - Scalar V = 1 / (Air::gasDensity(T, pg) / Air::molarMass()) * 1.e6; // molar volume in cm^3/mol - Scalar pg_bar = pg / 1.e5; // gas phase pressure in bar - Scalar a_Air = (7.54e7 - 4.13e4 * T); // mixture parameter of Redlich-Kwong equation - static const Scalar b_Air = 27.8; // mixture parameter of Redlich-Kwong equation - static const Scalar R = IdealGas::R * 10.; // ideal gas constant with unit bar cm^3 /(K mol) - Scalar lnPhiAir, phiAir; - - using std::log; - using std::pow; - using std::exp; - lnPhiAir = log(V / (V - b_Air)) + b_Air / (V - b_Air) - 2 * a_Air / (R - * pow(T, 1.5) * b_Air) * log((V + b_Air) / V) + a_Air * b_Air - / (R * pow(T, 1.5) * b_Air * b_Air) * (log((V + b_Air) / V) - - b_Air / (V + b_Air)) - log(pg_bar * V / (R * T)); - - phiAir = exp(lnPhiAir); // fugacity coefficient of Air - return phiAir; - - } - - /*! - * \brief Returns the fugacity coefficient \f$\mathrm{[-]}\f$ of the H2O component in a water-Air mixture - * (given in Spycher, Pruess and Ennis-King (2003) \cite spycher2003 ) - * - * \param T the temperature \f$\mathrm{[K]}\f$ - * \param pg the gas phase pressure \f$\mathrm{[Pa]}\f$ - */ - static Scalar fugacityCoefficientH2O(Scalar T, Scalar pg) { - - Scalar V = 1 / (Air::gasDensity(T, pg) / Air::molarMass()) * 1.e6; // molar volume in cm^3/mol - Scalar pg_bar = pg / 1.e5; // gas phase pressure in bar - Scalar a_Air = (7.54e7 - 4.13e4 * T);// mixture parameter of Redlich-Kwong equation - static const Scalar a_Air_H2O = 7.89e7;// mixture parameter of Redlich-Kwong equation - static const Scalar b_Air = 27.8;// mixture parameter of Redlich-Kwong equation - static const Scalar b_H2O = 18.18;// mixture parameter of Redlich-Kwong equation - static const Scalar R = IdealGas::R * 10.; // ideal gas constant with unit bar cm^3 /(K mol) - Scalar lnPhiH2O, phiH2O; - - using std::log; - using std::pow; - using std::exp; - lnPhiH2O = log(V / (V - b_Air)) + b_H2O / (V - b_Air) - 2 * a_Air_H2O - / (R * pow(T, 1.5) * b_Air) * log((V + b_Air) / V) + a_Air - * b_H2O / (R * pow(T, 1.5) * b_Air * b_Air) * (log((V + b_Air) - / V) - b_Air / (V + b_Air)) - log(pg_bar * V / (R * T)); - phiH2O = exp(lnPhiH2O); // fugacity coefficient of H2O - return phiH2O; - } - - /*! - * \brief Returns the molality of NaCl \f$\mathrm{(mol NaCl / kg water)}\f$ for a given mole fraction \f$\mathrm{(mol NaCl / mol solution)}\f$ - * - * \param XwNaCl mole fraction of NaCL in brine \f$\mathrm{[mol/mol]}\f$ - */ - static Scalar molalityNaCl(Scalar XwNaCl) { - - // conversion from mol fraction to molality - const Scalar mol_NaCl = XwNaCl / 58.4428e-3; - - return mol_NaCl; - } - -private: - /*! - * \brief Returns the molality of NaCl \f$\mathrm{(mol NaCl / kg water)}\f$ for a given mole fraction - * - * \param XwNaCl the XwNaCl \f$\mathrm{[kg NaCl / kg solution]}\f$ - */ - static Scalar massTomoleFrac_(Scalar XwNaCl) { - - DUNE_THROW(Dune::InvalidStateException, "Function: " << "massTomoleFrac_" << " is invalid."); - -// const Scalar Mw = H2O::molarMass(); /* molecular weight of water [kg/mol] */ -// const Scalar Ms = 58.8e-3; /* molecular weight of NaCl [kg/mol] */ -// -// const Scalar X_NaCl = XwNaCl; -// /* XwNaCl: conversion from mass fraction to mol fraction */ -// const Scalar xwNaCl = -Mw * X_NaCl / ((Ms - Mw) * X_NaCl - Ms); -// return xwNaCl; - } - - /*! - * \brief Returns the equilibrium molality of Air \f$\mathrm{(mol Air / kg water)}\f$ for a - * Air-water mixture at a given pressure and temperature - * - * \param T the temperature \f$\mathrm{[K]}\f$ - * \param pg the gas phase pressure \f$\mathrm{[Pa]}\f$ - */ - static Scalar molalityAirinPureWater_(Scalar temperature, Scalar pg) { - Scalar A = computeA_(temperature, pg); // according to Spycher, Pruess and Ennis-King (2003) - Scalar B = computeB_(temperature, pg); // according to Spycher, Pruess and Ennis-King (2003) - Scalar yH2OinGas = (1 - B) / (1. / A - B); // equilibrium mol fraction of H2O in the gas phase - Scalar xAirinWater = B * (1 - yH2OinGas); // equilibrium mol fraction of Air in the water phase - Scalar molalityAir = (xAirinWater * 55.508) / (1 - xAirinWater); // Air molality - return molalityAir; - } - - /*! - * \brief Returns the activity coefficient of Air in brine for a - * molal description. According to Duan and Sun (2003) \cite duan2003 <BR> - * given in Spycher and Pruess (2005) \cite spycher2005 <BR> - * - * \param temperature the temperature \f$\mathrm{[K]}\f$ - * \param pg the gas phase pressure \f$\mathrm{[Pa]}\f$ - * \param molalityNaCl molality of NaCl \f$\mathrm{(mol NaCl / kg water)}\f$ - */ - static Scalar activityCoefficient_(Scalar temperature, Scalar pg, - Scalar molalityNaCl) { - Scalar lambda = computeLambda_(temperature, pg); // lambda_{Air-Na+} - Scalar xi = computeXi_(temperature, pg); // Xi_{Air-Na+-Cl-} - Scalar lnGammaStar = 2 * lambda * molalityNaCl + xi * molalityNaCl - * molalityNaCl; - using std::exp; - Scalar gammaStar = exp(lnGammaStar); - return gammaStar; // molal activity coefficient of Air in brine - } - - /*! - * \brief Returns the paramater A for the calculation of - * them mutual solubility in the water-Air system. - * Given in Spycher, Pruess and Ennis-King (2003) \cite spycher2003 <BR> - * - * \param T the temperature \f$\mathrm{[K]}\f$ - * \param pg the gas phase pressure \f$\mathrm{[Pa]}\f$ - */ - static Scalar computeA_(Scalar T, Scalar pg) { - Scalar deltaP = pg / 1e5 - 1; // pressure range [bar] from p0 = 1bar to pg[bar] - const Scalar v_av_H2O = 18.1; // average partial molar volume of H2O [cm^3/mol] - const Scalar R = IdealGas::R * 10; - Scalar k0_H2O = equilibriumConstantH2O_(T); // equilibrium constant for H2O at 1 bar - Scalar phi_H2O = fugacityCoefficientH2O(T, pg); // fugacity coefficient of H2O for the water-Air system - Scalar pg_bar = pg / 1.e5; - using std::exp; - Scalar A = k0_H2O / (phi_H2O * pg_bar) * exp(deltaP * v_av_H2O / (R * T)); - return A; - - } - - /*! - * \brief Returns the paramater B for the calculation of - * the mutual solubility in the water-Air system. - * Given in Spycher, Pruess and Ennis-King (2003) \cite spycher2003 <BR> - * - * \param T the temperature \f$\mathrm{[K]}\f$ - * \param pg the gas phase pressure \f$\mathrm{[Pa]}\f$ - */ - static Scalar computeB_(Scalar T, Scalar pg) { - Scalar deltaP = pg / 1e5 - 1; // pressure range [bar] from p0 = 1bar to pg[bar] - const Scalar v_av_Air = 32.6; // average partial molar volume of Air [cm^3/mol] - const Scalar R = IdealGas::R * 10; - Scalar k0_Air = equilibriumConstantAir_(T); // equilibrium constant for Air at 1 bar - Scalar phi_Air = fugacityCoefficientAir(T, pg); // fugacity coefficient of Air for the water-Air system - Scalar pg_bar = pg / 1.e5; - using std::exp; - Scalar B = phi_Air * pg_bar / (55.508 * k0_Air) * exp(-(deltaP - * v_av_Air) / (R * T)); - return B; - } - - /*! - * \brief Returns the parameter lambda, which is needed for the - * calculation of the Air activity coefficient in the brine-Air system. - * Given in Spycher and Pruess (2005) \cite spycher2005 <BR> - * \param T the temperature \f$\mathrm{[K]}\f$ - * \param pg the gas phase pressure \f$\mathrm{[Pa]}\f$ - */ - static Scalar computeLambda_(Scalar T, Scalar pg) { - Scalar lambda; - static const Scalar c[6] = { -0.411370585, 6.07632013E-4, 97.5347708, - -0.0237622469, 0.0170656236, 1.41335834E-5 }; - - using std::log; - Scalar pg_bar = pg / 1.0E5; /* conversion from Pa to bar */ - lambda = c[0] + c[1] * T + c[2] / T + c[3] * pg_bar / T + c[4] * pg_bar - / (630.0 - T) + c[5] * T * log(pg_bar); - - return lambda; - } - - /*! - * \brief Returns the parameter xi, which is needed for the - * calculation of the Air activity coefficient in the brine-Air system. - * Given in Spycher and Pruess (2005) \cite spycher2005 <BR> - * \param T the temperature \f$\mathrm{[K]}\f$ - * \param pg the gas phase pressure \f$\mathrm{[Pa]}\f$ - */ - static Scalar computeXi_(Scalar T, Scalar pg) { - Scalar xi; - static const Scalar c[4] = { 3.36389723E-4, -1.98298980E-5, - 2.12220830E-3, -5.24873303E-3 }; - - Scalar pg_bar = pg / 1.0E5; /* conversion from Pa to bar */ - xi = c[0] + c[1] * T + c[2] * pg_bar / T + c[3] * pg_bar / (630.0 - T); - - return xi; - } - - /*! - * \brief Returns the equilibrium constant for Air, which is needed for the - * calculation of the mutual solubility in the water-Air system - * Given in Spycher, Pruess and Ennis-King (2003) \cite spycher2003 <BR> - * \param T the temperature \f$\mathrm{[K]}\f$ - */ - static Scalar equilibriumConstantAir_(Scalar T) { - Scalar TinC = T - 273.15; //temperature in °C - static const Scalar c[3] = { 1.189, 1.304e-2, -5.446e-5 }; - Scalar logk0_Air = c[0] + c[1] * TinC + c[2] * TinC * TinC; - Scalar k0_Air = pow(10, logk0_Air); - return k0_Air; - } - - /*! - * \brief Returns the equilibrium constant for H2O, which is needed for the - * calculation of the mutual solubility in the water-Air system - * Given in Spycher, Pruess and Ennis-King (2003) \cite spycher2003 <BR> - * \param T the temperature \f$\mathrm{[K]}\f$ - */ - static Scalar equilibriumConstantH2O_(Scalar T) { - Scalar TinC = T - 273.15; //temperature in °C - static const Scalar c[4] = { -2.209, 3.097e-2, -1.098e-4, 2.048e-7 }; - Scalar logk0_H2O = c[0] + c[1] * TinC + c[2] * TinC * TinC + c[3] - * TinC * TinC * TinC; - Scalar k0_H2O = pow(10, logk0_H2O); - return k0_H2O; - } - -}; - -/*! - * \brief Old version of binary coefficients for Air and brine. - * Calculates molfraction of Air in brine according to Duan and Sun 2003 - * molfraction of H2O has been assumed to be a constant value - * For use with the actual brine_co2_system this class still needs to be adapted - */ -template<class Scalar, class Air, bool verbose = true> -class Brine_Air_Old -{ - using H2O = Dumux::Components::H2O<Scalar>; - using Brine = Dumux::Components::Brine<Scalar,H2O>; - // using Air = Dumux::Components::Air<Scalar>; - using IdealGas = Dumux::IdealGas<Scalar>; - -public: - /*! - * \brief Returns the _mole_ (!) fraction of Air in the liquid - * phase at a given temperature, pressure and density of - * Air. - * - * \param temperature the temperature \f$\mathrm{[K]}\f$ - * \param pg the gas phase pressure \f$\mathrm{[Pa]}\f$ - * \param rhoAir density of Air - */ - static Scalar moleFracAirInBrine(Scalar temperature, Scalar pg, Scalar rhoAir) - { - // regularisations: - if (pg > 2.5e8) { - pg = 2.5e8; - } - if (pg < 2.e5) { - pg = 2.e5; - } - if (temperature < 275.) { - temperature = 275; - } - if (temperature > 600.) { - temperature = 600; - } - - const Scalar Mw = H2O::molarMass(); /* molecular weight of water [kg/mol] */ - const Scalar Ms = 58.8e-3; /* molecular weight of NaCl [kg/mol] */ - - const Scalar X_NaCl = Brine::XwNaCl; - /* XwNaCl: conversion from mass fraction to mole fraction */ - const Scalar xwNaCl = -Mw * X_NaCl / ((Ms - Mw) * X_NaCl - Ms); - - // XwNaCl: conversion from mole fraction to molality - const Scalar mol_NaCl = -55.56 * xwNaCl / (xwNaCl - 1); - - const Scalar A = computeA_(temperature, pg); /* mu_{Air}^{l(0)}/RT */ - const Scalar B = computeB_(temperature, pg); /* lambda_{Air-Na+} */ - const Scalar C = computeC_(temperature, pg); /* Xi_{Air-Na+-Cl-} */ - const Scalar pgAir = partialPressureAir_(temperature, pg); - const Scalar phiAir = fugacityCoeffAir_(temperature, pgAir, rhoAir); - - using std::log; - using std::pow; - using std::exp; - const Scalar exponent = A - log(phiAir) + 2*B*mol_NaCl + C*pow(mol_NaCl,2); - - const Scalar mol_Airw = pgAir / (1e5 * exp(exponent)); /* paper: equation (6) */ - - const Scalar x_Airw = mol_Airw / (mol_Airw + 55.56); /* conversion: molality to mole fraction */ - //Scalar X_Airw = x_Airw*MAir/(x_Airw*MAir + (1-x_Airw)*Mw); /* conversion: mole fraction to mass fraction */ - - return x_Airw; - } - -private: - /*! - * \brief computation of mu_{Air}^{l(0)}/RT - * \param T the temperature [K] - * \param pg the gas phase pressure [Pa] - */ - static Scalar computeA_(Scalar T, Scalar pg) - { - static const Scalar c[10] = { - 28.9447706, - -0.0354581768, - -4770.67077, - 1.02782768E-5, - 33.8126098, - 9.04037140E-3, - -1.14934031E-3, - -0.307405726, - -0.0907301486, - 9.32713393E-4, - }; - - const Scalar pg_bar = pg / 1.0E5; /* conversion from Pa to bar */ - const Scalar Tr = 630.0 - T; - - using std::log; - return - c[0] + - c[1]*T + - c[2]/T + - c[3]*T*T + - c[4]/Tr + - c[5]*pg_bar + - c[6]*pg_bar*log(T) + - c[7]*pg_bar/T + - c[8]*pg_bar/Tr + - c[9]*pg_bar*pg_bar/(Tr*Tr); - } - - /*! - * \brief computation of B - * - * \param T the temperature [K] - * \param pg the gas phase pressure [Pa] - */ - static Scalar computeB_(Scalar T, Scalar pg) - { - const Scalar c1 = -0.411370585; - const Scalar c2 = 6.07632013E-4; - const Scalar c3 = 97.5347708; - const Scalar c8 = -0.0237622469; - const Scalar c9 = 0.0170656236; - const Scalar c11 = 1.41335834E-5; - - const Scalar pg_bar = pg / 1.0E5; /* conversion from Pa to bar */ - - using std::log; - return - c1 + - c2*T + - c3/T + - c8*pg_bar/T + - c9*pg_bar/(630.0-T) + - c11*T*log(pg_bar); - } - /*! - * \brief computation of C - * - * \param T the temperature [K] - * \param pg the gas phase pressure [Pa] - */ - static Scalar computeC_(Scalar T, Scalar pg) - { - const Scalar c1 = 3.36389723E-4; - const Scalar c2 = -1.98298980E-5; - const Scalar c8 = 2.12220830E-3; - const Scalar c9 = -5.24873303E-3; - - const Scalar pg_bar = pg / 1.0E5; /* conversion from Pa to bar */ - - return - c1 + - c2*T + - c8*pg_bar/T + - c9*pg_bar/(630.0-T); - } - /*! - * \brief computation of partial pressure Air - * - * We assume that the partial pressure of brine is its vapor pressure. - * \warning: Strictly this is assumption is invalid for air because the - * mole fraction of air in brine can be considerable - * - * \param temperature the temperature [K] - * \param pg the gas phase pressure [Pa] - */ - static Scalar partialPressureAir_(Scalar temperature, Scalar pg) - { - return pg - Brine::vaporPressure(temperature); - } - - /*! - * \brief The fugacity coefficient of Air for a Air-H2O mixture. - * - * \param temperature the temperature [K] - * \param pg the gas phase pressure [Pa] - * \param rhoAir the density of Air for the critical volume [kg/m^3] - */ - static Scalar fugacityCoeffAir_(Scalar temperature, - Scalar pg, - Scalar rhoAir) - { - static const Scalar a[15] = { - 8.99288497E-2, - -4.94783127E-1, - 4.77922245E-2, - 1.03808883E-2, - -2.82516861E-2, - 9.49887563E-2, - 5.20600880E-4, - -2.93540971E-4, - -1.77265112E-3, - -2.51101973E-5, - 8.93353441E-5, - 7.88998563E-5, - -1.66727022E-2, - 1.3980, - 2.96000000E-2 - }; - - // reduced temperature - const Scalar Tr = temperature / Air::criticalTemperature(); - // reduced pressure - const Scalar pr = pg / Air::criticalPressure(); - - // reduced molar volume. ATTENTION: Vc is _NOT_ the critical - // molar volume of Air. See the reference! - const Scalar Vc = IdealGas::R*Air::criticalTemperature()/Air::criticalPressure(); - const Scalar Vr = - // molar volume of Air at (temperature, pg) - Air::molarMass() / rhoAir - * - // "pseudo-critical" molar volume - 1.0 / Vc; - - // the Z coefficient - const Scalar Z = pr * Vr / Tr; - - const Scalar A = a[0] + a[1] / (Tr * Tr) + a[2] / (Tr * Tr * Tr); - const Scalar B = a[3] + a[4] / (Tr * Tr) + a[5] / (Tr * Tr * Tr); - const Scalar C = a[6] + a[7] / (Tr * Tr) + a[8] / (Tr * Tr * Tr); - const Scalar D = a[9] + a[10] / (Tr * Tr) + a[11] / (Tr * Tr * Tr); - - using std::log; - using std::exp; - const Scalar lnphiAir = - Z - 1 - - log(Z) + - A/Vr + - B/(2*Vr*Vr) + - C/(4*Vr*Vr*Vr*Vr) + - D/(5*Vr*Vr*Vr*Vr*Vr) - + - a[12]/(2*Tr*Tr*Tr*a[14])* - ( - a[13] + 1 - - ( a[13] + 1 + - a[14]/(Vr*Vr) - )*exp(-a[14]/(Vr*Vr))); - - return exp(lnphiAir); - } - -}; -} -} // end namespace - -#endif diff --git a/dumux/material/components/nacl.hh b/dumux/material/components/nacl.hh index 4fd0e1071d6a5a5cabbc1f12c81bec6f77ee849e..038c2e1df91443e13cca75240cd1288194ade1ca 100644 --- a/dumux/material/components/nacl.hh +++ b/dumux/material/components/nacl.hh @@ -43,7 +43,6 @@ namespace Components { template <class Scalar> class NaCl : public Components::Base<Scalar, NaCl<Scalar> > -, public Components::Liquid<Scalar, NaCl<Scalar> > , public Components::Solid<Scalar, NaCl<Scalar> > { public: @@ -63,16 +62,6 @@ public: return 58.4428e-3 ; } - /*! - * \brief The diffusion Coefficient \f$\mathrm{[m^2/s]}\f$ of NaCl in water. - * \param temperature absolute temperature in \f$\mathrm{[K]}\f$ - * \param pressure of the phase in \f$\mathrm{[Pa]}\f$ - */ - static Scalar liquidDiffCoeff(Scalar temperature, Scalar pressure) - { - return 2e-9; - } - /*! * \brief The mass density \f$\mathrm{[kg/m^3]}\f$ of NaCl. */ @@ -105,8 +94,6 @@ public: { return 6.49; } - - }; } // end namespace Components diff --git a/dumux/material/fluidstates/2p2c.hh b/dumux/material/fluidstates/2p2c.hh index c628adde8cfa901829cdb57ee9c644c8eb8a55c8..23434d11a996c9496ee8b1d3a1ebecfa99308c91 100644 --- a/dumux/material/fluidstates/2p2c.hh +++ b/dumux/material/fluidstates/2p2c.hh @@ -32,7 +32,7 @@ namespace Dumux { * sequential 2p2c model. * This boils down to so-called "flash calculation", in this case isothermal and isobaric. */ -template <class Scalar, class FluidSystem> +template <class ScalarType, class FluidSystem> class TwoPTwoCFluidState { public: @@ -41,12 +41,12 @@ public: phase1Idx = FluidSystem::phase1Idx, }; - enum { - numPhases = FluidSystem::numPhases, - numComponents = FluidSystem::numComponents - }; - public: + static constexpr int numPhases = FluidSystem::numPhases; + static constexpr int numComponents = FluidSystem::numComponents; + + //! export the scalar type + using Scalar = ScalarType; // comply with new style 2p2c models int wettingPhase() const diff --git a/dumux/material/fluidstates/adapter.hh b/dumux/material/fluidstates/adapter.hh new file mode 100644 index 0000000000000000000000000000000000000000..4dae36fef463cebfff08a42a6259c662157251a7 --- /dev/null +++ b/dumux/material/fluidstates/adapter.hh @@ -0,0 +1,119 @@ +// -*- 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 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU 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 FluidStates + * \brief Adapter class for fluid states with different indices + */ +#ifndef DUMUX_MATERIAL_FLUID_STATE_ADAPTER_HH +#define DUMUX_MATERIAL_FLUID_STATE_ADAPTER_HH + +#include <array> +#include <dune/common/exceptions.hh> + +namespace Dumux { + +/*! + * \ingroup FluidStates + * \tparam FluidState the fluid state that is adapted to another fluid state's index set + * \tparam AdapterPolicy + * \brief Adapter class for fluid states with different indices + * \note This is useful when writing a fluid system that has another fluid system as an ingredient + * To forward to the other fluid system (which variables to be sorted according to its own indices) + * create the fluid state adapter of the fluid state to forward and pass the adapter to this fluid state. + * You need to provide an adapter policy which maps the phase and component indices from the embedded fluid + * system's indices to the actual fluid system's indices. + */ +template<class FluidState, class AdapterPolicy> +class FluidStateAdapter +{ + using FluidSystem = typename AdapterPolicy::FluidSystem; +public: + //! export scalar type + using Scalar = typename FluidState::Scalar; + + //! export number of phases and components of the embedded fluid system + static constexpr int numPhases = FluidSystem::numPhases; + static constexpr int numComponents = FluidSystem::numComponents; + + /*! + * \ingroup FluidStates + * \brief Adapter class for fluid states with different indices + * \param fluidState the fluid state to be wrapped + */ + FluidStateAdapter(const FluidState& fluidState) + : fluidState_(fluidState) + {} + + /*! + * \name Member functions forwarding to the fluid state mapping the indices + */ + // \{ + int wettingPhase() const + { DUNE_THROW(Dune::InvalidStateException, "wetting phase index cannot be mapped"); } + + Scalar moleFraction(int phaseIdx, int compIdx) const + { + Scalar sumMoleFrac = 0.0; + for (int cIdx = 0; cIdx < numComponents; ++cIdx) + sumMoleFrac += fluidState_.moleFraction(AdapterPolicy::phaseIdx(phaseIdx), AdapterPolicy::compIdx(cIdx)); + + return fluidState_.moleFraction(AdapterPolicy::phaseIdx(phaseIdx), AdapterPolicy::compIdx(compIdx))/sumMoleFrac; + } + + Scalar massFraction(int phaseIdx, int compIdx) const + { + Scalar sumMassFrac = 0.0; + for (int cIdx = 0; cIdx < numComponents; ++cIdx) + sumMassFrac += fluidState_.massFraction(AdapterPolicy::phaseIdx(phaseIdx), AdapterPolicy::compIdx(cIdx)); + + return fluidState_.massFraction(AdapterPolicy::phaseIdx(phaseIdx), AdapterPolicy::compIdx(compIdx))/sumMassFrac; + } + + Scalar averageMolarMass(int phaseIdx) const + { + Scalar sumXi = 0.0; + Scalar sumXiMi = 0.0; + for (int cIdx = 0; cIdx < numComponents; ++cIdx) + { + const auto xi = fluidState_.moleFraction(AdapterPolicy::phaseIdx(phaseIdx), AdapterPolicy::compIdx(cIdx)); + sumXi += xi; + sumXiMi += xi*FluidSystem::molarMass(cIdx); + } + + return sumXiMi/sumXi; + } + + Scalar pressure(int phaseIdx) const + { return fluidState_.pressure(AdapterPolicy::phaseIdx(phaseIdx)); } + + Scalar temperature(int phaseIdx) const + { return fluidState_.temperature(AdapterPolicy::phaseIdx(phaseIdx)); } + + Scalar temperature() const + { return fluidState_.temperature(0); } + // \} + +private: + const FluidState& fluidState_; +}; + +} // end namespace Dumux + +#endif diff --git a/dumux/material/fluidstates/compositional.hh b/dumux/material/fluidstates/compositional.hh index 35f58e3dc21bd5b90636a4f127a0857b1a650e67..31dd1cf6e0112c15fd2cccf703d163f63eabcc44 100644 --- a/dumux/material/fluidstates/compositional.hh +++ b/dumux/material/fluidstates/compositional.hh @@ -40,12 +40,15 @@ namespace Dumux { * multi-phase, multi-component fluid system assuming * thermodynamic equilibrium. */ -template <class Scalar, class FluidSystem> +template <class ScalarType, class FluidSystem> class CompositionalFluidState { public: - enum { numPhases = FluidSystem::numPhases }; - enum { numComponents = FluidSystem::numComponents }; + static constexpr int numPhases = FluidSystem::numPhases; + static constexpr int numComponents = FluidSystem::numComponents; + + //! export the scalar type + using Scalar = ScalarType; //! default constructor CompositionalFluidState() = default; diff --git a/dumux/material/fluidstates/immiscible.hh b/dumux/material/fluidstates/immiscible.hh index ec7b05b630a18e62f62fd53f30c2c85c3346795f..b1168b4026156701952f97ab53c974b08e7a756d 100644 --- a/dumux/material/fluidstates/immiscible.hh +++ b/dumux/material/fluidstates/immiscible.hh @@ -37,16 +37,19 @@ namespace Dumux { * multi-phase fluid system assuming immiscibility and * thermodynamic equilibrium. */ -template <class Scalar, class FluidSystem> +template <class ScalarType, class FluidSystem> class ImmiscibleFluidState { public: - static constexpr int numComponents = FluidSystem::numComponents; static constexpr int numPhases = FluidSystem::numPhases; + static constexpr int numComponents = FluidSystem::numComponents; static_assert(numPhases == numComponents, "The number of phases must be equal to the number of " "components if immiscibility is assumed!"); + //! export the scalar type + using Scalar = ScalarType; + //! default constructor ImmiscibleFluidState() = default; diff --git a/dumux/material/fluidstates/isothermalimmiscible.hh b/dumux/material/fluidstates/isothermalimmiscible.hh index 6885d05baf9abd25f0d744165350aefa37b285bf..41d89e189b302439421d96d0a38f2099017171a6 100644 --- a/dumux/material/fluidstates/isothermalimmiscible.hh +++ b/dumux/material/fluidstates/isothermalimmiscible.hh @@ -37,11 +37,15 @@ namespace Dumux { * multi-phase fluid system assuming immiscibility and * thermodynamic equilibrium. */ -template <class Scalar, class FluidSystem> +template <class ScalarType, class FluidSystem> class IsothermalImmiscibleFluidState { public: static constexpr int numPhases = FluidSystem::numPhases; + static constexpr int numComponents = FluidSystem::numComponents; + + //! export the scalar type + using Scalar = ScalarType; //! default constructor IsothermalImmiscibleFluidState() = default; diff --git a/dumux/material/fluidstates/nonequilibrium.hh b/dumux/material/fluidstates/nonequilibrium.hh index 0c1a34ad5f25ef0b79157cfef58d3adecfa68daa..879dd662322cfce06606749e42ca5e1c26324ca6 100644 --- a/dumux/material/fluidstates/nonequilibrium.hh +++ b/dumux/material/fluidstates/nonequilibrium.hh @@ -38,13 +38,16 @@ namespace Dumux { * multi-phase, multi-component fluid system without using * any assumptions. */ -template <class Scalar, class FluidSystem> +template <class ScalarType, class FluidSystem> class NonEquilibriumFluidState { public: static constexpr int numPhases = FluidSystem::numPhases; static constexpr int numComponents = FluidSystem::numComponents; + //! export the scalar type + using Scalar = ScalarType; + /***************************************************** * Generic access to fluid properties (No assumptions * on thermodynamic equilibrium required) diff --git a/dumux/material/fluidstates/nonequilibriumenergy.hh b/dumux/material/fluidstates/nonequilibriumenergy.hh index c9584df750eb5ade3948f5eaf9baca0964b720ab..aebaab721b5b3d691bf8f2a095127e4ada8e86f9 100644 --- a/dumux/material/fluidstates/nonequilibriumenergy.hh +++ b/dumux/material/fluidstates/nonequilibriumenergy.hh @@ -40,14 +40,17 @@ namespace Dumux { * - local thermal non-equilibrium * - local chemical equilibrium */ -template <class Scalar, class FluidSystem> +template <class ScalarType, class FluidSystem> class NonEquilibriumEnergyFluidState -: public NonEquilibriumFluidState<Scalar, FluidSystem> +: public NonEquilibriumFluidState<ScalarType, FluidSystem> { - using ParentType = NonEquilibriumFluidState<Scalar, FluidSystem>; + using ParentType = NonEquilibriumFluidState<ScalarType, FluidSystem>; public: - enum { numPhases = FluidSystem::numPhases }; - enum { numComponents = FluidSystem::numComponents }; + static constexpr int numPhases = FluidSystem::numPhases; + static constexpr int numComponents = FluidSystem::numComponents; + + //! export the scalar type + using Scalar = ScalarType; using ParentType::ParentType; diff --git a/dumux/material/fluidstates/nonequilibriummass.hh b/dumux/material/fluidstates/nonequilibriummass.hh index c450d2fc3b9931dcabe38338ea91c378aaab73f3..f0a2e61334578ce7edf69b5746cb7b3425c2d225 100644 --- a/dumux/material/fluidstates/nonequilibriummass.hh +++ b/dumux/material/fluidstates/nonequilibriummass.hh @@ -40,14 +40,17 @@ namespace Dumux { * - local thermal equilibrium * - local chemical non-equilibrium */ -template <class Scalar, class FluidSystem> +template <class ScalarType, class FluidSystem> class NonEquilibriumMassFluidState -: public NonEquilibriumFluidState<Scalar, FluidSystem> +: public NonEquilibriumFluidState<ScalarType, FluidSystem> { - using ParentType = NonEquilibriumFluidState<Scalar, FluidSystem>; + using ParentType = NonEquilibriumFluidState<ScalarType, FluidSystem>; public: - enum { numPhases = FluidSystem::numPhases }; - enum { numComponents = FluidSystem::numComponents }; + static constexpr int numPhases = FluidSystem::numPhases; + static constexpr int numComponents = FluidSystem::numComponents; + + //! export the scalar type + using Scalar = ScalarType; using ParentType::ParentType; diff --git a/dumux/material/fluidstates/pressureoverlay.hh b/dumux/material/fluidstates/pressureoverlay.hh index 5ee250dedaa6ed3f4f6cbaa9086d748a0405b5dc..793e06eef6e2a1eac3c46a918b839b8ada07d669 100644 --- a/dumux/material/fluidstates/pressureoverlay.hh +++ b/dumux/material/fluidstates/pressureoverlay.hh @@ -34,12 +34,15 @@ namespace Dumux { * pressures and takes all other quantities from an other * fluid state. */ -template <class Scalar, class FluidState> +template <class FluidState> class PressureOverlayFluidState { public: - enum { numPhases = FluidState::numPhases }; - enum { numComponents = FluidState::numComponents }; + static constexpr int numPhases = FluidState::numPhases; + static constexpr int numComponents = FluidState::numComponents; + + //! export the scalar type + using Scalar = typename FluidState::Scalar; /*! * \brief Constructor diff --git a/dumux/material/fluidstates/pseudo1p2c.hh b/dumux/material/fluidstates/pseudo1p2c.hh index 81213dd393af0a4a6e10fcbaf3daf872f94f086d..93872b3bd706812cbfd9ada25e47df6281315086 100644 --- a/dumux/material/fluidstates/pseudo1p2c.hh +++ b/dumux/material/fluidstates/pseudo1p2c.hh @@ -39,15 +39,17 @@ namespace Dumux { * The "flash" calculation routines are in the sequential flash constrain solver, see * CompositionalFlash . */ -template <class Scalar, class FluidSystem> +template <class ScalarType, class FluidSystem> class PseudoOnePTwoCFluidState { public: - enum { - numPhases = FluidSystem::numPhases, - numComponents = FluidSystem::numComponents - }; + static constexpr int numPhases = FluidSystem::numPhases; + static constexpr int numComponents = FluidSystem::numComponents; + + //! export the scalar type + using Scalar = ScalarType; + enum { phase0Idx = FluidSystem::phase0Idx, phase1Idx = FluidSystem::phase1Idx, @@ -56,7 +58,6 @@ public: comp1Idx = FluidSystem::comp1Idx }; -public: /*! \name Acess functions */ //@{ /*! diff --git a/dumux/material/fluidstates/saturationoverlay.hh b/dumux/material/fluidstates/saturationoverlay.hh index c3d2f81a9dda90d38debd5ec5be831a4ca44a2ac..3d02a3427f0f7ba1be4dd71be99d879b04514426 100644 --- a/dumux/material/fluidstates/saturationoverlay.hh +++ b/dumux/material/fluidstates/saturationoverlay.hh @@ -34,12 +34,15 @@ namespace Dumux { * saturations and takes all other quantities from an other * fluid state. */ -template <class Scalar, class FluidState> +template <class FluidState> class SaturationOverlayFluidState { public: - enum { numPhases = FluidState::numPhases }; - enum { numComponents = FluidState::numComponents }; + static constexpr int numPhases = FluidState::numPhases; + static constexpr int numComponents = FluidState::numComponents; + + //! export the scalar type + using Scalar = typename FluidState::Scalar; /*! * \brief Constructor diff --git a/dumux/material/fluidstates/temperatureoverlay.hh b/dumux/material/fluidstates/temperatureoverlay.hh index 65d52b8724a99d4ab3bd254864f7e72057e0c3d1..c1d721329244170fae68d1fa60927c0f32166c7c 100644 --- a/dumux/material/fluidstates/temperatureoverlay.hh +++ b/dumux/material/fluidstates/temperatureoverlay.hh @@ -34,12 +34,15 @@ namespace Dumux { * temperatures and takes all other quantities from an other * fluid state. */ -template <class Scalar, class FluidState> +template <class FluidState> class TemperatureOverlayFluidState { public: - enum { numPhases = FluidState::numPhases }; - enum { numComponents = FluidState::numComponents }; + static constexpr int numPhases = FluidState::numPhases; + static constexpr int numComponents = FluidState::numComponents; + + //! export the scalar type + using Scalar = typename FluidState::Scalar; /*! * \brief Constructor diff --git a/dumux/material/fluidsystems/base.hh b/dumux/material/fluidsystems/base.hh index 051c683c72a6ebf5aa41a8e752d1fd271df1d7b0..e2ab7ecf8c8c917838e136f9c82ee5446daba413 100644 --- a/dumux/material/fluidsystems/base.hh +++ b/dumux/material/fluidsystems/base.hh @@ -59,7 +59,6 @@ public: /*! * \brief Get the main component of a given phase if possible * - * \param compIdx The index of the component to check * \param phaseIdx The index of the fluid phase to consider * \note This method has to can throw at compile time if the fluid system doesn't assume a * main phase. Then using e.g. Fick's law will fail compiling. diff --git a/dumux/material/fluidsystems/brine.hh b/dumux/material/fluidsystems/brine.hh new file mode 100644 index 0000000000000000000000000000000000000000..2ac1d7ae960a3467acc0312c45bf79faec92871a --- /dev/null +++ b/dumux/material/fluidsystems/brine.hh @@ -0,0 +1,479 @@ +// -*- 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 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU 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 + * \brief A fluid system for brine, i.e. H2O with dissolved NaCl. + */ +#ifndef DUMUX_BRINE_FLUID_SYSTEM_HH +#define DUMUX_BRINE_FLUID_SYSTEM_HH + +#include <dumux/material/fluidsystems/base.hh> + +#include <dumux/material/constants.hh> +#include <dumux/material/components/h2o.hh> +#include <dumux/material/components/nacl.hh> +#include <dumux/material/components/tabulatedcomponent.hh> + +#include <dumux/common/exceptions.hh> + +namespace Dumux { +namespace FluidSystems { + +/*! + * \ingroup Fluidsystems + * \brief A compositional single phase fluid system consisting of + * two components, which are H2O and NaCl. + */ +template< class Scalar, class H2OType = Components::TabulatedComponent<Dumux::Components::H2O<Scalar>> > +class Brine : public BaseFluidSystem< Scalar, Brine<Scalar, H2OType>> +{ + using ThisType = Brine<Scalar, H2OType>; + using Base = BaseFluidSystem<Scalar, ThisType>; + +public: + //! export the involved components + using H2O = H2OType; + using NaCl = Dumux::Components::NaCl<Scalar>; + + static const int numPhases = 1; //!< Number of phases in the fluid system + static const int numComponents = 2; //!< Number of components in the fluid system (H2O, NaCl) + + static constexpr int phase0Idx = 0; //!< Index of the first (and only) phase + static constexpr int liquidPhaseIdx = phase0Idx; //!< The one considered phase is liquid + + static constexpr int H2OIdx = 0; //!< index of the water component + static constexpr int NaClIdx = 1; //!< index of the NaCl component + static constexpr int comp0Idx = H2OIdx; //!< index of the first component + static constexpr int comp1Idx = NaClIdx; //!< index of the second component + + /*! + * \brief Return the human readable name of the phase + * \param phaseIdx The index of the fluid phase to consider + */ + static const std::string phaseName(int phaseIdx = liquidPhaseIdx) + { + assert(phaseIdx == liquidPhaseIdx); + return "brine"; + } + + /*! + * \brief Returns whether the fluids are miscible + * \note There is only one phase, so miscibility makes no sense here + */ + static constexpr bool isMiscible() + { + return false; + } + + /*! + * \brief Return whether a phase is liquid + * \param phaseIdx The index of the fluid phase to consider + */ + static constexpr bool isLiquid(int phaseIdx = liquidPhaseIdx) + { + assert(phaseIdx == liquidPhaseIdx); + return true; + } + + /*! + * \brief Returns true if and only if a fluid phase is assumed to + * be an ideal mixture. + * + * We define an ideal mixture as a fluid phase where the fugacity + * coefficients of all components times the pressure of the phase + * are indepent on the fluid composition. This assumtion is true + * if Henry's law and Raoult's law apply. If you are unsure what + * this function should return, it is safe to return false. The + * only damage done will be (slightly) increased computation times + * in some cases. + * + * \param phaseIdx The index of the fluid phase to consider + */ + static bool isIdealMixture(int phaseIdx = liquidPhaseIdx) + { + assert(phaseIdx == liquidPhaseIdx); + return true; + } + + /*! + * \brief Returns true if and only if a fluid phase is assumed to + * be compressible. + * + * Compressible means that the partial derivative of the density + * to the fluid pressure is always larger than zero. + * + * \param phaseIdx The index of the fluid phase to consider + */ + static bool isCompressible(int phaseIdx = liquidPhaseIdx) + { + assert(phaseIdx == liquidPhaseIdx); + return H2O::liquidIsCompressible(); + } + + /*! + * \brief Returns true if and only if a fluid phase is assumed to + * be an ideal gas. + * + * \param phaseIdx The index of the fluid phase to consider + */ + + static bool isIdealGas(int phaseIdx = liquidPhaseIdx) + { + assert(phaseIdx == liquidPhaseIdx); + return false; /*we're a liquid!*/ + } + + /**************************************** + * Component related static parameters + ****************************************/ + + /*! + * \brief Return the human readable name of a component + * \param compIdx The index of the component to consider + */ + static std::string componentName(int compIdx) + { + switch (compIdx) + { + case H2OIdx: return H2O::name(); + case NaClIdx: return NaCl::name(); + }; + DUNE_THROW(Dune::InvalidStateException, "Invalid component index " << compIdx); + } + + /*! + * \brief Return the molar mass of a component in \f$\mathrm{[kg/mol]}\f$. + * \param compIdx The index of the component to consider + */ + static Scalar molarMass(int compIdx) + { + switch (compIdx) + { + case H2OIdx: return H2O::molarMass(); + case NaClIdx: return NaCl::molarMass(); + }; + DUNE_THROW(Dune::InvalidStateException, "Invalid component index " << compIdx); + } + + /**************************************** + * thermodynamic relations + ****************************************/ + /*! + * \brief Initialize the fluid system's static parameters generically + * \note If a tabulated H2O component is used, we do our best to create + * tables that always work. + */ + static void init() + { + init(/*tempMin=*/273.15, + /*tempMax=*/623.15, + /*numTemp=*/100, + /*pMin=*/-10., + /*pMax=*/20e6, + /*numP=*/200); + } + + /*! + * \brief Initialize the fluid system's static parameters using + * problem specific temperature and pressure ranges + * + * \param tempMin The minimum temperature used for tabulation of water [K] + * \param tempMax The maximum temperature used for tabulation of water [K] + * \param nTemp The number of ticks on the temperature axis of the table of water + * \param pressMin The minimum pressure used for tabulation of water [Pa] + * \param pressMax The maximum pressure used for tabulation of water [Pa] + * \param nPress The number of ticks on the pressure axis of the table of water + */ + static void init(Scalar tempMin, Scalar tempMax, unsigned nTemp, + Scalar pressMin, Scalar pressMax, unsigned nPress) + { + + if (H2O::isTabulated) + { + std::cout << "Initializing tables for the H2O fluid properties (" + << nTemp*nPress + << " entries).\n"; + + H2O::init(tempMin, tempMax, nTemp, pressMin, pressMax, nPress); + } + } + + using Base::density; + /*! + * \brief Return the phase density [kg/m^3]. + * \note The density is compuated as a function of the salt mass fraction + */ + template <class FluidState> + static Scalar density(const FluidState& fluidState, int phaseIdx = liquidPhaseIdx) + { + assert(phaseIdx == liquidPhaseIdx); + const Scalar temperature = fluidState.temperature(phaseIdx); + const Scalar pressure = fluidState.pressure(phaseIdx); + const Scalar xNaCl = fluidState.massFraction(phaseIdx, NaClIdx); + + using std::max; + const Scalar TempC = temperature - 273.15; + const Scalar pMPa = pressure/1.0E6; + const Scalar salinity = max(0.0, xNaCl); + + const Scalar rhow = H2O::liquidDensity(temperature, pressure); + const Scalar density = rhow + 1000*salinity*(0.668 + + 0.44*salinity + + 1.0E-6*(300*pMPa - + 2400*pMPa*salinity + + TempC*(80.0 + + 3*TempC - + 3300*salinity - + 13*pMPa + + 47*pMPa*salinity))); + assert(density > 0.0); + return density; + } + + using Base::fugacityCoefficient; + /*! + * \copybrief Base::fugacityCoefficient + * + * \param fluidState An arbitrary fluid state + * \param phaseIdx The index of the fluid phase to consider + * \param compIdx The index of the component to consider + */ + template <class FluidState> + static Scalar fugacityCoefficient(const FluidState &fluidState, + int phaseIdx, + int compIdx) + { + assert(0 <= phaseIdx && phaseIdx < numPhases); + assert(0 <= compIdx && compIdx < numComponents); + + if (phaseIdx == compIdx) + // We could calculate the real fugacity coefficient of + // the component in the fluid. Probably that's not worth + // the effort, since the fugacity coefficient of the other + // component is infinite anyway... + return 1.0; + return std::numeric_limits<Scalar>::infinity(); + } + + using Base::viscosity; + /*! + * \brief Return the viscosity of the phase. + */ + template <class FluidState> + static Scalar viscosity(const FluidState& fluidState, int phaseIdx = liquidPhaseIdx) + { + assert(phaseIdx == liquidPhaseIdx); + const Scalar temperature = fluidState.temperature(phaseIdx); + const Scalar xNaCl = fluidState.massFraction(phaseIdx, NaClIdx); + + using std::pow; + using std::exp; + using std::max; + const Scalar T = max(temperature, 275.0); + const Scalar salinity = max(0.0, xNaCl); + + const Scalar T_C = T - 273.15; + const Scalar A = ((0.42*pow((pow(salinity, 0.8)-0.17), 2)) + 0.045)*pow(T_C, 0.8); + const Scalar mu_brine = 0.1 + (0.333*salinity) + (1.65+(91.9*salinity*salinity*salinity))*exp(-A); // [cP] + assert(mu_brine > 0.0); + return mu_brine/1000.0; // [Pa·s] + } + + /*! + * \brief Vapor pressure of a component \f$\mathrm{[Pa]}\f$. + * + * \param fluidState The fluid state + * \param compIdx The index of the component to consider + */ + template <class FluidState> + static Scalar vaporPressure(const FluidState& fluidState, int compIdx) + { + if (compIdx == H2OIdx) + { + // simplified version of Eq 2.29 in Vishal Jambhekar's Promo + const Scalar temperature = fluidState.temperature(H2OIdx); + return H2O::vaporPressure(temperature)/fluidState.massFraction(phase0Idx, H2OIdx); + } + else if (compIdx == NaClIdx) + DUNE_THROW(Dune::NotImplemented, "NaCl::vaporPressure(t)"); + else + DUNE_THROW(Dune::NotImplemented, "Invalid component index " << compIdx); + } + + using Base::enthalpy; + /*! + * \brief Given a phase's composition, temperature and pressure, + * return its specific enthalpy \f$\mathrm{[J/kg]}\f$. + * + * \param fluidState The fluid state + * \param compIdx The index of the component to consider + * + * Equations given in: + * - Palliser & McKibbin (1998) \cite palliser1998 <BR> + * - Michaelides (1981) \cite michaelides1981 <BR> + * - Daubert & Danner (1989) \cite daubert1989 + * + */ + template <class FluidState> + static Scalar enthalpy(const FluidState& fluidState, int phaseIdx) + { + /*Numerical coefficients from PALLISER*/ + static const Scalar f[] = { 2.63500E-1, 7.48368E-6, 1.44611E-6, -3.80860E-10 }; + + /*Numerical coefficients from MICHAELIDES for the enthalpy of brine*/ + static const Scalar a[4][3] = { { +9633.6, -4080.0, +286.49 }, + { +166.58, +68.577, -4.6856 }, + { -0.90963, -0.36524, +0.249667E-1 }, + { +0.17965E-2, +0.71924E-3, -0.4900E-4 } }; + + const Scalar p = fluidState.pressure(phaseIdx); + const Scalar T = fluidState.temperature(phaseIdx); + const Scalar theta = T - 273.15; + const Scalar salSat = f[0] + f[1]*theta + f[2]*theta*theta + f[3]*theta*theta*theta; + + /*Regularization*/ + using std::min; + using std::max; + const Scalar xNaCl = fluidState.massFraction(phase0Idx, NaClIdx); + const Scalar salinity = min(max(xNaCl,0.0), salSat); + + const Scalar hw = H2O::liquidEnthalpy(T, p)/1E3; /* kJ/kg */ + + /*DAUBERT and DANNER*/ + const Scalar h_NaCl = (3.6710E4*T + 0.5*(6.2770E1)*T*T - ((6.6670E-2)/3)*T*T*T + + ((2.8000E-5)/4)*(T*T*T*T))/(58.44E3)- 2.045698e+02; /* U [kJ/kg] */ + + const Scalar m = (1E3/58.44)*(salinity/(1-salinity)); + + using std::pow; + Scalar d_h = 0; + for (int i = 0; i<=3; i++) + for (int j=0; j<=2; j++) + d_h = d_h + a[i][j] * pow(theta, i) * pow(m, j); + + /* heat of dissolution for halite according to Michaelides 1971 */ + const Scalar delta_h = (4.184/(1E3 + (58.44 * m)))*d_h; + + /* Enthalpy of brine without any dissolved gas */ + const Scalar h_ls1 =(1-salinity)*hw + salinity*h_NaCl + salinity*delta_h; /* kJ/kg */ + return h_ls1*1E3; /*J/kg*/ + } + + using Base::molarDensity; + /*! + * \brief The molar density \f$\rho_{mol,\alpha}\f$ of + * the fluid phase \f$\alpha\f$ in \f$\mathrm{[mol/m^3]}\f$ + * + * The molar density for the simple relation is defined by the + * mass density \f$\rho_\alpha\f$ and the molar mass of the main component \f$M_\kappa\f$: + * + * \f[\rho_{mol,\alpha} = \frac{\rho_\alpha}{M_\kappa} \;.\f] + */ + template <class FluidState> + static Scalar molarDensity(const FluidState& fluidState, int phaseIdx = liquidPhaseIdx) + { + return density(fluidState, phaseIdx)/fluidState.averageMolarMass(phaseIdx); + } + + using Base::diffusionCoefficient; + /*! + * \brief Returns the diffusion coefficient \f$\mathrm{[-]}\f$ + * of a component in a phase. + */ + template <class FluidState> + static Scalar diffusionCoefficient(const FluidState& fluidState, int phaseIdx, int compIdx) + { + DUNE_THROW(Dune::NotImplemented, "FluidSystems::Brine::diffusionCoefficient()"); + } + + using Base::binaryDiffusionCoefficient; + /*! + * \brief Given a phase's composition, temperature and pressure, + * return the binary diffusion coefficient \f$\mathrm{[m^2/s]}\f$ for components + * \f$\mathrm{i}\f$ and \f$\mathrm{j}\f$ in this phase. + * \param fluidState The fluid state + * \param paramCache mutable parameters + * \param phaseIdx Index of the fluid phase + * \param compIIdx Index of the component i + * \param compJIdx Index of the component j + */ + template <class FluidState> + static Scalar binaryDiffusionCoefficient(const FluidState& fluidState, + int phaseIdx, + int compIIdx, + int compJIdx) + { + if (phaseIdx == liquidPhaseIdx) + { + //! \todo TODO implement binary coefficients + // http://webserver.dmt.upm.es/~isidoro/dat1/Mass%20diffusivity%20data.htm + // The link above was given as a reference in brine_air fluid system. + // Doesn't work anymore though... + if (compJIdx == NaClIdx) + return 0.12e-9; + else + DUNE_THROW(Dune::NotImplemented, "Binary diffusion coefficient of components " + << compIIdx << " and " << compJIdx + << " in phase " << phaseIdx); + } + + DUNE_THROW(Dune::InvalidStateException, "Invalid phase index: " << phaseIdx); + } + + using Base::thermalConductivity; + /*! + * \brief Thermal conductivity of a fluid phase \f$\mathrm{[W/(m K)]}\f$. + * \param fluidState An abitrary fluid state + * \param phaseIdx The index of the fluid phase to consider + * + * \todo TODO: For the thermal conductivity of the phases the contribution of + * NaCl is neglected. This contribution is probably not big, but somebody + * would have to find out its influence. + */ + template <class FluidState> + static Scalar thermalConductivity(const FluidState& fluidState, int phaseIdx) + { + if (phaseIdx == liquidPhaseIdx) + return H2O::liquidThermalConductivity(fluidState.temperature(phaseIdx), fluidState.pressure(phaseIdx)); + DUNE_THROW(Dune::InvalidStateException, "Invalid phase index: " << phaseIdx); + } + + using Base::heatCapacity; + /*! + * \brief Specific isobaric heat capacity of a fluid phase. + * \f$\mathrm{[J/(kg*K)}\f$. + * \param fluidState An abitrary fluid state + * \param phaseIdx The index of the fluid phase to consider + * + * \todo TODO: The calculation of the isobaric heat capacity is preliminary. A better + * description of the influence of NaCl on the phase property has to be found. + */ + template <class FluidState> + static Scalar heatCapacity(const FluidState &fluidState, int phaseIdx) + { + if (phaseIdx == liquidPhaseIdx) + return H2O::liquidHeatCapacity(fluidState.temperature(phaseIdx), fluidState.pressure(phaseIdx)); + DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx); + } +}; + +} // end namespace FluidSystems +} // end namespace Dumux + +#endif diff --git a/dumux/material/fluidsystems/brineair.hh b/dumux/material/fluidsystems/brineair.hh index aa097bf58937c45ad442691eb7efacd8cd38f246..437977735f86c1db94d04d3fddea409eb7edf807 100644 --- a/dumux/material/fluidsystems/brineair.hh +++ b/dumux/material/fluidsystems/brineair.hh @@ -21,27 +21,31 @@ * \ingroup Fluidsystems * \brief @copybrief Dumux::FluidSystems::BrineAir */ -#ifndef DUMUX_BRINE_AIR_SYSTEM_HH -#define DUMUX_BRINE_AIR_SYSTEM_HH +#ifndef DUMUX_BRINE_AIR_FLUID_SYSTEM_HH +#define DUMUX_BRINE_AIR_FLUID_SYSTEM_HH +#include <array> #include <cassert> #include <iomanip> #include <dumux/material/idealgas.hh> +#include <dumux/material/fluidstates/adapter.hh> #include <dumux/material/fluidsystems/base.hh> -#include <dumux/material/components/brine.hh> +#include <dumux/material/fluidsystems/brine.hh> #include <dumux/material/components/air.hh> #include <dumux/material/components/h2o.hh> #include <dumux/material/components/nacl.hh> -#include <dumux/material/binarycoefficients/brine_air.hh> #include <dumux/material/binarycoefficients/h2o_air.hh> #include <dumux/material/components/tabulatedcomponent.hh> #include <dumux/common/valgrind.hh> #include <dumux/common/exceptions.hh> +#include "brine.hh" + namespace Dumux { namespace FluidSystems { + /*! * \ingroup Fluidsystems * \brief Policy for the brine-air fluid system @@ -58,8 +62,8 @@ struct BrineAirDefaultPolicy * \brief A compositional two-phase fluid system with a liquid and a gaseous phase * and \f$H_2O\f$, \f$Air\f$ and \f$S\f$ (dissolved minerals) as components. * - * This fluidsystem is applied by default with the tabulated version of - * water of the IAPWS-formulation. + * \note This fluidsystem is applied by default with the tabulated version of + * water of the IAPWS-formulation. */ template <class Scalar, class H2Otype = Components::TabulatedComponent<Components::H2O<Scalar>>, @@ -72,48 +76,74 @@ class BrineAir using IdealGas = Dumux::IdealGas<Scalar>; public: + //! export the involved components using H2O = H2Otype; using Air = Components::Air<Scalar>; - using Brine = Components::Brine<Scalar, H2Otype>; using NaCl = Components::NaCl<Scalar>; + + //! export the underlying brine fluid system for the liquid phase + using Brine = Dumux::FluidSystems::Brine<Scalar, H2Otype>; + + //! export the binary coefficients between air and water using H2O_Air = BinaryCoeff::H2O_Air; - using Brine_Air = BinaryCoeff::Brine_Air<Scalar, Air>; - // the type of parameter cache objects. this fluid system does not + //! the type of parameter cache objects using ParameterCache = NullParameterCache; /**************************************** * Fluid phase related static parameters ****************************************/ - static constexpr int numPhases = 2; // liquid and gas phases + static constexpr int numPhases = 2; // one liquid and one gas phase static constexpr int numComponents = 3; // H2O, Air, NaCl static constexpr int liquidPhaseIdx = 0; // index of the liquid phase - static constexpr int gasPhaseIdx = 1; // index of the gas phase + static constexpr int gasPhaseIdx = 1; // index of the gas phase static constexpr int phase0Idx = liquidPhaseIdx; // index of the first phase - static constexpr int phase1Idx = gasPhaseIdx; // index of the second phase + static constexpr int phase1Idx = gasPhaseIdx; // index of the second phase // export component indices to indicate the main component // of the corresponding phase at atmospheric pressure 1 bar // and room temperature 20°C: static constexpr int H2OIdx = 0; static constexpr int AirIdx = 1; + static constexpr int NaClIdx = 2; static constexpr int comp0Idx = H2OIdx; static constexpr int comp1Idx = AirIdx; - static constexpr int NaClIdx = 2; + static constexpr int comp2Idx = NaClIdx; + +private: + struct BrineAdapterPolicy + { + using FluidSystem = Brine; + + static constexpr int phaseIdx(int brinePhaseIdx) { return liquidPhaseIdx; } + static constexpr int compIdx(int brineCompIdx) { return compMap[brineCompIdx]; } + + private: + static constexpr std::array<int, Brine::numComponents> compMap{ {H2OIdx, NaClIdx} }; + }; + + template<class FluidState> + using BrineAdapter = FluidStateAdapter<FluidState, BrineAdapterPolicy>; + +public: + + /**************************************** + * phase related static parameters + ****************************************/ /*! * \brief Return the human readable name of a fluid phase - * * \param phaseIdx index of the phase */ static std::string phaseName(int phaseIdx) { + assert(0 <= phaseIdx && phaseIdx < numPhases); switch (phaseIdx) { - case liquidPhaseIdx: return "liquid"; - case gasPhaseIdx: return "gas"; + case liquidPhaseIdx: return Brine::phaseName(Brine::liquidPhaseIdx); + case gasPhaseIdx: return Air::name(); } DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx); } @@ -126,19 +156,16 @@ public: /*! * \brief Return whether a phase is liquid - * * \param phaseIdx The index of the fluid phase to consider */ static bool isLiquid(int phaseIdx) { assert(0 <= phaseIdx && phaseIdx < numPhases); - return phaseIdx != gasPhaseIdx; } /*! * \brief Return whether a phase is gaseous - * * \param phaseIdx The index of the fluid phase to consider */ static constexpr bool isGas(int phaseIdx) @@ -167,7 +194,6 @@ public: // we assume Henry's and Raoult's laws for the water phase and // and no interaction between gas molecules of different // components, so all phases are ideal mixtures! - return true; } @@ -186,72 +212,90 @@ public: // ideal gases are always compressible if (phaseIdx == gasPhaseIdx) return true; - // the water component decides for the liquid phase... - return H2O::liquidIsCompressible(); + // let brine decide for the liquid phase... + return Brine::isCompressible(Brine::liquidPhaseIdx); } /*! * \brief Returns true if and only if a fluid phase is assumed to * be an ideal gas. - * * \param phaseIdx The index of the fluid phase to consider */ static bool isIdealGas(int phaseIdx) { assert(0 <= phaseIdx && phaseIdx < numPhases); - // let the fluids decide if (phaseIdx == gasPhaseIdx) return H2O::gasIsIdeal() && Air::gasIsIdeal(); return false; // not a gas } + /*! + * \brief Get the main component of a given phase if possible + * \param phaseIdx The index of the fluid phase to consider + */ + static constexpr int getMainComponent(int phaseIdx) + { + assert(0 <= phaseIdx && phaseIdx < numPhases); + if (phaseIdx == liquidPhaseIdx) + return H2OIdx; + else + return AirIdx; + } + /**************************************** * Component related static parameters ****************************************/ /*! * \brief Return the human readable name of a component - * * \param compIdx The index of the component to consider */ static std::string componentName(int compIdx) { + assert(0 <= compIdx && compIdx < numComponents); switch (compIdx) { - case H2OIdx: return H2O::name(); - case AirIdx: return Air::name(); - case NaClIdx:return "NaCl"; + case H2OIdx: return H2O::name(); + case AirIdx: return Air::name(); + case NaClIdx: return NaCl::name(); } DUNE_THROW(Dune::InvalidStateException, "Invalid component index " << compIdx); } /*! * \brief Return the molar mass of a component in \f$\mathrm{[kg/mol]}\f$. - * * \param compIdx The index of the component to consider */ static Scalar molarMass(int compIdx) { + assert(0 <= compIdx && compIdx < numComponents); switch (compIdx) { - case H2OIdx: return H2O::molarMass(); - case AirIdx: return Air::molarMass(); - case NaClIdx:return NaCl::molarMass(); + case H2OIdx: return H2O::molarMass(); + case AirIdx: return Air::molarMass(); + case NaClIdx: return NaCl::molarMass(); } DUNE_THROW(Dune::InvalidStateException, "Invalid component index " << compIdx); } /*! - * \brief Return the saturation vapor pressure of the liquid phase \f$\mathrm{[Pa]}\f$. + * \brief Vapor pressure of a component \f$\mathrm{[Pa]}\f$. * - * \param Temperature temperature of the liquid phase - * \param salinity salinity (salt mass fraction) of the liquid phase + * \param fluidState The fluid state + * \param compIdx The index of the component to consider */ - static Scalar vaporPressure(Scalar temperature, Scalar salinity) //Vapor pressure dependence on Osmosis - { - return Brine::vaporPressure(temperature, salinity); - } - + template <class FluidState> + static Scalar vaporPressure(const FluidState& fluidState, int compIdx) + { + // The vapor pressure of the water is affected by the + // salinity, thus, we forward to the interface of Brine here + if (compIdx == H2OIdx) + return Brine::vaporPressure(BrineAdapter<FluidState>(fluidState), Brine::H2OIdx); + else if (compIdx == NaClIdx) + DUNE_THROW(Dune::NotImplemented, "NaCl::vaporPressure(t)"); + else + DUNE_THROW(Dune::NotImplemented, "Invalid component index " << compIdx); + } /**************************************** * thermodynamic relations @@ -291,13 +335,9 @@ public: std::cout << " - use ideal gas density: " << std::boolalpha << Policy::useIdealGasDensity() << std::endl; if (H2O::isTabulated) - { - H2O::init(tempMin, tempMax, nTemp, - pressMin, pressMax, nPress); - } + H2O::init(tempMin, tempMax, nTemp, pressMin, pressMax, nPress); } - using Base::density; /*! * \brief Given a phase's composition, temperature, pressure, and * the partial pressures of all components, return its @@ -311,47 +351,43 @@ public: * - cited by: Bachu & Adams (2002) * "Equations of State for basin geofluids" \cite adams2002 */ + using Base::density; template <class FluidState> - static Scalar density(const FluidState &fluidState, - int phaseIdx) + static Scalar density(const FluidState &fluidState, int phaseIdx) { assert(0 <= phaseIdx && phaseIdx < numPhases); - Scalar temperature = fluidState.temperature(phaseIdx); - Scalar pressure = fluidState.pressure(phaseIdx); + const auto T = fluidState.temperature(phaseIdx); + const auto p = fluidState.pressure(phaseIdx); - if (phaseIdx == phase0Idx){ + if (phaseIdx == liquidPhaseIdx) + { + // assume pure brine if (Policy::useBrineDensityAsLiquidMixtureDensity()) - // assume pure brine - return Brine::liquidDensity(temperature, - pressure, - fluidState.massFraction(phase0Idx, NaClIdx)); + return Brine::density(BrineAdapter<FluidState>(fluidState), Brine::liquidPhaseIdx); + + // assume one molecule of gas replaces one "brine" molecule else - { - return Brine::liquidMolarDensity(temperature, - pressure, - fluidState.massFraction(phase0Idx, NaClIdx)) - * (Brine::molarMass()*fluidState.moleFraction(liquidPhaseIdx, H2OIdx) - + Brine::molarMass()*fluidState.moleFraction(liquidPhaseIdx, NaClIdx) - + Air::molarMass()*fluidState.moleFraction(liquidPhaseIdx, AirIdx)); - } + return Brine::molarDensity(BrineAdapter<FluidState>(fluidState), Brine::liquidPhaseIdx) + *(H2O::molarMass()*fluidState.moleFraction(liquidPhaseIdx, H2OIdx) + + NaCl::molarMass()*fluidState.moleFraction(liquidPhaseIdx, NaClIdx) + + Air::molarMass()*fluidState.moleFraction(liquidPhaseIdx, AirIdx)); } - else if (phaseIdx == phase1Idx){ - if (Policy::useIdealGasDensity()) + else if (phaseIdx == phase1Idx) + { // for the gas phase assume an ideal gas - { - const Scalar averageMolarMass = fluidState.averageMolarMass(phase1Idx); - return IdealGas::density(averageMolarMass, temperature, pressure); - } + if (Policy::useIdealGasDensity()) + return IdealGas::density(fluidState.averageMolarMass(phase1Idx), T, p); - return Brine::gasDensity(temperature, fluidState.partialPressure(phase1Idx, H2OIdx)) - + Air::gasDensity(temperature, fluidState.partialPressure(phase1Idx, AirIdx)); + // if useComplexRelations = true, compute density. NaCl is assumed + // not to be present in gas phase, NaCl has only solid interfaces implemented + return H2O::gasDensity(T, fluidState.partialPressure(phase1Idx, H2OIdx)) + + Air::gasDensity(T, fluidState.partialPressure(phase1Idx, AirIdx)); } else DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx); } - using Base::molarDensity; /*! * \brief The molar density \f$\rho_{mol,\alpha}\f$ * of a fluid phase \f$\alpha\f$ in \f$\mathrm{[mol/m^3]}\f$ @@ -361,32 +397,29 @@ public: * * \f[\rho_{mol,\alpha} = \frac{\rho_\alpha}{\overline M_\alpha} \;.\f] */ + using Base::molarDensity; template <class FluidState> - static Scalar molarDensity(const FluidState &fluidState, int phaseIdx) + static Scalar molarDensity(const FluidState& fluidState, int phaseIdx) { - const Scalar temperature = fluidState.temperature(phaseIdx); - const Scalar pressure = fluidState.pressure(phaseIdx); if (phaseIdx == liquidPhaseIdx) - { - // assume pure water or that each gas molecule displaces exactly one - // molecule in the liquid. - Scalar salinity = fluidState.massFraction(liquidPhaseIdx, NaClIdx); - return Brine::liquidMolarDensity(temperature, pressure, salinity); - } + return Brine::molarDensity(BrineAdapter<FluidState>(fluidState), Brine::liquidPhaseIdx); else if (phaseIdx == phase1Idx) { - if (Policy::useIdealGasDensity()) + const Scalar T = fluidState.temperature(phaseIdx); + // for the gas phase assume an ideal gas - { return IdealGas::molarDensity(temperature, pressure); } + if (Policy::useIdealGasDensity()) + return IdealGas::molarDensity(T, fluidState.pressure(phaseIdx)); - return Brine::gasMolarDensity(temperature, fluidState.partialPressure(phase1Idx, H2OIdx)) - + Air::gasMolarDensity(temperature, fluidState.partialPressure(phase1Idx, AirIdx)); + // if useComplexRelations = true, compute density. NaCl is assumed + // not to be present in gas phase, NaCl has only solid interfaces implemented + return H2O::gasMolarDensity(T, fluidState.partialPressure(phase1Idx, H2OIdx)) + + Air::gasMolarDensity(T, fluidState.partialPressure(phase1Idx, AirIdx)); } else DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx); } - using Base::viscosity; /*! * \brief Calculate the dynamic viscosity of a fluid phase \f$\mathrm{[Pa*s]}\f$ * @@ -397,34 +430,18 @@ public: * component is neglected. This contribution is probably not big, but somebody * would have to find out its influence. */ + using Base::viscosity; template <class FluidState> - static Scalar viscosity(const FluidState &fluidState, - int phaseIdx) + static Scalar viscosity(const FluidState& fluidState, int phaseIdx) { - assert(0 <= phaseIdx && phaseIdx < numPhases); - Scalar temperature = fluidState.temperature(phaseIdx); - Scalar pressure = fluidState.pressure(phaseIdx); - Scalar result = 0; - if (phaseIdx == liquidPhaseIdx) - { - Scalar XNaCl = fluidState.massFraction(liquidPhaseIdx, NaClIdx); - result = Brine::liquidViscosity(temperature, pressure, XNaCl); - } - else if (phaseIdx == phase1Idx) - { - result = Air::gasViscosity(temperature, pressure); - } + return Brine::viscosity(BrineAdapter<FluidState>(fluidState), Brine::liquidPhaseIdx); else - DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx); - - Valgrind::CheckDefined(result); - return result; + return Air::gasViscosity(fluidState.temperature(phaseIdx), fluidState.pressure(phaseIdx)); } - using Base::fugacityCoefficient; /*! * \brief Returns the fugacity coefficient \f$\mathrm{[-]}\f$ of a component in a * phase. @@ -446,34 +463,38 @@ public: * Henry constant for the solutes and the saturated vapor pressure * both divided by phase pressure. */ + using Base::fugacityCoefficient; template <class FluidState> - static Scalar fugacityCoefficient(const FluidState &fluidState, - int phaseIdx, - int compIdx) + static Scalar fugacityCoefficient(const FluidState& fluidState, int phaseIdx, int compIdx) { assert(0 <= phaseIdx && phaseIdx < numPhases); assert(0 <= compIdx && compIdx < numComponents); Scalar T = fluidState.temperature(phaseIdx); Scalar p = fluidState.pressure(phaseIdx); - assert(T > 0); - assert(p > 0); if (phaseIdx == gasPhaseIdx) return 1.0; - else if (phaseIdx == phase0Idx) + else if (phaseIdx == liquidPhaseIdx) { + // TODO: Should we use the vapor pressure of the mixture (brine) here? + // The presence of NaCl lowers the vapor pressure, thus, we would + // expect the fugacity coefficient to be lower as well. However, + // with the fugacity coefficient being dependent on the salinity, + // the equation system for the phase equilibria becomes non-linear + // and our constraint solvers assume linear system of equations. if (compIdx == H2OIdx) return H2O::vaporPressure(T)/p; else if (compIdx == AirIdx) return BinaryCoeff::H2O_Air::henry(T)/p; + // we assume nacl always stays in the liquid phase else - return 1/p; + return 0.0; } - else + DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx); } @@ -486,7 +507,6 @@ public: DUNE_THROW(Dune::NotImplemented, "Diffusion coefficients"); } - using Base::binaryDiffusionCoefficient; /*! * \brief Given a phase's composition, temperature and pressure, * return the binary diffusion coefficient \f$\mathrm{[m^2/s]}\f$ for components @@ -497,8 +517,9 @@ public: * \param compIIdx The index of the first component to consider * \param compJIdx The index of the second component to consider */ + using Base::binaryDiffusionCoefficient; template <class FluidState> - static Scalar binaryDiffusionCoefficient(const FluidState &fluidState, + static Scalar binaryDiffusionCoefficient(const FluidState& fluidState, int phaseIdx, int compIIdx, int compJIdx) @@ -507,46 +528,43 @@ public: assert(0 <= compIIdx && compIIdx < numComponents); assert(0 <= compJIdx && compJIdx < numComponents); - Scalar temperature = fluidState.temperature(phaseIdx); - Scalar pressure = fluidState.pressure(phaseIdx); + const auto T = fluidState.temperature(phaseIdx); + const auto p = fluidState.pressure(phaseIdx); + + if (compIIdx > compJIdx) + std::swap(compIIdx, compJIdx); - if (phaseIdx == liquidPhaseIdx) { - Scalar result = 0.0; - if(compJIdx == AirIdx) - result = Brine_Air::liquidDiffCoeff(temperature, pressure); - else if (compJIdx == NaClIdx) - result = 0.12e-9; //http://webserver.dmt.upm.es/~isidoro/dat1/Mass%20diffusivity%20data.htm + if (phaseIdx == liquidPhaseIdx) + { + if(compIIdx == H2OIdx && compJIdx == AirIdx) + return H2O_Air::liquidDiffCoeff(T, p); + else if (compIIdx == H2OIdx && compJIdx == NaClIdx) + return Brine::binaryDiffusionCoefficient(BrineAdapter<FluidState>(fluidState), Brine::liquidPhaseIdx, Brine::H2OIdx, Brine::NaClIdx); else DUNE_THROW(Dune::NotImplemented, "Binary diffusion coefficient of components " << compIIdx << " and " << compJIdx << " in phase " << phaseIdx); - Valgrind::CheckDefined(result); - return result; } - else { - assert(phaseIdx == gasPhaseIdx); - - if (compIIdx != AirIdx) - { - using std::swap; - swap(compIIdx, compJIdx); - } - - Scalar result = 0.0; - if(compJIdx == H2OIdx) - result = Brine_Air::gasDiffCoeff(temperature, pressure); - else if (compJIdx == NaClIdx) - result = 0.12e-9; //Just added to avoid numerical problem. does not have any physical significance + else if (phaseIdx == gasPhaseIdx) + { + if (compIIdx == H2OIdx && compJIdx == AirIdx) + return H2O_Air::gasDiffCoeff(T, p); + + // NaCl is expected to never be present in the gas phase. we need to + // return a diffusion coefficient that does not case numerical problems. + // We choose a very small value here. + else if (compIIdx == AirIdx && compJIdx == NaClIdx) + return 1e-12; + else DUNE_THROW(Dune::NotImplemented, "Binary diffusion coefficient of components " << compIIdx << " and " << compJIdx << " in phase " << phaseIdx); - Valgrind::CheckDefined(result); - return result; } + + DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx); } - using Base::enthalpy; /*! * \brief Given a phase's composition, temperature and pressure, * return its specific enthalpy \f$\mathrm{[J/kg]}\f$. @@ -566,9 +584,9 @@ public: * is neglected. This contribution is probably not big. Somebody would have to * find out the enthalpy of solution for this system. ... */ + using Base::enthalpy; template <class FluidState> - static Scalar enthalpy(const FluidState &fluidState, - int phaseIdx) + static Scalar enthalpy(const FluidState& fluidState, int phaseIdx) { assert(0 <= phaseIdx && phaseIdx < numPhases); @@ -576,14 +594,10 @@ public: Scalar p = fluidState.pressure(phaseIdx); if (phaseIdx == liquidPhaseIdx) - { - Scalar XlNaCl = fluidState.massFraction(phaseIdx, NaClIdx); - Scalar result = Brine::liquidEnthalpy(T, p, XlNaCl); - Valgrind::CheckDefined(result); - return result; - } + return Brine::enthalpy(BrineAdapter<FluidState>(fluidState), Brine::liquidPhaseIdx); else { + // This assumes NaCl not to be present in the gas phase Scalar XAir = fluidState.massFraction(gasPhaseIdx, AirIdx); Scalar XH2O = fluidState.massFraction(gasPhaseIdx, H2OIdx); @@ -602,9 +616,7 @@ public: * \param componentIdx The index of the component */ template <class FluidState> - static Scalar componentEnthalpy(const FluidState &fluidState, - int phaseIdx, - int componentIdx) + static Scalar componentEnthalpy(const FluidState& fluidState, int phaseIdx, int componentIdx) { Scalar T = fluidState.temperature(gasPhaseIdx); Scalar p = fluidState.pressure(gasPhaseIdx); @@ -612,91 +624,69 @@ public: Valgrind::CheckDefined(p); if (phaseIdx == liquidPhaseIdx) - { DUNE_THROW(Dune::NotImplemented, "The component enthalpies in the liquid phase are not implemented."); - } + else if (phaseIdx == gasPhaseIdx) { - if (componentIdx == H2OIdx) - { + if (componentIdx == H2OIdx) return H2O::gasEnthalpy(T, p); - } else if (componentIdx == AirIdx) - { return Air::gasEnthalpy(T, p); - } + else if (componentIdx == NaClIdx) + DUNE_THROW(Dune::InvalidStateException, "Implementation assumes NaCl not to be present in gas phase"); DUNE_THROW(Dune::InvalidStateException, "Invalid component index " << componentIdx); } DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx); } - - using Base::thermalConductivity; /*! * \brief Thermal conductivity of a fluid phase \f$\mathrm{[W/(m K)]}\f$. * \param fluidState An abitrary fluid state * \param phaseIdx The index of the fluid phase to consider * - * \note For the thermal conductivity of the phases the contribution of the minor - * component is neglected. This contribution is probably not big, but somebody + * \todo TODO: For the thermal conductivity of the air phase the contribution of the minor + * components is neglected. This contribution is probably not big, but somebody * would have to find out its influence. */ + using Base::thermalConductivity; template <class FluidState> - static Scalar thermalConductivity(const FluidState &fluidState, - int phaseIdx) + static Scalar thermalConductivity(const FluidState& fluidState, int phaseIdx) { if (phaseIdx == liquidPhaseIdx) - return H2O::liquidThermalConductivity(fluidState.temperature(phaseIdx), - fluidState.pressure(phaseIdx)); - else // gas phase - return Air::gasThermalConductivity(fluidState.temperature(phaseIdx), - fluidState.pressure(phaseIdx)); + return Brine::thermalConductivity(BrineAdapter<FluidState>(fluidState), Brine::liquidPhaseIdx); + else if (phaseIdx == gasPhaseIdx) + return Air::gasThermalConductivity(fluidState.temperature(phaseIdx), fluidState.pressure(phaseIdx)); + + DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx); } - using Base::heatCapacity; /*! * \brief Specific isobaric heat capacity of a fluid phase. * \f$\mathrm{[J/(kg*K)}\f$. * \param fluidState An abitrary fluid state * \param phaseIdx The index of the fluid phase to consider * - * \note The calculation of the isobaric heat capacity is preliminary. A better - * description of the influence of the composition on the phase property + * \todo TODO: The calculation of the isobaric heat capacity is preliminary. A better + * description of the influence of the composition on the air phase property * has to be found. */ + using Base::heatCapacity; template <class FluidState> - static Scalar heatCapacity(const FluidState &fluidState, - int phaseIdx) + static Scalar heatCapacity(const FluidState &fluidState, int phaseIdx) { - const Scalar temperature = fluidState.temperature(phaseIdx); - const Scalar pressure = fluidState.pressure(phaseIdx); + const Scalar T = fluidState.temperature(phaseIdx); + const Scalar p = fluidState.pressure(phaseIdx); + if (phaseIdx == liquidPhaseIdx) - { - return H2O::liquidHeatCapacity(temperature, pressure); - } - else if (phaseIdx == gasPhaseIdx) - { - return Air::gasHeatCapacity(temperature, pressure) * fluidState.moleFraction(gasPhaseIdx, AirIdx) - + H2O::gasHeatCapacity(temperature, pressure) * fluidState.moleFraction(gasPhaseIdx, H2OIdx); - } - else - DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx); - } + return Brine::heatCapacity(BrineAdapter<FluidState>(fluidState), Brine::liquidPhaseIdx); - /*! - * \brief Return the molality of NaCl \f$\mathrm{[mol/m^3]}\f$. - * \param fluidState An abitrary fluid state - * \param paramCache parameter cache - * \param salinity Salinity of brine - */ - template <class FluidState> - static Scalar molalityNaCl(const FluidState &fluidState, - const ParameterCache ¶mCache, - Scalar salinity) - { - return Brine_Air::molalityNaCl(salinity); - } + // We assume NaCl not to be present in the gas phase here + else if (phaseIdx == gasPhaseIdx) + return Air::gasHeatCapacity(T, p)*fluidState.moleFraction(gasPhaseIdx, AirIdx) + + H2O::gasHeatCapacity(T, p)*fluidState.moleFraction(gasPhaseIdx, H2OIdx); + DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx); + } }; } // end namespace FluidSystems diff --git a/test/material/fluidsystems/checkfluidsystem.hh b/test/material/fluidsystems/checkfluidsystem.hh index dff2e241e41f8c1050c20b479608190050254215..7f8bb33017709a33b278681af3dce6b0279593f3 100644 --- a/test/material/fluidsystems/checkfluidsystem.hh +++ b/test/material/fluidsystems/checkfluidsystem.hh @@ -64,18 +64,15 @@ namespace Dumux /*! \brief This fluid state ensures that only the allowed quantities * are accessed */ -template<class Scalar, class FluidSystem, class BaseFluidState = CompositionalFluidState<Scalar, FluidSystem> > +template<class ScalarType, class FluidSystem, class BaseFluidState = CompositionalFluidState<ScalarType, FluidSystem> > class HairSplittingFluidState: protected BaseFluidState { public: - enum - { - numPhases = FluidSystem::numPhases - }; - enum - { - numComponents = FluidSystem::numComponents - }; + //! export the type used for scalars + using typename BaseFluidState::Scalar; + + static constexpr int numPhases = FluidSystem::numPhases; + static constexpr int numComponents = FluidSystem::numComponents; HairSplittingFluidState() { diff --git a/test/material/fluidsystems/test_fluidsystems.cc b/test/material/fluidsystems/test_fluidsystems.cc index 469a983cc3712fae9a35b1a5128843525936dad3..3c514c2e14fbd24dff71d93a81fadc338675027d 100644 --- a/test/material/fluidsystems/test_fluidsystems.cc +++ b/test/material/fluidsystems/test_fluidsystems.cc @@ -29,6 +29,7 @@ // include all fluid systems in dumux-stable #include <dumux/material/fluidsystems/2pimmiscible.hh> #include <dumux/material/fluidsystems/base.hh> +#include <dumux/material/fluidsystems/brine.hh> #include <dumux/material/fluidsystems/brineair.hh> #include <dumux/material/fluidsystems/brineco2.hh> #include <dumux/material/fluidsystems/1pgas.hh> @@ -104,15 +105,15 @@ int main() success += checkFluidState<Scalar>(nonEquilibriumMassFluidState); // PressureOverlayFluidState - PressureOverlayFluidState<Scalar, BaseFluidState> pressureOverlayFluidState(baseFs); + PressureOverlayFluidState<BaseFluidState> pressureOverlayFluidState(baseFs); success += checkFluidState<Scalar>(pressureOverlayFluidState); // SaturationOverlayFluidState - SaturationOverlayFluidState<Scalar, BaseFluidState> saturationOverlayFluidState(baseFs); + SaturationOverlayFluidState<BaseFluidState> saturationOverlayFluidState(baseFs); success += checkFluidState<Scalar>(saturationOverlayFluidState); // TemperatureOverlayFluidState - TemperatureOverlayFluidState<Scalar, BaseFluidState> temperatureOverlayFluidState(baseFs); + TemperatureOverlayFluidState<BaseFluidState> temperatureOverlayFluidState(baseFs); success += checkFluidState<Scalar>(temperatureOverlayFluidState); } @@ -130,6 +131,11 @@ int main() // base + // Brine + { using H2OType = Components::SimpleH2O<Scalar>; + using FluidSystem = FluidSystems::Brine<Scalar, H2OType>; + success += checkFluidSystem<Scalar, FluidSystem>(); } + // Brine -- Air { using H2OType = Components::SimpleH2O<Scalar>; using FluidSystem = FluidSystems::BrineAir<Scalar, H2OType, FluidSystems::BrineAirDefaultPolicy</*fastButSimplifiedRelations=*/true>>; diff --git a/test/porousmediumflow/1pnc/implicit/CMakeLists.txt b/test/porousmediumflow/1pnc/implicit/CMakeLists.txt index 3d36101c63320b6329ec3fb2039eb6dc73728a5b..96af0283d3e88d18ab8863d0d80244f958aa9068 100644 --- a/test/porousmediumflow/1pnc/implicit/CMakeLists.txt +++ b/test/porousmediumflow/1pnc/implicit/CMakeLists.txt @@ -31,6 +31,16 @@ dune_add_test(NAME test_1p2c_mpfa ${CMAKE_CURRENT_BINARY_DIR}/1pnctest_mpfa-00009.vtu --command "${CMAKE_CURRENT_BINARY_DIR}/test_1p2c_mpfa test_1p2c_fv.input -Problem.Name 1pnctest_mpfa -Vtk.AddVelocity false") +# salt-water intrusion test using the box model +dune_add_test(NAME test_saltwaterintrusion_box + SOURCES test_1p2c_fv.cc + COMPILE_DEFINITIONS TYPETAG=SaltWaterIntrusionTestTypeTag + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/saltwaterintrusion-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/saltwaterintrusion-00035.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_saltwaterintrusion_box saltwaterintrusion.input") + # non-isothermal tests # conduction dune_add_test(NAME test_1p2cni_conduction_box diff --git a/test/porousmediumflow/1pnc/implicit/saltwaterintrusion.input b/test/porousmediumflow/1pnc/implicit/saltwaterintrusion.input new file mode 100644 index 0000000000000000000000000000000000000000..51676dbf2395118db4e79848abf0b8d9b17c7bda --- /dev/null +++ b/test/porousmediumflow/1pnc/implicit/saltwaterintrusion.input @@ -0,0 +1,15 @@ +[TimeLoop] +DtInitial = 1 # [s] +TEnd = 10000000 # [s] + +[Grid] +LowerLeft = 0 0 +UpperRight = 200 50 +Cells = 20 5 + +[Problem] +Name = saltwaterintrusion # name passed to the output routines +EnableGravity = true # enable gravity + +[Vtk] +AddVelocity = true # enable velocity output diff --git a/test/porousmediumflow/1pnc/implicit/saltwaterintrusionproblem.hh b/test/porousmediumflow/1pnc/implicit/saltwaterintrusionproblem.hh new file mode 100644 index 0000000000000000000000000000000000000000..754486f0a473d5bf8456b703db8807f441498c45 --- /dev/null +++ b/test/porousmediumflow/1pnc/implicit/saltwaterintrusionproblem.hh @@ -0,0 +1,178 @@ +// -*- 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 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU 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 OnePNCTests + * \brief Definition of a problem involving salt + * water intrusion into a fresh water aquifer. + */ +#ifndef DUMUX_SALTWATERINTRUSION_TEST_PROBLEM_HH +#define DUMUX_SALTWATERINTRUSION_TEST_PROBLEM_HH + +#include <dumux/discretization/box/properties.hh> +#include <dumux/porousmediumflow/1pnc/model.hh> +#include <dumux/porousmediumflow/problem.hh> + +#include <dumux/material/fluidsystems/brine.hh> +#include "1pnctestspatialparams.hh" + +namespace Dumux { + +template <class TypeTag> +class SaltWaterIntrusionTestProblem; + +namespace Properties { +NEW_TYPE_TAG(SaltWaterIntrusionTestTypeTag, INHERITS_FROM(BoxModel, OnePNC)); + +// Use a structured yasp grid +SET_TYPE_PROP(SaltWaterIntrusionTestTypeTag, Grid, Dune::YaspGrid<2>); + +// Set the problem property +SET_TYPE_PROP(SaltWaterIntrusionTestTypeTag, Problem, SaltWaterIntrusionTestProblem<TypeTag>); + +// Set fluid configuration +SET_TYPE_PROP(SaltWaterIntrusionTestTypeTag, + FluidSystem, + FluidSystems::Brine< typename GET_PROP_TYPE(TypeTag, Scalar) >); + +// Set the spatial parameters +SET_TYPE_PROP(SaltWaterIntrusionTestTypeTag, SpatialParams, OnePNCTestSpatialParams<TypeTag>); + +// Use mass fractions to set salinity conveniently +SET_BOOL_PROP(SaltWaterIntrusionTestTypeTag, UseMoles, false); + +} // end namespace Properties + +/*! + * \ingroup OnePNCTests + * \brief Definition of a problem involving salt water intrusion into a + * fresh water aquifer. The aquifer is in contact with salt water + * with a salinity of 0.03 on the right boundary. + * \note To run the simulation execute the following line in shell: + * <tt>./test_saltwaterintrusion -parameterFile saltwaterintrusion.input</tt> or + */ +template <class TypeTag> +class SaltWaterIntrusionTestProblem : public PorousMediumFlowProblem<TypeTag> +{ + using ParentType = PorousMediumFlowProblem<TypeTag>; + + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using Indices = typename GET_PROP_TYPE(TypeTag, ModelTraits)::Indices; + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using Element = typename GridView::template Codim<0>::Entity; + using GlobalPosition = typename Element::Geometry::GlobalCoordinate; + using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem); + using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes); + using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); + using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry); + + // copy pressure index for convenience + enum { pressureIdx = Indices::pressureIdx }; + + //! The test is defined using mass fractions + static_assert(!GET_PROP_VALUE(TypeTag, UseMoles), "This test uses mass fractions!"); + +public: + SaltWaterIntrusionTestProblem(std::shared_ptr<const FVGridGeometry> fvGridGeometry) + : ParentType(fvGridGeometry) + { + //initialize fluid system + FluidSystem::init(); + } + + /*! + * \name Problem parameters + */ + // \{ + + /*! + * \brief Returns the temperature within the domain [K]. + * This problem assumes a temperature of 20 degrees Celsius. + */ + Scalar temperature() const + { return 273.15 + 20; } // in [K] + + // \} + + /*! + * \name Boundary conditions + */ + // \{ + + /*! + * \brief Specifies which kind of boundary condition should be + * used for which equation on a given boundary segment. + * \param globalPos The position for which the bc type should be evaluated + */ + BoundaryTypes boundaryTypesAtPos(const GlobalPosition& globalPos) const + { + BoundaryTypes values; + values.setAllNeumann(); + + // use Dirichlet BCs on the left and right boundary + if(globalPos[0] < eps_ || globalPos[0] > this->fvGridGeometry().bBoxMax()[0] - eps_) + values.setAllDirichlet(); + + return values; + } + + /*! + * \brief Evaluate the boundary conditions for a dirichlet boundary segment. + * \param globalPos The position for which the bc type should be evaluated + */ + PrimaryVariables dirichletAtPos(const GlobalPosition& globalPos) const + { + PrimaryVariables values = initialAtPos(globalPos); + + // salt water is in contact on the right boundary + if (globalPos[0] > this->fvGridGeometry().bBoxMax()[0] - eps_) + values[FluidSystem::NaClIdx] = 0.03; + + return values; + } + + // \} + + /*! + * \name Volume terms + */ + // \{ + + /*! + * \brief Evaluate the initial value for a control volume. + * \param globalPos The position for which the initial condition should be evaluated + */ + PrimaryVariables initialAtPos(const GlobalPosition& globalPos) const + { + const Scalar depth = this->fvGridGeometry().bBoxMax()[1] - globalPos[1]; + PrimaryVariables priVars; + priVars[pressureIdx] = 1e5 + depth*9.81*1000; // hydrostatic pressure (assume rho_water = 1000.0) + priVars[FluidSystem::NaClIdx] = 0.0; // initially only fresh water is present + return priVars; + } + + // \} + +private: + static constexpr Scalar eps_ = 1e-6; +}; + +} //end namespace Dumux + +#endif diff --git a/test/porousmediumflow/1pnc/implicit/test_1p2c_fv.cc b/test/porousmediumflow/1pnc/implicit/test_1p2c_fv.cc index 86133ee13d6ea3cf46a160c0f156baf15f4039e5..9d795a197585ee7d9ab56bcceea73036fa8b8051 100644 --- a/test/porousmediumflow/1pnc/implicit/test_1p2c_fv.cc +++ b/test/porousmediumflow/1pnc/implicit/test_1p2c_fv.cc @@ -24,6 +24,7 @@ #include <config.h> #include "1p2ctestproblem.hh" +#include "saltwaterintrusionproblem.hh" #include <ctime> #include <iostream> diff --git a/test/references/saltflushbox2pncmin-reference.vtu b/test/references/saltflushbox2pncmin-reference.vtu index d39e5de0d1f26c1e47a19765e8f25923d73f1790..dca33e83d23032f6c90cd7e04654b975ccfff19a 100644 --- a/test/references/saltflushbox2pncmin-reference.vtu +++ b/test/references/saltflushbox2pncmin-reference.vtu @@ -2,424 +2,424 @@ <VTKFile type="UnstructuredGrid" version="0.1" byte_order="LittleEndian"> <UnstructuredGrid> <Piece NumberOfCells="200" NumberOfPoints="231"> - <PointData Scalars="porosity" Vectors="velocity_liquid (m/s)"> + <PointData Scalars="porosity" Vectors="velocity_brine (m/s)"> <DataArray type="Float32" Name="porosity" NumberOfComponents="1" format="ascii"> - 0.11 0.11 0.11 0.11 0.11 0.11 0.109838 0.109828 0.062494 0.0625103 0.0575186 0.057519 - 0.0575076 0.0575094 0.0574979 0.0575014 0.0574905 0.0574927 0.0574824 0.0574865 0.105384 0.105401 0.10537 0.105387 - 0.10536 0.105376 0.105355 0.105368 0.105337 0.105319 0.105295 0.105295 0.105294 0.105294 0.105292 0.105292 - 0.10529 0.10529 0.105285 0.105285 0.11 0.11 0.11 0.11 0.11 0.109905 0.0653625 0.0575216 - 0.0575118 0.057503 0.057495 0.0574881 0.105409 0.105396 0.105385 0.105376 0.105317 0.105295 0.105294 0.105292 - 0.10529 0.105285 0.11 0.11 0.11 0.11 0.109944 0.0686765 0.0575236 0.0575135 0.0575043 0.0574967 - 0.0574891 0.105413 0.1054 0.10539 0.105381 0.105317 0.105295 0.105294 0.105292 0.10529 0.105285 0.11 - 0.11 0.11 0.11 0.109965 0.0718747 0.0575253 0.0575148 0.0575054 0.0574979 0.05749 0.105415 0.105403 - 0.105393 0.105384 0.105318 0.105295 0.105294 0.105292 0.10529 0.105285 0.11 0.11 0.11 0.11 - 0.109973 0.0749164 0.0575267 0.0575159 0.0575065 0.057499 0.0574908 0.105418 0.105406 0.105396 0.105387 0.105319 - 0.105295 0.105294 0.105292 0.10529 0.105285 0.11 0.11 0.11 0.11 0.109981 0.0780861 0.0575282 - 0.0575168 0.0575076 0.0574999 0.0574915 0.10542 0.105408 0.105399 0.10539 0.10532 0.105295 0.105294 0.105292 - 0.10529 0.105285 0.11 0.11 0.11 0.11 0.109985 0.0815867 0.0575298 0.0575178 0.0575088 0.0575008 - 0.0574922 0.105422 0.105411 0.105402 0.105393 0.105321 0.105295 0.105293 0.105292 0.10529 0.105286 0.11 - 0.11 0.11 0.11 0.10999 0.0858482 0.0575317 0.0575187 0.0575099 0.0575017 0.0574933 0.105424 0.105415 - 0.105405 0.105396 0.105321 0.105295 0.105293 0.105292 0.10529 0.105286 0.11 0.11 0.11 0.11 - 0.109992 0.0891326 0.0575339 0.0575196 0.0575107 0.0575026 0.0574949 0.105429 0.10542 0.10541 0.105399 0.105319 - 0.105295 0.105293 0.105292 0.10529 0.105286 0.11 0.11 0.11 0.11 0.109982 0.0758322 0.0575336 - 0.0575229 0.0575145 0.0575059 0.0574985 0.105454 0.105449 0.105435 0.105423 0.1053 0.105294 0.105293 0.105292 - 0.10529 0.105286 0.11 + 0.11 0.11 0.11 0.11 0.11 0.11 0.109738 0.109779 0.0605316 0.0612575 0.057518 0.0575188 + 0.057507 0.0575092 0.0574974 0.0575013 0.05749 0.0574925 0.0574819 0.0574865 0.105382 0.1054 0.105367 0.105385 + 0.105358 0.105375 0.105353 0.105367 0.10534 0.105322 0.105295 0.105295 0.105294 0.105294 0.105293 0.105293 + 0.105291 0.105291 0.105286 0.105286 0.11 0.11 0.11 0.11 0.11 0.109894 0.064714 0.0575217 + 0.0575119 0.0575033 0.0574952 0.0574884 0.105409 0.105395 0.105384 0.105375 0.105319 0.105295 0.105294 0.105293 + 0.105291 0.105286 0.11 0.11 0.11 0.11 0.109942 0.0684475 0.0575239 0.0575138 0.0575046 0.057497 + 0.0574895 0.105414 0.1054 0.10539 0.105381 0.10532 0.105295 0.105294 0.105293 0.105291 0.105286 0.11 + 0.11 0.11 0.11 0.109965 0.0719387 0.0575257 0.0575152 0.0575058 0.0574984 0.0574904 0.105416 0.105403 + 0.105394 0.105384 0.10532 0.105295 0.105294 0.105293 0.105291 0.105286 0.11 0.11 0.11 0.11 + 0.109973 0.0752046 0.0575273 0.0575164 0.0575071 0.0574995 0.0574913 0.105419 0.105407 0.105397 0.105388 0.105321 + 0.105295 0.105294 0.105293 0.105291 0.105286 0.11 0.11 0.11 0.11 0.109982 0.0786086 0.0575288 + 0.0575174 0.0575083 0.0575005 0.0574921 0.105421 0.10541 0.1054 0.105391 0.105322 0.105295 0.105294 0.105293 + 0.105291 0.105286 0.11 0.11 0.11 0.11 0.109986 0.0825068 0.0575306 0.0575184 0.0575096 0.0575015 + 0.0574928 0.105423 0.105413 0.105404 0.105394 0.105323 0.105295 0.105294 0.105293 0.105291 0.105286 0.11 + 0.11 0.11 0.11 0.10999 0.0875943 0.0575327 0.0575194 0.0575108 0.0575025 0.0574944 0.105426 0.105417 + 0.105408 0.105398 0.105323 0.105295 0.105294 0.105293 0.105291 0.105286 0.11 0.11 0.11 0.11 + 0.109993 0.0927399 0.0575351 0.0575204 0.0575122 0.0575036 0.0574962 0.105431 0.105423 0.105413 0.105402 0.10532 + 0.105295 0.105294 0.105293 0.105291 0.105286 0.11 0.11 0.11 0.11 0.109987 0.0805095 0.0575353 + 0.0575244 0.0575161 0.0575075 0.0575001 0.105461 0.105457 0.105442 0.105428 0.1053 0.105295 0.105294 0.105293 + 0.105291 0.105286 0.11 </DataArray> <DataArray type="Float32" Name="pc" NumberOfComponents="1" format="ascii"> - 516.075 509.366 516.075 514.447 506.126 510.667 499.687 499.687 499.687 499.687 499.687 499.687 + 516.075 509.662 516.075 514.651 506.072 510.683 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 - 499.687 499.687 499.687 499.687 504.238 515.318 520.562 529.773 529.794 545.147 559.974 616.585 - 844.827 1008.77 1041.31 1096.2 7500 7500 516.075 516.513 513.296 499.687 499.687 499.687 - 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 519.001 534.797 556.708 693.546 - 1068.46 1096.41 7500 516.075 516.935 514.703 499.687 499.687 499.687 499.687 499.687 499.687 - 499.687 499.687 499.687 499.687 499.687 520.687 538.112 567.377 766.702 1082.91 1096.44 7500 - 516.075 516.861 515.316 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 - 499.687 499.687 521.579 540.612 578.389 834.853 1087.11 1096.45 7500 516.075 516.738 515.556 - 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 522.217 - 542.86 591.082 899.417 1088.62 1096.46 7500 516.075 516.636 515.663 499.687 499.687 499.687 - 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 522.851 545.248 607.391 959.724 - 1089.24 1096.46 7500 516.075 516.553 515.726 499.687 499.687 499.687 499.687 499.687 499.687 - 499.687 499.687 499.687 499.687 499.687 523.604 548.085 630.774 1012.59 1089.54 1096.49 7500 - 516.075 516.481 515.755 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 - 499.687 499.687 524.656 551.886 668.444 1052.87 1090.08 1096.89 7500 516.075 516.495 515.654 - 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 526.82 - 558.326 735.181 1080.89 1094.93 1101.59 7500 516.075 523.194 528.934 499.687 499.687 499.687 - 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 548.81 616.637 958.196 1140.83 - 1142.68 1148.56 7500 + 499.687 499.687 499.687 499.687 502.488 513.847 519.203 528.195 527.213 541.837 550.462 598.301 + 783.76 971.181 1032.24 1096.18 7500 7500 516.075 516.585 513.333 499.687 499.687 499.687 + 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 517.703 533.32 552.944 668.018 + 1057.48 1096.5 7500 516.075 516.947 514.742 499.687 499.687 499.687 499.687 499.687 499.687 + 499.687 499.687 499.687 499.687 499.687 519.617 536.882 563.784 748.476 1081.1 1096.56 7500 + 516.075 516.86 515.355 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 + 499.687 499.687 520.732 539.705 575.648 826.381 1086.97 1096.57 7500 516.075 516.735 515.595 + 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 521.58 + 542.333 590.169 901.886 1088.78 1096.57 7500 516.075 516.634 515.704 499.687 499.687 499.687 + 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 522.419 545.18 609.884 971.268 + 1089.44 1096.58 7500 516.075 516.551 515.771 499.687 499.687 499.687 499.687 499.687 499.687 + 499.687 499.687 499.687 499.687 499.687 523.415 548.668 640.224 1028.38 1089.74 1096.63 7500 + 516.075 516.48 515.811 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 + 499.687 499.687 524.807 553.573 690.604 1065.63 1090.42 1097.22 7500 516.075 516.485 515.721 + 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 527.471 + 562.067 774.433 1088.24 1096.43 1103.23 7500 516.075 522.722 527.915 499.687 499.687 499.687 + 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 552.48 638.747 1021.94 1148.58 + 1149.63 1156.33 7500 </DataArray> <DataArray type="Float32" Name="S_w" NumberOfComponents="1" format="ascii"> - 0.95 0.969886 0.95 0.954755 0.979775 0.965969 1 1 1 1 1 1 + 0.95 0.968994 0.95 0.954156 0.979941 0.965922 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 - 1 1 1 1 0.985626 0.952206 0.937125 0.911718 0.911659 0.87214 0.837018 0.725414 - 0.479867 0.396291 0.384216 0.36623 0.2 0.2 0.95 0.948727 0.958142 1 1 1 - 1 1 1 1 1 1 1 1 0.941568 0.898407 0.844512 0.615276 - 0.374972 0.366165 0.2 0.95 0.947508 0.954004 1 1 1 1 1 1 - 1 1 1 1 1 0.936773 0.889829 0.820503 0.539808 0.370333 0.366156 0.2 - 0.95 0.947721 0.95221 1 1 1 1 1 1 1 1 1 - 1 1 0.934254 0.883465 0.797099 0.486594 0.36902 0.366153 0.2 0.95 0.948078 0.95151 - 1 1 1 1 1 1 1 1 1 1 1 0.932462 - 0.877814 0.771731 0.446925 0.368552 0.366152 0.2 0.95 0.948371 0.9512 1 1 1 - 1 1 1 1 1 1 1 1 0.930687 0.87189 0.741439 0.416867 - 0.36836 0.36615 0.2 0.95 0.948614 0.951017 1 1 1 1 1 1 - 1 1 1 1 1 0.928586 0.864953 0.702041 0.394814 0.368267 0.366141 0.2 - 0.95 0.948822 0.950932 1 1 1 1 1 1 1 1 1 - 1 1 0.925668 0.855826 0.647051 0.380192 0.368102 0.36602 0.2 0.95 0.94878 0.951224 - 1 1 1 1 1 1 1 1 1 1 1 0.919719 - 0.840782 0.569572 0.370971 0.366616 0.364607 0.2 0.95 0.929728 0.913977 1 1 1 - 1 1 1 1 1 1 1 1 0.863197 0.725325 0.41756 0.353477 - 0.352981 0.351419 0.2 + 1 1 1 1 0.991108 0.956518 0.94099 0.915977 0.918645 0.880376 0.859222 0.758017 + 0.525177 0.411781 0.387466 0.366237 0.2 0.2 0.95 0.94852 0.958034 1 1 1 + 1 1 1 1 1 1 1 1 0.945289 0.902282 0.853318 0.647621 + 0.378625 0.366137 0.2 0.95 0.947472 0.953888 1 1 1 1 1 1 + 1 1 1 1 1 0.939809 0.892995 0.828437 0.556559 0.370904 0.366121 0.2 + 0.95 0.947723 0.952097 1 1 1 1 1 1 1 1 1 + 1 1 0.936646 0.885763 0.802799 0.4925 0.369065 0.366117 0.2 0.95 0.948084 0.951397 + 1 1 1 1 1 1 1 1 1 1 1 0.934251 + 0.879134 0.7735 0.445575 0.368502 0.366116 0.2 0.95 0.948377 0.95108 1 1 1 + 1 1 1 1 1 1 1 1 0.931894 0.872059 0.737023 0.411743 + 0.3683 0.366114 0.2 0.95 0.948617 0.950884 1 1 1 1 1 1 + 1 1 1 1 1 0.929112 0.863541 0.68733 0.388877 0.368206 0.366099 0.2 + 0.95 0.948824 0.950767 1 1 1 1 1 1 1 1 1 + 1 1 0.925251 0.851833 0.618821 0.375904 0.367996 0.36592 0.2 0.95 0.948809 0.951031 + 1 1 1 1 1 1 1 1 1 1 1 0.917942 + 0.832281 0.533058 0.368668 0.36616 0.364117 0.2 0.95 0.931048 0.916735 1 1 1 + 1 1 1 1 1 1 1 1 0.854416 0.689587 0.391266 0.351412 + 0.351136 0.349391 0.2 </DataArray> <DataArray type="Float32" Name="p_w" NumberOfComponents="1" format="ascii"> - 1.29995e+07 1.29991e+07 1.29995e+07 1.29901e+07 1.2982e+07 1.29727e+07 1.29608e+07 1.29512e+07 1.28844e+07 1.28761e+07 1.26579e+07 1.26511e+07 - 1.23827e+07 1.23747e+07 1.20968e+07 1.20881e+07 1.18057e+07 1.17967e+07 1.15124e+07 1.15031e+07 1.13994e+07 1.139e+07 1.13562e+07 1.13467e+07 - 1.13127e+07 1.13032e+07 1.12687e+07 1.12592e+07 1.12225e+07 1.12142e+07 1.11716e+07 1.11616e+07 1.11084e+07 1.10989e+07 1.10457e+07 1.10323e+07 - 1.10082e+07 1.10087e+07 1.10048e+07 1.1004e+07 1.09925e+07 1.09925e+07 1.29995e+07 1.29841e+07 1.29643e+07 1.29415e+07 1.28698e+07 1.26497e+07 - 1.23688e+07 1.20804e+07 1.17881e+07 1.14939e+07 1.13806e+07 1.13373e+07 1.12938e+07 1.12499e+07 1.12059e+07 1.1152e+07 1.10888e+07 1.10234e+07 - 1.10091e+07 1.10038e+07 1.09925e+07 1.29995e+07 1.29793e+07 1.29567e+07 1.29321e+07 1.28647e+07 1.26515e+07 1.23647e+07 1.20736e+07 1.17799e+07 - 1.14848e+07 1.13713e+07 1.13279e+07 1.12844e+07 1.12408e+07 1.11972e+07 1.11427e+07 1.10788e+07 1.10194e+07 1.10091e+07 1.10037e+07 1.09925e+07 - 1.29995e+07 1.29752e+07 1.29495e+07 1.2923e+07 1.28601e+07 1.26544e+07 1.23617e+07 1.20675e+07 1.1772e+07 1.14759e+07 1.1362e+07 1.13186e+07 - 1.12751e+07 1.12316e+07 1.11883e+07 1.11335e+07 1.10691e+07 1.10172e+07 1.1009e+07 1.10037e+07 1.09925e+07 1.29995e+07 1.29713e+07 1.29427e+07 - 1.29141e+07 1.28553e+07 1.26574e+07 1.2359e+07 1.20616e+07 1.17643e+07 1.14669e+07 1.13527e+07 1.13093e+07 1.12658e+07 1.12225e+07 1.11793e+07 - 1.11243e+07 1.10594e+07 1.10158e+07 1.10088e+07 1.10036e+07 1.09925e+07 1.29995e+07 1.29674e+07 1.29358e+07 1.29051e+07 1.28502e+07 1.26599e+07 - 1.23562e+07 1.20556e+07 1.17565e+07 1.1458e+07 1.13435e+07 1.12999e+07 1.12565e+07 1.12132e+07 1.11702e+07 1.1115e+07 1.10498e+07 1.10149e+07 - 1.10087e+07 1.10035e+07 1.09925e+07 1.29995e+07 1.29633e+07 1.29287e+07 1.2896e+07 1.28443e+07 1.26612e+07 1.23524e+07 1.20492e+07 1.17486e+07 - 1.1449e+07 1.13342e+07 1.12906e+07 1.12471e+07 1.12039e+07 1.11611e+07 1.11058e+07 1.10408e+07 1.10145e+07 1.10086e+07 1.10034e+07 1.09925e+07 - 1.29995e+07 1.29585e+07 1.29211e+07 1.28866e+07 1.28374e+07 1.26602e+07 1.23472e+07 1.20422e+07 1.17404e+07 1.144e+07 1.13249e+07 1.12812e+07 - 1.12376e+07 1.11945e+07 1.11519e+07 1.10965e+07 1.10332e+07 1.10144e+07 1.10083e+07 1.10031e+07 1.09925e+07 1.29995e+07 1.29525e+07 1.29129e+07 - 1.28772e+07 1.2829e+07 1.26541e+07 1.23404e+07 1.20344e+07 1.17318e+07 1.14309e+07 1.13155e+07 1.12718e+07 1.12281e+07 1.11848e+07 1.1143e+07 - 1.10864e+07 1.10285e+07 1.10144e+07 1.10079e+07 1.10027e+07 1.09925e+07 1.29995e+07 1.29441e+07 1.29041e+07 1.2868e+07 1.28193e+07 1.26421e+07 - 1.23324e+07 1.20256e+07 1.17228e+07 1.14216e+07 1.13062e+07 1.12623e+07 1.12186e+07 1.11742e+07 1.11355e+07 1.10737e+07 1.10273e+07 1.1014e+07 - 1.10071e+07 1.10019e+07 1.09925e+07 + 1.29995e+07 1.29977e+07 1.29995e+07 1.29893e+07 1.29807e+07 1.29718e+07 1.2961e+07 1.2951e+07 1.28853e+07 1.28762e+07 1.2657e+07 1.26498e+07 + 1.23857e+07 1.23766e+07 1.21012e+07 1.20913e+07 1.18106e+07 1.18003e+07 1.15172e+07 1.15066e+07 1.14042e+07 1.13935e+07 1.13609e+07 1.13501e+07 + 1.13173e+07 1.13065e+07 1.12732e+07 1.12623e+07 1.12267e+07 1.12171e+07 1.11767e+07 1.11653e+07 1.1114e+07 1.11032e+07 1.10524e+07 1.10373e+07 + 1.10082e+07 1.10085e+07 1.10046e+07 1.10039e+07 1.09925e+07 1.09925e+07 1.29995e+07 1.29835e+07 1.29636e+07 1.2941e+07 1.28697e+07 1.26489e+07 + 1.23701e+07 1.20826e+07 1.17905e+07 1.14962e+07 1.13828e+07 1.13394e+07 1.12958e+07 1.12518e+07 1.12075e+07 1.11545e+07 1.1092e+07 1.10253e+07 + 1.10091e+07 1.10037e+07 1.09925e+07 1.29995e+07 1.29789e+07 1.2956e+07 1.29314e+07 1.28646e+07 1.26513e+07 1.23656e+07 1.20751e+07 1.17813e+07 + 1.14859e+07 1.13722e+07 1.13288e+07 1.12852e+07 1.12414e+07 1.11977e+07 1.11439e+07 1.10806e+07 1.10199e+07 1.10091e+07 1.10037e+07 1.09925e+07 + 1.29995e+07 1.29748e+07 1.2949e+07 1.29222e+07 1.286e+07 1.2655e+07 1.23625e+07 1.20682e+07 1.17724e+07 1.14757e+07 1.13617e+07 1.13182e+07 + 1.12746e+07 1.1231e+07 1.11876e+07 1.11334e+07 1.10695e+07 1.10172e+07 1.1009e+07 1.10037e+07 1.09925e+07 1.29995e+07 1.2971e+07 1.29421e+07 + 1.29133e+07 1.28554e+07 1.26587e+07 1.23599e+07 1.20617e+07 1.17637e+07 1.14656e+07 1.13511e+07 1.13076e+07 1.1264e+07 1.12206e+07 1.11774e+07 + 1.11229e+07 1.10584e+07 1.10158e+07 1.10089e+07 1.10037e+07 1.09925e+07 1.29995e+07 1.29672e+07 1.29353e+07 1.29043e+07 1.28505e+07 1.2662e+07 + 1.2357e+07 1.20551e+07 1.1755e+07 1.14555e+07 1.13406e+07 1.1297e+07 1.12534e+07 1.12101e+07 1.11671e+07 1.11125e+07 1.10474e+07 1.1015e+07 + 1.10088e+07 1.10036e+07 1.09925e+07 1.29995e+07 1.29632e+07 1.29283e+07 1.2895e+07 1.28447e+07 1.26643e+07 1.23532e+07 1.20481e+07 1.17461e+07 + 1.14453e+07 1.13301e+07 1.12863e+07 1.12428e+07 1.11996e+07 1.11568e+07 1.11021e+07 1.10376e+07 1.10147e+07 1.10087e+07 1.10034e+07 1.09925e+07 + 1.29995e+07 1.29586e+07 1.29209e+07 1.28854e+07 1.28378e+07 1.26645e+07 1.23479e+07 1.20403e+07 1.17368e+07 1.14351e+07 1.13195e+07 1.12757e+07 + 1.1232e+07 1.11889e+07 1.11464e+07 1.10916e+07 1.10303e+07 1.10146e+07 1.10084e+07 1.10032e+07 1.09925e+07 1.29995e+07 1.29529e+07 1.2913e+07 + 1.2876e+07 1.28292e+07 1.26596e+07 1.23406e+07 1.20316e+07 1.17271e+07 1.14247e+07 1.13089e+07 1.1265e+07 1.12212e+07 1.11779e+07 1.11362e+07 + 1.10798e+07 1.10266e+07 1.10145e+07 1.1008e+07 1.10027e+07 1.09925e+07 1.29995e+07 1.29451e+07 1.29046e+07 1.28668e+07 1.2819e+07 1.26476e+07 + 1.23315e+07 1.20216e+07 1.17168e+07 1.14141e+07 1.12982e+07 1.12542e+07 1.12104e+07 1.11659e+07 1.11276e+07 1.10652e+07 1.1026e+07 1.1014e+07 + 1.10072e+07 1.10019e+07 1.09925e+07 </DataArray> <DataArray type="Float32" Name="rho_w" NumberOfComponents="1" format="ascii"> - 998.008 998.513 998.008 998.158 999.166 998.672 978.643 977.993 940.73 939.397 942.376 941.002 - 944.473 943.133 947.132 945.9 950.413 949.346 954.296 953.427 962.545 962.078 970.408 970.364 - 976.891 977.251 981.644 982.38 984.431 984.428 984.41 984.406 984.384 984.38 984.358 984.352 - 984.342 984.342 984.341 984.341 947.795 947.795 998.008 998.054 998.377 983.952 938.28 939.695 - 941.704 944.419 947.878 952.034 960.967 969.626 976.925 982.434 984.424 984.402 984.376 984.349 - 984.343 984.34 947.795 998.008 998.022 998.226 988.323 937.57 938.819 940.692 943.32 946.746 - 950.925 960.035 968.962 976.564 982.36 984.421 984.398 984.372 984.347 984.343 984.34 947.795 - 998.008 998.008 998.138 991.153 937.079 938.194 939.937 942.47 945.847 950.025 959.261 968.398 - 976.24 982.26 984.417 984.394 984.368 984.346 984.343 984.34 947.795 998.008 997.999 998.082 - 992.902 936.714 937.713 939.33 941.761 945.077 949.24 958.573 967.895 975.949 982.165 984.413 - 984.39 984.364 984.345 984.343 984.34 947.795 998.008 997.993 998.044 994.249 936.423 937.312 - 938.807 941.131 944.377 948.511 957.921 967.414 975.675 982.077 984.41 984.387 984.36 984.345 - 984.342 984.34 947.795 998.008 997.988 998.017 995.169 936.186 936.969 938.342 940.557 943.72 - 947.814 957.283 966.936 975.403 981.996 984.406 984.383 984.356 984.345 984.342 984.34 947.795 - 998.008 997.984 997.998 995.907 935.992 936.673 937.935 940.042 943.117 947.158 956.666 966.469 - 975.143 981.937 984.402 984.379 984.353 984.345 984.342 984.34 947.795 998.008 997.98 997.985 - 996.253 935.883 936.489 937.675 939.692 942.682 946.661 956.183 966.12 975.006 982.002 984.398 - 984.375 984.351 984.345 984.342 984.34 947.795 998.008 997.974 997.982 994.245 936.884 937.615 - 938.86 940.881 943.846 947.776 957.228 967.24 976.406 983.809 984.395 984.369 984.35 984.345 - 984.342 984.34 947.795 + 929.152 933.512 929.152 930.521 940.555 935.595 1025.86 1017.48 1073.52 1072.01 1075.23 1073.66 + 1077.39 1075.84 1080.1 1078.67 1083.42 1082.16 1087.32 1086.28 1095.55 1094.97 1103.34 1103.22 + 1109.72 1110.05 1114.37 1115.09 1117.22 1117.22 1117.2 1117.19 1117.17 1117.16 1117.14 1117.13 + 1117.12 1117.12 1117.12 1117.12 1219.48 1219.48 929.152 929.636 932.708 995.981 1070.73 1072.17 + 1074.23 1077 1080.51 1084.72 1093.72 1102.4 1109.67 1115.14 1117.21 1117.19 1117.16 1117.13 + 1117.12 1117.12 1219.48 929.152 929.382 931.312 980.242 1069.95 1071.22 1073.12 1075.79 1079.27 + 1083.5 1092.7 1101.68 1109.28 1115.06 1117.21 1117.18 1117.15 1117.13 1117.12 1117.12 1219.48 + 929.152 929.271 930.538 969.082 1069.43 1070.55 1072.31 1074.87 1078.29 1082.52 1091.85 1101.06 + 1108.94 1114.96 1117.2 1117.18 1117.15 1117.12 1117.12 1117.12 1219.48 929.152 929.212 930.066 + 961.23 1069.05 1070.04 1071.66 1074.11 1077.45 1081.66 1091.1 1100.51 1108.63 1114.87 1117.2 + 1117.17 1117.14 1117.12 1117.12 1117.12 1219.48 929.152 929.177 929.76 954.605 1068.74 1069.62 + 1071.1 1073.43 1076.69 1080.86 1090.38 1099.99 1108.33 1114.79 1117.19 1117.17 1117.14 1117.12 + 1117.12 1117.12 1219.48 929.152 929.156 929.555 949.332 1068.49 1069.25 1070.6 1072.8 1075.97 + 1080.09 1089.68 1099.46 1108.04 1114.71 1117.19 1117.16 1117.13 1117.12 1117.12 1117.12 1219.48 + 929.152 929.142 929.42 944.723 1068.28 1068.93 1070.15 1072.22 1075.3 1079.36 1088.99 1098.95 + 1107.76 1114.66 1117.18 1117.16 1117.13 1117.12 1117.12 1117.12 1219.48 929.152 929.133 929.343 + 941.602 1068.14 1068.71 1069.84 1071.81 1074.79 1078.79 1088.44 1098.56 1107.62 1114.75 1117.18 + 1117.15 1117.13 1117.12 1117.12 1117.12 1219.48 929.152 929.124 929.35 952.524 1069.05 1069.74 + 1070.91 1072.88 1075.83 1079.79 1089.41 1099.67 1109.1 1116.71 1117.18 1117.15 1117.13 1117.12 + 1117.12 1117.12 1219.48 </DataArray> <DataArray type="Float32" Name="mob_w" NumberOfComponents="1" format="ascii"> - 4371.14 4548.01 4371.14 4377.89 4465.47 4372.47 3162.67 3171.86 2955.17 2955.39 2954.9 2955.12 - 2954.57 2954.77 2954.17 2954.34 2953.7 2953.85 2953.2 2953.3 2952.28 2952.33 2951.58 2951.58 - 2951.11 2951.09 2950.83 2950.8 2758.05 2317.85 2137.48 1857.67 1857.06 1477.67 1192.18 551.751 - 44.4164 10.7483 8.33764 5.52809 0 0 4371.14 4300.09 4332.38 3333.5 2955.58 2955.33 - 2954.99 2954.56 2954.05 2953.48 2952.44 2951.64 2951.11 2950.79 2189.48 1722.55 1249.29 215.32 - 6.78602 5.51948 0 4371.14 4291.53 4312.12 3528.4 2955.69 2955.47 2955.15 2954.73 2954.21 - 2953.62 2952.54 2951.69 2951.13 2950.8 2133.4 1639.47 1073.28 96.5325 6.09439 5.51825 0 - 4371.14 4305.61 4316.5 3729.61 2955.78 2955.58 2955.27 2954.86 2954.33 2953.74 2952.62 2951.74 - 2951.15 2950.8 2104.37 1579.8 920.288 48.8432 5.90867 5.51786 0 4371.14 4318.97 4330.47 - 3914.12 2955.84 2955.66 2955.37 2954.97 2954.45 2953.84 2952.7 2951.78 2951.17 2950.81 2083.9 - 1528.19 773.58 26.9152 5.84347 5.51768 0 4371.14 4328.81 4344.22 4108.82 2955.89 2955.73 - 2955.46 2955.06 2954.55 2953.94 2952.77 2951.82 2951.19 2950.81 2063.78 1475.47 622.209 16.0145 - 5.81697 5.51751 0 4371.14 4336.29 4354.68 4287.39 2955.93 2955.79 2955.53 2955.16 2954.65 - 2954.04 2952.84 2951.87 2951.21 2950.81 2040.14 1415.48 459.932 10.4284 5.80408 5.51632 0 - 4371.14 4342.25 4362.66 4469.01 2955.96 2955.84 2955.6 2955.24 2954.74 2954.13 2952.91 2951.91 - 2951.22 2950.82 2007.66 1339.34 289.178 7.63264 5.78136 5.50016 0 4371.14 4341.93 4375.01 - 4570.89 2955.98 2955.87 2955.65 2955.29 2954.8 2954.2 2952.96 2951.94 2951.23 2950.81 1942.63 - 1220.62 135.062 6.18618 5.57961 5.31529 0 4371.14 3916.95 3568.29 4033.48 2955.81 2955.67 - 2955.45 2955.1 2954.63 2954.04 2952.84 2951.84 2951.14 2950.72 1400.58 551.377 16.22 4.01709 - 3.96538 3.8059 0 + 4371.12 4529.91 4371.12 4361.03 4443.21 4350.25 3102.27 3149.7 2952.66 2952.89 2952.4 2952.63 + 2952.09 2952.3 2951.73 2951.91 2951.35 2951.48 2950.97 2951.06 2950.42 2950.45 2950.23 2950.23 + 2950.33 2950.34 2950.55 2950.6 2835.89 2371.5 2182.71 1902.58 1931.09 1551.47 1367.33 701.998 + 80.952 14.5644 8.94208 5.52909 0 0 4371.12 4293.3 4319.09 3339.08 2953.09 2952.85 + 2952.53 2952.13 2951.67 2951.2 2950.51 2950.24 2950.33 2950.6 2233.81 1761.14 1319 290.663 + 7.37088 5.51582 0 4371.12 4289.53 4304.02 3552.19 2953.22 2953 2952.69 2952.29 2951.82 + 2951.33 2950.57 2950.25 2950.32 2950.6 2168.83 1669.81 1129.26 117.023 6.17663 5.51374 0 + 4371.12 4304.92 4310.96 3763.7 2953.3 2953.11 2952.81 2952.42 2951.94 2951.43 2950.62 2950.25 + 2950.31 2950.59 2131.98 1601.19 955.951 52.9969 5.91514 5.51322 0 4371.12 4318.65 4326.3 + 3955.72 2953.37 2953.19 2952.91 2952.53 2952.05 2951.52 2950.67 2950.26 2950.3 2950.59 2104.39 + 1540.17 783.214 26.3318 5.83664 5.51301 0 4371.12 4328.64 4340.78 4156.22 2953.42 2953.26 + 2953 2952.63 2952.15 2951.61 2950.72 2950.27 2950.29 2950.58 2077.49 1476.99 602.167 14.5539 + 5.80874 5.51278 0 4371.12 4336.18 4351.64 4348.06 2953.46 2953.32 2953.08 2952.72 2952.25 + 2951.7 2950.77 2950.29 2950.28 2950.58 2046.08 1403.52 408.356 9.21424 5.79585 5.51082 0 + 4371.12 4342.15 4359.53 4546.35 2953.5 2953.38 2953.15 2952.81 2952.34 2951.79 2950.82 2950.3 + 2950.28 2950.57 2003.08 1307.05 222.772 6.93191 5.76693 5.48705 0 4371.12 4342.52 4371.86 + 4701.04 2953.52 2953.41 2953.2 2952.87 2952.41 2951.86 2950.87 2950.31 2950.27 2950.58 1923.55 + 1157.14 89.0892 5.85978 5.51891 5.25242 0 4371.12 3945.31 3625.51 4247.1 2953.37 2953.24 + 2953.03 2952.71 2952.26 2951.74 2950.79 2950.28 2950.31 2950.72 1327.89 415.973 9.68951 3.80531 + 3.77763 3.60616 0 </DataArray> <DataArray type="Float32" Name="S_n" NumberOfComponents="1" format="ascii"> - 0.05 0.0301141 0.05 0.045245 0.0202245 0.034031 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0.0143737 0.0477939 0.0628746 0.0882824 0.0883408 0.12786 0.162982 0.274586 - 0.520133 0.603709 0.615784 0.63377 0.8 0.8 0.05 0.0512725 0.0418582 0 0 0 - 0 0 0 0 0 0 0 0 0.0584324 0.101593 0.155488 0.384724 - 0.625028 0.633835 0.8 0.05 0.0524923 0.0459965 0 0 0 0 0 0 - 0 0 0 0 0 0.0632269 0.110171 0.179497 0.460192 0.629667 0.633844 0.8 - 0.05 0.0522795 0.0477896 0 0 0 0 0 0 0 0 0 - 0 0 0.0657465 0.116535 0.202901 0.513406 0.63098 0.633847 0.8 0.05 0.0519223 0.0484903 - 0 0 0 0 0 0 0 0 0 0 0 0.0675385 - 0.122186 0.228269 0.553075 0.631448 0.633848 0.8 0.05 0.0516293 0.0488004 0 0 0 - 0 0 0 0 0 0 0 0 0.0693132 0.12811 0.258561 0.583133 - 0.63164 0.63385 0.8 0.05 0.0513865 0.0489835 0 0 0 0 0 0 - 0 0 0 0 0 0.0714144 0.135047 0.297959 0.605186 0.631733 0.633859 0.8 - 0.05 0.0511776 0.0490679 0 0 0 0 0 0 0 0 0 - 0 0 0.0743319 0.144174 0.352949 0.619808 0.631898 0.63398 0.8 0.05 0.0512197 0.0487757 - 0 0 0 0 0 0 0 0 0 0 0 0.0802811 - 0.159218 0.430428 0.629029 0.633384 0.635393 0.8 0.05 0.0702721 0.086023 0 0 0 - 0 0 0 0 0 0 0 0 0.136803 0.274675 0.58244 0.646523 - 0.647019 0.648581 0.8 + 0.05 0.0310062 0.05 0.0458442 0.020059 0.0340778 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0.00889187 0.0434824 0.0590104 0.0840231 0.0813553 0.119624 0.140778 0.241983 + 0.474823 0.588219 0.612534 0.633763 0.8 0.8 0.05 0.0514797 0.0419658 0 0 0 + 0 0 0 0 0 0 0 0 0.0547107 0.097718 0.146682 0.352379 + 0.621375 0.633863 0.8 0.05 0.0525275 0.0461118 0 0 0 0 0 0 + 0 0 0 0 0 0.0601908 0.107005 0.171563 0.443441 0.629096 0.633879 0.8 + 0.05 0.0522773 0.0479031 0 0 0 0 0 0 0 0 0 + 0 0 0.0633537 0.114237 0.197201 0.5075 0.630935 0.633883 0.8 0.05 0.0519156 0.0486031 + 0 0 0 0 0 0 0 0 0 0 0 0.0657485 + 0.120866 0.2265 0.554425 0.631498 0.633884 0.8 0.05 0.0516233 0.04892 0 0 0 + 0 0 0 0 0 0 0 0 0.0681061 0.127941 0.262977 0.588257 + 0.6317 0.633886 0.8 0.05 0.0513829 0.0491163 0 0 0 0 0 0 + 0 0 0 0 0 0.0708882 0.136458 0.31267 0.611123 0.631794 0.633901 0.8 + 0.05 0.0511764 0.0492326 0 0 0 0 0 0 0 0 0 + 0 0 0.0747495 0.148167 0.381179 0.624096 0.632004 0.63408 0.8 0.05 0.0511906 0.0489692 + 0 0 0 0 0 0 0 0 0 0 0 0.082058 + 0.167719 0.466942 0.631332 0.63384 0.635883 0.8 0.05 0.0689524 0.0832654 0 0 0 + 0 0 0 0 0 0 0 0 0.145584 0.310413 0.608734 0.648588 + 0.648864 0.650609 0.8 </DataArray> <DataArray type="Float32" Name="p_n" NumberOfComponents="1" format="ascii"> - 1.3e+07 1.29996e+07 1.3e+07 1.29907e+07 1.29825e+07 1.29732e+07 1.29613e+07 1.29517e+07 1.28849e+07 1.28766e+07 1.26584e+07 1.26516e+07 - 1.23832e+07 1.23752e+07 1.20973e+07 1.20886e+07 1.18062e+07 1.17972e+07 1.15129e+07 1.15036e+07 1.13999e+07 1.13905e+07 1.13567e+07 1.13472e+07 - 1.13132e+07 1.13037e+07 1.12692e+07 1.12597e+07 1.1223e+07 1.12148e+07 1.11722e+07 1.11621e+07 1.11089e+07 1.10995e+07 1.10463e+07 1.10329e+07 - 1.1009e+07 1.10097e+07 1.10058e+07 1.10051e+07 1.1e+07 1.1e+07 1.3e+07 1.29846e+07 1.29648e+07 1.2942e+07 1.28703e+07 1.26502e+07 - 1.23693e+07 1.20809e+07 1.17886e+07 1.14944e+07 1.13811e+07 1.13378e+07 1.12943e+07 1.12504e+07 1.12064e+07 1.11526e+07 1.10894e+07 1.10241e+07 - 1.10102e+07 1.10049e+07 1.1e+07 1.3e+07 1.29798e+07 1.29572e+07 1.29326e+07 1.28652e+07 1.2652e+07 1.23652e+07 1.20741e+07 1.17804e+07 - 1.14853e+07 1.13718e+07 1.13284e+07 1.12849e+07 1.12413e+07 1.11977e+07 1.11433e+07 1.10794e+07 1.10202e+07 1.10102e+07 1.10048e+07 1.1e+07 - 1.3e+07 1.29757e+07 1.29501e+07 1.29235e+07 1.28606e+07 1.26549e+07 1.23622e+07 1.2068e+07 1.17725e+07 1.14764e+07 1.13625e+07 1.13191e+07 - 1.12756e+07 1.12321e+07 1.11888e+07 1.1134e+07 1.10697e+07 1.1018e+07 1.10101e+07 1.10048e+07 1.1e+07 1.3e+07 1.29718e+07 1.29432e+07 - 1.29146e+07 1.28558e+07 1.26579e+07 1.23595e+07 1.20621e+07 1.17648e+07 1.14674e+07 1.13532e+07 1.13098e+07 1.12663e+07 1.1223e+07 1.11798e+07 - 1.11248e+07 1.106e+07 1.10167e+07 1.10099e+07 1.10047e+07 1.1e+07 1.3e+07 1.29679e+07 1.29363e+07 1.29056e+07 1.28507e+07 1.26604e+07 - 1.23567e+07 1.20561e+07 1.1757e+07 1.14585e+07 1.1344e+07 1.13004e+07 1.1257e+07 1.12137e+07 1.11707e+07 1.11156e+07 1.10504e+07 1.10159e+07 - 1.10098e+07 1.10046e+07 1.1e+07 1.3e+07 1.29638e+07 1.29292e+07 1.28965e+07 1.28448e+07 1.26617e+07 1.23529e+07 1.20497e+07 1.17491e+07 - 1.14495e+07 1.13347e+07 1.12911e+07 1.12476e+07 1.12044e+07 1.11616e+07 1.11064e+07 1.10414e+07 1.10156e+07 1.10097e+07 1.10045e+07 1.1e+07 - 1.3e+07 1.2959e+07 1.29217e+07 1.28871e+07 1.28379e+07 1.26607e+07 1.23477e+07 1.20427e+07 1.17409e+07 1.14405e+07 1.13254e+07 1.12817e+07 - 1.12381e+07 1.1195e+07 1.11524e+07 1.10971e+07 1.10339e+07 1.10155e+07 1.10094e+07 1.10042e+07 1.1e+07 1.3e+07 1.2953e+07 1.29134e+07 - 1.28777e+07 1.28295e+07 1.26546e+07 1.23409e+07 1.20349e+07 1.17323e+07 1.14314e+07 1.1316e+07 1.12723e+07 1.12286e+07 1.11853e+07 1.11435e+07 - 1.10869e+07 1.10292e+07 1.10155e+07 1.1009e+07 1.10038e+07 1.1e+07 1.3e+07 1.29447e+07 1.29046e+07 1.28685e+07 1.28198e+07 1.26426e+07 - 1.23329e+07 1.20261e+07 1.17233e+07 1.14221e+07 1.13067e+07 1.12628e+07 1.12191e+07 1.11747e+07 1.1136e+07 1.10744e+07 1.10282e+07 1.10151e+07 - 1.10082e+07 1.1003e+07 1.1e+07 + 1.3e+07 1.29982e+07 1.3e+07 1.29898e+07 1.29812e+07 1.29723e+07 1.29615e+07 1.29515e+07 1.28858e+07 1.28767e+07 1.26575e+07 1.26503e+07 + 1.23862e+07 1.23771e+07 1.21017e+07 1.20918e+07 1.18111e+07 1.18008e+07 1.15177e+07 1.15071e+07 1.14047e+07 1.1394e+07 1.13614e+07 1.13506e+07 + 1.13178e+07 1.1307e+07 1.12737e+07 1.12628e+07 1.12272e+07 1.12177e+07 1.11772e+07 1.11659e+07 1.11145e+07 1.11038e+07 1.1053e+07 1.10379e+07 + 1.1009e+07 1.10094e+07 1.10056e+07 1.1005e+07 1.1e+07 1.1e+07 1.3e+07 1.2984e+07 1.29641e+07 1.29415e+07 1.28702e+07 1.26494e+07 + 1.23706e+07 1.20831e+07 1.1791e+07 1.14967e+07 1.13833e+07 1.13399e+07 1.12963e+07 1.12523e+07 1.1208e+07 1.1155e+07 1.10925e+07 1.1026e+07 + 1.10102e+07 1.10048e+07 1.1e+07 1.3e+07 1.29794e+07 1.29565e+07 1.29319e+07 1.28651e+07 1.26518e+07 1.23661e+07 1.20756e+07 1.17818e+07 + 1.14864e+07 1.13727e+07 1.13293e+07 1.12857e+07 1.12419e+07 1.11982e+07 1.11445e+07 1.10812e+07 1.10207e+07 1.10102e+07 1.10048e+07 1.1e+07 + 1.3e+07 1.29753e+07 1.29495e+07 1.29227e+07 1.28605e+07 1.26555e+07 1.2363e+07 1.20687e+07 1.17729e+07 1.14762e+07 1.13622e+07 1.13187e+07 + 1.12751e+07 1.12315e+07 1.11881e+07 1.11339e+07 1.10701e+07 1.10181e+07 1.10101e+07 1.10048e+07 1.1e+07 1.3e+07 1.29715e+07 1.29426e+07 + 1.29138e+07 1.28559e+07 1.26592e+07 1.23604e+07 1.20622e+07 1.17642e+07 1.14661e+07 1.13516e+07 1.13081e+07 1.12645e+07 1.12211e+07 1.11779e+07 + 1.11235e+07 1.1059e+07 1.10167e+07 1.101e+07 1.10048e+07 1.1e+07 1.3e+07 1.29677e+07 1.29358e+07 1.29048e+07 1.2851e+07 1.26625e+07 + 1.23575e+07 1.20556e+07 1.17555e+07 1.1456e+07 1.13411e+07 1.12975e+07 1.12539e+07 1.12106e+07 1.11676e+07 1.11131e+07 1.10481e+07 1.1016e+07 + 1.10099e+07 1.10047e+07 1.1e+07 1.3e+07 1.29637e+07 1.29288e+07 1.28955e+07 1.28452e+07 1.26648e+07 1.23538e+07 1.20486e+07 1.17466e+07 + 1.14458e+07 1.13306e+07 1.12868e+07 1.12433e+07 1.12001e+07 1.11573e+07 1.11027e+07 1.10383e+07 1.10157e+07 1.10098e+07 1.10045e+07 1.1e+07 + 1.3e+07 1.29591e+07 1.29214e+07 1.28859e+07 1.28383e+07 1.2665e+07 1.23484e+07 1.20408e+07 1.17373e+07 1.14356e+07 1.132e+07 1.12762e+07 + 1.12325e+07 1.11894e+07 1.11469e+07 1.10921e+07 1.1031e+07 1.10157e+07 1.10095e+07 1.10043e+07 1.1e+07 1.3e+07 1.29534e+07 1.29135e+07 + 1.28765e+07 1.28297e+07 1.26601e+07 1.23411e+07 1.20321e+07 1.17276e+07 1.14252e+07 1.13094e+07 1.12655e+07 1.12217e+07 1.11784e+07 1.11367e+07 + 1.10804e+07 1.10274e+07 1.10156e+07 1.10091e+07 1.10038e+07 1.1e+07 1.3e+07 1.29456e+07 1.29052e+07 1.28673e+07 1.28194e+07 1.26481e+07 + 1.2332e+07 1.20221e+07 1.17173e+07 1.14146e+07 1.12987e+07 1.12547e+07 1.12109e+07 1.11664e+07 1.11282e+07 1.10658e+07 1.10271e+07 1.10151e+07 + 1.10083e+07 1.10031e+07 1.1e+07 </DataArray> <DataArray type="Float32" Name="rho_n" NumberOfComponents="1" format="ascii"> - 107.068 107.067 107.068 106.991 106.928 106.848 -3748.69 -3896.38 -7923.7 -8163.91 -7611.86 -7859.67 - -7215.38 -7456.92 -6716.41 -6938.37 -6104.36 -6296.76 -5383.23 -5539.76 -3883.4 -3967.33 -2457.16 -2464.45 - -1280.13 -1214.26 -415.865 -281.921 92.3761 92.3074 91.9526 91.8688 91.4257 91.3473 90.9038 90.7924 - 90.5936 90.5994 90.5671 90.561 90.6021 90.6021 107.068 106.94 106.776 -3065.16 -8365.22 -8095.6 - -7714.63 -7205.53 -6561.47 -5790.97 -4167.77 -2597.5 -1272.54 -271.55 92.2377 91.7895 91.2633 90.719 - 90.6035 90.5593 90.6021 107.068 106.9 106.712 -2353.21 -8493.06 -8253.8 -7897.17 -7403.73 -6765.53 - -5991.04 -4335.76 -2717.12 -1337.37 -284.314 92.1655 91.7121 91.18 90.6867 90.6033 90.5589 90.6021 - 107.068 106.865 106.653 -1821.95 -8581.53 -8366.83 -8033.28 -7556.92 -6927.52 -6153.08 -4475.2 -2818.53 - -1395.5 -301.708 92.0914 91.6351 91.0991 90.6684 90.6023 90.5585 90.6021 107.068 106.833 106.595 - -1449.69 -8647.08 -8453.96 -8142.77 -7684.6 -7066.17 -6294.49 -4599.1 -2909.03 -1447.5 -318.427 92.0163 - 91.5582 91.0186 90.6573 90.6013 90.5579 90.6021 107.068 106.801 106.538 -1129.71 -8699.27 -8526.44 - -8237.11 -7797.93 -7192.29 -6425.64 -4716.4 -2995.54 -1496.64 -333.701 91.9406 91.4814 90.9386 90.651 - 90.6002 90.5571 90.6021 107.068 106.766 106.478 -887.029 -8741.65 -8588.61 -8320.81 -7901.37 -7310.37 - -6551.09 -4831.29 -3081.45 -1545.27 -347.691 91.8645 91.4047 90.8633 90.6481 90.599 90.5558 90.6021 - 107.068 106.727 106.416 -674.139 -8776.33 -8642.01 -8393.97 -7993.96 -7418.93 -6669.18 -4942.24 -3165.31 - -1591.64 -357.893 91.7883 91.327 90.8009 90.6474 90.5969 90.5537 90.6021 107.068 106.676 106.347 - -566.916 -8795.49 -8674.69 -8440.54 -8056.64 -7496.91 -6758.26 -5028.98 -3227.85 -1615.89 -345.345 91.7138 - 91.2425 90.7618 90.6473 90.5933 90.55 90.6021 107.068 106.607 106.274 -1154.86 -8614.13 -8470.62 - -8226 -7841.3 -7286.09 -6556.22 -4839.44 -3024.55 -1361.67 -17.2639 91.6515 91.1379 90.7536 90.6447 - 90.5871 90.5435 90.6021 + 107.068 107.055 107.068 106.984 106.917 106.84 -4638.64 -4402.16 -7862.51 -8129.96 -7542.83 -7822.19 + -7141.27 -7415.14 -6640.05 -6893.58 -6029.17 -6251.36 -5312.87 -5496.49 -3831.47 -3935.65 -2428.61 -2448.65 + -1274.66 -1214.56 -427.948 -297.108 92.4107 92.3316 91.9949 91.9001 91.4722 91.3831 90.9599 90.8346 + 90.5931 90.5972 90.5655 90.5599 90.6021 90.6021 107.068 106.935 106.77 -3224.85 -8355.02 -8084.91 + -7701.36 -7189.76 -6544.57 -5774.7 -4157.69 -2596.13 -1280.98 -288.214 92.2515 91.8099 91.2891 90.7347 + 90.6032 90.5586 90.6021 107.068 106.896 106.707 -2380.2 -8492.05 -8254.2 -7897.32 -7403.2 -6764.91 + -5991.25 -4340.08 -2725.91 -1350.59 -300.723 92.1693 91.7218 91.1945 90.6908 90.6037 90.5586 90.6021 + 107.068 106.863 106.648 -1801.75 -8584.1 -8372.24 -8040.76 -7565.96 -6938.1 -6165.34 -4490.82 -2835.63 + -1412.65 -317.664 92.0854 91.6342 91.102 90.669 90.6029 90.5585 90.6021 107.068 106.831 106.591 + -1409.22 -8651.42 -8462.38 -8155.41 -7701.14 -7086.1 -6317.2 -4624.78 -2933.55 -1467.66 -333.67 92.0005 + 91.547 91.0096 90.6573 90.602 90.5582 90.6021 107.068 106.799 106.534 -1080.26 -8704.81 -8537.32 + -8254.33 -7821.41 -7221.11 -6458.49 -4752.04 -3027.46 -1520.24 -348.526 91.915 91.4602 90.9188 90.6515 + 90.6011 90.5574 90.6021 107.068 106.765 106.475 -822.861 -8748.72 -8602.46 -8343.16 -7932.31 -7348.62 + -6594.64 -4877.37 -3121.02 -1572.33 -361.72 91.829 91.3739 90.8372 90.6495 90.6 90.5562 90.6021 + 107.068 106.727 106.413 -597.883 -8785.43 -8659.36 -8422.06 -8033.04 -7467.36 -6724.25 -4999.33 -3212.6 + -1621.65 -370.004 91.7426 91.2858 90.7769 90.649 90.5979 90.5541 90.6021 107.068 106.68 106.347 + -445.17 -8809.47 -8698.83 -8476.66 -8105.41 -7556.59 -6825.57 -5097.12 -3281.84 -1646.14 -351.907 91.6576 + 91.1883 90.7463 90.6482 90.5942 90.5505 90.6021 107.068 106.615 106.278 -858.577 -8648.73 -8515.32 + -8286.12 -7915.24 -7370.76 -6647.06 -4923.89 -3081.52 -1379.02 4.77713 91.586 91.0666 90.744 90.6446 + 90.588 90.544 90.6021 </DataArray> <DataArray type="Float32" Name="mob_n" NumberOfComponents="1" format="ascii"> - 17.6984 3.76007 17.6984 13.0704 1.08947 5.47796 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0.371135 15.5633 35.6382 98.3864 98.6043 294.253 598.092 2657.9 - 14793.9 21357.5 22392.5 23969.3 39947.1 39947.1 17.6984 19.0991 10.3165 0 0 0 - 0 0 0 0 0 0 0 0 28.5782 149.291 521.461 6723.95 - 23197.2 23975.1 39947.1 17.6984 20.5075 13.7432 0 0 0 0 0 0 - 0 0 0 0 0 36.2378 189.748 790.987 10806.6 23605.5 23975.9 39947.1 - 17.6984 20.2575 15.4352 0 0 0 0 0 0 0 0 0 - 0 0 40.7549 223.952 1125.87 14314.4 23721.5 23976.2 39947.1 17.6984 19.8421 16.1323 - 0 0 0 0 0 0 0 0 0 0 0 44.1835 - 257.474 1576.7 17248.8 23762.9 23976.3 39947.1 17.6984 19.5056 16.4476 0 0 0 - 0 0 0 0 0 0 0 0 47.7607 295.926 2244.31 19641.2 - 23779.9 23976.4 39947.1 17.6984 19.2296 16.6359 0 0 0 0 0 0 - 0 0 0 0 0 52.2352 345.444 3338.84 21482.4 23788.2 23977.3 39947.1 - 17.6984 18.9945 16.7235 0 0 0 0 0 0 0 0 0 - 0 0 58.8905 418.32 5323.59 22740.7 23802.8 23988.1 39947.1 17.6984 19.0424 16.4241 - 0 0 0 0 0 0 0 0 0 0 0 74.1302 - 558.71 9069.15 23548.6 23934.6 24113.8 39947.1 17.6984 49.3639 90.3495 0 0 0 - 0 0 0 0 0 0 0 0 358.725 2659.81 19583.5 25110.6 - 25156.2 25298.2 39947.1 + 17.6984 4.11412 17.6984 13.6034 1.06169 5.50114 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0.0765257 11.6778 29.4426 84.9116 77.1404 241.925 390.24 1861.09 + 11720.9 20060.3 22112.1 23968.8 39947.1 39947.1 17.6984 19.3336 10.3975 0 0 0 + 0 0 0 0 0 0 0 0 23.431 133.036 439.934 5300.37 + 22877.7 23977.6 39947.1 17.6984 20.5493 13.8482 0 0 0 0 0 0 + 0 0 0 0 0 31.2498 174.084 693.973 9808.77 23555.1 23979 39947.1 + 17.6984 20.255 15.5467 0 0 0 0 0 0 0 0 0 + 0 0 36.4584 211.178 1037.4 13900.3 23717.5 23979.4 39947.1 17.6984 19.8344 16.2464 + 0 0 0 0 0 0 0 0 0 0 0 40.7608 + 249.377 1542.16 17353.3 23767.4 23979.5 39947.1 17.6984 19.4988 16.5701 0 0 0 + 0 0 0 0 0 0 0 0 45.3098 294.783 2354 20062.8 + 23785.2 23979.7 39947.1 17.6984 19.2256 16.773 0 0 0 0 0 0 + 0 0 0 0 0 51.0914 356.138 3816.44 21989.8 23793.5 23981 39947.1 + 17.6984 18.9931 16.8943 0 0 0 0 0 0 0 0 0 + 0 0 59.8874 453.067 6558.17 23114.9 23812.2 23997 39947.1 17.6984 19.0096 16.6225 + 0 0 0 0 0 0 0 0 0 0 0 79.1369 + 649.858 11223 23752 23975.1 24157.4 39947.1 17.6984 46.6361 81.9896 0 0 0 + 0 0 0 0 0 0 0 0 430.317 3740.2 21783.9 25297.4 + 25323.2 25482.1 39947.1 </DataArray> - <DataArray type="Float32" Name="x^H2O_liquid" NumberOfComponents="1" format="ascii"> - 0.998841 0.996945 0.998841 0.998272 0.994171 0.99625 0.990231 0.992657 0.9876 0.990186 0.984242 0.98691 - 0.979974 0.982574 0.974602 0.976992 0.968013 0.970084 0.96025 0.961935 0.944103 0.945007 0.928749 0.928828 - 0.916078 0.915369 0.906774 0.905332 0.901302 0.901303 0.901307 0.901308 0.901313 0.901313 0.901318 0.90132 - 0.901322 0.901322 0.901322 0.901322 0.828569 0.828569 0.998841 0.998642 0.997394 0.994438 0.992353 0.98945 - 0.985348 0.979868 0.972934 0.964639 0.947165 0.93026 0.915996 0.90522 0.901304 0.901309 0.901314 0.90132 - 0.901322 0.901322 0.828569 0.998841 0.998745 0.997947 0.995519 0.993729 0.991153 0.987314 0.982002 0.975131 - 0.966793 0.948973 0.931548 0.916694 0.905358 0.901305 0.90131 0.901315 0.901321 0.901322 0.901322 0.828569 - 0.998841 0.998789 0.998258 0.996252 0.994682 0.99237 0.988779 0.983651 0.976875 0.968538 0.950475 0.93264 - 0.91732 0.905545 0.901305 0.90131 0.901316 0.901321 0.901322 0.901322 0.828569 0.998841 0.998812 0.99845 - 0.996782 0.995387 0.993308 0.989958 0.985025 0.978368 0.97006 0.951808 0.933614 0.91788 0.905725 0.901306 - 0.901311 0.901317 0.901321 0.901322 0.901322 0.828569 0.998841 0.998826 0.998574 0.997181 0.995949 0.994088 - 0.990973 0.986245 0.979725 0.971472 0.953071 0.934545 0.918409 0.905889 0.901307 0.901312 0.901318 0.901321 - 0.901322 0.901322 0.828569 0.998841 0.998834 0.998657 0.997486 0.996406 0.994757 0.991874 0.987359 0.980996 - 0.972822 0.954308 0.93547 0.918932 0.90604 0.901308 0.901313 0.901319 0.901321 0.901322 0.901322 0.828569 - 0.998841 0.998839 0.99871 0.997713 0.996779 0.995332 0.992662 0.988356 0.982165 0.974094 0.955502 0.936373 - 0.919432 0.90615 0.901309 0.901314 0.901319 0.901321 0.901322 0.901322 0.828569 0.998841 0.998842 0.998738 - 0.997812 0.996985 0.995684 0.993163 0.98903 0.983005 0.975053 0.956436 0.937046 0.919693 0.906015 0.90131 - 0.901315 0.90132 0.901321 0.901322 0.901322 0.828569 0.998841 0.998844 0.99873 0.996049 0.995033 0.993487 - 0.990854 0.986712 0.980735 0.972878 0.954396 0.934858 0.916956 0.902483 0.90131 0.901316 0.90132 0.901321 + <DataArray type="Float32" Name="x^H2O_brine" NumberOfComponents="1" format="ascii"> + 0.998841 0.996971 0.998841 0.998254 0.993918 0.996069 0.989685 0.992332 0.986941 0.98982 0.983499 0.986506 + 0.979176 0.982124 0.97378 0.97651 0.967204 0.969596 0.959492 0.961469 0.943544 0.944666 0.928442 0.928658 + 0.916019 0.915372 0.906904 0.905495 0.901302 0.901303 0.901307 0.901308 0.901312 0.901313 0.901318 0.901319 + 0.901322 0.901322 0.901322 0.901322 0.828569 0.828569 0.998841 0.998631 0.997312 0.994323 0.992243 0.989335 + 0.985206 0.979698 0.972752 0.964464 0.947056 0.930245 0.916087 0.9054 0.901304 0.901309 0.901314 0.90132 + 0.901322 0.901322 0.828569 0.998841 0.998739 0.99791 0.995488 0.993718 0.991157 0.987315 0.981996 0.975124 + 0.966795 0.94902 0.931643 0.916837 0.905534 0.901305 0.901309 0.901315 0.901321 0.901322 0.901322 0.828569 + 0.998841 0.998786 0.99824 0.996254 0.994709 0.992428 0.988859 0.983748 0.976989 0.96867 0.950643 0.932824 + 0.917505 0.905717 0.901306 0.90131 0.901316 0.901321 0.901322 0.901322 0.828569 0.998841 0.99881 0.998441 + 0.996799 0.995434 0.993398 0.990094 0.985203 0.978582 0.970305 0.952085 0.933878 0.918097 0.905889 0.901306 + 0.901311 0.901317 0.901321 0.901322 0.901322 0.828569 0.998841 0.998825 0.998571 0.997207 0.996009 0.994205 + 0.991159 0.986498 0.980035 0.971826 0.953455 0.934889 0.918663 0.906049 0.901307 0.901312 0.901318 0.901321 + 0.901322 0.901322 0.828569 0.998841 0.998833 0.998657 0.997521 0.996482 0.994906 0.992115 0.987692 0.981408 + 0.973291 0.954804 0.935896 0.919224 0.906191 0.901308 0.901313 0.901319 0.901321 0.901322 0.901322 0.828569 + 0.998841 0.998838 0.998714 0.997764 0.996877 0.995519 0.992964 0.988776 0.982687 0.974687 0.956117 0.936882 + 0.919755 0.90628 0.901309 0.901314 0.90132 0.901321 0.901322 0.901322 0.828569 0.998841 0.998841 0.998745 + 0.997907 0.997136 0.995944 0.993552 0.989555 0.983647 0.975777 0.95717 0.937627 0.920018 0.906085 0.90131 + 0.901315 0.90132 0.901321 0.901322 0.901322 0.828569 0.998841 0.998844 0.998741 0.996367 0.995405 0.993968 + 0.991501 0.987508 0.981647 0.973856 0.955305 0.935471 0.917143 0.902245 0.901311 0.901317 0.90132 0.901321 0.901322 0.901322 0.828569 </DataArray> - <DataArray type="Float32" Name="x^Air_liquid" NumberOfComponents="1" format="ascii"> - 0.0011285 0.00112854 0.0011285 0.00112768 0.00112711 0.0011262 -0.0403793 -0.0419692 -0.085324 -0.08791 -0.0819669 -0.0846347 - -0.0776986 -0.0802989 -0.0723269 -0.0747165 -0.0657379 -0.0678093 -0.0579747 -0.0596598 -0.0418283 -0.0427318 -0.0264741 -0.0265526 - -0.0138029 -0.0130938 -0.00449867 -0.00305669 0.00097279 0.00097205 0.000968231 0.000967329 0.000962558 0.000961714 0.00095694 0.000955741 - 0.0009536 0.000953663 0.000953315 0.000953249 0.000955504 0.000955504 0.0011285 0.00112712 0.0011254 -0.033021 -0.0900772 -0.0871746 - -0.0830733 -0.0775926 -0.0706589 -0.0623642 -0.0448897 -0.027985 -0.0137212 -0.00294505 0.0009713 0.000966475 0.00096081 0.000954951 - 0.000953707 0.000953231 0.000955504 0.0011285 0.00112669 0.00112469 -0.0253567 -0.0914534 -0.0888777 -0.0850385 -0.0797263 -0.0728558 - -0.0645181 -0.0466982 -0.0292727 -0.014419 -0.00308246 0.000970522 0.000965641 0.000959914 0.000954603 0.000953705 0.000953227 0.000955504 - 0.0011285 0.00112632 0.00112404 -0.0196377 -0.0924059 -0.0900945 -0.0865037 -0.0813754 -0.0745997 -0.0662624 -0.0481993 -0.0303645 - -0.0150449 -0.00326971 0.000969725 0.000964813 0.000959043 0.000954405 0.000953694 0.000953222 0.000955504 0.0011285 0.00112597 0.00112342 - -0.0156303 -0.0931115 -0.0910325 -0.0876824 -0.08275 -0.0760923 -0.0677848 -0.0495331 -0.0313388 -0.0156046 -0.0034497 0.000968917 - 0.000963985 0.000958175 0.000954287 0.000953683 0.000953216 0.000955504 0.0011285 0.00112562 0.0011228 -0.0121856 -0.0936734 -0.0918128 - -0.088698 -0.08397 -0.07745 -0.0691967 -0.050796 -0.03227 -0.0161337 -0.00361413 0.000968102 0.000963158 0.000957315 0.000954218 - 0.000953672 0.000953207 0.000955504 0.0011285 0.00112525 0.00112216 -0.00957311 -0.0941296 -0.0924821 -0.0895991 -0.0850836 -0.0787213 - -0.0705472 -0.0520328 -0.033195 -0.0166572 -0.00376473 0.000967283 0.000962333 0.000956504 0.000954187 0.000953658 0.000953193 0.000955504 - 0.0011285 0.00112483 0.00112148 -0.00728132 -0.094503 -0.093057 -0.0903867 -0.0860804 -0.0798899 -0.0718185 -0.0532272 -0.0340978 - -0.0171565 -0.00387457 0.000966462 0.000961495 0.000955832 0.000954179 0.000953636 0.00095317 0.000955504 0.0011285 0.00112429 0.00112074 - -0.00612705 -0.0947092 -0.0934088 -0.090888 -0.0867552 -0.0807295 -0.0727775 -0.054161 -0.034771 -0.0174175 -0.00373948 0.00096566 - 0.000960587 0.000955411 0.000954178 0.000953597 0.000953131 0.000955504 0.0011285 0.00112354 0.00111995 -0.0124563 -0.0927568 -0.0912118 - -0.0885785 -0.084437 -0.0784598 -0.0706025 -0.0521205 -0.0325824 -0.0146807 -0.000207536 0.000964989 0.00095946 0.000955323 0.00095415 - 0.00095353 0.000953061 0.000955504 + <DataArray type="Float32" Name="x^Air_brine" NumberOfComponents="1" format="ascii"> + 0.0011285 0.00112841 0.0011285 0.00112761 0.001127 0.00112612 -0.0499597 -0.0474141 -0.0846653 -0.0875444 -0.0812238 -0.0842312 + -0.0769008 -0.0798491 -0.0715049 -0.0742343 -0.0649285 -0.0673205 -0.0572172 -0.0591939 -0.0412692 -0.0423908 -0.0261668 -0.0263826 + -0.013744 -0.013097 -0.00462875 -0.00322019 0.000973163 0.00097231 0.000968686 0.000967665 0.000963059 0.0009621 0.000957543 0.000956194 + 0.000953595 0.000953639 0.000953298 0.000953238 0.000955504 0.000955504 0.0011285 0.00112707 0.00112534 -0.0347402 -0.0899674 -0.0870595 + -0.0829304 -0.0774228 -0.070477 -0.062189 -0.0447811 -0.0279703 -0.013812 -0.00312444 0.000971449 0.000966694 0.000961088 0.00095512 + 0.000953703 0.000953223 0.000955504 0.0011285 0.00112666 0.00112464 -0.0256474 -0.0914425 -0.088882 -0.08504 -0.0797206 -0.0728491 + -0.0645203 -0.0467447 -0.0293674 -0.0145614 -0.00325911 0.000970564 0.000965746 0.00096007 0.000954646 0.000953709 0.000953224 0.000955504 + 0.0011285 0.00112629 0.00112399 -0.0194202 -0.0924335 -0.0901528 -0.0865842 -0.0814728 -0.0747136 -0.0663944 -0.0483674 -0.0305485 + -0.0152295 -0.00344148 0.000969661 0.000964803 0.000959074 0.000954413 0.0009537 0.000953223 0.000955504 0.0011285 0.00112595 0.00112337 + -0.0151945 -0.0931583 -0.0911232 -0.0878185 -0.0829281 -0.0763068 -0.0680293 -0.0498096 -0.0316028 -0.0158217 -0.0036138 0.000968747 + 0.000963864 0.000958079 0.000954287 0.000953691 0.000953219 0.000955504 0.0011285 0.00112561 0.00112275 -0.0116533 -0.093733 -0.0919299 + -0.0888834 -0.0842229 -0.0777603 -0.0695503 -0.0511796 -0.0326137 -0.0163878 -0.00377373 0.000967826 0.00096293 0.000957102 0.000954224 + 0.000953682 0.000953211 0.000955504 0.0011285 0.00112524 0.00112212 -0.00888234 -0.0942058 -0.0926312 -0.0898397 -0.0854167 -0.0791331 + -0.0710161 -0.0525289 -0.033621 -0.0169485 -0.00391577 0.0009669 0.000962001 0.000956223 0.000954202 0.000953669 0.000953198 0.000955504 + 0.0011285 0.00112484 0.00112146 -0.00646041 -0.094601 -0.0932437 -0.0906891 -0.0865011 -0.0804113 -0.0724114 -0.0538418 -0.0346068 + -0.0174795 -0.00400495 0.00096597 0.000961052 0.000955574 0.000954197 0.000953647 0.000953175 0.000955504 0.0011285 0.00112433 0.00112075 + -0.00481642 -0.0948598 -0.0936687 -0.0912769 -0.0872802 -0.0813719 -0.0735021 -0.0548945 -0.0353522 -0.0177431 -0.00381012 0.000965055 + 0.000960003 0.000955245 0.000954188 0.000953606 0.000953136 0.000955504 0.0011285 0.00112363 0.00112 -0.0092668 -0.0931293 -0.0916931 + -0.0892256 -0.0852329 -0.0793714 -0.0715804 -0.0530296 -0.0331957 -0.0148675 2.97461e-05 0.000964284 0.000958693 0.00095522 0.00095415 + 0.00095354 0.000953066 0.000955504 </DataArray> - <DataArray type="Float32" Name="x^NaCl_liquid" NumberOfComponents="1" format="ascii"> - 3.08286e-05 0.00192665 3.08286e-05 0.000600458 0.00470226 0.00262359 0.0501478 0.0493123 0.0977244 0.0977244 0.0977248 0.0977248 + <DataArray type="Float32" Name="x^NaCl_brine" NumberOfComponents="1" format="ascii"> + 3.08286e-05 0.00190019 3.08286e-05 0.000618571 0.004955 0.00280456 0.0602749 0.0550818 0.0977245 0.0977244 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 - 0.0977248 0.0977248 0.0977248 0.0977248 0.170476 0.170476 3.08286e-05 0.000230814 0.00148097 0.038583 0.0977243 0.0977248 + 0.0977248 0.0977248 0.0977248 0.0977248 0.170476 0.170476 3.08286e-05 0.000241617 0.0015626 0.0404171 0.0977243 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 - 0.0977248 0.0977248 0.170476 3.08286e-05 0.000128513 0.000928503 0.0298381 0.0977242 0.0977248 0.0977248 0.0977248 0.0977248 + 0.0977248 0.0977248 0.170476 3.08286e-05 0.000134228 0.000965702 0.0301598 0.0977242 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.170476 - 3.08286e-05 8.45195e-05 0.000617802 0.0233853 0.0977241 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 - 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.170476 3.08286e-05 6.16223e-05 0.000426965 - 0.0188482 0.097724 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 - 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.170476 3.08286e-05 4.86342e-05 0.000303076 0.0150047 0.097724 0.0977248 + 3.08286e-05 8.77684e-05 0.000635973 0.0231663 0.0977241 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 + 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.170476 3.08286e-05 6.35674e-05 0.00043582 + 0.0183959 0.097724 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 + 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.170476 3.08286e-05 4.98211e-05 0.000306409 0.0144466 0.097724 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 - 0.0977248 0.0977248 0.170476 3.08286e-05 4.10399e-05 0.000221271 0.0120873 0.097724 0.0977248 0.0977248 0.0977248 0.0977248 + 0.0977248 0.0977248 0.170476 3.08286e-05 4.1759e-05 0.000220651 0.0113611 0.097724 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.170476 - 3.08286e-05 3.66096e-05 0.000168875 0.00956797 0.0977239 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 - 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.170476 3.08286e-05 3.40647e-05 0.000140859 - 0.00831498 0.0977239 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 - 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.170476 3.08286e-05 3.25468e-05 0.000149789 0.0164078 0.0977241 0.0977248 + 3.08286e-05 3.70387e-05 0.00016499 0.00869672 0.0977239 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 + 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.170476 3.08286e-05 3.43219e-05 0.000133902 + 0.00690959 0.0977239 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 + 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.170476 3.08286e-05 3.27107e-05 0.000138882 0.0129003 0.097724 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.170476 </DataArray> - <DataArray type="Float32" Name="x^H2O_gas" NumberOfComponents="1" format="ascii"> - 0.0319348 0.0318752 0.0319348 0.0319396 0.0318283 0.0319178 0.0317542 0.0318556 0.0318575 0.0319615 0.0323174 0.0324222 - 0.0328922 0.033001 0.0334851 0.0335914 0.0340786 0.0341778 0.0346667 0.0347556 0.0344216 0.034483 0.0339905 0.0340218 - 0.0336557 0.0336579 0.0334439 0.0334191 0.033379 0.0334036 0.0335311 0.0335613 0.0337222 0.0337509 0.0339137 0.0339548 - 0.0340286 0.0340264 0.0340384 0.0340407 0.0313075 0.0313075 0.0319348 0.0319664 0.0319752 0.0319365 0.0320471 0.0325093 - 0.0331098 0.0337116 0.0343031 0.0348812 0.0345902 0.0341026 0.0337091 0.0334424 0.0334286 0.03359 0.0337816 0.033982 - 0.0340249 0.0340413 0.0313075 0.0319348 0.0319814 0.0320117 0.0319946 0.0321043 0.0325608 0.0331869 0.033804 0.0344044 - 0.0349866 0.0346847 0.0341781 0.0337628 0.0334747 0.0334545 0.0336181 0.0338121 0.033994 0.034025 0.0340415 0.0313075 - 0.0319348 0.0319931 0.0320393 0.0320407 0.0321467 0.0325933 0.0332443 0.0338781 0.034489 0.0350772 0.0347679 0.0342464 - 0.0338137 0.0335088 0.0334811 0.033646 0.0338418 0.0340008 0.0340253 0.0340416 0.0313075 0.0319348 0.0320034 0.0320625 - 0.0320798 0.0321813 0.0326163 0.033291 0.033942 0.0345645 0.0351596 0.0348452 0.0343104 0.0338623 0.0335429 0.0335081 - 0.0336739 0.0338714 0.0340049 0.0340257 0.0340418 0.0313075 0.0319348 0.0320134 0.0320835 0.0321149 0.0322123 0.0326356 - 0.0333329 0.034001 0.0346353 0.0352382 0.0349199 0.034373 0.0339099 0.0335766 0.0335354 0.0337019 0.0339009 0.0340072 - 0.0340261 0.0340421 0.0313075 0.0319348 0.0320239 0.0321038 0.0321475 0.0322418 0.0326541 0.0333733 0.0340574 0.0347036 - 0.0353149 0.0349938 0.0344355 0.0339575 0.0336101 0.0335629 0.0337299 0.0339286 0.0340083 0.0340266 0.0340426 0.0313075 - 0.0319348 0.0320358 0.0321242 0.0321783 0.0322714 0.0326755 0.0334138 0.0341116 0.0347693 0.035389 0.0350664 0.0344975 - 0.0340045 0.0336425 0.0335904 0.0337583 0.0339517 0.0340086 0.0340273 0.0340434 0.0313075 0.0319348 0.0320507 0.0321457 - 0.0322048 0.032299 0.0327028 0.0334491 0.0341571 0.0348245 0.0354521 0.0351297 0.0345511 0.0340431 0.0336666 0.0336174 - 0.0337892 0.0339662 0.0340086 0.0340287 0.0340448 0.0313075 0.0319348 0.0320714 0.0321673 0.032171 0.0322602 0.0326615 - 0.0333932 0.0341019 0.0347708 0.0354017 0.0350838 0.0344994 0.0339705 0.0335671 0.03364 0.0338276 0.0339692 0.0340096 - 0.034031 0.0340472 0.0313075 + <DataArray type="Float32" Name="x^H2O_Air" NumberOfComponents="1" format="ascii"> + 0.0319348 0.0318795 0.0319348 0.0319412 0.0318235 0.0319142 0.031736 0.0318456 0.0318341 0.0319494 0.0322953 0.0324123 + 0.0328576 0.0329808 0.0334447 0.033566 0.0340361 0.0341501 0.0346248 0.034728 0.0343868 0.03446 0.0339652 0.0340054 + 0.0336399 0.0336483 0.0334355 0.0334158 0.0333666 0.0333949 0.0335158 0.03355 0.0337053 0.0337378 0.033893 0.0339393 + 0.0340287 0.0340272 0.034039 0.0340411 0.0313075 0.0313075 0.0319348 0.0319675 0.0319743 0.0319341 0.0320438 0.0325077 + 0.0331016 0.0336996 0.0342896 0.0348678 0.0345796 0.0340957 0.0337065 0.0334435 0.0334236 0.0335826 0.0337721 0.0339762 + 0.034025 0.0340416 0.0313075 0.0319348 0.0319823 0.0320121 0.0319952 0.0321042 0.0325612 0.0331844 0.0337998 0.0344001 + 0.0349834 0.0346836 0.034179 0.0337658 0.0334794 0.0334531 0.0336145 0.0338068 0.0339925 0.0340248 0.0340415 0.0313075 + 0.0319348 0.0319938 0.0320402 0.0320427 0.0321476 0.0325936 0.0332447 0.0338793 0.0344919 0.0350823 0.0347751 0.0342544 + 0.0338221 0.033517 0.0334832 0.0336463 0.0338407 0.0340005 0.0340251 0.0340416 0.0313075 0.0319348 0.032004 0.0320635 + 0.0320824 0.0321826 0.0326159 0.0332933 0.0339478 0.0345738 0.0351725 0.0348602 0.0343253 0.0338757 0.0335545 0.0335138 + 0.033678 0.0338747 0.0340049 0.0340254 0.0340417 0.0313075 0.0319348 0.0320138 0.0320847 0.0321179 0.0322136 0.032634 + 0.0333369 0.0340109 0.0346508 0.0352588 0.0349427 0.0343947 0.0339285 0.0335918 0.0335447 0.0337096 0.0339082 0.034007 + 0.0340258 0.034042 0.0313075 0.0319348 0.032024 0.0321049 0.0321511 0.0322433 0.032651 0.0333791 0.0340719 0.0347257 + 0.0353433 0.0350248 0.0344642 0.0339813 0.0336288 0.0335757 0.0337411 0.0339383 0.0340078 0.0340262 0.0340424 0.0313075 + 0.0319348 0.0320355 0.032125 0.0321828 0.0322736 0.0326705 0.0334221 0.0341313 0.0347983 0.0354258 0.0351057 0.0345331 + 0.0340335 0.0336642 0.033607 0.0337733 0.0339606 0.034008 0.0340269 0.0340432 0.0313075 0.0319348 0.0320497 0.0321457 + 0.0322111 0.0323034 0.0326971 0.0334617 0.0341831 0.0348612 0.0354977 0.0351773 0.0345934 0.0340761 0.0336901 0.0336378 + 0.033809 0.0339719 0.0340083 0.0340283 0.0340446 0.0313075 0.0319348 0.0320691 0.0321663 0.0321843 0.0322732 0.0326633 + 0.0334173 0.0341406 0.0348208 0.0354605 0.0351419 0.0345469 0.0340023 0.0335834 0.0336638 0.0338537 0.0339728 0.0340096 + 0.0340306 0.034047 0.0313075 </DataArray> - <DataArray type="Float32" Name="x^Air_gas" NumberOfComponents="1" format="ascii"> - 0.968065 0.968125 0.968065 0.96806 0.968172 0.968082 -34.7422 -36.137 -73.8477 -76.1348 -72.2117 -74.6015 - -69.9724 -72.3611 -66.6743 -68.9268 -62.0941 -64.0999 -56.1566 -57.8356 -40.9181 -41.8366 -25.9965 -26.0954 - -13.606 -12.9178 -4.4518 -3.02742 0.966621 0.966596 0.966469 0.966439 0.966278 0.966249 0.966086 0.966045 - 0.965971 0.965974 0.965962 0.965959 0.968693 0.968693 0.968065 0.968034 0.968025 -28.4534 -78.0497 -76.849 - -74.8966 -71.6254 -66.8423 -60.5056 -43.9854 -27.526 -13.5481 -2.91924 0.966571 0.96641 0.966218 0.966018 - 0.965975 0.965959 0.968693 0.968065 0.968019 0.967988 -21.8653 -79.2737 -78.3397 -76.6939 -73.6363 -68.9683 - -62.6447 -45.795 -28.8164 -14.249 -3.05793 0.966546 0.966382 0.966188 0.966006 0.965975 0.965959 0.968693 - 0.968065 0.968007 0.967961 -16.9456 -80.1283 -79.3938 -78.0345 -75.1979 -70.6664 -64.3887 -47.3057 -29.9159 - -14.8797 -3.24633 0.966519 0.966354 0.966158 0.965999 0.965975 0.965958 0.968693 0.968065 0.967997 0.967938 - -13.4969 -80.7698 -80.2014 -79.1146 -76.5055 -72.1278 -65.9193 -48.6545 -30.9012 -15.4461 -3.42783 0.966492 - 0.966326 0.966129 0.965995 0.965974 0.965958 0.968693 0.968065 0.967987 0.967916 -10.5296 -81.2895 -80.873 - -80.0496 -77.672 -73.4633 -67.3448 -49.9357 -31.8457 -15.983 -3.59418 0.966465 0.966298 0.966099 0.965993 - 0.965974 0.965958 0.968693 0.968065 0.967976 0.967896 -8.27805 -81.7229 -81.4539 -80.8874 -78.7438 -74.7195 - -68.7129 -51.1934 -32.7856 -16.5154 -3.74706 0.966437 0.96627 0.966071 0.965992 0.965973 0.965957 0.968693 - 0.968065 0.967964 0.967876 -6.30089 -82.0917 -81.9668 -81.6325 -79.7127 -75.8818 -70.0064 -52.4116 -33.7053 - -17.0247 -3.85963 0.96641 0.966242 0.966048 0.965991 0.965973 0.965957 0.968693 0.968065 0.967949 0.967854 - -5.30588 -82.3242 -82.3161 -82.1305 -80.3897 -76.7354 -70.998 -53.3751 -34.3995 -17.2984 -3.72829 0.966383 - 0.966211 0.966034 0.965991 0.965971 0.965955 0.968693 0.968065 0.967929 0.967833 -10.7947 -80.6881 -80.4562 - -80.0959 -78.2987 -74.6354 -68.9319 -51.4068 -32.2614 -14.5926 -0.207111 0.96636 0.966172 0.966031 0.96599 + <DataArray type="Float32" Name="x^Air_Air" NumberOfComponents="1" format="ascii"> + 0.968065 0.96812 0.968065 0.968059 0.968177 0.968086 -42.9843 -40.8257 -73.2726 -75.8175 -71.562 -74.2536 + -69.2372 -71.9447 -65.8926 -68.4639 -61.3044 -63.6185 -55.3995 -57.3662 -40.3543 -41.49 -25.6841 -25.9205 + -13.5425 -12.9173 -4.57873 -3.18846 0.966633 0.966605 0.966484 0.96645 0.966295 0.966262 0.966107 0.966061 + 0.965971 0.965973 0.965961 0.965959 0.968693 0.968693 0.968065 0.968032 0.968026 -29.9359 -77.9552 -76.7526 + -74.7602 -71.4555 -66.6564 -60.3235 -43.8706 -27.5063 -13.6354 -3.09655 0.966576 0.966417 0.966228 0.966024 + 0.965975 0.965958 0.968693 0.968065 0.968018 0.967988 -22.117 -79.2648 -78.3441 -76.6894 -73.6223 -68.9539 + -62.6409 -45.8369 -28.9074 -14.3887 -3.23299 0.966547 0.966385 0.966193 0.966008 0.965975 0.965958 0.968693 + 0.968065 0.968006 0.96796 -16.759 -80.1523 -79.4413 -78.1018 -75.2832 -70.772 -64.5176 -47.4721 -30.0983 + -15.063 -3.41706 0.966517 0.966354 0.966159 0.965999 0.965975 0.965958 0.968693 0.968065 0.967996 0.967936 + -13.1214 -80.8097 -80.2729 -79.2322 -76.6692 -72.3347 -66.1647 -48.9329 -31.1662 -15.6634 -3.59149 0.966486 + 0.966322 0.966125 0.965995 0.965975 0.965958 0.968693 0.968065 0.967986 0.967915 -10.0704 -81.3397 -80.9627 + -80.2115 -77.9087 -73.7672 -67.7037 -50.3255 -32.1933 -16.2391 -3.75394 0.966455 0.96629 0.966092 0.965993 + 0.965974 0.965958 0.968693 0.968065 0.967976 0.967895 -7.68131 -81.7866 -81.5653 -81.0991 -79.0591 -75.1265 + -69.192 -51.7003 -33.2188 -16.8107 -3.8989 0.966424 0.966259 0.966062 0.965992 0.965974 0.965958 0.968693 + 0.968065 0.967965 0.967875 -5.59101 -82.1742 -82.1032 -81.9011 -80.1145 -76.4003 -70.6148 -53.0421 -34.2253 + -17.3539 -3.99151 0.966393 0.966227 0.966039 0.965992 0.965973 0.965957 0.968693 0.968065 0.96795 0.967854 + -4.17133 -82.4537 -82.5093 -82.4807 -80.8949 -77.3771 -71.7436 -54.1299 -34.9956 -17.6327 -3.80107 0.966362 + 0.966191 0.966028 0.965992 0.965972 0.965955 0.968693 0.968065 0.967931 0.967834 -8.03136 -81.0146 -80.846 + -80.6866 -79.0627 -75.5408 -69.9324 -52.3404 -32.8923 -14.7891 0.0297073 0.966336 0.966146 0.966027 0.96599 0.965969 0.965953 0.968693 </DataArray> - <DataArray type="Float32" Name="x^NaCl_gas" NumberOfComponents="1" format="ascii"> - 2.37143e-12 1.48209e-10 2.37143e-12 4.62223e-11 3.62199e-10 2.02231e-10 3.86905e-09 3.80741e-09 7.58442e-09 7.5893e-09 7.72018e-09 7.72427e-09 - 7.89172e-09 7.89685e-09 8.07824e-09 8.08407e-09 8.27738e-09 8.28374e-09 8.4883e-09 8.49517e-09 8.57243e-09 8.57952e-09 8.60503e-09 8.61222e-09 - 8.6381e-09 8.64538e-09 8.67182e-09 8.67919e-09 8.70755e-09 8.71395e-09 8.74717e-09 8.75505e-09 8.79698e-09 8.80444e-09 8.84687e-09 8.85759e-09 - 8.8768e-09 8.87623e-09 8.87936e-09 8.87996e-09 1.54978e-08 1.54978e-08 2.37143e-12 1.7776e-11 1.1423e-10 2.98122e-09 7.59299e-09 7.72514e-09 - 7.90059e-09 8.08919e-09 8.28977e-09 8.50195e-09 8.58659e-09 8.61938e-09 8.6526e-09 8.68632e-09 8.72046e-09 8.76253e-09 8.81244e-09 8.86467e-09 - 8.87584e-09 8.88012e-09 1.54978e-08 2.37143e-12 9.90097e-12 7.16593e-11 2.3072e-09 7.596e-09 7.72409e-09 7.90322e-09 8.09373e-09 8.29553e-09 - 8.50866e-09 8.59363e-09 8.62651e-09 8.65977e-09 8.69338e-09 8.72721e-09 8.76984e-09 8.82039e-09 8.86779e-09 8.87586e-09 8.88016e-09 1.54978e-08 - 2.37143e-12 6.51369e-12 4.77065e-11 1.80953e-09 7.59875e-09 7.7223e-09 7.90515e-09 8.09787e-09 8.30108e-09 8.51531e-09 8.60065e-09 8.63363e-09 - 8.66692e-09 8.70046e-09 8.73414e-09 8.77711e-09 8.82813e-09 8.86957e-09 8.87595e-09 8.8802e-09 1.54978e-08 2.37143e-12 4.75049e-12 3.29876e-11 - 1.45945e-09 7.60153e-09 7.72047e-09 7.90683e-09 8.10183e-09 8.30655e-09 8.52194e-09 8.60767e-09 8.64075e-09 8.67407e-09 8.70757e-09 8.74118e-09 - 8.7844e-09 8.83585e-09 8.87063e-09 8.87605e-09 8.88025e-09 1.54978e-08 2.37143e-12 3.75035e-12 2.34283e-11 1.16265e-09 7.60454e-09 7.71896e-09 - 7.90868e-09 8.10586e-09 8.31204e-09 8.52858e-09 8.6147e-09 8.64789e-09 8.68126e-09 8.71474e-09 8.74829e-09 8.79168e-09 8.84352e-09 8.87125e-09 - 8.87616e-09 8.88033e-09 1.54978e-08 2.37143e-12 3.16574e-12 1.71141e-11 9.37255e-10 7.60803e-09 7.71814e-09 7.91108e-09 8.11015e-09 8.31764e-09 - 8.53526e-09 8.62175e-09 8.65505e-09 8.6885e-09 8.72198e-09 8.75545e-09 8.79897e-09 8.85077e-09 8.87153e-09 8.87628e-09 8.88046e-09 1.54978e-08 - 2.37143e-12 2.82503e-12 1.30692e-11 7.42446e-10 7.61217e-09 7.71876e-09 7.91439e-09 8.11487e-09 8.32346e-09 8.54201e-09 8.62884e-09 8.66225e-09 - 8.69581e-09 8.72933e-09 8.76263e-09 8.80637e-09 8.85678e-09 8.8716e-09 8.87648e-09 8.88067e-09 1.54978e-08 2.37143e-12 2.62987e-12 1.0908e-11 - 6.45686e-10 7.6171e-09 7.72246e-09 7.91874e-09 8.12014e-09 8.32956e-09 8.54884e-09 8.63596e-09 8.66949e-09 8.7032e-09 8.73688e-09 8.76967e-09 - 8.81442e-09 8.86055e-09 8.87161e-09 8.87683e-09 8.88102e-09 1.54978e-08 2.37143e-12 2.5143e-12 1.16074e-11 1.27503e-09 7.62288e-09 7.72978e-09 - 7.92393e-09 8.12606e-09 8.33597e-09 8.55576e-09 8.64312e-09 8.67678e-09 8.71056e-09 8.74515e-09 8.77556e-09 8.82442e-09 8.86134e-09 8.87186e-09 - 8.87743e-09 8.88165e-09 1.54978e-08 + <DataArray type="Float32" Name="x^NaCl_Air" 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 </DataArray> - <DataArray type="Float32" Name="m^H2O_liquid" NumberOfComponents="1" format="ascii"> - 51477.4 51405.7 51477.4 51455.9 51296.2 51378.1 51095.5 51227.9 50126.6 50254 49956.7 50088.2 - 49740.8 49869 49470.3 49588.1 49139.4 49241.6 48750.2 48833.4 47949.2 47993.8 47187.5 47191.2 - 46557.9 46522.5 46095 46023.1 45822.2 45822.1 45821.5 45821.4 45820.7 45820.6 45819.9 45819.8 - 45819.5 45819.5 45819.4 45819.4 40557.1 40557.1 51477.4 51469.6 51421.9 51399.4 50360.7 50213.4 - 50005.8 49729.9 49382.1 48966.9 48100.4 47262.1 46553.5 46017.4 45822 45821.3 45820.5 45819.7 - 45819.5 45819.4 40557.1 51477.4 51473.3 51442.7 51484.7 50428.5 50297.4 50102.7 49835.1 49490.5 - 49073.2 48189.8 47325.8 46588 46024.1 45821.9 45821.2 45820.4 45819.6 45819.5 45819.4 40557.1 - 51477.4 51474.8 51454.2 51522.1 50475.4 50357.5 50174.9 49916.3 49576.4 49159.2 48263.9 47379.7 - 46618.9 46033.2 45821.8 45821.1 45820.2 45819.6 45819.5 45819.4 40557.1 51477.4 51475.5 51461.2 - 51536.9 50510.1 50403.8 50232.9 49984 49649.9 49234.2 48329.8 47427.9 46646.5 46042 45821.6 - 45820.9 45820.1 45819.6 45819.5 45819.4 40557.1 51477.4 51475.9 51465.7 51538.7 50537.7 50442.3 - 50282.9 50044.1 49716.8 49303.8 48392.1 47473.9 46672.6 46050 45821.5 45820.8 45820 45819.5 - 45819.5 45819.4 40557.1 51477.4 51476.1 51468.5 51534.9 50560 50475.3 50327.3 50098.9 49779.4 - 49370.3 48453.1 47519.5 46698.5 46057.4 45821.4 45820.7 45819.9 45819.5 45819.5 45819.4 40557.1 - 51477.4 51476.2 51470.3 51526 50578.3 50503.6 50366 50147.9 49836.9 49432.9 48512 47564.1 - 46723.1 46062.7 45821.3 45820.6 45819.8 45819.5 45819.5 45819.4 40557.1 51477.4 51476.1 51471.2 - 51519.4 50588.3 50520.8 50390.6 50181 49878.1 49480.1 48558 47597.3 46735.9 46055.8 45821.2 - 45820.5 45819.7 45819.5 45819.5 45819.4 40557.1 51477.4 51476 51470.6 51486.9 50491.9 50412.3 - 50276.6 50066.6 49766 49372.5 48456.9 47488.7 46599.8 45880 45821.1 45820.3 45819.7 45819.5 - 45819.4 45819.4 40557.1 + <DataArray type="Float32" Name="m^H2O_brine" NumberOfComponents="1" format="ascii"> + 51477.4 51406.7 51477.4 51455.2 51286.1 51371.1 51006 51192.6 50358.2 50509.5 50172.8 50331 + 49940.4 50095.3 49651.2 49794.7 49299.9 49425.5 48888.7 48992.5 48047.2 48106.1 47251.3 47262.5 + 46596.3 46562 46115.3 46040.9 45819.4 45819.2 45818.7 45818.6 45817.9 45817.8 45817.2 45817 + 45816.6 45816.6 45816.6 45816.6 40550.7 40550.7 51477.4 51469.1 51418.8 51395 50636.9 50479.8 + 50257.4 49962.3 49591.5 49150 48231.7 47345.9 46599.5 46035.7 45819.1 45818.5 45817.7 45816.8 + 45816.6 45816.6 40550.7 51477.4 51473 51441.3 51484.2 50714.4 50575.7 50368.3 50083 49716.1 + 49272.5 48334.9 47419.3 46638.8 46042.6 45819 45818.3 45817.5 45816.8 45816.6 45816.6 40550.7 + 51477.4 51474.7 51453.5 51520.5 50766.5 50642.6 50449.4 50175.1 49814 49370.9 48420.1 47481.3 + 46673.8 46052 45818.9 45818.2 45817.4 45816.7 45816.6 45816.6 40550.7 51477.4 51475.5 51460.9 + 51534.1 50804.5 50693.7 50514.3 50251.5 49897.7 49456.7 48495.8 47536.6 46704.8 46060.9 45818.7 + 45818.1 45817.3 45816.7 45816.6 45816.6 40550.7 51477.4 51475.9 51465.5 51535 50834.7 50736.2 + 50570.3 50319.5 49974 49536.6 48567.8 47589.6 46734.4 46069.2 45818.6 45817.9 45817.1 45816.7 + 45816.6 45816.6 40550.7 51477.4 51476.1 51468.6 51529.9 50859.4 50773.2 50620.5 50382.2 50046.1 + 49613.5 48638.6 47642.5 46763.7 46076.5 45818.5 45817.8 45817 45816.7 45816.6 45816.6 40550.7 + 51477.4 51476.1 51470.5 51519.8 50880.1 50805.4 50665.1 50439.1 50113.1 49686.7 48707.5 47694.2 + 46791.5 46081 45818.4 45817.7 45816.9 45816.7 45816.6 45816.6 40550.7 51477.4 51476.1 51471.4 + 51509.8 50893.5 50827.7 50695.9 50479.9 50163.5 49743.9 48762.7 47733.3 46805.2 46070.5 45818.2 + 45817.5 45816.9 45816.7 45816.6 45816.6 40550.7 51477.4 51476 51471 51480.8 50802.3 50723.5 + 50587.8 50372 50058 49642.6 48664.4 47619.5 46653.6 45868 45818.1 45817.3 45816.8 45816.7 + 45816.6 45816.5 40550.7 </DataArray> - <DataArray type="Float32" Name="m^Air_liquid" NumberOfComponents="1" format="ascii"> - 58.1597 58.191 58.1597 58.1264 58.1553 58.0796 -2083.56 -2165.9 -4330.71 -4461.62 -4160.35 -4295.42 - -3943.77 -4075.45 -3671.28 -3792.3 -3337.06 -3442 -2943.28 -3028.68 -2124.38 -2170.21 -1345.09 -1349.07 - -701.506 -665.475 -228.685 -155.389 49.4566 49.4189 49.2239 49.1778 48.9343 48.8913 48.6476 48.5864 - 48.4771 48.4803 48.4625 48.4592 46.7704 46.7704 58.1597 58.0915 58.0213 -1706.75 -4571.31 -4424.01 - -4215.91 -3937.95 -3586.36 -3165.72 -2279.66 -1421.78 -697.348 -149.713 49.3805 49.1343 48.8451 48.546 - 48.4825 48.4582 46.7704 58.1597 58.0675 57.9763 -1311.36 -4640.96 -4510.22 -4315.4 -4045.99 -3697.62 - -3274.85 -2371.38 -1487.15 -732.801 -156.697 49.3409 49.0917 48.7993 48.5283 48.4824 48.458 46.7704 - 58.1597 58.0474 57.9377 -1015.58 -4689.16 -4571.82 -4389.57 -4129.48 -3785.94 -3363.22 -2447.5 -1542.57 - -764.591 -166.215 49.3002 49.0494 48.7549 48.5182 48.4819 48.4578 46.7704 58.1597 58.0289 57.9023 - -808.138 -4724.86 -4619.3 -4449.23 -4199.06 -3861.51 -3440.34 -2515.13 -1592.02 -793.026 -175.363 49.2589 - 49.0072 48.7106 48.5121 48.4813 48.4575 46.7704 58.1597 58.0106 57.8681 -629.805 -4753.29 -4658.79 - -4500.62 -4260.81 -3930.25 -3511.85 -2579.16 -1639.28 -819.901 -183.721 49.2173 48.965 48.6667 48.5086 - 48.4807 48.457 46.7704 58.1597 57.9912 57.8336 -494.593 -4776.37 -4692.66 -4546.22 -4317.17 -3994.61 - -3580.24 -2641.86 -1686.22 -846.488 -191.375 49.1755 48.9228 48.6253 48.507 48.48 48.4563 46.7704 - 58.1597 57.969 57.7975 -376.037 -4795.24 -4721.75 -4586.07 -4367.61 -4053.76 -3644.62 -2702.41 -1732.03 - -871.846 -196.957 49.1336 48.8801 48.591 48.5066 48.4789 48.4552 46.7704 58.1597 57.941 57.7586 - -316.354 -4805.67 -4739.55 -4611.43 -4401.75 -4096.25 -3693.17 -2749.74 -1766.19 -885.102 -190.091 49.0926 - 48.8337 48.5695 48.5066 48.4769 48.4531 46.7704 58.1597 57.9022 57.7179 -643.883 -4706.85 -4628.34 - -4494.53 -4284.4 -3981.33 -3583 -2646.28 -1655.11 -746.074 -10.5506 49.0584 48.7762 48.565 48.5052 - 48.4735 48.4496 46.7704 + <DataArray type="Float32" Name="m^Air_brine" NumberOfComponents="1" format="ascii"> + 58.1597 58.1839 58.1597 58.1227 58.1531 58.0784 -2574.8 -2446 -4320 -4467.3 -4143.6 -4297.42 + -3922.13 -4072.87 -3645.9 -3785.39 -3309.5 -3431.69 -2915.37 -3016.28 -2101.51 -2158.7 -1331.71 -1342.7 + -699.134 -666.202 -235.368 -163.734 49.4725 49.429 49.244 49.1919 48.9568 48.9079 48.6753 48.6065 + 48.4738 48.4761 48.4587 48.4556 46.763 46.763 58.1597 58.089 58.0194 -1795.67 -4591.28 -4442.12 + -4230.45 -3948.38 -3592.96 -3169.21 -2280.62 -1423.58 -702.59 -158.865 49.3851 49.1424 48.8562 48.5516 + 48.4793 48.4549 46.763 58.1597 58.0656 57.974 -1326.42 -4666.77 -4535.37 -4338.35 -4065.85 -3714.16 + -3288.26 -2380.77 -1494.76 -740.726 -165.712 49.3399 49.094 48.8043 48.5275 48.4796 48.4549 46.763 + 58.1597 58.0459 57.9353 -1004.3 -4717.48 -4600.41 -4417.34 -4155.44 -3809.45 -3383.97 -2463.55 -1554.94 + -774.729 -174.985 49.2938 49.0459 48.7534 48.5155 48.4792 48.4548 46.763 58.1597 58.0277 57.8999 + -785.553 -4754.57 -4650.07 -4480.48 -4229.85 -3890.87 -3467.48 -2537.13 -1608.66 -804.869 -183.748 49.2471 + 48.9979 48.7027 48.5091 48.4787 48.4546 46.763 58.1597 58.0098 57.8658 -602.237 -4783.98 -4691.36 + -4534.96 -4296.06 -3965.16 -3545.17 -2607.02 -1660.17 -833.682 -191.88 49.2001 48.9502 48.6528 48.5059 + 48.4782 48.4542 46.763 58.1597 57.9909 57.8316 -458.843 -4808.17 -4727.26 -4583.88 -4357.11 -4035.32 + -3620.04 -2675.87 -1711.5 -862.223 -199.102 49.1529 48.9028 48.6079 48.5048 48.4776 48.4536 46.763 + 58.1597 57.9695 57.7963 -333.585 -4828.38 -4758.61 -4627.33 -4412.56 -4100.66 -3691.32 -2742.87 -1761.74 + -889.251 -203.637 49.1054 48.8544 48.5748 48.5045 48.4765 48.4524 46.763 58.1597 57.943 57.7588 + -248.613 -4841.62 -4780.35 -4657.39 -4452.4 -4149.76 -3747.04 -2796.58 -1799.73 -902.667 -193.728 49.0587 + 48.8009 48.558 48.5041 48.4744 48.4504 46.763 58.1597 57.9067 57.7203 -478.802 -4753.02 -4679.22 + -4552.42 -4347.67 -4047.46 -3648.83 -2701.39 -1689.8 -756.286 1.51222 49.0194 48.734 48.5567 48.5021 + 48.471 48.4468 46.763 </DataArray> - <DataArray type="Float32" Name="m^NaCl_liquid" NumberOfComponents="1" format="ascii"> - 1.58882 99.3445 1.58882 30.9506 242.622 135.302 2587.61 2544.85 4960.1 4959.72 4960.17 4959.78 - 4960.25 4959.87 4960.46 4960.11 4960.82 4960.52 4961.32 4961.08 4963.25 4963.12 4965.16 4965.13 - 4966.67 4966.75 4967.74 4967.9 4968.33 4968.31 4968.23 4968.21 4968.11 4968.09 4967.99 4967.97 - 4967.92 4967.92 4967.92 4967.92 8344.5 8344.5 1.58882 11.896 76.3531 1994.23 4959.39 4959.42 - 4959.47 4959.7 4960.11 4960.69 4962.82 4964.93 4966.65 4967.9 4968.29 4968.19 4968.08 4967.95 - 4967.93 4967.92 8344.5 1.58882 6.62328 47.8629 1543.12 4959.18 4959.18 4959.18 4959.39 4959.79 - 4960.38 4962.56 4964.75 4966.54 4967.87 4968.28 4968.18 4968.06 4967.94 4967.93 4967.92 8344.5 - 1.58882 4.3559 31.844 1209.39 4959.03 4959.01 4958.97 4959.14 4959.53 4960.13 4962.35 4964.59 - 4966.45 4967.83 4968.26 4968.16 4968.04 4967.94 4967.93 4967.92 8344.5 1.58882 3.17581 22.0062 - 974.514 4958.92 4958.88 4958.8 4958.94 4959.31 4959.9 4962.15 4964.45 4966.36 4967.79 4968.24 - 4968.14 4968.02 4967.94 4967.92 4967.92 8344.5 1.58882 2.50643 15.6203 775.51 4958.83 4958.78 - 4958.65 4958.76 4959.11 4959.69 4961.97 4964.31 4966.28 4967.75 4968.23 4968.12 4968 4967.94 - 4967.92 4967.92 8344.5 1.58882 2.11504 11.4038 624.488 4958.75 4958.68 4958.52 4958.59 4958.92 - 4959.49 4961.78 4964.17 4966.2 4967.71 4968.21 4968.11 4967.98 4967.94 4967.92 4967.91 8344.5 - 1.58882 1.88671 8.7033 494.129 4958.68 4958.6 4958.39 4958.43 4958.74 4959.3 4961.61 4964.04 - 4966.11 4967.68 4968.19 4968.09 4967.97 4967.94 4967.92 4967.91 8344.5 1.58882 1.75555 7.25934 - 429.322 4958.64 4958.54 4958.31 4958.32 4958.6 4959.15 4961.46 4963.93 4966.06 4967.68 4968.18 - 4968.07 4967.96 4967.94 4967.92 4967.91 8344.5 1.58882 1.67732 7.71955 848.136 4958.91 4958.83 - 4958.62 4958.63 4958.9 4959.43 4961.72 4964.2 4966.39 4968.09 4968.16 4968.05 4967.96 4967.93 - 4967.92 4967.91 8344.5 + <DataArray type="Float32" Name="m^NaCl_brine" NumberOfComponents="1" format="ascii"> + 1.58882 97.9793 1.58882 31.8844 255.678 144.642 3106.43 2841.57 4986.34 4986.78 4985.39 4985.86 + 4984.2 4984.66 4982.8 4983.23 4981.18 4981.56 4979.34 4979.66 4976.35 4976.53 4973.52 4973.54 + 4971.08 4970.94 4969.22 4968.92 4968.02 4968 4967.93 4967.91 4967.81 4967.79 4967.7 4967.67 + 4967.62 4967.62 4967.61 4967.61 8343.18 8343.18 1.58882 12.4529 80.5635 2089.1 4987.14 4986.3 + 4985.14 4983.73 4982.06 4980.14 4976.93 4973.81 4971.06 4968.89 4967.98 4967.89 4967.77 4967.65 + 4967.62 4967.61 8343.18 1.58882 6.91785 49.781 1559.79 4987.35 4986.59 4985.47 4984.09 4982.44 + 4980.52 4977.26 4974.05 4971.18 4968.89 4967.97 4967.87 4967.75 4967.64 4967.62 4967.61 8343.18 + 1.58882 4.52334 32.7808 1198.03 4987.49 4986.8 4985.7 4984.36 4982.72 4980.81 4977.52 4974.25 + 4971.29 4968.91 4967.95 4967.85 4967.73 4967.63 4967.62 4967.61 8343.18 1.58882 3.27606 22.4627 + 951.063 4987.59 4986.96 4985.89 4984.58 4982.97 4981.06 4977.76 4974.42 4971.39 4968.92 4967.93 + 4967.83 4967.71 4967.63 4967.62 4967.61 8343.18 1.58882 2.5676 15.7921 746.59 4987.67 4987.09 + 4986.05 4984.77 4983.18 4981.29 4977.98 4974.59 4971.47 4968.94 4967.91 4967.81 4967.69 4967.63 + 4967.62 4967.61 8343.18 1.58882 2.1521 11.3719 586.889 4987.73 4987.2 4986.2 4984.94 4983.39 + 4981.52 4978.19 4974.75 4971.56 4968.94 4967.89 4967.79 4967.67 4967.63 4967.62 4967.61 8343.18 + 1.58882 1.90883 8.50303 449.058 4987.78 4987.29 4986.32 4985.1 4983.58 4981.73 4978.4 4974.91 + 4971.64 4968.94 4967.87 4967.77 4967.66 4967.63 4967.62 4967.61 8343.18 1.58882 1.76881 6.90078 + 356.658 4987.8 4987.35 4986.4 4985.21 4983.71 4981.89 4978.56 4975.03 4971.67 4968.88 4967.85 + 4967.75 4967.65 4967.63 4967.62 4967.61 8343.18 1.58882 1.68576 7.15743 666.541 4987.52 4987.02 + 4986.06 4984.87 4983.37 4981.55 4978.22 4974.62 4971.1 4968.1 4967.84 4967.72 4967.65 4967.63 + 4967.61 4967.6 8343.18 </DataArray> <DataArray type="Float32" Name="phasePresence" NumberOfComponents="1" format="ascii"> 3 3 3 3 3 3 1 1 1 1 1 1 @@ -444,168 +444,168 @@ 3 3 3 </DataArray> <DataArray type="Float32" Name="precipitateVolumeFraction^NaCl" NumberOfComponents="1" format="ascii"> - 0 8.75474e-12 0 8.75474e-12 9.46029e-11 9.55498e-11 0.000161565 0.00017243 0.047506 0.0474897 0.0524814 0.052481 - 0.0524924 0.0524906 0.0525021 0.0524986 0.0525095 0.0525073 0.0525176 0.0525135 0.00461579 0.00459889 0.00463046 0.00461312 - 0.00463986 0.00462356 0.00464531 0.00463193 0.00466322 0.00468069 0.00470538 0.0047054 0.00470641 0.00470643 0.0047079 0.00470793 - 0.00471021 0.00471022 0.00471457 0.00471458 0 0 0 8.75474e-12 9.50576e-11 9.47611e-05 0.0446375 0.0524784 - 0.0524882 0.052497 0.052505 0.0525119 0.00459081 0.00460433 0.00461501 0.00462396 0.00468304 0.00470542 0.00470645 0.00470795 - 0.00471021 0.00471457 0 0 8.75474e-12 9.46818e-11 5.57275e-05 0.0413235 0.0524764 0.0524865 0.0524957 0.0525033 - 0.0525109 0.00458701 0.00459981 0.00460991 0.00461908 0.00468273 0.00470543 0.00470647 0.00470795 0.0047102 0.00471456 0 - 0 8.75474e-12 9.43632e-11 3.5357e-05 0.0381253 0.0524747 0.0524852 0.0524946 0.0525021 0.05251 0.00458458 0.00459718 - 0.00460654 0.00461583 0.00468176 0.00470544 0.00470648 0.00470795 0.0047102 0.00471454 0 0 8.75474e-12 9.40646e-11 - 2.7203e-05 0.0350836 0.0524733 0.0524841 0.0524935 0.052501 0.0525092 0.00458245 0.00459438 0.00460382 0.00461321 0.00468074 - 0.00470544 0.00470649 0.00470794 0.00471019 0.00471453 0 0 8.75474e-12 9.37641e-11 1.89587e-05 0.0319139 0.0524718 - 0.0524832 0.0524924 0.0525001 0.0525085 0.00458034 0.00459156 0.00460109 0.00461047 0.00467985 0.00470545 0.00470649 0.00470793 - 0.00471018 0.00471451 0 0 8.75474e-12 9.34386e-11 1.49237e-05 0.0284133 0.0524702 0.0524822 0.0524912 0.0524992 - 0.0525078 0.00457809 0.00458856 0.00459807 0.0046075 0.0046791 0.00470546 0.0047065 0.00470792 0.00471017 0.0047145 0 - 0 8.75474e-12 9.3049e-11 1.03954e-05 0.0241518 0.0524683 0.0524813 0.0524901 0.0524983 0.0525067 0.00457551 0.00458509 - 0.00459457 0.00460424 0.00467877 0.00470546 0.00470651 0.00470792 0.00471017 0.00471448 0 0 8.75337e-12 9.25403e-11 - 8.31699e-06 0.0208674 0.0524661 0.0524804 0.0524893 0.0524974 0.0525051 0.00457145 0.00458001 0.00458977 0.00460059 0.00468083 - 0.00470548 0.00470651 0.00470792 0.00471017 0.00471447 0 0 8.74742e-12 9.35714e-11 1.80854e-05 0.0341678 0.0524664 - 0.0524771 0.0524855 0.0524941 0.0525015 0.00454594 0.00455065 0.00456523 0.00457735 0.00470028 0.00470557 0.00470657 0.00470794 - 0.00471018 0.00471448 0 + 0 8.75336e-12 0 8.75336e-12 9.45476e-11 9.55679e-11 0.000261906 0.000220615 0.0494684 0.0487425 0.052482 0.0524812 + 0.052493 0.0524908 0.0525026 0.0524987 0.05251 0.0525075 0.0525181 0.0525135 0.00461809 0.00460008 0.00463263 0.00461464 + 0.00464187 0.00462503 0.00464705 0.00463311 0.00465967 0.00467814 0.00470464 0.00470465 0.00470567 0.00470569 0.00470715 0.00470719 + 0.00470947 0.00470947 0.00471382 0.00471384 0 0 0 8.75336e-12 9.50588e-11 0.000105607 0.045286 0.0524783 + 0.0524881 0.0524967 0.0525048 0.0525116 0.00459088 0.00460495 0.00461581 0.00462495 0.00468052 0.00470467 0.00470571 0.00470721 + 0.00470947 0.00471383 0 0 8.75336e-12 9.46725e-11 5.77226e-05 0.0415525 0.0524761 0.0524862 0.0524954 0.052503 + 0.0525105 0.00458649 0.00459975 0.00461006 0.00461949 0.00468035 0.00470469 0.00470572 0.00470721 0.00470946 0.00471381 0 + 0 8.75336e-12 9.43471e-11 3.53989e-05 0.0380613 0.0524743 0.0524848 0.0524941 0.0525016 0.0525096 0.00458375 0.00459667 + 0.00460618 0.00461573 0.00467951 0.0047047 0.00470574 0.0047072 0.00470945 0.0047138 0 0 8.75336e-12 9.4043e-11 + 2.65512e-05 0.0347954 0.0524727 0.0524836 0.0524929 0.0525005 0.0525087 0.0045814 0.0045934 0.00460306 0.00461246 0.00467864 + 0.0047047 0.00470575 0.00470719 0.00470944 0.00471378 0 0 8.75336e-12 9.37368e-11 1.84026e-05 0.0313914 0.0524712 + 0.0524826 0.0524917 0.0524995 0.0525079 0.00457907 0.00459027 0.00459994 0.0046093 0.00467787 0.00470471 0.00470576 0.00470718 + 0.00470944 0.00471377 0 0 8.75336e-12 9.3404e-11 1.39136e-05 0.0274932 0.0524694 0.0524816 0.0524904 0.0524985 + 0.0525072 0.00457654 0.00458688 0.00459646 0.0046059 0.00467727 0.00470472 0.00470576 0.00470718 0.00470943 0.00471375 0 + 0 8.75336e-12 9.30027e-11 9.65228e-06 0.0224057 0.0524673 0.0524806 0.0524892 0.0524975 0.0525056 0.00457361 0.0045829 + 0.00459237 0.00460208 0.00467722 0.00470473 0.00470577 0.00470717 0.00470943 0.00471374 0 0 8.7519e-12 9.24761e-11 + 6.93071e-06 0.0172601 0.0524649 0.0524796 0.0524878 0.0524964 0.0525038 0.00456881 0.00457676 0.00458654 0.00459763 0.0046799 + 0.00470474 0.00470577 0.00470717 0.00470943 0.00471373 0 0 8.74584e-12 9.35876e-11 1.34817e-05 0.0294905 0.0524647 + 0.0524756 0.0524839 0.0524925 0.0524999 0.00453936 0.00454294 0.00455807 0.0045719 0.0047005 0.00470484 0.00470582 0.00470719 + 0.00470943 0.00471374 0 </DataArray> - <DataArray type="Float32" Name="velocity_liquid (m/s)" NumberOfComponents="3" format="ascii"> - 1.27655e-07 -7.35984e-07 0 4.99343e-07 -1.86473e-07 0 4.37784e-07 -7.70995e-07 0 6.50245e-07 -2.93285e-07 0 - 9.65073e-07 -4.72416e-08 0 9.58374e-07 -9.5325e-08 0 1.07042e-06 -9.89083e-09 0 1.06548e-06 -2.01277e-08 0 - 1.08162e-06 -1.33559e-08 0 1.08038e-06 -2.86876e-08 0 1.11918e-06 -1.88145e-08 0 1.12332e-06 -3.85448e-08 0 - 1.17872e-06 -1.09137e-08 0 1.18318e-06 -2.10693e-08 0 1.21078e-06 -5.06794e-09 0 1.21305e-06 -9.79916e-09 0 - 1.22546e-06 -2.21636e-09 0 1.22683e-06 -4.32139e-09 0 1.23147e-06 -7.37212e-10 0 1.23274e-06 -1.5364e-09 0 - 1.23524e-06 -1.12922e-09 0 1.23686e-06 -2.36991e-09 0 1.24135e-06 -1.93667e-09 0 1.24279e-06 -3.67467e-09 0 - 1.25212e-06 -3.47238e-09 0 1.25289e-06 -6.80775e-09 0 1.28604e-06 -1.35079e-08 0 1.273e-06 -2.02464e-08 0 - 1.34158e-06 -4.53618e-08 0 1.23319e-06 -4.44216e-08 0 1.33771e-06 4.41894e-09 0 1.1542e-06 -1.15218e-09 0 - 1.22481e-06 1.28193e-08 0 1.03632e-06 9.55813e-09 0 7.68472e-07 3.51882e-08 0 5.36519e-07 1.38865e-08 0 - 1.97109e-07 -1.72238e-09 0 6.46891e-08 -1.44182e-09 0 1.3203e-09 -9.89616e-10 0 5.72193e-10 -1.01194e-09 0 - 1.047e-09 0 0 6.64442e-10 0 0 7.43913e-07 -8.22202e-07 0 8.47309e-07 -4.52167e-07 0 - 1.02654e-06 -1.81359e-07 0 1.1279e-06 -4.61365e-08 0 1.14145e-06 -5.64831e-08 0 1.15513e-06 -7.10826e-08 0 - 1.19596e-06 -3.8793e-08 0 1.2189e-06 -1.8378e-08 0 1.23021e-06 -8.1842e-09 0 1.23528e-06 -3.05805e-09 0 - 1.23903e-06 -4.7429e-09 0 1.244e-06 -6.78136e-09 0 1.25107e-06 -1.23277e-08 0 1.25845e-06 -2.85123e-08 0 - 1.20038e-06 -3.92498e-08 0 1.09648e-06 -8.87079e-09 0 9.18926e-07 -1.8822e-09 0 4.07622e-07 -8.78673e-09 0 - 1.57127e-08 -1.11867e-09 0 4.96947e-10 -1.03734e-09 0 6.48608e-10 0 0 9.80148e-07 -8.45916e-07 0 - 1.03191e-06 -5.3035e-07 0 1.13303e-06 -2.43815e-07 0 1.21141e-06 -7.84316e-08 0 1.21085e-06 -7.76023e-08 0 - 1.19305e-06 -8.97631e-08 0 1.21355e-06 -5.06952e-08 0 1.22745e-06 -2.47871e-08 0 1.23512e-06 -1.11622e-08 0 - 1.2387e-06 -4.30048e-09 0 1.24139e-06 -6.67703e-09 0 1.24464e-06 -8.98672e-09 0 1.24809e-06 -1.54261e-08 0 - 1.24867e-06 -2.94388e-08 0 1.18561e-06 -3.16041e-08 0 1.06853e-06 -1.16059e-08 0 8.14304e-07 -1.32627e-08 0 - 3.12579e-07 -8.25699e-09 0 5.08538e-09 -1.06846e-09 0 4.79556e-10 -1.0399e-09 0 6.44541e-10 0 0 - 1.18416e-06 -8.56551e-07 0 1.20687e-06 -5.67993e-07 0 1.25419e-06 -2.80342e-07 0 1.29809e-06 -1.05965e-07 0 - 1.27061e-06 -9.07442e-08 0 1.22679e-06 -9.709e-08 0 1.23258e-06 -5.64244e-08 0 1.23764e-06 -2.84282e-08 0 - 1.24104e-06 -1.29484e-08 0 1.24278e-06 -5.06856e-09 0 1.24401e-06 -7.82128e-09 0 1.24512e-06 -1.00558e-08 0 - 1.24537e-06 -1.62563e-08 0 1.24254e-06 -2.75266e-08 0 1.17798e-06 -2.60037e-08 0 1.05011e-06 -1.19407e-08 0 - 7.22995e-07 -1.62184e-08 0 2.32878e-07 -5.10205e-09 0 2.11027e-09 -1.06068e-09 0 4.71605e-10 -1.03851e-09 0 - 6.41587e-10 0 0 1.37504e-06 -8.59703e-07 0 1.37627e-06 -5.80298e-07 0 1.3789e-06 -2.92738e-07 0 - 1.38034e-06 -1.17998e-07 0 1.31934e-06 -9.61663e-08 0 1.25592e-06 -9.73363e-08 0 1.25135e-06 -5.66935e-08 0 - 1.24838e-06 -2.90915e-08 0 1.24741e-06 -1.33918e-08 0 1.24718e-06 -5.2693e-09 0 1.24683e-06 -8.01273e-09 0 - 1.2458e-06 -9.93979e-09 0 1.24334e-06 -1.53193e-08 0 1.23838e-06 -2.46075e-08 0 1.17242e-06 -2.25004e-08 0 - 1.03416e-06 -1.15897e-08 0 6.42533e-07 -1.51591e-08 0 1.64135e-07 -3.13638e-09 0 1.05778e-09 -1.06188e-09 0 - 4.66337e-10 -1.03633e-09 0 6.37589e-10 0 0 1.5658e-06 -8.56642e-07 0 1.54539e-06 -5.71014e-07 0 - 1.50458e-06 -2.82581e-07 0 1.46653e-06 -1.10884e-07 0 1.37066e-06 -9.30574e-08 0 1.2843e-06 -9.20509e-08 0 - 1.26917e-06 -5.20285e-08 0 1.25862e-06 -2.688e-08 0 1.25361e-06 -1.25039e-08 0 1.25153e-06 -4.89552e-09 0 - 1.24974e-06 -7.26879e-09 0 1.24685e-06 -8.75399e-09 0 1.24206e-06 -1.29317e-08 0 1.23494e-06 -2.09996e-08 0 - 1.16631e-06 -2.02347e-08 0 1.01599e-06 -1.22871e-08 0 5.70196e-07 -1.45493e-08 0 1.05543e-07 -2.03977e-09 0 - 6.32683e-10 -1.06351e-09 0 4.61931e-10 -1.03252e-09 0 6.31715e-10 0 0 1.76959e-06 -8.46018e-07 0 - 1.71983e-06 -5.36206e-07 0 1.6281e-06 -2.50751e-07 0 1.55736e-06 -8.88248e-08 0 1.43152e-06 -7.91721e-08 0 - 1.31591e-06 -7.86739e-08 0 1.28525e-06 -4.24097e-08 0 1.26739e-06 -2.21742e-08 0 1.25909e-06 -1.04404e-08 0 - 1.25549e-06 -4.01424e-09 0 1.25261e-06 -5.76521e-09 0 1.24844e-06 -6.76205e-09 0 1.2416e-06 -9.15658e-09 0 - 1.23142e-06 -1.61714e-08 0 1.15834e-06 -1.83501e-08 0 9.8975e-07 -1.3874e-08 0 5.0298e-07 -1.52816e-08 0 - 5.90022e-08 -1.46206e-09 0 4.49498e-10 -1.0591e-09 0 4.56906e-10 -1.02375e-09 0 6.22412e-10 0 0 - 2.00516e-06 -8.23184e-07 0 1.90518e-06 -4.61577e-07 0 1.74064e-06 -1.96869e-07 0 1.66011e-06 -6.72028e-08 0 - 1.52007e-06 -5.0488e-08 0 1.35481e-06 -4.87666e-08 0 1.2973e-06 -2.81332e-08 0 1.27385e-06 -1.56744e-08 0 - 1.26342e-06 -7.45696e-09 0 1.25876e-06 -2.75751e-09 0 1.25528e-06 -3.79212e-09 0 1.25076e-06 -4.42937e-09 0 - 1.24258e-06 -4.02838e-09 0 1.2267e-06 -8.31057e-09 0 1.14804e-06 -1.74004e-08 0 9.46845e-07 -1.11934e-08 0 - 4.33907e-07 -1.41933e-08 0 2.70209e-08 -1.17164e-09 0 3.71732e-10 -1.02725e-09 0 4.48042e-10 -9.91759e-10 0 - 6.05369e-10 0 0 2.30462e-06 -7.7948e-07 0 2.10533e-06 -3.12143e-07 0 1.82045e-06 -1.21143e-07 0 - 1.7119e-06 -4.82245e-08 0 1.55123e-06 -7.98578e-09 0 1.36485e-06 -3.80283e-09 0 1.3009e-06 -1.22656e-08 0 - 1.27784e-06 -8.164e-09 0 1.26629e-06 -3.8618e-09 0 1.26114e-06 -1.33259e-09 0 1.25772e-06 -1.72003e-09 0 - 1.25372e-06 -2.27386e-09 0 1.24774e-06 8.42476e-10 0 1.21642e-06 1.03755e-08 0 1.1314e-06 -2.40101e-08 0 - 8.74285e-07 6.75908e-09 0 3.46962e-07 -7.40689e-09 0 9.72215e-09 -8.92021e-10 0 3.34941e-10 -8.4206e-10 0 - 4.20025e-10 -8.16549e-10 0 5.59221e-10 0 0 2.59529e-06 -7.51082e-07 0 2.16988e-06 -2.12588e-07 0 - 1.58798e-06 -7.80021e-08 0 1.3572e-06 -3.69456e-08 0 1.25347e-06 1.56733e-08 0 1.26516e-06 2.05529e-08 0 - 1.29717e-06 -4.59466e-09 0 1.27962e-06 -4.24278e-09 0 1.26735e-06 -1.95197e-09 0 1.26234e-06 -6.09542e-10 0 - 1.25975e-06 -7.10391e-10 0 1.2557e-06 -1.29636e-09 0 1.25871e-06 2.82608e-09 0 1.19794e-06 2.4029e-08 0 - 9.75455e-07 -3.06338e-08 0 5.41278e-07 2.12396e-08 0 1.32654e-07 -2.23733e-09 0 1.18926e-09 -7.09703e-10 0 - 2.32594e-10 -6.8406e-10 0 2.89136e-10 -6.67088e-10 0 3.7787e-10 0 0 + <DataArray type="Float32" Name="velocity_brine (m/s)" NumberOfComponents="3" format="ascii"> + 1.90603e-07 -6.84497e-07 0 5.26899e-07 -1.6874e-07 0 4.81727e-07 -7.16056e-07 0 6.71431e-07 -2.64139e-07 0 + 9.24199e-07 -3.07078e-08 0 9.35692e-07 -6.8215e-08 0 9.95594e-07 -1.03917e-08 0 1.02038e-06 -2.02481e-08 0 + 1.0232e-06 -1.92065e-08 0 1.04303e-06 -3.79628e-08 0 1.09037e-06 -2.49571e-08 0 1.10204e-06 -4.81921e-08 0 + 1.16703e-06 -1.3335e-08 0 1.17286e-06 -2.54693e-08 0 1.20592e-06 -6.06548e-09 0 1.20857e-06 -1.17376e-08 0 + 1.22352e-06 -2.68226e-09 0 1.22511e-06 -5.22846e-09 0 1.23088e-06 -9.49826e-10 0 1.2323e-06 -1.95169e-09 0 + 1.2358e-06 -1.48792e-09 0 1.2375e-06 -3.06651e-09 0 1.24327e-06 -2.26695e-09 0 1.24472e-06 -4.31561e-09 0 + 1.25552e-06 -3.88092e-09 0 1.25622e-06 -7.6082e-09 0 1.29183e-06 -1.42936e-08 0 1.27843e-06 -2.16947e-08 0 + 1.35224e-06 -4.76952e-08 0 1.24046e-06 -4.72596e-08 0 1.35303e-06 5.02357e-09 0 1.16663e-06 -1.29478e-09 0 + 1.24614e-06 1.48114e-08 0 1.06412e-06 1.29919e-08 0 8.52497e-07 4.38917e-08 0 5.90533e-07 2.2106e-08 0 + 2.68846e-07 -2.59621e-09 0 9.95153e-08 -2.00434e-09 0 2.04986e-09 -1.15182e-09 0 6.50617e-10 -1.17612e-09 0 + 1.10724e-09 0 0 6.57081e-10 0 0 7.7259e-07 -7.62004e-07 0 8.64437e-07 -4.05819e-07 0 + 1.02121e-06 -1.38189e-07 0 1.10811e-06 -4.40594e-08 0 1.12216e-06 -7.17307e-08 0 1.14256e-06 -8.55819e-08 0 + 1.18856e-06 -4.64043e-08 0 1.21548e-06 -2.2024e-08 0 1.22908e-06 -9.90677e-09 0 1.23523e-06 -3.8487e-09 0 + 1.23989e-06 -6.06024e-09 0 1.24593e-06 -7.9882e-09 0 1.25413e-06 -1.38361e-08 0 1.26316e-06 -3.11346e-08 0 + 1.20635e-06 -4.29907e-08 0 1.10602e-06 -9.80228e-09 0 9.53332e-07 9.21153e-10 0 4.44099e-07 -6.09577e-09 0 + 2.42282e-08 -1.32302e-09 0 5.10556e-10 -1.20296e-09 0 6.43482e-10 0 0 1.00083e-06 -7.83091e-07 0 + 1.0471e-06 -4.75458e-07 0 1.13717e-06 -1.92372e-07 0 1.20604e-06 -7.2461e-08 0 1.20249e-06 -9.73727e-08 0 + 1.18656e-06 -1.06061e-07 0 1.2093e-06 -6.02035e-08 0 1.22559e-06 -2.97335e-08 0 1.23487e-06 -1.35335e-08 0 + 1.23925e-06 -5.38983e-09 0 1.24259e-06 -8.47775e-09 0 1.24657e-06 -1.06217e-08 0 1.25077e-06 -1.74556e-08 0 + 1.25241e-06 -3.28992e-08 0 1.18975e-06 -3.59237e-08 0 1.07528e-06 -1.25827e-08 0 8.41236e-07 -1.36527e-08 0 + 3.36093e-07 -1.01237e-08 0 6.4669e-09 -1.22028e-09 0 4.82742e-10 -1.20382e-09 0 6.42276e-10 0 0 + 1.20025e-06 -7.92619e-07 0 1.22091e-06 -5.09321e-07 0 1.26345e-06 -2.24746e-07 0 1.30024e-06 -9.56462e-08 0 + 1.26789e-06 -1.14254e-07 0 1.22419e-06 -1.14141e-07 0 1.23127e-06 -6.69422e-08 0 1.23761e-06 -3.42043e-08 0 + 1.2419e-06 -1.57461e-08 0 1.24407e-06 -6.35117e-09 0 1.24562e-06 -9.92089e-09 0 1.24707e-06 -1.19363e-08 0 + 1.2476e-06 -1.85619e-08 0 1.24514e-06 -3.14335e-08 0 1.18033e-06 -3.06066e-08 0 1.05426e-06 -1.31053e-08 0 + 7.36188e-07 -1.75655e-08 0 2.43032e-07 -6.02029e-09 0 2.29456e-09 -1.20703e-09 0 4.7342e-10 -1.20061e-09 0 + 6.4147e-10 0 0 1.38774e-06 -7.95565e-07 0 1.38939e-06 -5.20806e-07 0 1.39164e-06 -2.35379e-07 0 + 1.38682e-06 -1.02612e-07 0 1.31924e-06 -1.232e-07 0 1.25587e-06 -1.15271e-07 0 1.25281e-06 -6.77319e-08 0 + 1.25032e-06 -3.52262e-08 0 1.2495e-06 -1.63576e-08 0 1.24931e-06 -6.62082e-09 0 1.24893e-06 -1.01984e-08 0 + 1.24779e-06 -1.18582e-08 0 1.24511e-06 -1.76201e-08 0 1.23977e-06 -2.85271e-08 0 1.17282e-06 -2.72171e-08 0 + 1.03564e-06 -1.36286e-08 0 6.42161e-07 -1.6578e-08 0 1.62068e-07 -3.42087e-09 0 1.0306e-09 -1.20907e-09 0 + 4.68341e-10 -1.19744e-09 0 6.38735e-10 0 0 1.57476e-06 -7.93038e-07 0 1.55736e-06 -5.13233e-07 0 + 1.52094e-06 -2.25522e-07 0 1.47665e-06 -8.88303e-08 0 1.37197e-06 -1.23808e-07 0 1.28657e-06 -1.11629e-07 0 + 1.27355e-06 -6.32387e-08 0 1.26261e-06 -3.28855e-08 0 1.25696e-06 -1.53594e-08 0 1.2545e-06 -6.18387e-09 0 + 1.25234e-06 -9.32273e-09 0 1.24892e-06 -1.05036e-08 0 1.24341e-06 -1.49343e-08 0 1.23512e-06 -2.4451e-08 0 + 1.16429e-06 -2.47122e-08 0 1.01312e-06 -1.61659e-08 0 5.58779e-07 -1.68956e-08 0 9.52069e-08 -2.11384e-09 0 + 5.86496e-10 -1.21106e-09 0 4.64503e-10 -1.19291e-09 0 6.33589e-10 0 0 1.77293e-06 -7.83811e-07 0 + 1.7297e-06 -4.8319e-07 0 1.64995e-06 -1.97121e-07 0 1.57589e-06 -5.84671e-08 0 1.43822e-06 -1.13327e-07 0 + 1.32203e-06 -1.00564e-07 0 1.29307e-06 -5.32145e-08 0 1.27343e-06 -2.74992e-08 0 1.26361e-06 -1.29041e-08 0 + 1.25923e-06 -5.11164e-09 0 1.25567e-06 -7.4885e-09 0 1.25065e-06 -8.16863e-09 0 1.24268e-06 -1.05838e-08 0 + 1.23051e-06 -1.86266e-08 0 1.15328e-06 -2.17659e-08 0 9.77352e-07 -1.9346e-08 0 4.81716e-07 -1.7867e-08 0 + 4.61374e-08 -1.51273e-09 0 4.16885e-10 -1.20428e-09 0 4.59817e-10 -1.18246e-09 0 6.2462e-10 0 0 + 1.999e-06 -7.63576e-07 0 1.91086e-06 -4.17749e-07 0 1.77083e-06 -1.52308e-07 0 1.69877e-06 -3.02645e-08 0 + 1.54503e-06 -8.53292e-08 0 1.36973e-06 -7.16454e-08 0 1.30924e-06 -3.73067e-08 0 1.28173e-06 -1.97054e-08 0 + 1.26892e-06 -9.27215e-09 0 1.26314e-06 -3.55293e-09 0 1.25873e-06 -5.0226e-09 0 1.25317e-06 -5.38942e-09 0 + 1.24364e-06 -4.66971e-09 0 1.22495e-06 -9.16906e-09 0 1.14e-06 -1.87126e-08 0 9.17051e-07 -1.48532e-08 0 + 4.00959e-07 -1.47163e-08 0 1.76438e-08 -1.25383e-09 0 3.54114e-10 -1.16186e-09 0 4.50333e-10 -1.14104e-09 0 + 6.0693e-10 0 0 2.28225e-06 -7.24018e-07 0 2.10327e-06 -2.84396e-07 0 1.86187e-06 -9.45169e-08 0 + 1.79825e-06 -1.99434e-08 0 1.62816e-06 -3.30455e-08 0 1.39818e-06 -2.02254e-08 0 1.317e-06 -1.77959e-08 0 + 1.28702e-06 -1.03411e-08 0 1.27245e-06 -4.82621e-09 0 1.26594e-06 -1.74617e-09 0 1.26147e-06 -2.34958e-09 0 + 1.25636e-06 -2.76854e-09 0 1.24936e-06 9.13469e-10 0 1.21379e-06 1.23168e-08 0 1.12154e-06 -2.35711e-08 0 + 8.2406e-07 8.86708e-09 0 2.99321e-07 -6.55741e-09 0 5.59107e-09 -9.70486e-10 0 3.24488e-10 -9.3578e-10 0 + 4.18112e-10 -9.21839e-10 0 5.55444e-10 0 0 2.55486e-06 -6.98111e-07 0 2.16466e-06 -1.94997e-07 0 + 1.64799e-06 -6.29693e-08 0 1.48265e-06 -1.947e-08 0 1.36654e-06 -3.65483e-10 0 1.30999e-06 1.03263e-08 0 + 1.31532e-06 -7.71118e-09 0 1.28928e-06 -5.37136e-09 0 1.27376e-06 -2.44867e-09 0 1.26734e-06 -8.17157e-10 0 + 1.2637e-06 -1.02064e-09 0 1.25849e-06 -1.5634e-09 0 1.26165e-06 3.17652e-09 0 1.19383e-06 2.78084e-08 0 + 9.51315e-07 -2.97354e-08 0 4.77317e-07 2.68598e-08 0 8.64097e-08 -1.62526e-09 0 6.8953e-10 -7.67816e-10 0 + 2.2033e-10 -7.45348e-10 0 2.76362e-10 -7.36519e-10 0 3.59817e-10 0 0 </DataArray> - <DataArray type="Float32" Name="velocity_gas (m/s)" NumberOfComponents="3" format="ascii"> - 5.1794e-10 4.69411e-10 0 6.19103e-10 5.72669e-10 0 1.77295e-09 3.27724e-10 0 2.17456e-09 9.52096e-10 0 - 4.89378e-10 3.16889e-10 0 1.94868e-09 8.68767e-10 0 1.29245e-10 0 0 6.60596e-10 0 0 + <DataArray type="Float32" Name="velocity_Air (m/s)" NumberOfComponents="3" format="ascii"> + 7.7276e-10 4.13748e-10 0 7.78447e-10 5.833e-10 0 1.95084e-09 2.8521e-10 0 2.31878e-09 9.4714e-10 0 + 5.09817e-10 3.21633e-10 0 1.98245e-09 8.90533e-10 0 1.1775e-10 0 0 6.39088e-10 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 9.21562e-11 5.94668e-11 0 3.96019e-09 1.26181e-09 0 1.09719e-08 6.10443e-09 0 3.38366e-08 1.11916e-08 0 - 4.12404e-08 1.73465e-08 0 1.23775e-07 3.41922e-08 0 1.27944e-07 1.18352e-07 0 3.9952e-07 2.37133e-07 0 - 3.50869e-07 2.18896e-08 0 7.72787e-07 -2.67155e-08 0 9.09883e-07 -2.00487e-07 0 1.10978e-06 -2.88125e-07 0 - 1.3132e-06 -6.06808e-07 0 1.28524e-06 -6.63646e-07 0 3.012e-09 1.20528e-10 0 3.61764e-09 1.40531e-09 0 - 3.42492e-09 1.84883e-09 0 1.31329e-09 0 0 0 0 0 0 0 0 + 1.86686e-11 1.41766e-11 0 2.92342e-09 1.07469e-09 0 8.93344e-09 5.79293e-09 0 2.8481e-08 1.09742e-08 0 + 3.22775e-08 1.55768e-08 0 1.02104e-07 3.21769e-08 0 9.91589e-08 8.8094e-08 0 3.36301e-07 2.13677e-07 0 + 2.80096e-07 7.14821e-08 0 6.90783e-07 3.5072e-08 0 8.32519e-07 -2.10289e-07 0 1.05726e-06 -3.07766e-07 0 + 1.25644e-06 -6.19954e-07 0 1.25247e-06 -6.75246e-07 0 3.12811e-09 9.82328e-11 0 3.71757e-09 1.3767e-09 0 + 3.46164e-09 1.88267e-09 0 1.30812e-09 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 7.43299e-09 3.54476e-09 0 5.30778e-08 2.02839e-08 0 2.08958e-07 6.71272e-08 0 6.36567e-07 3.90737e-07 0 - 1.05965e-06 -1.23983e-07 0 1.1979e-06 -3.88244e-07 0 1.22301e-06 -7.372e-07 0 3.96839e-09 2.46139e-11 0 - 4.57369e-09 1.41333e-09 0 4.47483e-09 2.46174e-09 0 1.88533e-09 0 0 0 0 0 + 6.00587e-09 3.24479e-09 0 4.62766e-08 2.05463e-08 0 1.80128e-07 6.52622e-08 0 5.68473e-07 3.99361e-07 0 + 1.00948e-06 -6.53505e-08 0 1.18222e-06 -4.15404e-07 0 1.20273e-06 -7.48119e-07 0 4.05212e-09 1.26283e-11 0 + 4.64523e-09 1.37969e-09 0 4.52023e-09 2.48123e-09 0 1.90106e-09 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 9.54101e-09 5.30691e-09 0 6.81525e-08 2.74879e-08 0 2.84585e-07 1.0147e-07 0 - 7.61165e-07 4.20803e-07 0 1.14272e-06 -2.06229e-07 0 1.21054e-06 -3.98407e-07 0 1.20602e-06 -7.54015e-07 0 - 4.79443e-09 -1.84034e-11 0 5.28994e-09 1.28935e-09 0 5.18047e-09 2.6734e-09 0 2.28775e-09 0 0 + 0 0 0 8.12143e-09 5.12936e-09 0 6.14191e-08 2.86955e-08 0 2.55346e-07 1.01808e-07 0 + 7.14858e-07 4.63791e-07 0 1.12709e-06 -1.76833e-07 0 1.21359e-06 -4.18014e-07 0 1.19862e-06 -7.63962e-07 0 + 4.85961e-09 -2.60234e-11 0 5.35079e-09 1.26178e-09 0 5.24004e-09 2.67679e-09 0 2.31905e-09 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 1.08036e-08 6.41045e-09 0 8.05191e-08 3.34623e-08 0 - 3.50824e-07 1.43514e-07 0 8.37887e-07 3.9196e-07 0 1.16113e-06 -2.62532e-07 0 1.20105e-06 -3.92217e-07 0 - 1.1934e-06 -7.5198e-07 0 5.5673e-09 -3.11418e-11 0 5.94801e-09 1.21805e-09 0 5.73681e-09 2.68576e-09 0 - 2.57245e-09 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 9.55533e-09 6.43637e-09 0 7.48421e-08 3.58878e-08 0 + 3.25448e-07 1.50413e-07 0 8.04431e-07 4.44222e-07 0 1.15532e-06 -2.5654e-07 0 1.20875e-06 -4.03737e-07 0 + 1.19541e-06 -7.58304e-07 0 5.61875e-09 -3.7983e-11 0 6.00382e-09 1.19221e-09 0 5.81e-09 2.67721e-09 0 + 2.61555e-09 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 0 0 0 1.17597e-08 7.1543e-09 0 - 9.2454e-08 3.89322e-08 0 4.11032e-07 1.9888e-07 0 8.97849e-07 3.30289e-07 0 1.16659e-06 -3.00521e-07 0 - 1.18714e-06 -3.82798e-07 0 1.17612e-06 -7.46491e-07 0 6.3397e-09 -1.8723e-11 0 6.60574e-09 1.24228e-09 0 - 6.24695e-09 2.6755e-09 0 2.81106e-09 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 1.07394e-08 7.40945e-09 0 + 8.85584e-08 4.27332e-08 0 3.92882e-07 2.18858e-07 0 8.80331e-07 3.75014e-07 0 1.17099e-06 -3.08505e-07 0 + 1.19754e-06 -3.90013e-07 0 1.18362e-06 -7.50088e-07 0 6.37601e-09 -2.77569e-11 0 6.65655e-09 1.20832e-09 0 + 6.33669e-09 2.65445e-09 0 2.86814e-09 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 1.27428e-08 7.80679e-09 0 1.05943e-07 4.45185e-08 0 4.68334e-07 2.69039e-07 0 9.59554e-07 2.40467e-07 0 - 1.18073e-06 -3.21452e-07 0 1.17166e-06 -3.66735e-07 0 1.15069e-06 -7.37222e-07 0 7.16485e-09 2.4319e-11 0 - 7.28553e-09 1.38194e-09 0 6.73432e-09 2.72579e-09 0 3.03121e-09 0 0 0 0 0 + 1.1971e-08 8.31863e-09 0 1.04486e-07 4.98598e-08 0 4.58901e-07 3.06733e-07 0 9.59646e-07 2.63473e-07 0 + 1.19726e-06 -3.3334e-07 0 1.18468e-06 -3.71319e-07 0 1.16137e-06 -7.3931e-07 0 7.17841e-09 9.61223e-12 0 + 7.32799e-09 1.32683e-09 0 6.84971e-09 2.68339e-09 0 3.11092e-09 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 1.39598e-08 8.54666e-09 0 1.22245e-07 5.1076e-08 0 5.28288e-07 3.44634e-07 0 - 1.03766e-06 1.18815e-07 0 1.21401e-06 -3.16283e-07 0 1.15181e-06 -3.35742e-07 0 1.11091e-06 -7.20434e-07 0 - 8.11868e-09 1.16804e-10 0 8.00771e-09 1.69337e-09 0 7.16235e-09 2.86852e-09 0 3.21397e-09 0 0 + 0 0 0 1.35152e-08 9.39234e-09 0 1.23948e-07 5.86346e-08 0 5.32035e-07 3.93878e-07 0 + 1.05768e-06 1.12968e-07 0 1.24084e-06 -3.22621e-07 0 1.16647e-06 -3.38065e-07 0 1.12341e-06 -7.21568e-07 0 + 8.09374e-09 9.1562e-11 0 8.03336e-09 1.59863e-09 0 7.31864e-09 2.78294e-09 0 3.33215e-09 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 0 0 0 0 0 0 1.58241e-08 9.51716e-09 0 1.42736e-07 6.14255e-08 0 - 6.10415e-07 3.9171e-07 0 1.15364e-06 -3.04412e-08 0 1.26782e-06 -2.69093e-07 0 1.1203e-06 -2.77734e-07 0 - 1.04525e-06 -6.89851e-07 0 9.33098e-09 2.93469e-10 0 8.84514e-09 2.2896e-09 0 7.43766e-09 3.11944e-09 0 - 3.25801e-09 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 1.59428e-08 1.08829e-08 0 1.48576e-07 7.40087e-08 0 + 6.34235e-07 4.28343e-07 0 1.18963e-06 -5.57425e-08 0 1.29367e-06 -2.65486e-07 0 1.13508e-06 -2.78398e-07 0 + 1.05887e-06 -6.90342e-07 0 9.24047e-09 2.51456e-10 0 8.83208e-09 2.13035e-09 0 7.63434e-09 2.9517e-09 0 + 3.42249e-09 0 0 0 0 0 0 0 0 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.04734e-08 1.07381e-08 0 - 1.74413e-07 8.58886e-08 0 7.79216e-07 3.24889e-07 0 1.36401e-06 -1.62277e-07 0 1.34031e-06 -1.64139e-07 0 - 1.06959e-06 -1.73539e-07 0 9.36045e-07 -6.33724e-07 0 1.05071e-08 4.08148e-10 0 1.62449e-08 2.67673e-09 0 - 2.9127e-08 3.27361e-09 0 1.81356e-08 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 2.17953e-08 1.29353e-08 0 + 1.86154e-07 1.12428e-07 0 8.29315e-07 3.12734e-07 0 1.4101e-06 -1.77646e-07 0 1.35424e-06 -1.5617e-07 0 + 1.08476e-06 -1.73717e-07 0 9.51334e-07 -6.33731e-07 0 1.03435e-08 3.5607e-10 0 1.56584e-08 2.47826e-09 0 + 2.77026e-08 3.05277e-09 0 1.72159e-08 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 1.04828e-07 1.13978e-08 0 7.35778e-07 1.03668e-07 0 1.88581e-06 2.48003e-07 0 2.08185e-06 -2.14275e-07 0 - 1.46192e-06 -9.5544e-08 0 1.05493e-06 -1.06875e-07 0 8.40003e-07 -5.97307e-07 0 + 1.26708e-07 1.41028e-08 0 8.9241e-07 1.40533e-07 0 2.01912e-06 2.01832e-07 0 2.07659e-06 -2.15112e-07 0 + 1.46892e-06 -8.8162e-08 0 1.0759e-06 -1.07146e-07 0 8.6031e-07 -5.97082e-07 0 </DataArray> <DataArray type="Float32" Name="Permeability" NumberOfComponents="1" format="ascii"> - 2.23e-14 2.23e-14 2.23e-14 2.23e-14 2.2273e-14 2.22748e-14 1.53529e-14 1.54488e-14 3.46096e-15 3.55815e-15 2.84266e-15 2.84285e-15 - 2.84107e-15 2.84142e-15 2.83971e-15 2.84014e-15 2.83852e-15 2.83891e-15 5.13611e-15 5.13758e-15 1.94074e-14 1.94163e-14 1.93995e-14 1.94084e-14 - 1.93943e-14 1.94025e-14 1.93877e-14 1.9391e-14 1.93706e-14 1.93645e-14 1.93536e-14 1.93536e-14 1.93529e-14 1.93529e-14 1.93519e-14 1.93519e-14 - 1.93502e-14 1.93502e-14 2.00582e-14 2.00582e-14 2.15338e-14 2.15337e-14 2.23e-14 2.23e-14 2.2286e-14 1.58539e-14 3.97558e-15 2.84322e-15 - 2.84173e-15 2.8404e-15 2.83922e-15 5.13824e-15 1.94206e-14 1.9413e-14 1.9407e-14 1.9394e-14 1.93638e-14 1.93536e-14 1.93529e-14 1.93519e-14 - 1.93502e-14 2.00582e-14 2.15338e-14 2.23e-14 2.23e-14 2.22917e-14 1.6295e-14 4.47608e-15 2.84351e-15 2.84197e-15 2.8406e-15 2.83943e-15 - 5.13861e-15 1.94227e-14 1.94155e-14 1.94097e-14 1.9396e-14 1.9364e-14 1.93536e-14 1.93529e-14 1.93519e-14 1.93502e-14 2.00582e-14 2.15338e-14 - 2.23e-14 2.23e-14 2.22945e-14 1.67211e-14 4.99728e-15 2.84374e-15 2.84215e-15 2.84078e-15 2.8396e-15 5.13889e-15 1.94242e-14 1.94172e-14 - 1.94116e-14 1.93976e-14 1.93644e-14 1.93536e-14 1.93529e-14 1.93519e-14 1.93502e-14 2.00582e-14 2.15338e-14 2.23e-14 2.23e-14 2.22959e-14 - 1.71397e-14 5.54368e-15 2.84395e-15 2.84232e-15 2.84095e-15 2.83975e-15 5.13916e-15 1.94255e-14 1.94189e-14 1.94132e-14 1.93989e-14 1.93648e-14 - 1.93536e-14 1.93529e-14 1.93519e-14 1.93503e-14 2.00582e-14 2.15338e-14 2.23e-14 2.23e-14 2.2297e-14 1.75901e-14 6.16595e-15 2.84416e-15 - 2.84247e-15 2.84111e-15 2.83988e-15 5.13941e-15 1.94269e-14 1.94206e-14 1.94149e-14 1.94003e-14 1.93652e-14 1.93536e-14 1.93529e-14 1.93519e-14 - 1.93503e-14 2.00582e-14 2.15338e-14 2.23e-14 2.23e-14 2.22977e-14 1.81097e-14 6.92961e-15 2.84439e-15 2.84262e-15 2.84128e-15 2.84002e-15 - 5.13968e-15 1.94284e-14 1.94224e-14 1.94168e-14 1.94017e-14 1.93655e-14 1.93536e-14 1.93529e-14 1.93519e-14 1.93503e-14 2.00582e-14 2.15338e-14 - 2.23e-14 2.23e-14 2.22984e-14 1.86874e-14 7.8337e-15 2.84466e-15 2.84277e-15 2.84144e-15 2.84017e-15 5.14007e-15 1.94303e-14 1.94247e-14 - 1.9419e-14 1.94032e-14 1.93654e-14 1.93535e-14 1.93529e-14 1.93519e-14 1.93503e-14 2.00582e-14 2.15338e-14 2.23e-14 2.23e-14 2.22982e-14 - 1.85623e-14 7.6333e-15 2.8449e-15 2.84301e-15 2.84167e-15 2.84043e-15 5.14098e-15 1.94362e-14 1.94312e-14 1.94246e-14 1.94061e-14 1.93625e-14 - 1.93535e-14 1.93529e-14 1.93519e-14 1.93503e-14 2.00582e-14 2.15338e-14 2.23e-14 2.23e-14 2.22974e-14 1.76183e-14 6.20529e-15 2.84494e-15 - 2.84327e-15 2.84195e-15 2.84069e-15 5.14205e-15 1.94441e-14 1.94396e-14 1.94318e-14 1.94098e-14 1.93582e-14 1.93535e-14 1.93529e-14 1.93519e-14 - 1.93503e-14 2.00582e-14 2.15338e-14 + 2.23e-14 2.23e-14 2.23e-14 2.23e-14 2.22586e-14 2.22684e-14 1.50965e-14 1.52951e-14 3.22972e-15 3.41131e-15 2.84259e-15 2.84283e-15 + 2.841e-15 2.84141e-15 2.83964e-15 2.84014e-15 2.83845e-15 2.8389e-15 5.13593e-15 5.13753e-15 1.94062e-14 1.94157e-14 1.93983e-14 1.94076e-14 + 1.93932e-14 1.94017e-14 1.93875e-14 1.93909e-14 1.93722e-14 1.93658e-14 1.9354e-14 1.9354e-14 1.93534e-14 1.93533e-14 1.93524e-14 1.93523e-14 + 1.93507e-14 1.93507e-14 2.00585e-14 2.00585e-14 2.15339e-14 2.15339e-14 2.23e-14 2.23e-14 2.22846e-14 1.57806e-14 3.89672e-15 2.84324e-15 + 2.84176e-15 2.84044e-15 2.83925e-15 5.13829e-15 1.94205e-14 1.94127e-14 1.94066e-14 1.9394e-14 1.9365e-14 1.9354e-14 1.93533e-14 1.93523e-14 + 1.93507e-14 2.00585e-14 2.15339e-14 2.23e-14 2.23e-14 2.22914e-14 1.6274e-14 4.45143e-15 2.84356e-15 2.84202e-15 2.84066e-15 2.83949e-15 + 5.13871e-15 1.9423e-14 1.94156e-14 1.94097e-14 1.93963e-14 1.93651e-14 1.9354e-14 1.93533e-14 1.93523e-14 1.93507e-14 2.00585e-14 2.15339e-14 + 2.23e-14 2.23e-14 2.22945e-14 1.67372e-14 5.0179e-15 2.84381e-15 2.84222e-15 2.84085e-15 2.83967e-15 5.13902e-15 1.94246e-14 1.94175e-14 + 1.94119e-14 1.9398e-14 1.93655e-14 1.9354e-14 1.93533e-14 1.93523e-14 1.93507e-14 2.00586e-14 2.15339e-14 2.23e-14 2.23e-14 2.2296e-14 + 1.71873e-14 5.60785e-15 2.84403e-15 2.8424e-15 2.84103e-15 2.83983e-15 5.13931e-15 1.94262e-14 1.94195e-14 1.94137e-14 1.93996e-14 1.93659e-14 + 1.9354e-14 1.93533e-14 1.93523e-14 1.93507e-14 2.00586e-14 2.15339e-14 2.23e-14 2.23e-14 2.22972e-14 1.76769e-14 6.29031e-15 2.84426e-15 + 2.84257e-15 2.84122e-15 2.83998e-15 5.13959e-15 1.94277e-14 1.94214e-14 1.94157e-14 1.94011e-14 1.93662e-14 1.9354e-14 1.93533e-14 1.93523e-14 + 1.93507e-14 2.00586e-14 2.15339e-14 2.23e-14 2.23e-14 2.22979e-14 1.82703e-14 7.17534e-15 2.84451e-15 2.84273e-15 2.8414e-15 2.84013e-15 + 5.1399e-15 1.94294e-14 1.94235e-14 1.94178e-14 1.94028e-14 1.93664e-14 1.9354e-14 1.93533e-14 1.93524e-14 1.93507e-14 2.00586e-14 2.15339e-14 + 2.23e-14 2.23e-14 2.22985e-14 1.90103e-14 8.36522e-15 2.84481e-15 2.8429e-15 2.84159e-15 2.84032e-15 5.14039e-15 1.94316e-14 1.94262e-14 + 1.94204e-14 1.94045e-14 1.93661e-14 1.9354e-14 1.93533e-14 1.93524e-14 1.93507e-14 2.00586e-14 2.15339e-14 2.23e-14 2.23e-14 2.22986e-14 + 1.91284e-14 8.56413e-15 2.84509e-15 2.84318e-15 2.84189e-15 2.84061e-15 5.14143e-15 1.94385e-14 1.94337e-14 1.9427e-14 1.94078e-14 1.93629e-14 + 1.9354e-14 1.93533e-14 1.93524e-14 1.93507e-14 2.00586e-14 2.15339e-14 2.23e-14 2.23e-14 2.22981e-14 1.82406e-14 7.12905e-15 2.84517e-15 + 2.84348e-15 2.84219e-15 2.84091e-15 5.14263e-15 1.94476e-14 1.94434e-14 1.94353e-14 1.9412e-14 1.93583e-14 1.93539e-14 1.93533e-14 1.93523e-14 + 1.93507e-14 2.00586e-14 2.15339e-14 </DataArray> </PointData> <CellData Scalars="process rank"> diff --git a/test/references/saltflushtpfa2pncmin-reference.vtu b/test/references/saltflushtpfa2pncmin-reference.vtu index 8e947f34a0b31a380772f3deeae6f8ca9c3bc524..154b85435457a0bd3795f7cac8712255333f01ac 100644 --- a/test/references/saltflushtpfa2pncmin-reference.vtu +++ b/test/references/saltflushtpfa2pncmin-reference.vtu @@ -2,367 +2,367 @@ <VTKFile type="UnstructuredGrid" version="0.1" byte_order="LittleEndian"> <UnstructuredGrid> <Piece NumberOfCells="200" NumberOfPoints="231"> - <CellData Scalars="S_w" Vectors="velocity_liquid (m/s)"> - <DataArray type="Float32" Name="S_w" NumberOfComponents="1" format="ascii"> - 0.965011 0.971902 1 1 1 1 1 1 1 1 1 1 - 0.987701 0.927475 0.898434 0.812309 0.459262 0.37794 0.37739 0.372943 0.953387 0.962149 1 1 - 1 1 1 1 1 1 1 1 0.978569 0.911874 0.871158 0.722084 - 0.395077 0.368387 0.368128 0.364517 0.949783 0.957716 1 1 1 1 1 1 - 1 1 1 1 0.978346 0.903325 0.850654 0.630858 0.376786 0.368335 0.368114 0.364501 - 0.949496 0.9563 1 1 1 1 1 1 1 1 1 1 - 0.980676 0.898016 0.833545 0.565929 0.371639 0.368326 0.368114 0.364498 0.94963 0.955754 1 1 - 1 1 1 1 1 1 1 1 0.983635 0.894094 0.817618 0.517018 - 0.369819 0.368323 0.368115 0.364496 0.949726 0.955331 1 1 1 1 1 1 - 1 1 1 1 0.986463 0.89048 0.800132 0.47596 0.369054 0.368322 0.368115 0.364493 - 0.949791 0.954921 1 1 1 1 1 1 1 1 1 1 - 0.989094 0.886577 0.778011 0.440536 0.368708 0.368317 0.368111 0.364486 0.949834 0.95453 1 1 - 1 1 1 1 1 1 1 1 0.991168 0.881861 0.746441 0.410835 - 0.368483 0.368248 0.368041 0.364421 0.949618 0.953915 1 1 1 1 1 1 - 1 1 1 1 0.98978 0.874746 0.689581 0.386567 0.367579 0.36742 0.367214 0.363672 - 0.939155 0.934241 1 1 1 1 1 1 1 1 1 1 - 0.943361 0.813077 0.525056 0.362679 0.360032 0.359928 0.35976 0.3568 + <CellData Scalars="porosity" Vectors="velocity_brine (m/s)"> + <DataArray type="Float32" Name="porosity" NumberOfComponents="1" format="ascii"> + 0.11 0.11 0.100091 0.0575376 0.0575154 0.0575048 0.0574949 0.057487 0.0574812 0.0574761 0.105372 0.105365 + 0.10535 0.105296 0.105296 0.105295 0.105294 0.105292 0.105289 0.105283 0.11 0.11 0.108447 0.0577398 + 0.0575191 0.0575086 0.0574995 0.0574911 0.0574847 0.0574791 0.105388 0.105378 0.105353 0.105296 0.105296 0.105295 + 0.105294 0.105292 0.105289 0.105283 0.11 0.11 0.109588 0.0596167 0.0575205 0.0575102 0.0575025 0.057493 + 0.0574859 0.0574801 0.105396 0.105386 0.105361 0.105296 0.105296 0.105295 0.105294 0.105292 0.105289 0.105283 + 0.11 0.11 0.109809 0.0620427 0.0575217 0.0575131 0.0575041 0.057494 0.0574866 0.0574819 0.1054 0.105391 + 0.105367 0.105296 0.105296 0.105295 0.105294 0.105292 0.105289 0.105283 0.11 0.11 0.109892 0.0645101 + 0.0575227 0.0575153 0.0575053 0.0574949 0.0574875 0.0574832 0.105402 0.105394 0.105373 0.105296 0.105296 0.105295 + 0.105294 0.105292 0.105289 0.105283 0.11 0.11 0.109935 0.0671705 0.057524 0.0575173 0.0575064 0.0574958 + 0.0574892 0.0574842 0.105404 0.105396 0.105378 0.105296 0.105296 0.105295 0.105294 0.105292 0.105289 0.105283 + 0.11 0.11 0.109956 0.0703222 0.0575261 0.0575193 0.0575076 0.0574966 0.0574907 0.0574851 0.105406 0.105399 + 0.105384 0.105296 0.105296 0.105295 0.105294 0.105292 0.105289 0.105283 0.11 0.11 0.109973 0.0745795 + 0.0575286 0.0575214 0.0575089 0.057499 0.0574922 0.0574859 0.105409 0.105402 0.105388 0.105296 0.105296 0.105295 + 0.105294 0.105292 0.105289 0.105283 0.11 0.11 0.109985 0.0811171 0.0575319 0.0575235 0.0575103 0.0575015 + 0.0574936 0.0574867 0.105413 0.105408 0.105391 0.105296 0.105296 0.105295 0.105294 0.105292 0.105289 0.105283 + 0.11 0.11 0.109986 0.0806637 0.0575346 0.0575268 0.0575136 0.0575043 0.0574965 0.0574899 0.105436 0.105435 + 0.10537 0.105296 0.105296 0.105295 0.105294 0.105292 0.105289 0.105283 </DataArray> - <DataArray type="Float32" Name="S_n" NumberOfComponents="1" format="ascii"> - 0.0349889 0.0280977 0 0 0 0 0 0 0 0 0 0 - 0.012299 0.0725254 0.101567 0.187691 0.540738 0.62206 0.62261 0.627057 0.0466127 0.037851 0 0 - 0 0 0 0 0 0 0 0 0.0214312 0.0881262 0.128842 0.277916 - 0.604923 0.631613 0.631872 0.635483 0.0502168 0.0422835 0 0 0 0 0 0 - 0 0 0 0 0.0216543 0.0966754 0.149346 0.369142 0.623214 0.631665 0.631886 0.635499 - 0.0505043 0.0437001 0 0 0 0 0 0 0 0 0 0 - 0.0193238 0.101984 0.166455 0.434071 0.628361 0.631674 0.631886 0.635502 0.05037 0.0442455 0 0 - 0 0 0 0 0 0 0 0 0.0163648 0.105906 0.182382 0.482982 - 0.630181 0.631677 0.631885 0.635504 0.050274 0.0446689 0 0 0 0 0 0 - 0 0 0 0 0.013537 0.10952 0.199868 0.52404 0.630946 0.631678 0.631885 0.635507 - 0.0502088 0.0450793 0 0 0 0 0 0 0 0 0 0 - 0.0109063 0.113423 0.221989 0.559464 0.631292 0.631683 0.631889 0.635514 0.0501665 0.0454699 0 0 - 0 0 0 0 0 0 0 0 0.00883172 0.118139 0.253559 0.589165 - 0.631517 0.631752 0.631958 0.635579 0.050382 0.0460853 0 0 0 0 0 0 - 0 0 0 0 0.0102202 0.125254 0.31042 0.613433 0.632421 0.63258 0.632787 0.636328 - 0.0608445 0.0657593 0 0 0 0 0 0 0 0 0 0 - 0.0566393 0.186923 0.474944 0.637321 0.639968 0.640072 0.64024 0.6432 + <DataArray type="Float32" Name="pc" NumberOfComponents="1" format="ascii"> + 511.17 508.684 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 + 502.537 522.785 532.308 561.245 822.879 1054.7 1057.19 1070.98 515.063 511.996 499.687 499.687 + 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 505.392 528.486 542.699 601.323 + 980.181 1089.15 1090.11 1102 516.193 513.491 499.687 499.687 499.687 499.687 499.687 499.687 + 499.687 499.687 499.687 499.687 505.514 531.882 551.197 661.891 1053.52 1089.43 1090.16 1102.06 + 516.258 513.964 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 + 504.835 534.159 559.111 727.27 1077 1089.47 1090.16 1102.07 516.206 514.144 499.687 499.687 + 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 503.932 535.926 567.193 791.018 + 1084.49 1089.48 1090.16 1102.08 516.171 514.285 499.687 499.687 499.687 499.687 499.687 499.687 + 499.687 499.687 499.687 499.687 503.068 537.591 576.851 857.838 1087.29 1089.49 1090.16 1102.09 + 516.148 514.423 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 + 502.299 539.434 590.487 928.247 1088.42 1089.51 1090.18 1102.12 516.133 514.555 499.687 499.687 + 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 501.861 541.766 613.235 997.09 + 1089.18 1089.83 1090.5 1102.42 516.195 514.748 499.687 499.687 499.687 499.687 499.687 499.687 + 499.687 499.687 499.687 499.687 502.771 545.469 661.625 1056.14 1092.77 1093.23 1093.9 1105.59 + 519.576 521.071 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 + 520.549 579.313 839.476 1116.79 1121.23 1121.58 1122.16 1132.47 + </DataArray> + <DataArray type="Float32" Name="S_w" NumberOfComponents="1" format="ascii"> + 0.964462 0.971953 1 1 1 1 1 1 1 1 1 1 + 0.990954 0.930871 0.904953 0.834134 0.494995 0.379569 0.378722 0.37415 0.952949 0.961997 1 1 + 1 1 1 1 1 1 1 1 0.982042 0.915187 0.878217 0.752422 + 0.407909 0.368387 0.368093 0.364484 0.949657 0.957566 1 1 1 1 1 1 + 1 1 1 1 0.981664 0.906084 0.857467 0.655947 0.379969 0.368303 0.368076 0.364466 + 0.949468 0.956174 1 1 1 1 1 1 1 1 1 1 + 0.983768 0.900078 0.838986 0.577655 0.37221 0.368289 0.368077 0.364464 0.949619 0.955645 1 1 + 1 1 1 1 1 1 1 1 0.986581 0.895467 0.820905 0.519238 + 0.369837 0.368286 0.368077 0.364461 0.94972 0.95523 1 1 1 1 1 1 + 1 1 1 1 0.989285 0.891167 0.800287 0.471441 0.368964 0.368284 0.368077 0.364458 + 0.949787 0.954824 1 1 1 1 1 1 1 1 1 1 + 0.991703 0.886452 0.772884 0.431825 0.368614 0.368276 0.36807 0.364448 0.949832 0.954438 1 1 + 1 1 1 1 1 1 1 1 0.993085 0.880556 0.731169 0.400918 + 0.368377 0.368177 0.367971 0.364357 0.949652 0.95387 1 1 1 1 1 1 + 1 1 1 1 0.990218 0.871346 0.656312 0.379077 0.367275 0.367134 0.366929 0.363417 + 0.939925 0.935686 1 1 1 1 1 1 1 1 1 1 + 0.937164 0.795196 0.483446 0.360157 0.35889 0.358791 0.358628 0.355752 </DataArray> <DataArray type="Float32" Name="p_w" NumberOfComponents="1" format="ascii"> - 1.30029e+07 1.29931e+07 1.29738e+07 1.28564e+07 1.26384e+07 1.24035e+07 1.21597e+07 1.1911e+07 1.16596e+07 1.14069e+07 1.12617e+07 1.12244e+07 - 1.11865e+07 1.115e+07 1.11001e+07 1.10466e+07 1.10155e+07 1.10111e+07 1.1007e+07 1.10021e+07 1.29973e+07 1.29848e+07 1.2966e+07 1.28508e+07 - 1.26333e+07 1.23964e+07 1.21515e+07 1.19022e+07 1.16505e+07 1.13975e+07 1.12522e+07 1.12149e+07 1.11772e+07 1.11409e+07 1.10907e+07 1.10357e+07 - 1.10146e+07 1.10104e+07 1.10063e+07 1.10016e+07 1.29936e+07 1.2978e+07 1.29584e+07 1.28484e+07 1.26321e+07 1.23914e+07 1.21444e+07 1.1894e+07 - 1.16417e+07 1.13883e+07 1.12428e+07 1.12055e+07 1.11679e+07 1.11323e+07 1.10819e+07 1.10282e+07 1.1014e+07 1.10099e+07 1.10058e+07 1.10013e+07 - 1.29909e+07 1.29719e+07 1.2951e+07 1.2848e+07 1.26336e+07 1.23878e+07 1.21381e+07 1.18863e+07 1.16331e+07 1.13792e+07 1.12335e+07 1.11961e+07 - 1.11586e+07 1.11238e+07 1.10739e+07 1.1024e+07 1.10134e+07 1.10094e+07 1.10053e+07 1.10011e+07 1.29886e+07 1.29663e+07 1.29436e+07 1.28485e+07 - 1.26364e+07 1.23851e+07 1.21324e+07 1.18788e+07 1.16247e+07 1.13701e+07 1.12242e+07 1.11868e+07 1.11494e+07 1.11155e+07 1.10661e+07 1.10211e+07 - 1.10129e+07 1.10089e+07 1.10049e+07 1.10009e+07 1.29864e+07 1.29607e+07 1.2936e+07 1.28491e+07 1.26397e+07 1.23827e+07 1.21269e+07 1.18715e+07 - 1.16163e+07 1.13611e+07 1.12149e+07 1.11776e+07 1.11401e+07 1.11072e+07 1.10583e+07 1.10189e+07 1.10123e+07 1.10084e+07 1.10045e+07 1.10007e+07 - 1.29841e+07 1.29549e+07 1.2928e+07 1.28493e+07 1.26426e+07 1.23801e+07 1.21211e+07 1.1864e+07 1.16079e+07 1.13521e+07 1.12056e+07 1.11683e+07 - 1.11309e+07 1.10987e+07 1.10501e+07 1.10173e+07 1.10118e+07 1.10078e+07 1.10041e+07 1.10005e+07 1.29814e+07 1.29486e+07 1.29193e+07 1.28481e+07 - 1.26442e+07 1.23765e+07 1.21149e+07 1.18563e+07 1.15993e+07 1.1343e+07 1.11963e+07 1.11591e+07 1.11218e+07 1.109e+07 1.10416e+07 1.10161e+07 - 1.10112e+07 1.10072e+07 1.10036e+07 1.10003e+07 1.29777e+07 1.29415e+07 1.29101e+07 1.28443e+07 1.26431e+07 1.23714e+07 1.21078e+07 1.18482e+07 - 1.15906e+07 1.13339e+07 1.1187e+07 1.11498e+07 1.11129e+07 1.1081e+07 1.10335e+07 1.10152e+07 1.10106e+07 1.10066e+07 1.1003e+07 1.1e+07 - 1.29725e+07 1.29336e+07 1.29008e+07 1.28363e+07 1.26364e+07 1.23642e+07 1.20997e+07 1.18395e+07 1.15815e+07 1.13246e+07 1.11776e+07 1.11405e+07 - 1.11046e+07 1.10715e+07 1.10278e+07 1.10146e+07 1.10098e+07 1.10058e+07 1.10023e+07 1.09995e+07 + 1.30022e+07 1.29924e+07 1.29741e+07 1.28582e+07 1.26424e+07 1.2409e+07 1.21657e+07 1.1917e+07 1.16653e+07 1.14121e+07 1.12666e+07 1.12291e+07 + 1.11911e+07 1.11549e+07 1.11051e+07 1.10521e+07 1.10158e+07 1.1011e+07 1.1007e+07 1.10021e+07 1.29969e+07 1.29843e+07 1.29657e+07 1.28521e+07 + 1.26362e+07 1.24008e+07 1.21564e+07 1.1907e+07 1.16549e+07 1.14015e+07 1.12558e+07 1.12183e+07 1.11804e+07 1.11445e+07 1.10944e+07 1.10396e+07 + 1.10147e+07 1.10103e+07 1.10063e+07 1.10016e+07 1.29934e+07 1.29775e+07 1.29578e+07 1.28495e+07 1.26344e+07 1.23949e+07 1.21483e+07 1.18977e+07 + 1.16449e+07 1.1391e+07 1.12451e+07 1.12077e+07 1.11699e+07 1.11345e+07 1.10842e+07 1.10298e+07 1.1014e+07 1.10098e+07 1.10057e+07 1.10013e+07 + 1.29907e+07 1.29714e+07 1.29503e+07 1.28492e+07 1.26358e+07 1.23907e+07 1.21411e+07 1.18889e+07 1.16352e+07 1.13806e+07 1.12345e+07 1.11971e+07 + 1.11593e+07 1.11249e+07 1.10749e+07 1.10245e+07 1.10135e+07 1.10093e+07 1.10053e+07 1.10011e+07 1.29885e+07 1.29658e+07 1.29428e+07 1.285e+07 + 1.26389e+07 1.23877e+07 1.21346e+07 1.18804e+07 1.16256e+07 1.13704e+07 1.1224e+07 1.11865e+07 1.11489e+07 1.11154e+07 1.1066e+07 1.10212e+07 + 1.10129e+07 1.10089e+07 1.10049e+07 1.10009e+07 1.29863e+07 1.29603e+07 1.29352e+07 1.2851e+07 1.26425e+07 1.2385e+07 1.21283e+07 1.18721e+07 + 1.16161e+07 1.13601e+07 1.12135e+07 1.1176e+07 1.11385e+07 1.11059e+07 1.1057e+07 1.10189e+07 1.10124e+07 1.10084e+07 1.10045e+07 1.10007e+07 + 1.2984e+07 1.29545e+07 1.29271e+07 1.28516e+07 1.2646e+07 1.23821e+07 1.21218e+07 1.18637e+07 1.16065e+07 1.13499e+07 1.1203e+07 1.11656e+07 + 1.11281e+07 1.10963e+07 1.10477e+07 1.10172e+07 1.10118e+07 1.10079e+07 1.10041e+07 1.10006e+07 1.29814e+07 1.29483e+07 1.29184e+07 1.2851e+07 + 1.26484e+07 1.23783e+07 1.21148e+07 1.18549e+07 1.15968e+07 1.13396e+07 1.11924e+07 1.11551e+07 1.11179e+07 1.10865e+07 1.10383e+07 1.1016e+07 + 1.10112e+07 1.10073e+07 1.10036e+07 1.10003e+07 1.29779e+07 1.29415e+07 1.2909e+07 1.28476e+07 1.2648e+07 1.23727e+07 1.21069e+07 1.18457e+07 + 1.15869e+07 1.13292e+07 1.11819e+07 1.11447e+07 1.11079e+07 1.10764e+07 1.10303e+07 1.10152e+07 1.10106e+07 1.10066e+07 1.1003e+07 1.1e+07 + 1.2973e+07 1.29339e+07 1.28997e+07 1.28398e+07 1.26418e+07 1.23648e+07 1.20977e+07 1.18358e+07 1.15766e+07 1.13187e+07 1.11712e+07 1.11341e+07 + 1.10985e+07 1.10656e+07 1.10255e+07 1.10146e+07 1.10099e+07 1.10058e+07 1.10023e+07 1.09995e+07 </DataArray> - <DataArray type="Float32" Name="p_n" NumberOfComponents="1" format="ascii"> - 1.30034e+07 1.29936e+07 1.29743e+07 1.28569e+07 1.26389e+07 1.2404e+07 1.21602e+07 1.19114e+07 1.16601e+07 1.14074e+07 1.12622e+07 1.12249e+07 - 1.1187e+07 1.11506e+07 1.11006e+07 1.10472e+07 1.10164e+07 1.10121e+07 1.10081e+07 1.10032e+07 1.29978e+07 1.29853e+07 1.29665e+07 1.28513e+07 - 1.26338e+07 1.23969e+07 1.2152e+07 1.19027e+07 1.1651e+07 1.1398e+07 1.12527e+07 1.12154e+07 1.11777e+07 1.11415e+07 1.10912e+07 1.10363e+07 - 1.10156e+07 1.10115e+07 1.10074e+07 1.10027e+07 1.29941e+07 1.29785e+07 1.29589e+07 1.28489e+07 1.26326e+07 1.23919e+07 1.21449e+07 1.18945e+07 - 1.16422e+07 1.13888e+07 1.12433e+07 1.1206e+07 1.11684e+07 1.11328e+07 1.10825e+07 1.10289e+07 1.1015e+07 1.10109e+07 1.10068e+07 1.10024e+07 - 1.29914e+07 1.29724e+07 1.29515e+07 1.28485e+07 1.26341e+07 1.23883e+07 1.21386e+07 1.18868e+07 1.16336e+07 1.13797e+07 1.1234e+07 1.11966e+07 - 1.11591e+07 1.11244e+07 1.10744e+07 1.10247e+07 1.10145e+07 1.10104e+07 1.10064e+07 1.10022e+07 1.29891e+07 1.29668e+07 1.29441e+07 1.2849e+07 - 1.26369e+07 1.23856e+07 1.21329e+07 1.18793e+07 1.16252e+07 1.13706e+07 1.12247e+07 1.11873e+07 1.11499e+07 1.11161e+07 1.10667e+07 1.10219e+07 - 1.1014e+07 1.101e+07 1.1006e+07 1.1002e+07 1.29869e+07 1.29612e+07 1.29365e+07 1.28496e+07 1.26402e+07 1.23832e+07 1.21274e+07 1.1872e+07 - 1.16168e+07 1.13616e+07 1.12154e+07 1.11781e+07 1.11406e+07 1.11077e+07 1.10588e+07 1.10198e+07 1.10134e+07 1.10094e+07 1.10056e+07 1.10018e+07 - 1.29846e+07 1.29554e+07 1.29285e+07 1.28498e+07 1.26431e+07 1.23806e+07 1.21216e+07 1.18645e+07 1.16084e+07 1.13526e+07 1.12061e+07 1.11688e+07 - 1.11314e+07 1.10992e+07 1.10507e+07 1.10182e+07 1.10129e+07 1.10089e+07 1.10052e+07 1.10017e+07 1.29819e+07 1.29491e+07 1.29198e+07 1.28486e+07 - 1.26447e+07 1.2377e+07 1.21154e+07 1.18568e+07 1.15998e+07 1.13435e+07 1.11968e+07 1.11596e+07 1.11223e+07 1.10905e+07 1.10422e+07 1.10171e+07 - 1.10123e+07 1.10083e+07 1.10047e+07 1.10014e+07 1.29783e+07 1.29421e+07 1.29106e+07 1.28448e+07 1.26436e+07 1.23719e+07 1.21083e+07 1.18487e+07 - 1.15911e+07 1.13344e+07 1.11875e+07 1.11503e+07 1.11134e+07 1.10816e+07 1.10341e+07 1.10163e+07 1.10116e+07 1.10077e+07 1.10041e+07 1.10011e+07 - 1.2973e+07 1.29341e+07 1.29013e+07 1.28368e+07 1.26369e+07 1.23647e+07 1.21002e+07 1.184e+07 1.1582e+07 1.13251e+07 1.11781e+07 1.1141e+07 - 1.11051e+07 1.1072e+07 1.10286e+07 1.10157e+07 1.10109e+07 1.10069e+07 1.10034e+07 1.10006e+07 + <DataArray type="Float32" Name="rho_w" NumberOfComponents="1" format="ascii"> + 937.213 951.562 1075.04 1076.99 1079.39 1082.39 1086.03 1090.25 1094.91 1099.76 1107.7 1113.6 + 1117.21 1117.19 1117.17 1117.14 1117.12 1117.12 1117.12 1117.12 930.835 938.252 1063.08 1073.34 + 1075.68 1078.78 1082.66 1087.25 1092.37 1097.7 1106.53 1113.23 1117.2 1117.18 1117.16 1117.13 + 1117.12 1117.12 1117.12 1117.12 929.746 933.924 1029.51 1071.71 1073.85 1076.83 1080.69 1085.37 + 1090.65 1096.21 1105.56 1112.78 1117.2 1117.18 1117.16 1117.13 1117.12 1117.12 1117.12 1117.12 + 929.429 931.987 1007.55 1070.74 1072.68 1075.53 1079.33 1084.03 1089.4 1095.12 1104.81 1112.4 + 1117.19 1117.17 1117.15 1117.13 1117.12 1117.12 1117.12 1117.12 929.291 930.932 991.856 1070.06 + 1071.82 1074.51 1078.23 1082.92 1088.36 1094.19 1104.17 1112.06 1117.19 1117.17 1117.15 1117.13 + 1117.12 1117.12 1117.12 1117.12 929.221 930.29 979.209 1069.54 1071.11 1073.63 1077.25 1081.91 + 1087.39 1093.33 1103.58 1111.74 1117.18 1117.17 1117.14 1117.12 1117.12 1117.12 1117.12 1117.12 + 929.182 929.88 968.744 1069.11 1070.48 1072.82 1076.31 1080.92 1086.44 1092.47 1102.97 1111.43 + 1117.18 1117.16 1117.14 1117.12 1117.12 1117.12 1117.12 1117.12 929.161 929.615 959.327 1068.74 + 1069.92 1072.07 1075.41 1079.95 1085.47 1091.58 1102.35 1111.12 1117.17 1117.16 1117.13 1117.12 + 1117.12 1117.12 1117.12 1117.12 929.149 929.453 951.154 1068.46 1069.47 1071.43 1074.62 1079.06 + 1084.56 1090.72 1101.75 1110.88 1117.17 1117.15 1117.13 1117.12 1117.12 1117.12 1117.12 1117.12 + 929.141 929.377 951.934 1068.57 1069.5 1071.34 1074.4 1078.75 1084.21 1090.41 1101.74 1111.52 + 1117.16 1117.15 1117.13 1117.12 1117.12 1117.12 1117.12 1117.12 </DataArray> - <DataArray type="Float32" Name="pc" NumberOfComponents="1" format="ascii"> - 510.987 508.701 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 - 503.573 524.004 534.787 571.161 877.756 1059.51 1061.15 1074.71 514.913 511.945 499.687 499.687 - 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 506.518 529.715 545.546 618.547 - 1011.91 1089.15 1089.99 1101.89 516.15 513.44 499.687 499.687 499.687 499.687 499.687 499.687 - 499.687 499.687 499.687 499.687 506.591 532.924 554.075 680.889 1062.97 1089.32 1090.04 1101.94 - 516.249 513.921 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 - 505.834 534.947 561.506 738.831 1078.79 1089.35 1090.04 1101.95 516.202 514.106 499.687 499.687 - 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 504.878 536.456 568.7 793.782 - 1084.55 1089.36 1090.04 1101.96 516.169 514.25 499.687 499.687 499.687 499.687 499.687 499.687 - 499.687 499.687 499.687 499.687 503.969 537.858 576.926 850.786 1087 1089.36 1090.03 1101.97 - 516.147 514.39 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 - 503.129 539.385 587.862 911.283 1088.12 1089.38 1090.05 1101.99 516.132 514.523 499.687 499.687 - 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 502.469 541.247 604.605 973.356 - 1088.84 1089.6 1090.27 1102.21 516.206 514.733 499.687 499.687 499.687 499.687 499.687 499.687 - 499.687 499.687 499.687 499.687 502.91 544.093 638.751 1034.73 1091.78 1092.3 1092.97 1104.73 - 519.847 521.584 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 - 518.374 570.803 783.907 1108.1 1117.22 1117.59 1118.17 1128.68 + <DataArray type="Float32" Name="mob_w" NumberOfComponents="1" format="ascii"> + 4242.5 3880.42 2952.45 2952.17 2951.85 2951.48 2951.1 2950.75 2950.46 2950.28 2950.27 2950.51 + 2833.68 2065.91 1788.08 1170.77 54.8285 7.52794 7.38687 6.65947 4313.3 4142.38 2962.64 2952.69 + 2952.34 2951.91 2951.44 2950.99 2950.6 2950.34 2950.25 2950.49 2708.11 1894.19 1531.87 674.265 + 13.5283 5.82082 5.78018 5.29954 4311.52 4244.84 3071.84 2952.94 2952.6 2952.17 2951.67 2951.16 + 2950.71 2950.39 2950.24 2950.46 2702.88 1799.59 1352.82 312.899 7.59524 5.80916 5.7779 5.2973 + 4332.08 4317.22 3219.94 2953.09 2952.77 2952.34 2951.83 2951.29 2950.8 2950.44 2950.23 2950.44 + 2732.1 1739.13 1207.01 147.275 6.36765 5.80727 5.77796 5.29695 4347.57 4368.12 3380.9 2953.2 + 2952.91 2952.49 2951.97 2951.4 2950.88 2950.49 2950.23 2950.43 2771.53 1693.76 1076.09 75.1975 + 6.02391 5.80676 5.77802 5.2966 4356.53 4400.37 3562.17 2953.29 2953.02 2952.62 2952.1 2951.51 + 2950.96 2950.53 2950.23 2950.41 2809.84 1652.26 940.117 39.3052 5.90103 5.80653 5.77802 5.2962 + 4361.88 4419.81 3763.7 2953.36 2953.12 2952.74 2952.22 2951.63 2951.05 2950.58 2950.23 2950.4 + 2844.43 1607.63 779.855 20.9115 5.85217 5.80547 5.77705 5.295 4365.04 4430.72 4002.91 2953.42 + 2953.21 2952.85 2952.34 2951.74 2951.14 2950.64 2950.24 2950.39 2864.34 1553.11 576.338 11.7983 + 5.81944 5.79182 5.76341 5.28329 4361.94 4430.33 4273.51 2953.47 2953.28 2952.95 2952.46 2951.85 + 2951.22 2950.7 2950.24 2950.38 2823.15 1470.73 313.903 7.44574 5.66857 5.6494 5.62174 5.16338 + 4140.44 4023.63 4249.94 2953.45 2953.28 2952.97 2952.49 2951.89 2951.26 2950.72 2950.24 2950.4 + 2137.97 908.629 46.7336 4.76348 4.61456 4.6031 4.58422 4.26065 </DataArray> - <DataArray type="Float32" Name="rho_w" NumberOfComponents="1" format="ascii"> - 998.819 1000 942.176 944.102 946.451 949.405 953.002 957.205 961.869 966.742 974.773 980.797 - 984.416 984.401 984.38 984.358 984.345 984.343 984.342 984.34 998.192 998.923 951.542 940.759 - 943.043 946.076 949.895 954.437 959.517 964.844 973.698 980.462 984.412 984.397 984.377 984.354 - 984.345 984.343 984.341 984.34 998.07 998.504 968.196 939.254 941.346 944.273 948.077 952.695 - 957.928 963.466 972.792 980.039 984.409 984.394 984.373 984.351 984.345 984.343 984.341 984.339 - 998.033 998.303 977.487 938.35 940.263 943.067 946.818 951.457 956.778 962.456 972.1 979.676 - 984.405 984.39 984.37 984.349 984.344 984.343 984.341 984.339 998.017 998.188 983.285 937.712 - 939.456 942.125 945.806 950.442 955.822 961.61 971.513 979.359 984.401 984.387 984.366 984.348 - 984.344 984.343 984.341 984.339 998.008 998.115 987.4 937.213 938.787 941.308 944.899 949.514 - 954.939 960.823 970.966 979.065 984.397 984.383 984.363 984.347 984.344 984.342 984.341 984.339 - 998.003 998.067 990.32 936.802 938.199 940.556 944.037 948.612 954.065 960.034 970.411 978.771 - 984.393 984.38 984.36 984.346 984.344 984.342 984.341 984.339 997.999 998.034 992.649 936.457 - 937.677 939.862 943.214 947.725 953.185 959.223 969.833 978.47 984.389 984.376 984.356 984.346 - 984.344 984.342 984.34 984.339 997.995 998.013 994.292 936.192 937.253 939.278 942.492 946.913 - 952.351 958.433 969.281 978.233 984.386 984.372 984.353 984.345 984.343 984.342 984.34 984.339 - 997.992 998 993.792 936.389 937.42 939.334 942.425 946.748 952.134 958.219 969.306 978.81 - 984.382 984.369 984.35 984.345 984.343 984.341 984.34 984.339 + <DataArray type="Float32" Name="S_n" NumberOfComponents="1" format="ascii"> + 0.035538 0.0280471 0 0 0 0 0 0 0 0 0 0 + 0.00904638 0.0691286 0.095047 0.165866 0.505005 0.620431 0.621278 0.62585 0.0470509 0.0380035 0 0 + 0 0 0 0 0 0 0 0 0.0179582 0.0848134 0.121783 0.247578 + 0.592091 0.631613 0.631907 0.635516 0.0503428 0.0424337 0 0 0 0 0 0 + 0 0 0 0 0.0183365 0.0939156 0.142533 0.344053 0.620031 0.631697 0.631924 0.635534 + 0.0505324 0.0438263 0 0 0 0 0 0 0 0 0 0 + 0.0162321 0.0999223 0.161014 0.422345 0.62779 0.631711 0.631923 0.635536 0.0503809 0.0443554 0 0 + 0 0 0 0 0 0 0 0 0.0134191 0.104533 0.179095 0.480762 + 0.630163 0.631714 0.631923 0.635539 0.0502805 0.0447699 0 0 0 0 0 0 + 0 0 0 0 0.0107154 0.108833 0.199713 0.528559 0.631036 0.631716 0.631923 0.635542 + 0.0502131 0.0451759 0 0 0 0 0 0 0 0 0 0 + 0.00829715 0.113548 0.227116 0.568175 0.631386 0.631724 0.63193 0.635552 0.0501678 0.0455617 0 0 + 0 0 0 0 0 0 0 0 0.00691532 0.119444 0.268831 0.599082 + 0.631623 0.631823 0.632029 0.635643 0.0503483 0.0461295 0 0 0 0 0 0 + 0 0 0 0 0.00978231 0.128654 0.343688 0.620923 0.632725 0.632866 0.633071 0.636583 + 0.0600749 0.0643144 0 0 0 0 0 0 0 0 0 0 + 0.0628364 0.204804 0.516554 0.639844 0.64111 0.641209 0.641372 0.644248 </DataArray> - <DataArray type="Float32" Name="rho_n" NumberOfComponents="1" format="ascii"> - 107.1 107.024 -7668.2 -7312.76 -6874.28 -6325.35 -5659.31 -4883 -4022.88 -3124.15 -1660.32 -566.509 - 92.0766 91.7727 91.3568 90.9113 90.6549 90.6196 90.5858 90.5452 107.05 106.95 -6961.21 -7916.26 - -7489.68 -6926.47 -6220.45 -5383.1 -4447.83 -3467.2 -1854.34 -626.577 91.999 91.6968 91.2784 90.8212 - 90.6484 90.6142 90.5801 90.541 107.019 106.891 -5174.67 -8187.92 -7796.15 -7251.92 -6548.57 -5697.58 - -4734.68 -3715.92 -2017.91 -702.547 91.9215 91.6246 91.2055 90.7595 90.6436 90.6097 90.5756 90.5384 - 106.997 106.839 -4014.7 -8351.1 -7991.85 -7469.7 -6775.7 -5920.87 -4942.14 -3898.15 -2142.64 -767.667 - 91.844 91.5546 91.1384 90.7245 90.6393 90.6055 90.5718 90.5366 106.977 106.792 -3187.25 -8466.36 - -8137.78 -7639.65 -6958.37 -6104 -5114.43 -4050.67 -2248.3 -824.556 91.7668 91.4854 91.0739 90.7009 - 90.635 90.6014 90.5684 90.5351 106.959 106.745 -2520.04 -8556.51 -8258.85 -7787.15 -7121.86 -6271.18 - -5273.63 -4192.53 -2346.81 -877.098 91.6899 91.4158 91.0086 90.6834 90.6304 90.5972 90.5651 90.5338 - 106.94 106.697 -1983.57 -8630.73 -8365.28 -7922.8 -7277.14 -6433.73 -5431.11 -4334.74 -2446.63 -929.859 - 91.6133 91.3451 90.9405 90.6703 90.6256 90.5928 90.5616 90.5323 106.917 106.644 -1498.1 -8693.03 - -8459.68 -8047.95 -7425.46 -6593.64 -5589.82 -4480.89 -2550.63 -983.673 91.5375 91.2728 90.8699 90.6607 - 90.6207 90.588 90.5576 90.5304 106.887 106.585 -1109.74 -8740.68 -8536.09 -8152.96 -7555.59 -6739.85 - -5740.04 -4623.12 -2650.06 -1026.09 91.4633 91.1978 90.8027 90.6539 90.6155 90.5825 90.5529 90.5278 - 106.843 106.519 -1238.87 -8704.43 -8505.58 -8142.46 -7567.16 -6769.05 -5778.62 -4661.29 -2644.95 -920.917 - 91.3943 91.1185 90.7566 90.6496 90.6096 90.5761 90.5469 90.5236 + <DataArray type="Float32" Name="p_n" NumberOfComponents="1" format="ascii"> + 1.30028e+07 1.29929e+07 1.29746e+07 1.28587e+07 1.26429e+07 1.24095e+07 1.21662e+07 1.19175e+07 1.16658e+07 1.14126e+07 1.12671e+07 1.12296e+07 + 1.11916e+07 1.11554e+07 1.11057e+07 1.10526e+07 1.10167e+07 1.1012e+07 1.1008e+07 1.10032e+07 1.29974e+07 1.29848e+07 1.29662e+07 1.28526e+07 + 1.26367e+07 1.24013e+07 1.21569e+07 1.19075e+07 1.16554e+07 1.1402e+07 1.12563e+07 1.12188e+07 1.11809e+07 1.1145e+07 1.10949e+07 1.10402e+07 + 1.10157e+07 1.10114e+07 1.10074e+07 1.10027e+07 1.29939e+07 1.2978e+07 1.29583e+07 1.285e+07 1.26349e+07 1.23954e+07 1.21488e+07 1.18982e+07 + 1.16454e+07 1.13915e+07 1.12456e+07 1.12082e+07 1.11704e+07 1.11351e+07 1.10848e+07 1.10305e+07 1.10151e+07 1.10109e+07 1.10068e+07 1.10024e+07 + 1.29912e+07 1.29719e+07 1.29508e+07 1.28497e+07 1.26363e+07 1.23912e+07 1.21416e+07 1.18894e+07 1.16357e+07 1.13811e+07 1.1235e+07 1.11976e+07 + 1.11599e+07 1.11254e+07 1.10755e+07 1.10252e+07 1.10145e+07 1.10104e+07 1.10064e+07 1.10022e+07 1.2989e+07 1.29663e+07 1.29433e+07 1.28505e+07 + 1.26394e+07 1.23882e+07 1.21351e+07 1.18809e+07 1.16261e+07 1.13709e+07 1.12245e+07 1.1187e+07 1.11494e+07 1.1116e+07 1.10666e+07 1.1022e+07 + 1.1014e+07 1.101e+07 1.1006e+07 1.1002e+07 1.29868e+07 1.29608e+07 1.29357e+07 1.28515e+07 1.2643e+07 1.23855e+07 1.21288e+07 1.18726e+07 + 1.16166e+07 1.13606e+07 1.1214e+07 1.11765e+07 1.1139e+07 1.11064e+07 1.10576e+07 1.10198e+07 1.10135e+07 1.10095e+07 1.10056e+07 1.10018e+07 + 1.29845e+07 1.2955e+07 1.29276e+07 1.28521e+07 1.26465e+07 1.23826e+07 1.21223e+07 1.18642e+07 1.1607e+07 1.13504e+07 1.12035e+07 1.11661e+07 + 1.11286e+07 1.10968e+07 1.10482e+07 1.10181e+07 1.10129e+07 1.10089e+07 1.10052e+07 1.10017e+07 1.29819e+07 1.29488e+07 1.29189e+07 1.28515e+07 + 1.26489e+07 1.23788e+07 1.21153e+07 1.18554e+07 1.15973e+07 1.13401e+07 1.11929e+07 1.11556e+07 1.11184e+07 1.1087e+07 1.10389e+07 1.1017e+07 + 1.10123e+07 1.10084e+07 1.10047e+07 1.10014e+07 1.29784e+07 1.2942e+07 1.29095e+07 1.28481e+07 1.26485e+07 1.23732e+07 1.21074e+07 1.18462e+07 + 1.15874e+07 1.13297e+07 1.11824e+07 1.11452e+07 1.11084e+07 1.10769e+07 1.10309e+07 1.10162e+07 1.10117e+07 1.10077e+07 1.10041e+07 1.10011e+07 + 1.29735e+07 1.29344e+07 1.29002e+07 1.28403e+07 1.26423e+07 1.23652e+07 1.20982e+07 1.18363e+07 1.15771e+07 1.13192e+07 1.11717e+07 1.11346e+07 + 1.1099e+07 1.10662e+07 1.10263e+07 1.10157e+07 1.1011e+07 1.1007e+07 1.10034e+07 1.10006e+07 </DataArray> - <DataArray type="Float32" Name="mob_w" NumberOfComponents="1" format="ascii"> - 4291.57 3944.96 2954.95 2954.65 2954.29 2953.87 2953.39 2952.87 2952.36 2951.89 2951.25 2950.88 - 2787.3 2027.72 1722.81 1017.7 32.7111 7.25832 7.16899 6.47657 4329.89 4177.94 2954.97 2955.17 - 2954.8 2954.33 2953.79 2953.2 2952.6 2952.06 2951.32 2950.9 2660.27 1859.3 1469.05 537.898 - 10.4849 5.82062 5.78497 5.3037 4317.68 4265.09 3045.9 2955.41 2955.06 2954.6 2954.04 2953.41 - 2952.78 2952.19 2951.39 2950.92 2657.22 1771.58 1297.59 249.502 7.07179 5.81341 5.78296 5.30168 - 4334.58 4329.73 3180.54 2955.56 2955.24 2954.78 2954.21 2953.57 2952.91 2952.29 2951.44 2950.94 - 2689.19 1718.69 1166.4 129.815 6.28347 5.81222 5.78302 5.30133 4348.95 4376.45 3330.58 2955.67 - 2955.37 2954.93 2954.36 2953.7 2953.02 2952.38 2951.49 2950.96 2730.19 1680.39 1053.46 73.1264 - 6.02118 5.81184 5.78309 5.30098 4357.36 4406.12 3501.75 2955.75 2955.48 2955.05 2954.49 2953.83 - 2953.12 2952.46 2951.53 2950.98 2769.81 1645.66 939.131 41.9877 5.91347 5.81167 5.78312 5.3006 - 4362.38 4423.76 3688.89 2955.82 2955.58 2955.17 2954.62 2953.95 2953.23 2952.54 2951.57 2950.99 - 2807.06 1608.77 808.134 24.2359 5.86513 5.81101 5.78255 5.29971 4365.29 4433.24 3911.93 2955.88 - 2955.66 2955.29 2954.74 2954.07 2953.34 2952.62 2951.62 2951.01 2836.7 1565.02 645.522 14.3057 - 5.83397 5.80149 5.77303 5.29137 4361.28 4430.7 4141.56 2955.93 2955.74 2955.38 2954.85 2954.19 - 2953.44 2952.71 2951.66 2951.02 2816.84 1500.72 415.943 8.77151 5.70974 5.68805 5.66009 5.19559 - 4123.3 3990.92 4043.67 2955.89 2955.71 2955.37 2954.86 2954.21 2953.47 2952.73 2951.66 2950.99 - 2210.73 1022.81 80.8292 5.07061 4.74855 4.73623 4.71639 4.37646 + <DataArray type="Float32" Name="rho_n" NumberOfComponents="1" format="ascii"> + 107.095 107.02 -7599.71 -7244.95 -6804.29 -6253.98 -5589.08 -4817.47 -3965.48 -3077.35 -1636.25 -564.645 + 92.1142 91.8129 91.3988 90.9569 90.6573 90.6188 90.5855 90.5451 107.047 106.946 -7539.75 -7892.58 + -7462.39 -6896.25 -6188.8 -5352.39 -4420.48 -3445.05 -1844.97 -631.198 92.0258 91.7264 91.3092 90.8533 + 90.6496 90.6137 90.5798 90.5409 107.017 106.887 -5369.16 -8180.49 -7786.73 -7241.2 -6537.6 -5687.75 + -4727.31 -3711.79 -2020.36 -711.925 91.9378 91.6437 91.2249 90.7724 90.644 90.6095 90.5754 90.5384 + 106.995 106.836 -4034.92 -8351.89 -7993.47 -7472.02 -6779.26 -5926.28 -4949.71 -3907.7 -2154.57 -780.995 + 91.8501 91.5635 91.1473 90.7289 90.6396 90.6055 90.5717 90.5366 106.976 106.788 -3130.46 -8471.54 + -8146.64 -7651.86 -6973.82 -6122.36 -5134.95 -4072.19 -2268.75 -841.709 91.7628 91.4844 91.0731 90.7019 + 90.6353 90.6015 90.5684 90.5351 106.958 106.742 -2427.08 -8564.42 -8273.2 -7807.9 -7148.24 -6301.79 + -5306.54 -4225.55 -2375.46 -897.909 91.6761 91.4052 90.9981 90.6832 90.6308 90.5974 90.5652 90.5338 + 106.939 106.694 -1862.75 -8640.83 -8384.45 -7951.58 -7314.23 -6476.6 -5476.56 -4379.45 -2483.57 -954.141 + 91.5899 91.325 90.9204 90.6697 90.6261 90.593 90.5617 90.5323 106.917 106.642 -1364.53 -8705.03 + -8483.23 -8084.54 -7473.28 -6648.93 -5648 -4537.43 -2595.21 -1009.22 91.5046 91.2434 90.8426 90.6602 + 90.6213 90.5882 90.5578 90.5305 106.888 106.585 -939.242 -8754.68 -8562.98 -8196.3 -7613.06 -6806.53 + -5810.07 -4690.76 -2701.2 -1051.14 91.4211 91.1593 90.776 90.6538 90.6161 90.5828 90.553 90.5279 + 106.847 106.522 -945.745 -8735.74 -8557.4 -8212.88 -7651.51 -6860.71 -5870.42 -4746.53 -2702.64 -934.133 + 91.3434 91.0699 90.7379 90.6497 90.6101 90.5765 90.5471 90.5237 </DataArray> <DataArray type="Float32" Name="mob_n" NumberOfComponents="1" format="ascii"> - 5.96404 3.03567 0 0 0 0 0 0 0 0 0 0 - 0.224149 54.7098 149.212 899.908 16308.2 22937.2 22985.7 23376.2 14.3073 7.58781 0 0 - 0 0 0 0 0 0 0 0 1.31769 97.8785 300.955 2749.14 - 21460 23777.4 23800.7 24121.9 17.9323 10.6384 0 0 0 0 0 0 - 0 0 0 0 1.3612 128.883 463.682 6013.69 23037.8 23782.1 23802.1 24123.3 - 18.2452 11.7612 0 0 0 0 0 0 0 0 0 0 - 0.951904 151.02 635.768 9273.11 23489.8 23782.9 23802.1 24123.6 18.0989 12.2137 0 0 - 0 0 0 0 0 0 0 0 0.562285 168.869 828.317 12246.6 - 23650.4 23783.2 23802.1 24123.9 17.9949 12.5728 0 0 0 0 0 0 - 0 0 0 0 0.30602 186.487 1078.28 15074.9 23718.1 23783.3 23802.1 24124.2 - 17.9244 12.9276 0 0 0 0 0 0 0 0 0 0 - 0.151231 206.806 1456.27 17745.4 23748.8 23783.8 23802.5 24124.8 17.879 13.2713 0 0 - 0 0 0 0 0 0 0 0 0.0748283 233.205 2124.05 20137.7 - 23768.7 23790 23808.7 24130.6 18.1129 13.825 0 0 0 0 0 0 - 0 0 0 0 0.121999 277.005 3740.97 22188.5 23848.9 23863.5 23882.2 24197.3 - 32.0201 40.4523 0 0 0 0 0 0 0 0 0 0 - 26.0266 889.228 11727.6 24284.3 24521.5 24531.2 24546.7 24812.7 - </DataArray> - <DataArray type="Float32" Name="porosity" NumberOfComponents="1" format="ascii"> - 0.11 0.11 0.103243 0.057538 0.0575157 0.0575051 0.0574955 0.0574874 0.0574814 0.0574762 0.105374 0.105366 - 0.105348 0.105296 0.105295 0.105294 0.105293 0.105291 0.105289 0.105282 0.11 0.11 0.10889 0.0580744 - 0.0575189 0.0575085 0.0574996 0.057491 0.0574845 0.0574789 0.105389 0.105379 0.105351 0.105296 0.105295 0.105294 - 0.105293 0.105291 0.105289 0.105282 0.11 0.11 0.109639 0.059971 0.0575202 0.0575101 0.0575022 0.0574926 - 0.0574856 0.0574799 0.105396 0.105386 0.105358 0.105296 0.105295 0.105294 0.105293 0.105291 0.105289 0.105282 - 0.11 0.11 0.10982 0.0621927 0.0575213 0.0575128 0.0575037 0.0574936 0.0574862 0.0574815 0.105399 0.10539 - 0.105364 0.105296 0.105295 0.105294 0.105293 0.105291 0.105289 0.105282 0.11 0.11 0.109893 0.0644536 - 0.0575223 0.0575149 0.0575048 0.0574944 0.0574869 0.0574827 0.105401 0.105393 0.10537 0.105296 0.105295 0.105294 - 0.105293 0.105291 0.105289 0.105282 0.11 0.11 0.109933 0.0669062 0.0575234 0.0575166 0.0575058 0.0574952 - 0.0574885 0.0574836 0.105403 0.105395 0.105375 0.105296 0.105295 0.105294 0.105293 0.105291 0.105289 0.105282 - 0.11 0.11 0.109953 0.0697906 0.0575254 0.0575185 0.0575069 0.057496 0.05749 0.0574845 0.105405 0.105397 - 0.10538 0.105296 0.105295 0.105294 0.105293 0.105291 0.105289 0.105282 0.11 0.11 0.10997 0.0735659 - 0.0575277 0.0575205 0.0575081 0.0574979 0.0574914 0.0574852 0.105407 0.1054 0.105385 0.105296 0.105295 0.105294 - 0.105293 0.105291 0.105289 0.105282 0.11 0.11 0.109983 0.0788894 0.0575307 0.0575226 0.0575094 0.0575003 - 0.0574927 0.057486 0.10541 0.105405 0.105388 0.105296 0.105295 0.105294 0.105293 0.105291 0.105289 0.105282 - 0.11 0.11 0.109982 0.076047 0.0575331 0.0575254 0.0575123 0.0575028 0.0574952 0.0574887 0.105431 0.105429 - 0.105369 0.105296 0.105295 0.105294 0.105293 0.105291 0.105289 0.105282 + 6.25561 3.0188 0 0 0 0 0 0 0 0 0 0 + 0.0811145 47.3836 122.562 629.319 13727.3 22795.2 22869.4 23270.1 14.7194 7.68164 0 0 + 0 0 0 0 0 0 0 0 0.755121 87.3223 255.015 1985.5 + 20380.7 23777.3 23803.9 24124.9 18.069 10.7539 0 0 0 0 0 0 + 0 0 0 0 0.806636 118.264 404.58 4965.3 22760 23784.9 23805.4 24126.4 + 18.276 11.8649 0 0 0 0 0 0 0 0 0 0 + 0.547866 142.152 577.263 8625.98 23439.5 23786.1 23805.4 24126.7 18.1108 12.3062 0 0 + 0 0 0 0 0 0 0 0 0.297477 162.476 785.914 12102.2 + 23648.8 23786.5 23805.4 24127 18.0019 12.6595 0 0 0 0 0 0 + 0 0 0 0 0.142671 183.054 1075.89 15404 23726 23786.7 23805.5 24127.3 + 17.9292 13.0119 0 0 0 0 0 0 0 0 0 0 + 0.0605463 207.481 1554.21 18433.1 23757.1 23787.4 23806.1 24128.1 17.8804 13.3529 0 0 + 0 0 0 0 0 0 0 0 0.032282 240.875 2504.43 20965.8 + 23778.1 23796.3 23815 24136.2 18.0762 13.8653 0 0 0 0 0 0 + 0 0 0 0 0.105461 299.685 4950.88 22837.6 23875.8 23888.8 23907.4 24220.1 + 30.8158 37.8401 0 0 0 0 0 0 0 0 0 0 + 35.5851 1156.45 14536.9 24509.8 24623.8 24633.1 24648.2 24907.1 </DataArray> - <DataArray type="Float32" Name="x^H2O_liquid" NumberOfComponents="1" format="ascii"> - 0.995716 0.99001 0.984849 0.981022 0.976302 0.970392 0.963222 0.954865 0.945605 0.93593 0.920171 0.908396 - 0.901306 0.901309 0.901313 0.901318 0.901321 0.901321 0.901322 0.901322 0.998163 0.995237 0.990908 0.987519 - 0.982927 0.976864 0.969263 0.960248 0.95018 0.939623 0.92226 0.909042 0.901307 0.90131 0.901314 0.901319 - 0.901321 0.901321 0.901322 0.901322 0.998604 0.996929 0.993319 0.990444 0.986226 0.980367 0.972795 0.963634 - 0.953268 0.9423 0.924021 0.90986 0.901307 0.901311 0.901315 0.90132 0.901321 0.901321 0.901322 0.901322 - 0.99873 0.997692 0.99469 0.992201 0.988333 0.982712 0.97524 0.966038 0.955501 0.944262 0.925363 0.910561 - 0.901308 0.901311 0.901316 0.90132 0.901321 0.901321 0.901322 0.901322 0.998784 0.998112 0.995622 0.993442 - 0.989904 0.984541 0.977207 0.968009 0.957356 0.945904 0.926501 0.911174 0.901309 0.901312 0.901316 0.90132 - 0.901321 0.901322 0.901322 0.901322 0.998812 0.998368 0.996313 0.994412 0.991207 0.986129 0.978967 0.969809 - 0.95907 0.947431 0.927561 0.911739 0.90131 0.901313 0.901317 0.901321 0.901321 0.901322 0.901322 0.901322 - 0.998827 0.998532 0.996846 0.995211 0.992353 0.98759 0.980639 0.971559 0.960765 0.948962 0.928636 0.912307 - 0.901311 0.901314 0.901318 0.901321 0.901321 0.901322 0.901322 0.901322 0.998835 0.998636 0.997261 0.995882 - 0.993369 0.988937 0.982235 0.97328 0.962474 0.950536 0.929756 0.912887 0.901311 0.901314 0.901319 0.901321 - 0.901321 0.901322 0.901322 0.901322 0.998839 0.998699 0.997542 0.996395 0.994192 0.990067 0.983636 0.974855 - 0.964091 0.952067 0.930826 0.913343 0.901312 0.901315 0.901319 0.901321 0.901321 0.901322 0.901322 0.901322 - 0.998841 0.998727 0.997159 0.996005 0.993863 0.989954 0.983761 0.975169 0.964506 0.952478 0.930771 0.912211 - 0.901313 0.901316 0.90132 0.901321 0.901321 0.901322 0.901322 0.901322 + <DataArray type="Float32" Name="x^H2O_brine" NumberOfComponents="1" format="ascii"> + 0.995374 0.98907 0.984112 0.980292 0.975548 0.969624 0.962466 0.954159 0.944987 0.935426 0.919912 0.908376 + 0.901305 0.901308 0.901313 0.901318 0.901321 0.901321 0.901322 0.901322 0.998121 0.994921 0.990697 0.987264 + 0.982633 0.976538 0.968922 0.959918 0.949885 0.939385 0.922159 0.909092 0.901306 0.901309 0.901314 0.901319 + 0.901321 0.901321 0.901322 0.901322 0.998586 0.996791 0.99326 0.990364 0.986125 0.980252 0.972677 0.963528 + 0.953189 0.942256 0.924047 0.909961 0.901307 0.90131 0.901315 0.90132 0.901321 0.901321 0.901322 0.901322 + 0.998721 0.997623 0.994691 0.992209 0.98835 0.982737 0.975279 0.966096 0.955583 0.944365 0.925492 0.910705 + 0.901308 0.901311 0.901316 0.90132 0.901321 0.901321 0.901322 0.901322 0.998779 0.998074 0.995649 0.993498 + 0.989999 0.984673 0.977373 0.968207 0.957577 0.946136 0.926721 0.911358 0.901309 0.901312 0.901316 0.90132 + 0.901321 0.901322 0.901322 0.901322 0.998809 0.998348 0.996354 0.994498 0.991362 0.986353 0.979251 0.970139 + 0.959424 0.947787 0.92787 0.911963 0.90131 0.901313 0.901317 0.901321 0.901321 0.901322 0.901322 0.901322 + 0.998825 0.998523 0.996896 0.99532 0.992559 0.987899 0.981038 0.972021 0.961255 0.949444 0.929034 0.912569 + 0.901311 0.901314 0.901318 0.901321 0.901321 0.901322 0.901322 0.901322 0.998834 0.998635 0.997321 0.996011 + 0.993623 0.989331 0.98275 0.973876 0.9631 0.951144 0.930236 0.913162 0.901312 0.901315 0.901319 0.901321 + 0.901321 0.901322 0.901322 0.901322 0.998839 0.998703 0.99764 0.996546 0.994481 0.990534 0.984255 0.975572 + 0.964845 0.952795 0.931377 0.913613 0.901313 0.901316 0.90132 0.901321 0.901321 0.901322 0.901322 0.901322 + 0.998841 0.998734 0.997338 0.996342 0.994421 0.990712 0.984669 0.976156 0.965495 0.953395 0.931392 0.912353 + 0.901314 0.901316 0.90132 0.901321 0.901321 0.901322 0.901322 0.901322 </DataArray> - <DataArray type="Float32" Name="x^Air_liquid" NumberOfComponents="1" format="ascii"> - 0.00112892 0.00112825 -0.0825735 -0.0787469 -0.0740265 -0.068117 -0.0609467 -0.0525895 -0.0433298 -0.0336546 -0.0178958 -0.00612041 - 0.000969566 0.000966294 0.000961817 0.00095702 0.00095426 0.00095388 0.000953517 0.000953079 0.00112833 0.00112732 -0.0749627 -0.0852439 - -0.0806516 -0.0745884 -0.0669877 -0.0579732 -0.0479047 -0.0373477 -0.0199846 -0.00676708 0.00096873 0.000965477 0.000960972 0.00095605 - 0.00095419 0.000953823 0.000953455 0.000953034 0.00112798 0.00112664 -0.0557303 -0.0881685 -0.0839508 -0.078092 -0.0705201 -0.0613588 - -0.0509928 -0.0400253 -0.0217454 -0.00758493 0.000967895 0.0009647 0.000960188 0.000955386 0.000954139 0.000953774 0.000953406 0.000953006 - 0.00112774 0.00112607 -0.0432431 -0.0899251 -0.0860576 -0.0804365 -0.0729653 -0.0637626 -0.0532261 -0.0419871 -0.0230883 -0.00828598 - 0.000967062 0.000963946 0.000959466 0.00095501 0.000954093 0.000953729 0.000953366 0.000952987 0.00112753 0.00112555 -0.0343354 -0.091166 - -0.0876287 -0.0822661 -0.0749318 -0.0657341 -0.055081 -0.043629 -0.0242257 -0.00889841 0.000966231 0.000963201 0.000958771 0.000954755 - 0.000954046 0.000953685 0.000953329 0.000952971 0.00112733 0.00112504 -0.0271527 -0.0921365 -0.0889321 -0.083854 -0.0766918 -0.0675339 - -0.0567947 -0.0451562 -0.0252861 -0.00946405 0.000965402 0.000962452 0.000958068 0.000954568 0.000953997 0.00095364 0.000953294 0.000952956 - 0.00112712 0.00112451 -0.0213776 -0.0929355 -0.0900779 -0.0853143 -0.0783635 -0.0692838 -0.0584901 -0.0466872 -0.0263608 -0.0100321 - 0.000964578 0.000961691 0.000957334 0.000954427 0.000953945 0.000953592 0.000953256 0.00095294 0.00112687 0.00112394 -0.0161514 -0.0936062 - -0.0910941 -0.0866616 -0.0799602 -0.0710053 -0.0601987 -0.0482606 -0.0274804 -0.0106114 0.000963762 0.000960912 0.000956575 0.000954322 - 0.000953893 0.00095354 0.000953213 0.00095292 0.00112655 0.00112331 -0.0119707 -0.0941192 -0.0919167 -0.0877921 -0.0813611 -0.0725793 - -0.0618159 -0.0497917 -0.0285508 -0.011068 0.000962963 0.000960105 0.000955852 0.00095425 0.000953837 0.000953481 0.000953162 0.000952892 - 0.00112608 0.0011226 -0.0133607 -0.093729 -0.0915882 -0.087679 -0.0814857 -0.0728936 -0.0622312 -0.0502026 -0.0284958 -0.00993578 - 0.00096222 0.000959251 0.000955355 0.000954203 0.000953773 0.000953413 0.000953098 0.000952847 + <DataArray type="Float32" Name="x^Air_brine" NumberOfComponents="1" format="ascii"> + 0.00112888 0.00112823 -0.0818361 -0.078017 -0.073273 -0.0673487 -0.0601907 -0.051884 -0.0427119 -0.0331508 -0.0176367 -0.00610034 + 0.00096997 0.000966727 0.000962268 0.000957511 0.000954286 0.000953871 0.000953513 0.000953078 0.00112829 0.00112728 -0.0811908 -0.084989 + -0.0803578 -0.074263 -0.066647 -0.0576427 -0.0476103 -0.0371093 -0.0198837 -0.00681682 0.000969019 0.000965795 0.000961304 0.000956396 + 0.000954203 0.000953817 0.000953452 0.000953033 0.00112796 0.0011266 -0.057824 -0.0880885 -0.0838495 -0.0779766 -0.070402 -0.061253 + -0.0509134 -0.0399808 -0.0217718 -0.00768589 0.000968071 0.000964905 0.000960396 0.000955525 0.000954143 0.000953771 0.000953405 0.000953006 + 0.00112772 0.00112603 -0.0434607 -0.0899336 -0.0860751 -0.0804615 -0.0730036 -0.0638208 -0.0533076 -0.0420899 -0.0232167 -0.00842946 + 0.000967127 0.000964042 0.000959562 0.000955057 0.000954095 0.000953728 0.000953365 0.000952986 0.00112751 0.00112551 -0.033724 -0.0912218 + -0.087724 -0.0823976 -0.0750981 -0.0659317 -0.0553018 -0.0438607 -0.0244458 -0.00908307 0.000966188 0.000963191 0.000958762 0.000954766 + 0.000954049 0.000953685 0.000953329 0.000952971 0.00112732 0.001125 -0.026152 -0.0922217 -0.0890866 -0.0840773 -0.0769758 -0.0678634 + -0.0571491 -0.0455117 -0.0255946 -0.00968809 0.000965254 0.000962338 0.000957955 0.000954565 0.000954001 0.000953641 0.000953294 0.000952956 + 0.00112711 0.00112448 -0.020077 -0.0930443 -0.0902842 -0.0856241 -0.0787628 -0.0697453 -0.0589794 -0.0471685 -0.0267585 -0.0102935 + 0.000964326 0.000961474 0.000957119 0.00095442 0.000953951 0.000953594 0.000953257 0.000952941 0.00112688 0.00112392 -0.0147135 -0.0937354 + -0.0913476 -0.0870556 -0.0804751 -0.0716005 -0.060825 -0.0488692 -0.0279603 -0.0108864 0.000963408 0.000960596 0.000956281 0.000954317 + 0.000953898 0.000953543 0.000953215 0.000952921 0.00112657 0.0011233 -0.0101352 -0.0942699 -0.0922062 -0.0882586 -0.0819798 -0.0732971 + -0.0625698 -0.0505199 -0.0291014 -0.0113377 0.000962509 0.000959691 0.000955564 0.000954249 0.000953842 0.000953484 0.000953164 0.000952893 + 0.00112613 0.00112262 -0.0102052 -0.094066 -0.0921461 -0.0884372 -0.0823938 -0.0738804 -0.0632195 -0.0511203 -0.0291169 -0.0100781 + 0.000961672 0.000958728 0.000955154 0.000954204 0.000953778 0.000953416 0.0009531 0.000952848 </DataArray> - <DataArray type="Float32" Name="x^NaCl_liquid" NumberOfComponents="1" format="ascii"> - 0.00315553 0.0088619 0.0977244 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 - 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.000708328 0.00363554 0.0840543 0.0977247 + <DataArray type="Float32" Name="x^NaCl_brine" NumberOfComponents="1" format="ascii"> + 0.00349724 0.00980135 0.0977245 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 + 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.000751119 0.00395201 0.0904937 0.0977247 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 - 0.0977248 0.0977248 0.0977248 0.0977248 0.000268116 0.0019442 0.0624116 0.0977245 0.0977248 0.0977248 0.0977248 0.0977248 + 0.0977248 0.0977248 0.0977248 0.0977248 0.000286081 0.00208249 0.064564 0.0977245 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 - 0.000142376 0.00118185 0.0485531 0.0977244 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 - 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 8.8219e-05 0.000762518 0.0387131 0.0977243 + 0.000151439 0.00125131 0.0487696 0.0977244 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 + 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 9.32163e-05 0.000800235 0.0380748 0.0977243 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 - 0.0977248 0.0977248 0.0977248 0.0977248 6.07623e-05 0.000506813 0.0308393 0.0977242 0.0977248 0.0977248 0.0977248 0.0977248 + 0.0977248 0.0977248 0.0977248 0.0977248 6.35722e-05 0.000527004 0.0297985 0.0977242 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 - 4.61232e-05 0.000343878 0.0245312 0.0977241 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 - 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 3.83998e-05 0.000239965 0.0188909 0.0977241 + 4.76646e-05 0.000352974 0.0231813 0.0977241 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 + 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 3.92065e-05 0.000241501 0.017393 0.0977241 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 - 0.0977248 0.0977248 0.0977248 0.0977248 3.44971e-05 0.000177412 0.0144289 0.0977239 0.0977248 0.0977248 0.0977248 0.0977248 + 0.0977248 0.0977248 0.0977248 0.0977248 3.49011e-05 0.000173724 0.0124957 0.0977239 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 - 3.26369e-05 0.000149954 0.0162021 0.097724 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 + 3.28386e-05 0.000143149 0.0128672 0.097724 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 0.0977248 </DataArray> - <DataArray type="Float32" Name="x^H2O_gas" NumberOfComponents="1" format="ascii"> - 0.0318266 0.0316682 0.0315499 0.0317142 0.0321061 0.032516 0.032923 0.0333188 0.0337069 0.0341012 0.0339591 0.033636 - 0.0334864 0.0335961 0.0337474 0.0339109 0.0340058 0.0340189 0.0340314 0.0340465 0.0319187 0.0318556 0.0317631 0.0319381 - 0.032337 0.0327515 0.0331517 0.0335313 0.0338965 0.0342638 0.0340649 0.0336885 0.0335144 0.0336236 0.0337761 0.0339442 - 0.0340082 0.0340209 0.0340336 0.0340481 0.0319417 0.0319266 0.031859 0.0320387 0.0324485 0.0328825 0.033292 0.0336727 - 0.0340324 0.0343893 0.0341585 0.0337471 0.0335423 0.0336498 0.0338027 0.033967 0.03401 0.0340226 0.0340353 0.0340491 - 0.0319524 0.031966 0.0319213 0.0320966 0.032514 0.0329706 0.0333929 0.0337787 0.0341373 0.0344885 0.0342367 0.0338013 - 0.0335703 0.0336753 0.0338274 0.03398 0.0340116 0.0340241 0.0340366 0.0340497 0.0319598 0.0319933 0.0319694 0.0321355 - 0.0325585 0.0330391 0.033476 0.0338688 0.0342284 0.034576 0.0343072 0.0338522 0.0335982 0.0337005 0.0338511 0.0339888 - 0.0340132 0.0340256 0.0340379 0.0340503 0.0319661 0.0320153 0.0320104 0.0321653 0.032593 0.0330987 0.0335517 0.0339528 - 0.0343144 0.0346593 0.0343748 0.0339013 0.0336261 0.0337258 0.0338751 0.0339952 0.0340149 0.0340272 0.0340391 0.0340508 - 0.0319723 0.0320349 0.0320473 0.0321908 0.0326231 0.0331549 0.0336248 0.0340354 0.0344 0.0347428 0.0344431 0.0339505 - 0.0336539 0.0337516 0.0339002 0.0340001 0.0340167 0.0340288 0.0340404 0.0340513 0.0319793 0.0320538 0.0320822 0.0322155 - 0.0326523 0.0332097 0.033697 0.0341178 0.0344865 0.0348283 0.0345133 0.0340002 0.0336815 0.0337781 0.0339262 0.0340037 - 0.0340185 0.0340306 0.0340419 0.034052 0.0319883 0.0320733 0.0321143 0.0322416 0.0326823 0.0332614 0.0337647 0.0341965 - 0.0345706 0.0349126 0.0345818 0.0340454 0.0337085 0.0338056 0.033951 0.0340061 0.0340204 0.0340327 0.0340437 0.034053 - 0.0320012 0.0320938 0.0321249 0.0322491 0.0326887 0.0332771 0.0337917 0.0342326 0.0346125 0.0349562 0.0346089 0.0340316 - 0.0337337 0.0338347 0.0339681 0.0340078 0.0340226 0.034035 0.0340459 0.0340546 + <DataArray type="Float32" Name="x^H2O_Air" NumberOfComponents="1" format="ascii"> + 0.0318173 0.0316397 0.0315256 0.0316863 0.0320712 0.0324759 0.0328808 0.0332773 0.0336684 0.0340673 0.0339349 0.0336212 + 0.0334729 0.0335816 0.0337321 0.0338941 0.0340049 0.0340192 0.0340316 0.0340466 0.0319182 0.0318467 0.031757 0.0319267 + 0.03232 0.0327291 0.0331267 0.0335062 0.0338731 0.0342433 0.0340503 0.03368 0.0335047 0.0336129 0.0337648 0.0339323 + 0.0340078 0.0340211 0.0340337 0.0340481 0.0319417 0.0319234 0.0318586 0.0320334 0.0324392 0.0328692 0.0332773 0.0336586 + 0.0340201 0.0343796 0.0341525 0.0337443 0.0335364 0.0336429 0.0337956 0.0339623 0.0340098 0.0340227 0.0340353 0.0340491 + 0.0319526 0.0319649 0.0319231 0.0320938 0.0325089 0.0329636 0.033386 0.0337732 0.0341341 0.0344879 0.0342382 0.0338039 + 0.0335681 0.033672 0.0338241 0.0339784 0.0340115 0.0340241 0.0340367 0.0340497 0.03196 0.0319932 0.0319723 0.0321336 + 0.0325553 0.0330368 0.0334757 0.0338712 0.0342336 0.0345837 0.0343159 0.03386 0.0335997 0.0337008 0.0338514 0.0339884 + 0.0340131 0.0340256 0.0340379 0.0340503 0.0319663 0.0320157 0.0320137 0.0321634 0.0325907 0.0331002 0.0335574 0.0339626 + 0.0343277 0.0346753 0.0343906 0.0339143 0.0336311 0.0337297 0.0338789 0.0339953 0.0340147 0.0340271 0.0340391 0.0340508 + 0.0319724 0.0320355 0.0320511 0.0321884 0.0326211 0.0331599 0.0336365 0.0340526 0.0344214 0.0347672 0.034466 0.0339686 + 0.0336624 0.033759 0.0339076 0.0340003 0.0340165 0.0340288 0.0340404 0.0340513 0.0319792 0.0320544 0.0320864 0.0322124 + 0.0326499 0.0332182 0.0337148 0.0341428 0.0345164 0.034861 0.034543 0.0340224 0.0336935 0.0337889 0.0339363 0.0340038 + 0.0340183 0.0340305 0.0340419 0.034052 0.0319878 0.0320736 0.03212 0.0322381 0.0326791 0.0332735 0.0337886 0.0342289 + 0.0346086 0.0349536 0.0346181 0.0340712 0.0337239 0.0338197 0.0339609 0.0340062 0.0340202 0.0340326 0.0340436 0.034053 + 0.032 0.0320933 0.0321335 0.032251 0.032693 0.033301 0.0338285 0.0342779 0.0346626 0.0350082 0.0346518 0.0340564 + 0.0337523 0.0338525 0.033975 0.0340077 0.0340224 0.0340349 0.0340458 0.0340545 </DataArray> - <DataArray type="Float32" Name="x^Air_gas" NumberOfComponents="1" format="ascii"> - 0.968173 0.968332 -70.9746 -68.3035 -65.3168 -61.2406 -55.893 -49.2358 -41.441 -32.9006 -17.7204 -6.08057 - 0.966514 0.966404 0.966253 0.966089 0.965994 0.965981 0.965969 0.965953 0.968081 0.968144 -64.4717 -73.971 - -71.1912 -67.097 -61.4743 -54.3161 -45.8523 -36.541 -19.8054 -6.72873 0.966486 0.966376 0.966224 0.966056 - 0.965992 0.965979 0.965966 0.965952 0.968058 0.968073 -47.9588 -76.5232 -74.1101 -70.2776 -64.7538 -57.5276 - -48.8451 -39.1925 -21.5685 -7.54827 0.966458 0.96635 0.966197 0.966033 0.96599 0.965977 0.965965 0.965951 - 0.968048 0.968034 -37.2343 -78.0503 -75.961 -72.4084 -67.0335 -59.8202 -51.0219 -41.1464 -22.9194 -8.25282 - 0.96643 0.966325 0.966173 0.96602 0.965988 0.965976 0.965963 0.96595 0.96804 0.968007 -29.5813 -79.1242 - -77.3306 -74.0713 -68.8727 -61.7085 -52.8383 -42.7895 -24.0685 -8.87018 0.966402 0.9663 0.966149 0.966011 - 0.965987 0.965974 0.965962 0.96595 0.968034 0.967985 -23.4068 -79.9625 -78.4607 -75.5154 -70.5227 -63.4374 - -54.5216 -44.3224 -25.1429 -9.44185 0.966374 0.966274 0.966125 0.966005 0.965985 0.965973 0.965961 0.965949 - 0.968028 0.967965 -18.4398 -80.6552 -79.4532 -76.847 -72.094 -65.1219 -56.1898 -45.8615 -26.2331 -10.0168 - 0.966346 0.966248 0.9661 0.966 0.965983 0.965971 0.96596 0.965949 0.968021 0.967946 -13.9412 -81.2448 - -80.3391 -78.0831 -73.6009 -66.7834 -57.8737 -47.445 -27.37 -10.604 0.966318 0.966222 0.966074 0.965996 - 0.965982 0.965969 0.965958 0.965948 0.968012 0.967927 -10.34 -81.7141 -81.072 -79.1346 -74.9342 -68.3107 - -59.4735 -48.9898 -28.4598 -11.0695 0.966291 0.966194 0.966049 0.965994 0.96598 0.965967 0.965956 0.965947 - 0.967999 0.967906 -11.5489 -81.4263 -80.8249 -79.0788 -75.0992 -68.6569 -59.9197 -49.4345 -28.4288 -9.94541 - 0.966266 0.966165 0.966032 0.965992 0.965977 0.965965 0.965954 0.965945 + <DataArray type="Float32" Name="x^Air_Air" NumberOfComponents="1" format="ascii"> + 0.968183 0.96836 -70.3392 -67.6611 -64.6315 -60.5231 -55.1722 -48.5506 -40.8301 -32.3934 -17.4562 -6.05809 + 0.966527 0.966418 0.966268 0.966106 0.965995 0.965981 0.965968 0.965953 0.968082 0.968153 -69.8296 -73.7424 + -70.9156 -66.7807 -61.1371 -53.9846 -45.5531 -36.2952 -19.6991 -6.77611 0.966495 0.966387 0.966235 0.966068 + 0.965992 0.965979 0.965966 0.965952 0.968058 0.968077 -49.7629 -76.4473 -74.0071 -70.1536 -64.6247 -57.4107 + -48.7554 -39.1397 -21.5902 -7.64726 0.966464 0.966357 0.966204 0.966038 0.96599 0.965977 0.965965 0.965951 + 0.968047 0.968035 -37.4238 -78.0503 -75.9631 -72.4136 -67.0523 -59.8617 -51.0909 -41.242 -23.0448 -8.39503 + 0.966432 0.966328 0.966176 0.966022 0.965989 0.965976 0.965963 0.96595 0.96804 0.968007 -29.0563 -79.1636 + -77.3998 -74.1744 -69.0132 -61.8857 -53.0459 -43.0158 -24.2876 -9.0545 0.9664 0.966299 0.966149 0.966012 + 0.965987 0.965974 0.965962 0.96595 0.968034 0.967984 -22.5456 -80.0249 -78.5792 -75.7027 -70.7755 -63.7436 + -54.8627 -44.6751 -25.4528 -9.66669 0.966369 0.96627 0.966121 0.966005 0.965985 0.965973 0.965961 0.965949 + 0.968028 0.967965 -17.3191 -80.7348 -79.6136 -77.1135 -72.4571 -65.5578 -56.6663 -46.3433 -26.6352 -10.2803 + 0.966338 0.966241 0.966092 0.966 0.965984 0.965971 0.96596 0.965949 0.968021 0.967946 -12.701 -81.3385 + -80.5364 -78.427 -74.0752 -67.3512 -58.4885 -48.0578 -27.8576 -10.8827 0.966307 0.966211 0.966064 0.965996 + 0.965982 0.965969 0.965958 0.965948 0.968012 0.967926 -8.75524 -81.8236 -81.2959 -79.5465 -75.5099 -69.0009 + -60.2179 -49.7266 -29.0219 -11.3445 0.966276 0.96618 0.966039 0.965994 0.96598 0.965967 0.965956 0.965947 + 0.968 0.967907 -8.82208 -81.6963 -81.2823 -79.7588 -75.9488 -69.608 -60.8971 -50.3644 -29.0651 -10.0936 + 0.966248 0.966147 0.966025 0.965992 0.965978 0.965965 0.965954 0.965945 </DataArray> - <DataArray type="Float32" Name="x^NaCl_gas" NumberOfComponents="1" format="ascii"> - 2.42669e-10 6.82021e-10 7.53216e-09 7.60095e-09 7.73207e-09 7.87847e-09 8.03647e-09 8.20427e-09 8.38112e-09 8.5668e-09 8.67722e-09 8.70608e-09 - 8.73553e-09 8.76411e-09 8.80353e-09 8.84615e-09 8.87087e-09 8.87428e-09 8.87755e-09 8.88149e-09 5.44961e-11 2.79973e-10 6.48242e-09 7.60424e-09 - 7.73521e-09 7.88298e-09 8.04187e-09 8.21031e-09 8.38768e-09 8.57383e-09 8.68454e-09 8.71345e-09 8.74281e-09 8.77128e-09 8.811e-09 8.85482e-09 - 8.8715e-09 8.8748e-09 8.87811e-09 8.88189e-09 2.06336e-11 1.49802e-10 4.8161e-09 7.60566e-09 7.73589e-09 7.88621e-09 8.04656e-09 8.21596e-09 - 8.39403e-09 8.58078e-09 8.69181e-09 8.72076e-09 8.7501e-09 8.77811e-09 8.81796e-09 8.86077e-09 8.87196e-09 8.87524e-09 8.87854e-09 8.88214e-09 - 1.09592e-11 9.11052e-11 3.74884e-09 7.60589e-09 7.73499e-09 7.88849e-09 8.05071e-09 8.22131e-09 8.40023e-09 8.58765e-09 8.69905e-09 8.72805e-09 - 8.75739e-09 8.78474e-09 8.82437e-09 8.86414e-09 8.87237e-09 8.87564e-09 8.87891e-09 8.88232e-09 6.79176e-12 5.88055e-11 2.99079e-09 7.60559e-09 - 7.73328e-09 7.89019e-09 8.05452e-09 8.22646e-09 8.40632e-09 8.59449e-09 8.70626e-09 8.73531e-09 8.76467e-09 8.79131e-09 8.83055e-09 8.86643e-09 - 8.87279e-09 8.87604e-09 8.87924e-09 8.88246e-09 4.67873e-12 3.91023e-11 2.3839e-09 7.6052e-09 7.73129e-09 7.89169e-09 8.05821e-09 8.23155e-09 - 8.41238e-09 8.6013e-09 8.71346e-09 8.74256e-09 8.77193e-09 8.79792e-09 8.83681e-09 8.86811e-09 8.87324e-09 8.87645e-09 8.87956e-09 8.88259e-09 - 3.55214e-12 2.65432e-11 1.89745e-09 7.60512e-09 7.72951e-09 7.89339e-09 8.06202e-09 8.23671e-09 8.41847e-09 8.60813e-09 8.72067e-09 8.7498e-09 - 8.77917e-09 8.80464e-09 8.84335e-09 8.86938e-09 8.8737e-09 8.87688e-09 8.8799e-09 8.88274e-09 2.95796e-12 1.85314e-11 1.46216e-09 7.60582e-09 - 7.7285e-09 7.89567e-09 8.06618e-09 8.24207e-09 8.42468e-09 8.61502e-09 8.72791e-09 8.75704e-09 8.78636e-09 8.81154e-09 8.85013e-09 8.87031e-09 - 8.87417e-09 8.87734e-09 8.88028e-09 8.88292e-09 2.65807e-12 1.37082e-11 1.1176e-09 7.60805e-09 7.7292e-09 7.89895e-09 8.07089e-09 8.24773e-09 - 8.43104e-09 8.62198e-09 8.73518e-09 8.76429e-09 8.7934e-09 8.81869e-09 8.8566e-09 8.87096e-09 8.87467e-09 8.87787e-09 8.88074e-09 8.88317e-09 - 2.51575e-12 1.15937e-11 1.25585e-09 7.61283e-09 7.73329e-09 7.90356e-09 8.0763e-09 8.25378e-09 8.43762e-09 8.62904e-09 8.74253e-09 8.77161e-09 - 8.79997e-09 8.82628e-09 8.86105e-09 8.87138e-09 8.87524e-09 8.87849e-09 8.88132e-09 8.88358e-09 + <DataArray type="Float32" Name="x^NaCl_Air" 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 </DataArray> - <DataArray type="Float32" Name="m^H2O_liquid" NumberOfComponents="1" format="ascii"> - 51358.1 51124.3 49992.6 49801.5 49564.3 49268 48909.1 48491.2 48028.3 47544.4 46760.2 46174.8 - 45821.7 45821.3 45820.6 45820 45819.6 45819.5 45819.4 45819.4 51452 51338.7 50600.9 50122 - 49891.3 49587.6 49207.6 48757.4 48254.6 47727.2 46863.7 46206.7 45821.6 45821.2 45820.5 45819.8 - 45819.5 45819.5 45819.4 45819.4 51468.4 51404.5 51105 50266.2 50054.1 49760.4 49381.9 48924.6 - 48407.3 47859.7 46950.9 46247.2 45821.5 45821 45820.4 45819.7 45819.5 45819.5 45819.4 45819.4 - 51473 51433.5 51339.4 50352.8 50158 49876.1 49502.6 49043.3 48517.6 47956.7 47017.4 46281.9 - 45821.4 45820.9 45820.3 45819.7 45819.5 45819.5 45819.4 45819.4 51475 51449.2 51459.8 50414 - 50235.5 49966.3 49599.6 49140.6 48609.2 48037.8 47073.6 46312.1 45821.3 45820.8 45820.2 45819.6 - 45819.5 45819.5 45819.4 45819.4 51476 51458.7 51524.2 50461.9 50299.9 50044.6 49686.3 49229.3 - 48693.8 48113.3 47126.1 46340.1 45821.1 45820.7 45820.1 45819.6 45819.5 45819.5 45819.4 45819.4 - 51476.4 51464.6 51554.4 50501.3 50356.4 50116.6 49768.7 49315.7 48777.5 48188.9 47179.2 46368.1 - 45821 45820.6 45820 45819.6 45819.5 45819.5 45819.4 45819.4 51476.7 51468.3 51562 50534.3 - 50406.5 50182.9 49847.4 49400.5 48861.8 48266.6 47234.6 46396.7 45820.9 45820.5 45819.9 45819.6 - 45819.5 45819.4 45819.4 45819.4 51476.7 51470.5 51554 50559.5 50447.1 50238.6 49916.4 49478.1 - 48941.6 48342.2 47287.5 46419.3 45820.8 45820.4 45819.8 45819.6 45819.5 45819.4 45819.4 45819.4 - 51476.7 51471.3 51544.1 50540.1 50430.8 50232.9 49922.4 49493.5 48961.9 48362.4 47284.6 46362.9 - 45820.7 45820.3 45819.7 45819.5 45819.5 45819.4 45819.4 45819.4 + <DataArray type="Float32" Name="m^H2O_brine" NumberOfComponents="1" format="ascii"> + 51344.7 51084.1 50210.9 50007.8 49754.2 49438.1 49057 48615.2 48127.9 47620 46800.4 46192.1 + 45818.9 45818.5 45817.8 45817.2 45816.7 45816.7 45816.6 45816.6 51450.4 51326.3 50670.5 50374.6 + 50126.9 49801.9 49396.6 48918.2 48385.5 47828.2 46918.6 46229.6 45818.8 45818.3 45817.7 45817 + 45816.7 45816.7 45816.6 45816.5 51467.7 51399.2 51147.6 50537.6 50310.6 49997.2 49594.1 49108 + 48559.2 47979.2 47017.8 46275.2 45818.6 45818.2 45817.6 45816.9 45816.7 45816.6 45816.6 45816.5 + 51472.7 51430.8 51365.4 50634.7 50427.7 50127.8 49730.8 49243 48685.1 48090 47093.7 46314.2 + 45818.5 45818.1 45817.5 45816.8 45816.7 45816.6 45816.6 45816.5 51474.8 51447.8 51473.7 50702.5 + 50514.5 50229.6 49840.9 49353.9 48789.9 48183.1 47158.3 46348.5 45818.4 45818 45817.3 45816.8 + 45816.7 45816.6 45816.6 45816.5 51475.8 51457.9 51529.4 50755.1 50586.3 50318 49939.6 49455.4 + 48886.9 48269.8 47218.6 46380.2 45818.3 45817.8 45817.2 45816.8 45816.7 45816.6 45816.6 45816.5 + 51476.4 51464.3 51553.8 50798.4 50649.4 50399.3 50033.5 49554.3 48983.1 48356.8 47279.7 46411.9 + 45818.1 45817.7 45817.1 45816.7 45816.7 45816.6 45816.6 45816.5 51476.6 51468.3 51556.9 50834.8 + 50705.3 50474.5 50123.5 49651.7 49080 48446.1 47342.8 46442.9 45818 45817.6 45817 45816.7 + 45816.7 45816.6 45816.6 45816.5 51476.7 51470.6 51544.7 50862.9 50750.5 50537.7 50202.5 49740.8 + 49171.7 48532.8 47402.7 46466.5 45817.9 45817.5 45816.9 45816.7 45816.7 45816.6 45816.6 45816.5 + 51476.7 51471.6 51531.5 50852 50747.2 50547 50224.1 49771.4 49205.7 48564.2 47403.3 46400 + 45817.8 45817.3 45816.8 45816.7 45816.6 45816.6 45816.6 45816.5 </DataArray> - <DataArray type="Float32" Name="m^Air_liquid" NumberOfComponents="1" format="ascii"> - 58.2288 58.2632 -4191.57 -3997.58 -3758.14 -3458.39 -3094.67 -2670.67 -2200.77 -1709.62 -909.409 -311.107 - 49.292 49.125 48.8965 48.6517 48.5108 48.4914 48.4728 48.4505 58.1614 58.1522 -3827.98 -4326.6 - -4093.71 -3786.26 -3400.83 -2943.64 -2432.82 -1897.04 -1015.5 -343.972 49.2494 49.0833 48.8534 48.6021 - 48.5072 48.4884 48.4697 48.4482 58.1367 58.0928 -2867.25 -4474.66 -4260.77 -3963.71 -3579.81 -3115.24 - -2589.43 -2032.9 -1104.92 -385.534 49.2068 49.0436 48.8133 48.5683 48.5046 48.486 48.4672 48.4468 - 58.1218 58.0516 -2231.93 -4563.58 -4367.44 -4082.44 -3703.67 -3237.06 -2702.67 -2132.42 -1173.11 -421.159 - 49.1642 49.0052 48.7765 48.549 48.5022 48.4837 48.4651 48.4458 58.1101 58.0181 -1774.66 -4626.38 - -4446.97 -4175.07 -3803.27 -3336.96 -2796.7 -2215.71 -1230.86 -452.279 49.1218 48.9671 48.741 48.536 - 48.4998 48.4814 48.4633 48.445 58.0994 57.9876 -1404.2 -4675.5 -4512.95 -4255.46 -3892.4 -3428.15 - -2883.58 -2293.16 -1284.7 -481.02 49.0795 48.9289 48.7051 48.5265 48.4973 48.4791 48.4614 48.4442 - 58.0883 57.9577 -1105.6 -4715.94 -4570.95 -4329.39 -3977.05 -3516.8 -2969.51 -2370.8 -1339.25 -509.88 - 49.0374 48.8901 48.6677 48.5193 48.4947 48.4767 48.4595 48.4434 58.0754 57.9266 -835.088 -4749.89 - -4622.39 -4397.58 -4057.9 -3604 -3056.1 -2450.59 -1396.09 -539.315 48.9958 48.8503 48.6289 48.5139 - 48.492 48.474 48.4573 48.4424 58.0585 57.8926 -618.658 -4775.84 -4664.02 -4454.8 -4128.82 -3683.72 - -3138.05 -2528.23 -1450.43 -562.512 48.955 48.8091 48.592 48.5103 48.4892 48.471 48.4547 48.441 - 58.0342 57.8553 -690.628 -4756.07 -4647.38 -4449.06 -4135.11 -3699.62 -3159.09 -2549.06 -1447.63 -504.983 - 48.9171 48.7655 48.5667 48.5078 48.4859 48.4675 48.4515 48.4386 + <DataArray type="Float32" Name="m^Air_brine" NumberOfComponents="1" format="ascii"> + 58.2312 58.2716 -4175.41 -3979.89 -3737.02 -3433.9 -3067.92 -2643.53 -2175.3 -1687.62 -897.263 -310.21 + 49.3096 49.144 48.9165 48.6737 48.5091 48.4879 48.4697 48.4475 58.1604 58.1547 -4152.61 -4336.51 + -4099.28 -3787.29 -3397.73 -2937.52 -2425.19 -1889.4 -1011.66 -346.653 49.261 49.0965 48.8673 48.6168 + 48.5048 48.4852 48.4665 48.4452 58.1358 58.0928 -2977.63 -4495.1 -4277.87 -3977.15 -3589.6 -3121.87 + -2593.73 -2035.8 -1107.8 -390.859 49.2126 49.051 48.8209 48.5723 48.5018 48.4828 48.4641 48.4437 + 58.1211 58.0506 -2244.29 -4589.52 -4391.74 -4104.21 -3722.56 -3253.02 -2715.92 -2143.35 -1181.38 -428.683 + 49.1645 49.007 48.7783 48.5484 48.4994 48.4806 48.4621 48.4428 58.1095 58.0166 -1743.48 -4655.45 + -4476.1 -4203.22 -3829.61 -3360.84 -2817.7 -2233.66 -1243.98 -461.933 49.1165 48.9635 48.7375 48.5336 + 48.497 48.4784 48.4603 48.442 58.0989 57.986 -1352.53 -4706.62 -4545.83 -4289.14 -3925.59 -3459.52 + -2912 -2317.86 -1302.49 -492.712 49.0688 48.92 48.6964 48.5233 48.4945 48.4762 48.4585 48.4412 + 58.088 57.9562 -1038.27 -4748.73 -4607.11 -4368.26 -4016.95 -3555.67 -3005.44 -2402.38 -1361.77 -523.51 + 49.0215 48.876 48.6537 48.5159 48.492 48.4738 48.4566 48.4404 58.0756 57.9254 -760.621 -4784.1 + -4661.54 -4441.48 -4104.49 -3650.46 -3099.67 -2489.13 -1422.99 -553.677 48.9746 48.8311 48.6109 48.5107 + 48.4893 48.4711 48.4544 48.4394 58.0594 57.8923 -523.652 -4811.46 -4705.48 -4503.02 -4181.43 -3737.15 + -3188.76 -2573.35 -1481.12 -576.639 48.9288 48.7849 48.5743 48.5072 48.4864 48.4682 48.4518 48.438 + 58.0365 57.8565 -527.293 -4801 -4702.39 -4512.14 -4202.58 -3766.95 -3221.93 -2603.97 -1481.91 -512.544 + 48.8861 48.7358 48.5534 48.5049 48.4832 48.4647 48.4486 48.4357 </DataArray> - <DataArray type="Float32" Name="m^NaCl_liquid" NumberOfComponents="1" format="ascii"> - 162.759 457.63 4960.66 4960.99 4961.24 4961.61 4962.13 4962.79 4963.54 4964.33 4966.07 4967.46 - 4968.26 4968.19 4968.1 4968 4967.94 4967.93 4967.92 4967.91 36.5119 187.537 4292.24 4960.06 - 4960.3 4960.71 4961.29 4962.05 4962.92 4963.84 4965.79 4967.36 4968.24 4968.17 4968.08 4967.98 - 4967.94 4967.93 4967.92 4967.91 13.8188 100.248 3211 4959.63 4959.84 4960.21 4960.8 4961.58 - 4962.5 4963.47 4965.55 4967.25 4968.22 4968.16 4968.06 4967.96 4967.93 4967.93 4967.92 4967.91 - 7.33785 60.9275 2505.99 4959.38 4959.54 4959.88 4960.45 4961.24 4962.18 4963.2 4965.36 4967.14 - 4968.21 4968.14 4968.05 4967.95 4967.93 4967.93 4967.92 4967.91 4.5466 39.3051 2000.93 4959.2 - 4959.33 4959.61 4960.16 4960.96 4961.92 4962.96 4965.2 4967.05 4968.19 4968.12 4968.03 4967.95 - 4967.93 4967.92 4967.92 4967.91 3.13152 26.1226 1594.85 4959.06 4959.15 4959.39 4959.91 4960.69 - 4961.67 4962.75 4965.04 4966.96 4968.17 4968.11 4968.02 4967.94 4967.93 4967.92 4967.92 4967.91 - 2.37705 17.7236 1268.69 4958.94 4958.99 4959.17 4959.67 4960.44 4961.43 4962.53 4964.89 4966.87 - 4968.15 4968.09 4968 4967.94 4967.93 4967.92 4967.92 4967.91 1.979 12.3675 976.726 4958.84 - 4958.85 4958.98 4959.43 4960.19 4961.18 4962.3 4964.73 4966.78 4968.14 4968.08 4967.99 4967.94 - 4967.93 4967.92 4967.92 4967.91 1.77786 9.14337 745.7 4958.75 4958.73 4958.81 4959.22 4959.96 - 4960.95 4962.08 4964.58 4966.71 4968.12 4968.06 4967.97 4967.94 4967.93 4967.92 4967.91 4967.91 - 1.68199 7.72817 837.5 4958.8 4958.76 4958.81 4959.19 4959.9 4960.87 4962.01 4964.57 4966.83 - 4968.1 4968.04 4967.96 4967.94 4967.93 4967.92 4967.91 4967.91 + <DataArray type="Float32" Name="m^NaCl_brine" NumberOfComponents="1" format="ascii"> + 180.399 506.226 4986.06 4985.25 4984.09 4982.68 4981.04 4979.16 4977.09 4974.9 4971.74 4969.43 + 4967.95 4967.89 4967.8 4967.7 4967.63 4967.62 4967.61 4967.6 38.7181 203.877 4628.41 4986.35 + 4985.22 4983.8 4982.1 4980.13 4977.93 4975.6 4972.14 4969.55 4967.93 4967.87 4967.78 4967.67 + 4967.63 4967.62 4967.61 4967.6 14.7448 107.383 3324.7 4986.82 4985.77 4984.39 4982.71 4980.73 + 4978.49 4976.09 4972.48 4969.7 4967.91 4967.85 4967.76 4967.66 4967.63 4967.62 4967.61 4967.6 + 7.80497 64.5094 2518.44 4987.1 4986.12 4984.79 4983.12 4981.14 4978.89 4976.45 4972.73 4969.83 + 4967.9 4967.83 4967.74 4967.65 4967.63 4967.62 4967.61 4967.6 4.80415 41.2498 1968.41 4987.3 + 4986.39 4985.09 4983.45 4981.48 4979.21 4976.75 4972.94 4969.94 4967.88 4967.81 4967.72 4967.64 + 4967.62 4967.62 4967.61 4967.6 3.27634 27.1634 1541.12 4987.45 4986.61 4985.35 4983.74 4981.78 + 4979.51 4977.02 4973.14 4970.04 4967.86 4967.8 4967.71 4967.64 4967.62 4967.62 4967.61 4967.6 + 2.45649 18.1924 1198.8 4987.57 4986.8 4985.59 4984.02 4982.08 4979.8 4977.29 4973.33 4970.13 + 4967.84 4967.78 4967.69 4967.63 4967.62 4967.62 4967.61 4967.6 2.02057 12.4467 899.138 4987.68 + 4986.97 4985.81 4984.28 4982.37 4980.1 4977.57 4973.54 4970.23 4967.82 4967.76 4967.67 4967.63 + 4967.62 4967.61 4967.61 4967.6 1.79868 8.95331 645.61 4987.75 4987.1 4985.99 4984.51 4982.63 + 4980.37 4977.84 4973.73 4970.3 4967.8 4967.74 4967.66 4967.63 4967.62 4967.61 4967.61 4967.6 + 1.69238 7.37745 664.834 4987.7 4987.08 4986 4984.56 4982.7 4980.46 4977.92 4973.71 4970.03 + 4967.78 4967.72 4967.65 4967.63 4967.62 4967.61 4967.61 4967.6 </DataArray> <DataArray type="Float32" Name="phasePresence" NumberOfComponents="1" format="ascii"> 3 3 1 1 1 1 1 1 1 1 1 1 @@ -384,127 +384,127 @@ 3 3 3 3 3 3 3 3 </DataArray> <DataArray type="Float32" Name="precipitateVolumeFraction^NaCl" NumberOfComponents="1" format="ascii"> - 1.75112e-11 1.15125e-10 0.00675665 0.052462 0.0524843 0.0524949 0.0525045 0.0525126 0.0525186 0.0525238 0.00462611 0.00463376 - 0.00465183 0.00470437 0.00470498 0.00470581 0.00470694 0.00470863 0.00471149 0.00471766 1.75112e-11 1.14988e-10 0.00110951 0.0519256 - 0.0524811 0.0524915 0.0525004 0.052509 0.0525155 0.0525211 0.00461146 0.00462107 0.00464866 0.00470439 0.004705 0.00470583 - 0.00470695 0.00470863 0.00471148 0.00471765 1.75112e-11 1.14629e-10 0.000361002 0.050029 0.0524798 0.0524899 0.0524978 0.0525074 - 0.0525144 0.0525201 0.00460399 0.00461365 0.0046419 0.00470441 0.00470502 0.00470585 0.00470694 0.00470863 0.00471148 0.00471763 - 1.75112e-11 1.14373e-10 0.0001803 0.0478073 0.0524787 0.0524872 0.0524963 0.0525064 0.0525138 0.0525185 0.0046009 0.00460972 - 0.0046356 0.00470441 0.00470502 0.00470585 0.00470694 0.00470863 0.00471147 0.00471761 1.75112e-11 1.14154e-10 0.00010721 0.0455464 - 0.0524778 0.0524851 0.0524952 0.0525056 0.0525131 0.0525173 0.00459894 0.00460716 0.00463003 0.00470442 0.00470503 0.00470585 - 0.00470694 0.00470862 0.00471146 0.00471759 1.75112e-11 1.13944e-10 6.68885e-05 0.0430938 0.0524766 0.0524834 0.0524942 0.0525048 - 0.0525115 0.0525164 0.00459716 0.00460494 0.00462497 0.00470442 0.00470504 0.00470584 0.00470694 0.00470862 0.00471145 0.00471757 - 1.75112e-11 1.13723e-10 4.68893e-05 0.0402094 0.0524746 0.0524815 0.0524931 0.052504 0.05251 0.0525155 0.00459526 0.0046026 - 0.00462 0.00470443 0.00470504 0.00470584 0.00470693 0.00470862 0.00471144 0.00471755 1.75112e-11 1.13462e-10 2.96641e-05 0.0364341 - 0.0524723 0.0524795 0.0524919 0.0525021 0.0525086 0.0525148 0.00459309 0.00459982 0.00461511 0.00470443 0.00470505 0.00470583 - 0.00470693 0.00470861 0.00471143 0.00471753 1.75112e-11 1.13097e-10 1.73332e-05 0.0311106 0.0524693 0.0524774 0.0524906 0.0524997 - 0.0525073 0.052514 0.00458967 0.00459499 0.00461209 0.00470444 0.00470506 0.00470583 0.00470693 0.00470861 0.00471143 0.00471752 - 1.74829e-11 1.12957e-10 1.81624e-05 0.033953 0.0524669 0.0524746 0.0524877 0.0524972 0.0525048 0.0525113 0.00456904 0.00457137 - 0.00463074 0.00470447 0.00470509 0.00470584 0.00470694 0.00470862 0.00471143 0.00471751 + 1.75084e-11 1.1511e-10 0.009909 0.0524624 0.0524846 0.0524952 0.0525051 0.052513 0.0525188 0.0525239 0.0046277 0.00463534 + 0.00465039 0.00470363 0.00470423 0.00470506 0.0047062 0.00470789 0.00471074 0.00471691 1.75084e-11 1.14986e-10 0.00155348 0.0522602 + 0.0524809 0.0524914 0.0525005 0.0525089 0.0525153 0.0525209 0.0046123 0.00462211 0.00464665 0.00470365 0.00470426 0.00470509 + 0.0047062 0.00470789 0.00471074 0.0047169 1.75084e-11 1.14617e-10 0.000411956 0.0503833 0.0524795 0.0524898 0.0524975 0.052507 + 0.0525141 0.0525199 0.00460379 0.00461395 0.00463949 0.00470366 0.00470427 0.00470511 0.0047062 0.00470789 0.00471073 0.00471688 + 1.75084e-11 1.14356e-10 0.000191181 0.0479573 0.0524783 0.0524869 0.0524959 0.052506 0.0525134 0.0525181 0.00460018 0.00460943 + 0.00463287 0.00470367 0.00470428 0.00470511 0.0047062 0.00470789 0.00471073 0.00471686 1.75084e-11 1.14134e-10 0.00010817 0.0454899 + 0.0524773 0.0524847 0.0524947 0.0525051 0.0525125 0.0525168 0.00459798 0.00460648 0.00462698 0.00470368 0.00470429 0.0047051 + 0.0047062 0.00470788 0.00471072 0.00471684 1.75084e-11 1.13921e-10 6.53787e-05 0.0428295 0.052476 0.0524827 0.0524936 0.0525042 + 0.0525108 0.0525158 0.00459603 0.00460396 0.00462166 0.00470368 0.0047043 0.0047051 0.00470619 0.00470788 0.00471071 0.00471682 + 1.75084e-11 1.13697e-10 4.35929e-05 0.0396778 0.0524739 0.0524807 0.0524924 0.0525034 0.0525093 0.0525149 0.00459392 0.00460131 + 0.00461649 0.00470369 0.0047043 0.00470509 0.00470619 0.00470788 0.0047107 0.0047168 1.75084e-11 1.1343e-10 2.69082e-05 0.0354205 + 0.0524714 0.0524786 0.0524911 0.052501 0.0525078 0.0525141 0.00459148 0.00459786 0.00461151 0.0047037 0.00470431 0.00470509 + 0.00470619 0.00470787 0.00471069 0.00471679 1.75084e-11 1.13054e-10 1.5053e-05 0.0288829 0.0524681 0.0524765 0.0524897 0.0524985 + 0.0525064 0.0525133 0.00458749 0.00459227 0.00460911 0.00470371 0.00470432 0.00470509 0.00470619 0.00470787 0.00471068 0.00471677 + 1.74796e-11 1.12929e-10 1.39641e-05 0.0293363 0.0524654 0.0524732 0.0524864 0.0524957 0.0525035 0.0525101 0.00456389 0.00456505 + 0.00463029 0.00470374 0.00470435 0.0047051 0.0047062 0.00470787 0.00471069 0.00471676 </DataArray> - <DataArray type="Float32" Name="velocity_liquid (m/s)" NumberOfComponents="3" format="ascii"> - 7.15746e-08 -4.00371e-07 0 6.16053e-07 -1.45855e-07 0 8.07379e-07 -8.76403e-08 0 8.84768e-07 -3.13402e-08 0 - 9.50998e-07 -3.48411e-08 0 1.00442e-06 -1.85087e-08 0 1.03281e-06 -9.80071e-09 0 1.04787e-06 -5.16758e-09 0 - 1.05572e-06 -2.59387e-09 0 1.05939e-06 -9.87821e-10 0 1.06444e-06 -3.98581e-09 0 1.07568e-06 -7.22426e-09 0 - 1.0341e-06 -1.73327e-08 0 9.8264e-07 -1.93963e-08 0 9.36149e-07 -6.49122e-09 0 5.99225e-07 2.38255e-08 0 - 1.5377e-07 -1.77405e-09 0 8.41656e-10 -1.01206e-09 0 3.12085e-10 -1.0005e-09 0 7.72697e-10 -9.36512e-10 0 - 4.08483e-07 -4.96525e-07 0 7.31308e-07 -2.1167e-07 0 8.70214e-07 -1.05115e-07 0 9.02771e-07 -4.6585e-08 0 - 9.61105e-07 -5.15235e-08 0 1.01117e-06 -2.68239e-08 0 1.03668e-06 -1.41962e-08 0 1.05019e-06 -7.48601e-09 0 - 1.05725e-06 -3.7592e-09 0 1.06064e-06 -1.46946e-09 0 1.06538e-06 -5.83726e-09 0 1.07367e-06 -9.50552e-09 0 - 1.00672e-06 -1.7696e-08 0 9.19689e-07 -2.65383e-08 0 8.42745e-07 -1.45869e-08 0 4.45659e-07 6.62533e-09 0 - 5.52145e-08 -1.50503e-09 0 3.27372e-10 -1.01869e-09 0 2.4715e-10 -1.01022e-09 0 5.98285e-10 -9.4754e-10 0 - 6.62938e-07 -6.3858e-07 0 8.38875e-07 -3.19582e-07 0 9.34885e-07 -1.35318e-07 0 9.57176e-07 -7.54961e-08 0 - 9.89575e-07 -7.90565e-08 0 1.02389e-06 -4.14104e-08 0 1.04339e-06 -2.20253e-08 0 1.05399e-06 -1.16272e-08 0 - 1.05957e-06 -5.84619e-09 0 1.0623e-06 -2.3502e-09 0 1.06622e-06 -9.21136e-09 0 1.0724e-06 -1.33395e-08 0 - 9.96734e-07 -1.84369e-08 0 8.90416e-07 -3.75961e-08 0 7.68417e-07 -2.93318e-08 0 3.54236e-07 -1.20727e-08 0 - 1.73941e-08 -1.17304e-09 0 2.55414e-10 -1.02745e-09 0 2.40481e-10 -1.02501e-09 0 5.75663e-10 -9.63311e-10 0 - 8.7716e-07 -7.05347e-07 0 9.62777e-07 -3.83392e-07 0 1.0142e-06 -1.56298e-07 0 1.01603e-06 -9.94737e-08 0 - 1.02154e-06 -9.54637e-08 0 1.0403e-06 -5.14679e-08 0 1.05226e-06 -2.76122e-08 0 1.05898e-06 -1.46071e-08 0 - 1.06257e-06 -7.36292e-09 0 1.0644e-06 -3.02046e-09 0 1.06721e-06 -1.18303e-08 0 1.07175e-06 -1.60536e-08 0 - 9.90027e-07 -1.97042e-08 0 8.68666e-07 -4.26231e-08 0 6.97098e-07 -3.7352e-08 0 2.88057e-07 -1.15692e-08 0 - 6.75996e-09 -1.08675e-09 0 2.37569e-10 -1.03009e-09 0 2.32475e-10 -1.03258e-09 0 5.57938e-10 -9.70175e-10 0 - 1.07187e-06 -7.32199e-07 0 1.0939e-06 -4.09812e-07 0 1.09564e-06 -1.63588e-07 0 1.0678e-06 -1.17385e-07 0 - 1.05206e-06 -1.02867e-07 0 1.05836e-06 -5.65198e-08 0 1.06242e-06 -3.0485e-08 0 1.06473e-06 -1.61508e-08 0 - 1.06601e-06 -8.1653e-09 0 1.06674e-06 -3.40279e-09 0 1.06827e-06 -1.35451e-08 0 1.0713e-06 -1.80949e-08 0 - 9.83822e-07 -2.16855e-08 0 8.49196e-07 -4.2654e-08 0 6.31297e-07 -3.58217e-08 0 2.32294e-07 -7.83474e-09 0 - 3.01875e-09 -1.05267e-09 0 2.28879e-10 -1.02997e-09 0 2.23579e-10 -1.03559e-09 0 5.42446e-10 -9.72831e-10 0 - 1.26192e-06 -7.32278e-07 0 1.23032e-06 -4.04254e-07 0 1.18147e-06 -1.50373e-07 0 1.11868e-06 -1.29522e-07 0 - 1.08223e-06 -1.03315e-07 0 1.07698e-06 -5.6519e-08 0 1.07301e-06 -3.04396e-08 0 1.07074e-06 -1.61237e-08 0 - 1.06961e-06 -8.17034e-09 0 1.06916e-06 -3.44566e-09 0 1.06926e-06 -1.42447e-08 0 1.07072e-06 -1.9609e-08 0 - 9.77985e-07 -2.40835e-08 0 8.31558e-07 -3.90403e-08 0 5.68174e-07 -2.79301e-08 0 1.79949e-07 -4.93247e-09 0 - 1.45574e-09 -1.03655e-09 0 2.22408e-10 -1.02767e-09 0 2.14068e-10 -1.03473e-09 0 5.27455e-10 -9.7259e-10 0 - 1.46038e-06 -7.06434e-07 0 1.37288e-06 -3.69766e-07 0 1.27608e-06 -1.1519e-07 0 1.17559e-06 -1.33857e-07 0 - 1.11366e-06 -9.65812e-08 0 1.09528e-06 -5.13561e-08 0 1.08316e-06 -2.74633e-08 0 1.07648e-06 -1.45304e-08 0 - 1.07303e-06 -7.37598e-09 0 1.07145e-06 -3.13232e-09 0 1.06994e-06 -1.37821e-08 0 1.06965e-06 -2.06271e-08 0 - 9.73572e-07 -2.78634e-08 0 8.16902e-07 -3.29272e-08 0 5.06599e-07 -1.87647e-08 0 1.28707e-07 -3.04882e-09 0 - 7.61909e-10 -1.02741e-09 0 2.17217e-10 -1.0224e-09 0 2.04111e-10 -1.02941e-09 0 5.11453e-10 -9.68848e-10 0 - 1.68089e-06 -6.43344e-07 0 1.52011e-06 -3.07867e-07 0 1.39494e-06 -6.79949e-08 0 1.25829e-06 -1.21294e-07 0 - 1.14876e-06 -7.94273e-08 0 1.11203e-06 -4.08701e-08 0 1.09198e-06 -2.17649e-08 0 1.08143e-06 -1.15157e-08 0 - 1.076e-06 -5.85434e-09 0 1.07343e-06 -2.48385e-09 0 1.07007e-06 -1.19277e-08 0 1.06719e-06 -2.08639e-08 0 - 9.70726e-07 -3.5697e-08 0 8.04017e-07 -2.4191e-08 0 4.46342e-07 -1.35821e-08 0 7.99415e-08 -1.91327e-09 0 - 4.50827e-10 -1.01077e-09 0 2.13275e-10 -1.00465e-09 0 1.93694e-10 -1.01009e-09 0 4.9218e-10 -9.52424e-10 0 - 1.94011e-06 -5.10248e-07 0 1.65739e-06 -2.18282e-07 0 1.55506e-06 -4.46502e-08 0 1.39518e-06 -6.67172e-08 0 - 1.18843e-06 -4.44176e-08 0 1.12463e-06 -2.55255e-08 0 1.09843e-06 -1.38819e-08 0 1.08512e-06 -7.3757e-09 0 - 1.07826e-06 -3.74946e-09 0 1.07497e-06 -1.56339e-09 0 1.06952e-06 -8.37097e-09 0 1.06131e-06 -1.88456e-08 0 - 9.64324e-07 -4.9557e-08 0 7.80626e-07 -1.05639e-08 0 3.81832e-07 -9.39183e-09 0 3.69443e-08 -1.19046e-09 0 - 3.07686e-10 -9.0893e-10 0 2.07491e-10 -9.01703e-10 0 1.80498e-10 -9.04334e-10 0 4.60219e-10 -8.55912e-10 0 - 2.20857e-06 -4.20302e-07 0 1.62378e-06 -1.66375e-07 0 1.41244e-06 -4.55703e-08 0 1.27632e-06 -2.45004e-08 0 - 1.16573e-06 -2.12272e-08 0 1.12782e-06 -1.67703e-08 0 1.10167e-06 -9.4859e-09 0 1.08721e-06 -5.07084e-09 0 - 1.07966e-06 -2.57411e-09 0 1.07614e-06 -1.04634e-09 0 1.06904e-06 -6.12477e-09 0 1.04597e-06 -1.69744e-08 0 - 8.69583e-07 -5.80568e-08 0 5.71158e-07 -2.0933e-09 0 2.21224e-07 -6.20912e-09 0 5.26859e-09 -8.88843e-10 0 - 2.10192e-10 -8.19959e-10 0 1.72756e-10 -8.12933e-10 0 1.44442e-10 -8.13917e-10 0 3.59761e-10 -7.72858e-10 0 + <DataArray type="Float32" Name="velocity_brine (m/s)" NumberOfComponents="3" format="ascii"> + 1.0145e-07 -3.64313e-07 0 5.68981e-07 -1.04886e-07 0 7.51759e-07 -1.16476e-07 0 8.68073e-07 -3.78979e-08 0 + 9.42445e-07 -3.64281e-08 0 9.99304e-07 -2.03633e-08 0 1.03076e-06 -1.1017e-08 0 1.04775e-06 -5.88958e-09 0 + 1.05673e-06 -3.00484e-09 0 1.06104e-06 -1.20861e-09 0 1.06729e-06 -4.98108e-09 0 1.08052e-06 -8.22383e-09 0 + 1.04097e-06 -1.82453e-08 0 9.93683e-07 -2.07336e-08 0 9.56269e-07 -5.85922e-09 0 6.64431e-07 3.43525e-08 0 + 2.0653e-07 -2.58578e-09 0 1.43268e-09 -1.16248e-09 0 3.1931e-10 -1.1458e-09 0 7.93568e-10 -1.06905e-09 0 + 4.29679e-07 -4.52357e-07 0 7.21602e-07 -1.63325e-07 0 8.45648e-07 -1.37111e-07 0 8.8252e-07 -5.42358e-08 0 + 9.49661e-07 -5.529e-08 0 1.00616e-06 -2.97181e-08 0 1.03492e-06 -1.60008e-08 0 1.05028e-06 -8.54337e-09 0 + 1.05838e-06 -4.35805e-09 0 1.06234e-06 -1.79148e-09 0 1.06822e-06 -7.31089e-09 0 1.07858e-06 -1.10603e-08 0 + 1.01389e-06 -1.94116e-08 0 9.30896e-07 -2.83123e-08 0 8.65226e-07 -1.37856e-08 0 4.87128e-07 1.35896e-08 0 + 8.13248e-08 -2.04413e-09 0 4.03185e-10 -1.16855e-09 0 2.45532e-10 -1.15585e-09 0 5.96813e-10 -1.08029e-09 0 + 6.80564e-07 -5.82787e-07 0 8.44221e-07 -2.61221e-07 0 9.23971e-07 -1.64861e-07 0 9.38944e-07 -8.63149e-08 0 + 9.79258e-07 -8.71216e-08 0 1.01977e-06 -4.63261e-08 0 1.04227e-06 -2.49396e-08 0 1.05448e-06 -1.33032e-08 0 + 1.06093e-06 -6.78723e-09 0 1.06413e-06 -2.858e-09 0 1.06907e-06 -1.1595e-08 0 1.07719e-06 -1.59931e-08 0 + 1.00324e-06 -2.17721e-08 0 9.00502e-07 -4.03802e-08 0 7.94253e-07 -3.00536e-08 0 3.80224e-07 -1.16642e-08 0 + 2.40778e-08 -1.39218e-09 0 2.68628e-10 -1.17612e-09 0 2.39608e-10 -1.17095e-09 0 5.7454e-10 -1.09629e-09 0 + 8.93101e-07 -6.44702e-07 0 9.74231e-07 -3.21482e-07 0 1.01224e-06 -1.74115e-07 0 1.00477e-06 -1.14614e-07 0 + 1.0151e-06 -1.06903e-07 0 1.03788e-06 -5.81197e-08 0 1.05214e-06 -3.14446e-08 0 1.06005e-06 -1.67712e-08 0 + 1.06427e-06 -8.56682e-09 0 1.06643e-06 -3.67425e-09 0 1.07004e-06 -1.49908e-08 0 1.07621e-06 -1.97276e-08 0 + 9.95434e-07 -2.45681e-08 0 8.76314e-07 -4.64326e-08 0 7.15017e-07 -4.03958e-08 0 3.02281e-07 -1.36515e-08 0 + 8.01356e-09 -1.24912e-09 0 2.40281e-10 -1.17776e-09 0 2.32145e-10 -1.17842e-09 0 5.57184e-10 -1.10315e-09 0 + 1.08659e-06 -6.70056e-07 0 1.10853e-06 -3.47109e-07 0 1.09923e-06 -1.6936e-07 0 1.06174e-06 -1.3723e-07 0 + 1.04921e-06 -1.16348e-07 0 1.05806e-06 -6.44163e-08 0 1.06356e-06 -3.49449e-08 0 1.06653e-06 -1.86239e-08 0 + 1.06812e-06 -9.528e-09 0 1.06901e-06 -4.14863e-09 0 1.07103e-06 -1.72724e-08 0 1.07525e-06 -2.26268e-08 0 + 9.88069e-07 -2.79308e-08 0 8.54151e-07 -4.71212e-08 0 6.38141e-07 -3.89557e-08 0 2.36194e-07 -8.86094e-09 0 + 3.13616e-09 -1.20313e-09 0 2.298e-10 -1.17705e-09 0 2.23633e-10 -1.18124e-09 0 5.42015e-10 -1.10577e-09 0 + 1.27513e-06 -6.70747e-07 0 1.24718e-06 -3.42723e-07 0 1.18844e-06 -1.4398e-07 0 1.11573e-06 -1.54867e-07 0 + 1.08262e-06 -1.1822e-07 0 1.07908e-06 -6.5123e-08 0 1.0756e-06 -3.51623e-08 0 1.07337e-06 -1.86861e-08 0 + 1.07217e-06 -9.56667e-09 0 1.07167e-06 -4.21643e-09 0 1.07187e-06 -1.82542e-08 0 1.07394e-06 -2.47784e-08 0 + 9.81017e-07 -3.17015e-08 0 8.34152e-07 -4.38477e-08 0 5.64277e-07 -2.99662e-08 0 1.7452e-07 -5.16324e-09 0 + 1.35391e-09 -1.18379e-09 0 2.23168e-10 -1.17426e-09 0 2.14402e-10 -1.18014e-09 0 5.27288e-10 -1.10544e-09 0 + 1.47099e-06 -6.47644e-07 0 1.39225e-06 -3.11709e-07 0 1.2866e-06 -9.55117e-08 0 1.17536e-06 -1.66061e-07 0 + 1.11753e-06 -1.12709e-07 0 1.10009e-06 -6.00616e-08 0 1.08733e-06 -3.20171e-08 0 1.07995e-06 -1.69328e-08 0 + 1.07604e-06 -8.66907e-09 0 1.07419e-06 -3.85216e-09 0 1.0723e-06 -1.77104e-08 0 1.07185e-06 -2.61254e-08 0 + 9.75085e-07 -3.69454e-08 0 8.16917e-07 -3.81233e-08 0 4.93071e-07 -2.11061e-08 0 1.15404e-07 -2.98923e-09 0 + 6.57944e-10 -1.17306e-09 0 2.18108e-10 -1.16802e-09 0 2.04625e-10 -1.17404e-09 0 5.11464e-10 -1.10116e-09 0 + 1.68665e-06 -5.90546e-07 0 1.54337e-06 -2.56953e-07 0 1.41222e-06 -3.33934e-08 0 1.26313e-06 -1.61606e-07 0 + 1.15722e-06 -9.64654e-08 0 1.11994e-06 -4.88585e-08 0 1.09775e-06 -2.56519e-08 0 1.08571e-06 -1.34965e-08 0 + 1.07941e-06 -6.90538e-09 0 1.07635e-06 -3.07394e-09 0 1.07205e-06 -1.53313e-08 0 1.06791e-06 -2.61996e-08 0 + 9.69343e-07 -4.58591e-08 0 7.97866e-07 -2.96846e-08 0 4.24243e-07 -1.77531e-08 0 6.24202e-08 -1.84351e-09 0 + 3.83616e-10 -1.1509e-09 0 2.14117e-10 -1.14502e-09 0 1.94181e-10 -1.14966e-09 0 4.92023e-10 -1.08052e-09 0 + 1.93684e-06 -4.69413e-07 0 1.68756e-06 -1.80882e-07 0 1.60065e-06 -9.62579e-10 0 1.42599e-06 -1.09636e-07 0 + 1.20457e-06 -6.07605e-08 0 1.13602e-06 -3.15586e-08 0 1.10562e-06 -1.6557e-08 0 1.09004e-06 -8.68918e-09 0 + 1.08197e-06 -4.43603e-09 0 1.07803e-06 -1.95129e-09 0 1.07103e-06 -1.07459e-08 0 1.06012e-06 -2.32468e-08 0 + 9.58062e-07 -5.91605e-08 0 7.58859e-07 -1.40016e-08 0 3.51161e-07 -1.16622e-08 0 2.30419e-08 -1.20979e-09 0 + 2.74256e-10 -1.02274e-09 0 2.07181e-10 -1.01608e-09 0 1.80089e-10 -1.01817e-09 0 4.5796e-10 -9.6144e-10 0 + 2.19305e-06 -3.87409e-07 0 1.66963e-06 -1.3776e-07 0 1.53215e-06 -6.68711e-10 0 1.38392e-06 -6.57349e-08 0 + 1.20051e-06 -3.65501e-08 0 1.14259e-06 -2.14498e-08 0 1.10983e-06 -1.14148e-08 0 1.09252e-06 -5.99346e-09 0 + 1.08357e-06 -3.05168e-09 0 1.07929e-06 -1.31657e-09 0 1.07018e-06 -7.85415e-09 0 1.04166e-06 -2.06762e-08 0 + 8.51106e-07 -6.67819e-08 0 5.17007e-07 -3.43181e-09 0 1.78848e-07 -5.61321e-09 0 2.56789e-09 -9.58495e-10 0 + 1.99765e-10 -9.12141e-10 0 1.68622e-10 -9.05845e-10 0 1.41045e-10 -9.06454e-10 0 3.50557e-10 -8.59557e-10 0 </DataArray> - <DataArray type="Float32" Name="velocity_gas (m/s)" NumberOfComponents="3" format="ascii"> - 9.98821e-11 6.11062e-10 0 6.20252e-10 4.86489e-10 0 2.93066e-10 0 0 0 0 0 + <DataArray type="Float32" Name="velocity_Air (m/s)" NumberOfComponents="3" format="ascii"> + 1.50018e-10 6.02772e-10 0 6.04669e-10 4.76707e-10 0 2.6205e-10 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 3.95955e-11 3.65681e-11 0 1.32572e-08 8.6958e-09 0 5.18325e-08 2.46098e-08 0 1.72634e-07 1.72899e-07 0 - 4.68298e-07 -4.56636e-08 0 7.84074e-07 -1.13713e-07 0 9.9237e-07 -9.15818e-08 0 1.26612e-06 -1.80198e-07 0 - 1.43099e-09 7.17892e-10 0 1.77538e-09 7.36446e-10 0 7.83813e-10 0 0 0 0 0 + 1.42073e-11 1.52641e-11 0 1.14131e-08 8.70153e-09 0 4.28561e-08 2.33775e-08 0 1.40984e-07 1.40595e-07 0 + 4.16409e-07 9.58525e-09 0 7.47066e-07 -1.30759e-07 0 9.76898e-07 -9.51924e-08 0 1.25499e-06 -1.80681e-07 0 + 1.54768e-09 7.04217e-10 0 1.81029e-09 7.34262e-10 0 7.77661e-10 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 2.31465e-10 1.25647e-10 0 2.40231e-08 1.17097e-08 0 1.03717e-07 3.51665e-08 0 3.55806e-07 2.59727e-07 0 - 7.01482e-07 -9.3086e-08 0 8.97386e-07 -1.36622e-07 0 1.01199e-06 -1.25676e-07 0 1.16967e-06 -2.24855e-07 0 - 2.72379e-09 7.44229e-10 0 2.71931e-09 1.08625e-09 0 1.15225e-09 0 0 0 0 0 + 1.3146e-10 7.83887e-11 0 2.12916e-08 1.19784e-08 0 8.8691e-08 3.44576e-08 0 3.02518e-07 2.39822e-07 0 + 6.58997e-07 -4.47919e-08 0 8.92038e-07 -1.52542e-07 0 1.00585e-06 -1.29972e-07 0 1.16554e-06 -2.25658e-07 0 + 2.8101e-09 7.24787e-10 0 2.77391e-09 1.09309e-09 0 1.17042e-09 0 0 0 0 0 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.34945e-10 2.18178e-10 0 3.16088e-08 1.67264e-08 0 1.51506e-07 5.49931e-08 0 5.24887e-07 3.6571e-07 0 - 8.581e-07 -1.55997e-07 0 9.25155e-07 -1.68621e-07 0 9.85457e-07 -1.80574e-07 0 1.07065e-06 -2.9123e-07 0 - 3.6254e-09 5.86766e-10 0 3.30225e-09 1.19547e-09 0 1.36828e-09 0 0 0 0 0 + 1.37938e-10 1.4605e-10 0 2.8908e-08 1.7614e-08 0 1.3511e-07 5.57085e-08 0 4.76575e-07 3.77846e-07 0 + 8.26796e-07 -1.30245e-07 0 9.27123e-07 -1.81173e-07 0 9.82795e-07 -1.85473e-07 0 1.06802e-06 -2.92454e-07 0 + 3.69546e-09 5.6982e-10 0 3.36393e-09 1.20251e-09 0 1.39759e-09 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 1.60212e-10 1.88073e-10 0 3.6666e-08 2.01981e-08 0 1.89354e-07 7.43146e-08 0 6.11648e-07 3.67518e-07 0 - 9.1999e-07 -1.69179e-07 0 9.27098e-07 -1.79937e-07 0 9.52652e-07 -2.11686e-07 0 9.92966e-07 -3.22737e-07 0 - 4.40119e-09 4.85817e-10 0 3.79689e-09 1.21873e-09 0 1.5415e-09 0 0 0 0 0 + 9.13015e-11 1.26164e-10 0 3.44548e-08 2.18112e-08 0 1.7469e-07 7.77513e-08 0 5.87681e-07 4.04107e-07 0 + 9.11514e-07 -1.65602e-07 0 9.30203e-07 -1.8883e-07 0 9.5225e-07 -2.16164e-07 0 9.91845e-07 -3.2404e-07 0 + 4.46384e-09 4.71939e-10 0 3.86466e-09 1.22216e-09 0 1.57708e-09 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 9.20342e-11 1.22714e-10 0 4.04546e-08 2.3013e-08 0 2.19828e-07 9.7844e-08 0 6.48126e-07 3.17399e-07 0 - 9.29396e-07 -1.61307e-07 0 9.16694e-07 -1.79649e-07 0 9.16127e-07 -2.23994e-07 0 9.25403e-07 -3.35123e-07 0 - 5.16014e-09 4.86648e-10 0 4.30964e-09 1.28225e-09 0 1.72819e-09 0 0 0 0 0 + 4.81663e-11 7.83326e-11 0 3.88704e-08 2.53698e-08 0 2.08269e-07 1.06451e-07 0 6.37966e-07 3.55129e-07 0 + 9.32119e-07 -1.65764e-07 0 9.2053e-07 -1.86175e-07 0 9.17279e-07 -2.27738e-07 0 9.25609e-07 -3.36326e-07 0 + 5.21572e-09 4.69634e-10 0 4.38309e-09 1.27929e-09 0 1.76967e-09 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 4.87826e-11 7.00753e-11 0 4.41593e-08 2.58703e-08 0 2.47752e-07 1.31692e-07 0 6.68157e-07 2.42007e-07 0 - 9.21303e-07 -1.51083e-07 0 9.00537e-07 -1.70495e-07 0 8.77066e-07 -2.20677e-07 0 8.60159e-07 -3.34555e-07 0 - 5.9557e-09 5.93352e-10 0 4.85594e-09 1.42256e-09 0 1.93748e-09 0 0 0 0 0 + 2.24776e-11 4.05438e-11 0 4.33063e-08 2.90085e-08 0 2.40127e-07 1.49466e-07 0 6.65495e-07 2.67736e-07 0 + 9.28576e-07 -1.56538e-07 0 9.05204e-07 -1.75268e-07 0 8.79334e-07 -2.23627e-07 0 8.61455e-07 -3.35591e-07 0 + 6.00023e-09 5.64901e-10 0 4.93697e-09 1.40823e-09 0 1.9875e-09 0 0 0 0 0 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.35902e-11 3.66639e-11 0 4.86362e-08 2.92813e-08 0 2.77095e-07 1.82854e-07 0 6.89216e-07 1.46608e-07 0 - 9.13776e-07 -1.4215e-07 0 8.83927e-07 -1.5266e-07 0 8.36261e-07 -2.02512e-07 0 7.90667e-07 -3.21435e-07 0 - 6.84324e-09 8.50022e-10 0 5.43057e-09 1.64594e-09 0 2.16494e-09 0 0 0 0 0 + 9.32731e-12 1.85693e-11 0 4.87702e-08 3.33413e-08 0 2.75128e-07 2.14911e-07 0 6.9291e-07 1.53428e-07 0 + 9.22985e-07 -1.46008e-07 0 8.89217e-07 -1.55873e-07 0 8.39297e-07 -2.04694e-07 0 7.92815e-07 -3.22307e-07 0 + 6.86733e-09 7.97297e-10 0 5.5231e-09 1.61008e-09 0 2.22877e-09 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 1.15207e-11 1.78594e-11 0 5.45882e-08 3.38782e-08 0 3.12712e-07 2.54183e-07 0 7.25119e-07 2.89511e-08 0 - 9.19502e-07 -1.30392e-07 0 8.71464e-07 -1.24573e-07 0 7.94969e-07 -1.68123e-07 0 7.09842e-07 -2.90479e-07 0 - 7.94717e-09 1.35403e-09 0 6.08183e-09 1.94815e-09 0 2.42644e-09 0 0 0 0 0 + 4.90502e-12 8.34468e-12 0 5.60798e-08 3.93181e-08 0 3.21483e-07 2.9927e-07 0 7.39409e-07 1.66455e-08 0 + 9.30001e-07 -1.31372e-07 0 8.77046e-07 -1.2634e-07 0 7.98514e-07 -1.69609e-07 0 7.12672e-07 -2.91251e-07 0 + 7.92662e-09 1.25741e-09 0 6.18198e-09 1.87394e-09 0 2.5084e-09 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 1.88391e-11 1.4563e-11 0 6.35886e-08 4.14213e-08 0 3.86895e-07 3.15756e-07 0 8.18217e-07 -1.03429e-07 0 - 9.5272e-07 -1.04269e-07 0 8.68336e-07 -8.3984e-08 0 7.57803e-07 -1.14972e-07 0 6.08906e-07 -2.26813e-07 0 - 1.22648e-08 1.68325e-09 0 1.43438e-08 2.11765e-09 0 7.40001e-09 0 0 0 0 0 + 1.60626e-11 1.14888e-11 0 6.67409e-08 4.99674e-08 0 4.18092e-07 3.48735e-07 0 8.5263e-07 -1.2034e-07 0 + 9.62463e-07 -1.02059e-07 0 8.7413e-07 -8.46092e-08 0 7.62076e-07 -1.15867e-07 0 6.12553e-07 -2.27547e-07 0 + 1.19427e-08 1.55892e-09 0 1.39349e-08 2.01924e-09 0 7.21532e-09 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 4.17376e-09 1.74962e-11 0 1.91109e-07 4.62673e-08 0 9.15875e-07 3.36793e-07 0 1.29206e-06 -1.7093e-07 0 - 1.04016e-06 -8.56305e-08 0 8.93244e-07 -6.02879e-08 0 7.48426e-07 -8.33618e-08 0 4.79407e-07 -1.84144e-07 0 + 5.65922e-09 1.72626e-11 0 2.28701e-07 5.70545e-08 0 9.68206e-07 3.53099e-07 0 1.30866e-06 -1.83896e-07 0 + 1.04449e-06 -8.19593e-08 0 9.00878e-07 -6.04588e-08 0 7.55079e-07 -8.3991e-08 0 4.84536e-07 -1.8487e-07 0 </DataArray> <DataArray type="Float32" Name="process rank" NumberOfComponents="1" format="ascii"> 0 0 0 0 0 0 0 0 0 0 0 0 @@ -526,23 +526,23 @@ 0 0 0 0 0 0 0 0 </DataArray> <DataArray type="Float32" Name="Permeability" NumberOfComponents="1" format="ascii"> - 2.23e-14 2.23e-14 1.81612e-14 2.84606e-15 2.84261e-15 2.84097e-15 2.83949e-15 2.83824e-15 2.83732e-15 2.83652e-15 1.94009e-14 1.93964e-14 - 1.93856e-14 1.93544e-14 1.9354e-14 1.93535e-14 1.93528e-14 1.93518e-14 1.93501e-14 1.93465e-14 2.23e-14 2.23e-14 2.15782e-14 2.92973e-15 - 2.84311e-15 2.8415e-15 2.84013e-15 2.8388e-15 2.8378e-15 2.83694e-15 1.94097e-14 1.94039e-14 1.93875e-14 1.93543e-14 1.9354e-14 1.93535e-14 - 1.93528e-14 1.93518e-14 1.93501e-14 1.93465e-14 2.23e-14 2.23e-14 2.20633e-14 3.23928e-15 2.84331e-15 2.84175e-15 2.84053e-15 2.83906e-15 - 2.83797e-15 2.83709e-15 1.94141e-14 1.94084e-14 1.93915e-14 1.93543e-14 1.9354e-14 1.93535e-14 1.93528e-14 1.93518e-14 1.93501e-14 1.93465e-14 - 2.23e-14 2.23e-14 2.21815e-14 3.62993e-15 2.84348e-15 2.84217e-15 2.84076e-15 2.8392e-15 2.83807e-15 2.83734e-15 1.9416e-14 1.94107e-14 - 1.93953e-14 1.93543e-14 1.9354e-14 1.93535e-14 1.93528e-14 1.93518e-14 1.93501e-14 1.93465e-14 2.23e-14 2.23e-14 2.22295e-14 4.05993e-15 - 2.84362e-15 2.84248e-15 2.84093e-15 2.83933e-15 2.83818e-15 2.83752e-15 1.94171e-14 1.94122e-14 1.93986e-14 1.93543e-14 1.9354e-14 1.93535e-14 - 1.93528e-14 1.93518e-14 1.93501e-14 1.93465e-14 2.23e-14 2.23e-14 2.2256e-14 4.56516e-15 2.8438e-15 2.84276e-15 2.84109e-15 2.83946e-15 - 2.83842e-15 2.83766e-15 1.94182e-14 1.94136e-14 1.94016e-14 1.93543e-14 1.9354e-14 1.93535e-14 1.93528e-14 1.93518e-14 1.93501e-14 1.93465e-14 - 2.23e-14 2.23e-14 2.22691e-14 5.21357e-15 2.84411e-15 2.84304e-15 2.84125e-15 2.83958e-15 2.83865e-15 2.83779e-15 1.94193e-14 1.94149e-14 - 1.94046e-14 1.93543e-14 1.9354e-14 1.93535e-14 1.93528e-14 1.93518e-14 1.93502e-14 1.93465e-14 2.23e-14 2.23e-14 2.22805e-14 6.15613e-15 - 2.84447e-15 2.84335e-15 2.84144e-15 2.83987e-15 2.83886e-15 2.83792e-15 1.94206e-14 1.94166e-14 1.94075e-14 1.93543e-14 1.9354e-14 1.93535e-14 - 1.93528e-14 1.93518e-14 1.93502e-14 1.93465e-14 2.23e-14 2.23e-14 2.22886e-14 7.67961e-15 2.84493e-15 2.84367e-15 2.84164e-15 2.84024e-15 - 2.83906e-15 2.83803e-15 1.94227e-14 1.94195e-14 1.94093e-14 1.93543e-14 1.93539e-14 1.93535e-14 1.93528e-14 1.93518e-14 1.93502e-14 1.93465e-14 - 2.23e-14 2.23e-14 2.2288e-14 6.83681e-15 2.8453e-15 2.8441e-15 2.84209e-15 2.84062e-15 2.83946e-15 2.83846e-15 1.9435e-14 1.94336e-14 - 1.93982e-14 1.93543e-14 1.93539e-14 1.93535e-14 1.93528e-14 1.93518e-14 1.93502e-14 1.93465e-14 + 2.23e-14 2.23e-14 1.64322e-14 2.846e-15 2.84257e-15 2.84092e-15 2.83941e-15 2.83819e-15 2.8373e-15 2.83651e-15 1.94e-14 1.93954e-14 + 1.93865e-14 1.93548e-14 1.93544e-14 1.93539e-14 1.93533e-14 1.93523e-14 1.93506e-14 1.93469e-14 2.23e-14 2.23e-14 2.12941e-14 2.87734e-15 + 2.84314e-15 2.84152e-15 2.84012e-15 2.83881e-15 2.83783e-15 2.83697e-15 1.94092e-14 1.94033e-14 1.93887e-14 1.93548e-14 1.93544e-14 1.93539e-14 + 1.93533e-14 1.93523e-14 1.93506e-14 1.93469e-14 2.23e-14 2.23e-14 2.203e-14 3.17981e-15 2.84335e-15 2.84176e-15 2.84057e-15 2.83911e-15 + 2.83802e-15 2.83713e-15 1.94142e-14 1.94082e-14 1.9393e-14 1.93548e-14 1.93544e-14 1.93539e-14 1.93533e-14 1.93523e-14 1.93506e-14 1.93469e-14 + 2.23e-14 2.23e-14 2.21744e-14 3.60258e-15 2.84354e-15 2.84222e-15 2.84082e-15 2.83926e-15 2.83813e-15 2.8374e-15 1.94164e-14 1.94109e-14 + 1.93969e-14 1.93548e-14 1.93544e-14 1.93539e-14 1.93533e-14 1.93523e-14 1.93506e-14 1.93469e-14 2.23e-14 2.23e-14 2.22289e-14 4.07111e-15 + 2.84369e-15 2.84256e-15 2.84101e-15 2.8394e-15 2.83826e-15 2.8376e-15 1.94177e-14 1.94126e-14 1.94004e-14 1.93548e-14 1.93544e-14 1.93539e-14 + 1.93533e-14 1.93523e-14 1.93506e-14 1.93469e-14 2.23e-14 2.23e-14 2.2257e-14 4.62208e-15 2.84389e-15 2.84286e-15 2.84118e-15 2.83954e-15 + 2.83852e-15 2.83775e-15 1.94189e-14 1.94141e-14 1.94036e-14 1.93548e-14 1.93544e-14 1.93539e-14 1.93533e-14 1.93523e-14 1.93506e-14 1.9347e-14 + 2.23e-14 2.23e-14 2.22713e-14 5.33972e-15 2.84422e-15 2.84316e-15 2.84136e-15 2.83967e-15 2.83876e-15 2.83789e-15 1.94201e-14 1.94157e-14 + 1.94067e-14 1.93548e-14 1.93544e-14 1.93539e-14 1.93533e-14 1.93523e-14 1.93506e-14 1.9347e-14 2.23e-14 2.23e-14 2.22823e-14 6.42817e-15 + 2.84461e-15 2.84349e-15 2.84156e-15 2.84003e-15 2.83899e-15 2.83802e-15 1.94216e-14 1.94178e-14 1.94096e-14 1.93548e-14 1.93544e-14 1.93539e-14 + 1.93533e-14 1.93523e-14 1.93506e-14 1.9347e-14 2.23e-14 2.23e-14 2.22901e-14 8.38925e-15 2.84511e-15 2.84382e-15 2.84178e-15 2.84043e-15 + 2.8392e-15 2.83814e-15 1.9424e-14 1.94211e-14 1.94111e-14 1.93548e-14 1.93544e-14 1.93539e-14 1.93533e-14 1.93523e-14 1.93506e-14 1.9347e-14 + 2.23e-14 2.23e-14 2.22908e-14 8.24124e-15 2.84553e-15 2.84432e-15 2.84229e-15 2.84086e-15 2.83965e-15 2.83864e-15 1.9438e-14 1.94373e-14 + 1.93984e-14 1.93547e-14 1.93544e-14 1.93539e-14 1.93533e-14 1.93523e-14 1.93506e-14 1.9347e-14 </DataArray> </CellData> <Points> diff --git a/test/references/saltwaterintrusion-reference.vtu b/test/references/saltwaterintrusion-reference.vtu new file mode 100644 index 0000000000000000000000000000000000000000..3deaa92ec18afd48a117ccae5b510283831bad07 --- /dev/null +++ b/test/references/saltwaterintrusion-reference.vtu @@ -0,0 +1,256 @@ +<?xml version="1.0"?> +<VTKFile type="UnstructuredGrid" version="0.1" byte_order="LittleEndian"> + <UnstructuredGrid> + <Piece NumberOfCells="100" NumberOfPoints="126"> + <PointData Scalars="pressure" Vectors="velocity_H2O (m/s)"> + <DataArray type="Float32" Name="pressure" NumberOfComponents="1" format="ascii"> + 590500 590285 492400 492299 590207 492235 590200 492207 590269 492202 590418 492216 + 590651 492253 590968 492318 591361 492418 591823 492559 592340 492748 592899 492988 + 593489 493284 594098 493636 594720 494046 595348 494504 595967 494988 596546 495423 + 596965 495582 596369 494686 590500 492400 394300 394261 394232 394210 394188 394161 + 394128 394088 394044 394000 393963 393940 393943 393981 394063 394197 394410 394754 + 395020 394887 394300 296200 296216 296225 296219 296198 296160 296103 296026 295927 + 295807 295665 295503 295321 295121 294908 294697 294523 294491 294846 295460 296200 + 198100 198186 198236 198248 198232 198192 198128 198038 197921 197773 197591 197370 + 197108 196799 196441 196029 195549 194971 194673 195828 198100 100000 100216 100289 + 100308 100294 100254 100189 100096 99974.3 99818.8 99625.4 99388.3 99100.9 98755 98339.4 + 97833.1 97203.1 96378.1 95093.2 94304.6 100000 + </DataArray> + <DataArray type="Float32" Name="rho" NumberOfComponents="1" format="ascii"> + 998.415 998.415 998.37 998.37 998.415 998.37 998.77 998.431 999.963 998.711 1002.07 999.319 + 1005.05 1000.36 1008.66 1001.92 1012.57 1004.06 1016.45 1006.76 1020.04 1009.94 1023.17 1013.41 + 1025.77 1016.89 1027.82 1020.11 1029.41 1022.91 1030.64 1025.29 1031.71 1027.37 1033.13 1029.74 + 1036.83 1037.78 1053.37 1056.01 1062.69 1062.64 998.325 998.325 998.325 998.34 998.409 998.571 + 998.88 999.396 1000.17 1001.28 1002.75 1004.68 1007.18 1010.41 1014.47 1019.11 1023.83 1027.21 + 1038.49 1059.75 1062.6 998.281 998.281 998.281 998.285 998.3 998.338 998.416 998.561 998.801 + 999.174 999.727 1000.53 1001.66 1003.19 1005.16 1007.65 1010.56 1021.69 1038.7 1060.59 1062.55 + 998.236 998.236 998.236 998.237 998.239 998.245 998.259 998.286 998.338 998.427 998.573 998.807 + 999.166 999.695 1000.47 1001.67 1003.53 1004.97 1031.51 1060.27 1062.51 998.191 998.191 998.191 + 998.191 998.191 998.192 998.194 998.197 998.205 998.22 998.247 998.296 998.378 998.515 998.749 + 999.171 999.996 1001.16 1001.19 1058.2 1062.47 + </DataArray> + <DataArray type="Float32" Name="mu" NumberOfComponents="1" format="ascii"> + 0.000980804 0.000980804 0.000980804 0.000980804 0.000980804 0.000980804 0.00098427 0.000981637 0.000992116 0.00098416 0.00100318 0.000988447 + 0.00101646 0.000994607 0.0010305 0.00100268 0.00104409 0.00101245 0.00105643 0.00102352 0.00106707 0.00103529 0.00107588 0.001047 + 0.00108291 0.0010579 0.00108835 0.0010674 0.00109246 0.00107528 0.00109562 0.00108175 0.00109837 0.00108728 0.00110197 0.00109344 + 0.00111121 0.00111366 0.00115229 0.0011592 0.0011768 0.0011768 0.000980804 0.000980804 0.000980804 0.000981072 0.000981887 0.000983382 + 0.000985767 0.000989222 0.000993834 0.000999725 0.00100682 0.00101529 0.00102531 0.00103707 0.00105055 0.00106464 0.00107792 0.00108697 + 0.00111554 0.00116914 0.0011768 0.000980804 0.000980804 0.000980804 0.000980896 0.00098114 0.0009816 0.000982397 0.000983666 0.000985521 + 0.000988087 0.000991523 0.000996038 0.00100184 0.00100903 0.00101748 0.00102727 0.00103777 0.00107214 0.00111617 0.0011715 0.0011768 + 0.000980804 0.000980804 0.000980806 0.000980831 0.000980888 0.000980992 0.000981187 0.000981527 0.000982074 0.000982906 0.000984133 0.000985892 + 0.00098833 0.0009916 0.000995949 0.00100211 0.00101073 0.00101686 0.00109832 0.00117076 0.0011768 0.000980804 0.000980804 0.000980805 + 0.00098081 0.000980821 0.000980839 0.000980875 0.000980943 0.000981064 0.000981267 0.000981594 0.000982105 0.000982877 0.000984026 0.000985795 + 0.000988654 0.000993602 0.000999832 0.000999968 0.00116538 0.0011768 + </DataArray> + <DataArray type="Float32" Name="delp" NumberOfComponents="1" format="ascii"> + 490500 490285 392400 392299 490207 392235 490200 392207 490269 392202 490418 392216 + 490651 392253 490968 392318 491361 392418 491823 392559 492340 392748 492899 392988 + 493489 393284 494098 393636 494720 394046 495348 394504 495967 394988 496546 395423 + 496965 395582 496369 394686 490500 392400 294300 294261 294232 294210 294188 294161 + 294128 294088 294044 294000 293963 293940 293943 293981 294063 294197 294410 294754 + 295020 294887 294300 196200 196216 196225 196219 196198 196160 196103 196026 195927 + 195807 195665 195503 195321 195121 194908 194697 194523 194491 194846 195460 196200 + 98100 98186.2 98236.4 98248.1 98231.9 98191.8 98127.9 98038.5 97921 97772.8 97590.5 97370.4 + 97108 96799.2 96440.7 96028.8 95548.6 94970.6 94672.6 95827.8 98100 0 216.437 288.781 + 308.084 294.356 254.183 188.678 96.3219 -25.7275 -181.171 -374.606 -611.69 -899.142 -1244.97 -1660.62 + -2166.87 -2796.87 -3621.87 -4906.8 -5695.4 0 + </DataArray> + <DataArray type="Float32" Name="x_H2O" NumberOfComponents="1" format="ascii"> + 1 1 1 1 1 1 0.999837 0.999972 0.999289 0.999843 0.99832 0.999564 + 0.996948 0.999087 0.995283 0.998368 0.993478 0.997384 0.991682 0.996136 0.990016 0.994668 0.988562 0.993068 + 0.987356 0.991458 0.986399 0.989963 0.985661 0.988663 0.985088 0.987558 0.984586 0.986588 0.983922 0.985484 + 0.982192 0.981728 0.974418 0.973145 0.97 0.97 1 1 1 0.999993 0.999961 0.999887 + 0.999745 0.999508 0.999151 0.998642 0.997965 0.997077 0.995923 0.994433 0.992556 0.990405 0.988216 0.986643 + 0.981372 0.971351 0.97 1 1 1 0.999998 0.999991 0.999974 0.999938 0.999871 0.999761 + 0.999589 0.999335 0.998967 0.998447 0.997741 0.996834 0.995685 0.994341 0.989188 0.981253 0.970931 0.97 + 1 1 1 1 0.999998 0.999996 0.999989 0.999977 0.999953 0.999912 0.999845 0.999737 + 0.999572 0.999329 0.998974 0.998422 0.997565 0.996902 0.984595 0.971063 0.97 1 1 1 + 1 1 0.999999 0.999999 0.999997 0.999993 0.999987 0.999974 0.999952 0.999914 0.999851 0.999743 + 0.999549 0.99917 0.998632 0.99862 0.972024 0.97 + </DataArray> + <DataArray type="Float32" Name="x_NaCl" NumberOfComponents="1" format="ascii"> + 0 1.23038e-16 0 1.25424e-16 1.44703e-10 9.7583e-11 0.000163246 2.78637e-05 0.000711444 0.000156837 0.00167959 0.000436138 + 0.0030524 0.000912874 0.00471708 0.00163164 0.00652198 0.00261643 0.0083182 0.00386361 0.00998376 0.00533152 0.0114382 0.00693182 + 0.0126439 0.00854176 0.0136008 0.0100366 0.0143387 0.0113371 0.0149121 0.0124424 0.015414 0.0134121 0.0160783 0.0145161 + 0.0178083 0.0182716 0.0255822 0.0268545 0.03 0.03 0 1.01531e-16 4.135e-11 6.8197e-06 3.85549e-05 0.00011307 + 0.000254897 0.000491869 0.000849285 0.00135803 0.00203526 0.00292306 0.00407734 0.00556658 0.00744436 0.00959452 0.0117842 0.0133567 + 0.0186279 0.0286486 0.03 0 6.06804e-13 1.77139e-11 1.81266e-06 9.04556e-06 2.63165e-05 6.22498e-05 0.000128721 0.000239279 + 0.000410718 0.000665066 0.00103334 0.00155326 0.00225895 0.00316604 0.00431548 0.00565921 0.0108122 0.0187471 0.0290689 0.03 + 0 2.82482e-09 1.81409e-08 3.93417e-07 1.61257e-06 4.39747e-06 1.06263e-05 2.33725e-05 4.70045e-05 8.78081e-05 0.000155288 0.000262911 + 0.000427838 0.000671106 0.00102576 0.00157834 0.00243458 0.00309756 0.0154047 0.0289371 0.03 0 2.81504e-09 9.31256e-09 + 6.70071e-08 2.18654e-07 5.41553e-07 1.30858e-06 3.02933e-06 6.57872e-06 1.34302e-05 2.60733e-05 4.84203e-05 8.62638e-05 0.000149084 0.000256678 + 0.000450905 0.000830349 0.00136774 0.00138014 0.0279759 0.03 + </DataArray> + <DataArray type="Float32" Name="X_H2O" NumberOfComponents="1" format="ascii"> + 1 1 1 1 1 1 0.999471 0.99991 0.997696 0.999491 0.994572 0.998587 + 0.990165 0.997045 0.984858 0.994726 0.979147 0.991562 0.97351 0.987574 0.968322 0.982909 0.963822 0.977857 + 0.960114 0.972811 0.957185 0.968158 0.954934 0.964134 0.95319 0.960732 0.951668 0.957761 0.949657 0.954394 + 0.944448 0.94306 0.921515 0.917833 0.908816 0.908816 1 1 1 0.999978 0.999875 0.999633 + 0.999174 0.998406 0.99725 0.995608 0.993427 0.990579 0.986893 0.982164 0.976247 0.969531 0.962756 0.957931 + 0.941994 0.912675 0.908816 1 1 1 0.999994 0.999971 0.999915 0.999798 0.999583 0.999224 + 0.998669 0.997846 0.996656 0.994979 0.992709 0.989802 0.986134 0.981871 0.965755 0.941638 0.911473 0.908816 + 1 1 1 0.999999 0.999995 0.999986 0.999966 0.999924 0.999848 0.999715 0.999496 0.999148 + 0.998613 0.997826 0.99668 0.994898 0.992145 0.990021 0.951696 0.91185 0.908816 1 1 1 + 1 0.999999 0.999998 0.999996 0.99999 0.999979 0.999956 0.999915 0.999843 0.99972 0.999517 0.999168 + 0.998539 0.997311 0.995577 0.995537 0.914605 0.908816 + </DataArray> + <DataArray type="Float32" Name="X_NaCl" NumberOfComponents="1" format="ascii"> + 0 3.99145e-16 0 4.06886e-16 4.69427e-10 3.16568e-10 0.000529391 9.03866e-05 0.00230431 0.000508614 0.00542828 0.00141348 + 0.00983488 0.00295539 0.0151423 0.00527386 0.0208527 0.00843838 0.0264905 0.0124262 0.0316784 0.0170914 0.0361777 0.022143 + 0.0398863 0.027189 0.0428155 0.0318425 0.0450659 0.035866 0.0468097 0.0392679 0.0483325 0.0422387 0.0503429 0.0456059 + 0.0555517 0.0569401 0.0784851 0.0821668 0.0911839 0.0911839 0 3.29376e-16 1.34143e-10 2.21234e-05 0.000125065 0.000366716 + 0.000826436 0.00159391 0.00274991 0.00439219 0.00657253 0.00942085 0.0131073 0.0178357 0.0237533 0.0304694 0.0372441 0.0420692 + 0.0580057 0.0873246 0.0911839 0 1.96852e-12 5.74654e-11 5.88041e-06 2.9344e-05 8.53678e-05 0.000201916 0.000417461 0.000775824 + 0.00133118 0.00215432 0.00334448 0.00502141 0.00729127 0.0101984 0.0138655 0.0181287 0.0342447 0.0583621 0.088527 0.0911839 + 0 9.16396e-09 5.88507e-08 1.27628e-06 5.23129e-06 1.42656e-05 3.44719e-05 7.58186e-05 0.000152471 0.000284801 0.000503593 0.000852404 + 0.00138661 0.00217385 0.00332002 0.00510221 0.00785508 0.00997939 0.0483044 0.0881501 0.0911839 0 9.13224e-09 3.02107e-08 + 2.17377e-07 7.09331e-07 1.75684e-06 4.24513e-06 9.82734e-06 2.13416e-05 4.35676e-05 8.4579e-05 0.000157063 0.000279793 0.00048348 0.000832206 + 0.0014613 0.00268871 0.00442348 0.00446347 0.0853952 0.0911839 + </DataArray> + <DataArray type="Float32" Name="velocity_H2O (m/s)" NumberOfComponents="3" format="ascii"> + 1.90517e-06 1.31733e-06 0 1.3318e-06 5.73367e-07 0 1.09948e-06 1.40499e-06 0 8.61489e-07 8.11376e-07 0 + 4.38221e-07 3.20212e-07 0 4.35845e-07 5.07866e-07 0 -1.93381e-07 3.1139e-07 0 1.14063e-07 4.45532e-07 0 + -8.27179e-07 3.22407e-07 0 -1.42296e-07 4.44639e-07 0 -1.4806e-06 3.31012e-07 0 -3.95628e-07 4.62127e-07 0 + -2.13601e-06 3.24384e-07 0 -6.77492e-07 4.75147e-07 0 -2.76339e-06 3.0298e-07 0 -9.99844e-07 4.74578e-07 0 + -3.33797e-06 2.71569e-07 0 -1.35999e-06 4.60125e-07 0 -3.84273e-06 2.33156e-07 0 -1.74793e-06 4.32533e-07 0 + -4.26789e-06 1.91964e-07 0 -2.15509e-06 3.99742e-07 0 -4.61296e-06 1.53075e-07 0 -2.57818e-06 3.68367e-07 0 + -4.88802e-06 1.21961e-07 0 -3.01503e-06 3.435e-07 0 -5.10875e-06 9.87616e-08 0 -3.45582e-06 3.17995e-07 0 + -5.27571e-06 6.81912e-08 0 -3.86656e-06 2.59683e-07 0 -5.33537e-06 -8.53964e-09 0 -4.17581e-06 1.09202e-07 0 + -5.126e-06 -2.00849e-07 0 -4.16399e-06 -3.30428e-07 0 -4.05517e-06 -8.70044e-07 0 -2.93941e-06 -1.96515e-06 0 + 1.42515e-06 -4.61054e-06 0 2.50472e-06 -8.95995e-06 0 2.45981e-05 -1.85637e-05 0 1.43032e-05 -2.60141e-05 0 + 4.31608e-05 -4.29635e-05 0 2.17527e-05 -4.52844e-05 0 4.04782e-07 1.52496e-06 0 3.49948e-07 1.10424e-06 0 + 2.53485e-07 7.37166e-07 0 2.0606e-07 5.85482e-07 0 2.16481e-07 5.50667e-07 0 2.56259e-07 5.69693e-07 0 + 2.9955e-07 6.06195e-07 0 3.26075e-07 6.39393e-07 0 3.19201e-07 6.62366e-07 0 2.64155e-07 6.73295e-07 0 + 1.46639e-07 6.83672e-07 0 -4.39274e-08 6.98091e-07 0 -3.08055e-07 7.14746e-07 0 -6.3572e-07 7.15192e-07 0 + -1.02419e-06 6.61682e-07 0 -1.54094e-06 5.33181e-07 0 -2.34037e-06 3.31729e-08 0 -2.59963e-06 -3.29431e-06 0 + -5.72773e-07 -1.51027e-05 0 3.32061e-06 -3.55659e-05 0 5.42106e-06 -4.82239e-05 0 -1.84477e-07 1.56061e-06 0 + -1.37289e-07 1.11194e-06 0 -1.68466e-08 7.05573e-07 0 1.33522e-07 5.1419e-07 0 2.93138e-07 4.51973e-07 0 + 4.6627e-07 4.55527e-07 0 6.55046e-07 4.88348e-07 0 8.55453e-07 5.30362e-07 0 1.05973e-06 5.74055e-07 0 + 1.25806e-06 6.18374e-07 0 1.44325e-06 6.70972e-07 0 1.61278e-06 7.31877e-07 0 1.76397e-06 7.93946e-07 0 + 1.8818e-06 8.4586e-07 0 1.91242e-06 8.88896e-07 0 1.74375e-06 9.91398e-07 0 1.05699e-06 1.06113e-06 0 + -9.13944e-07 -2.09237e-06 0 -3.6835e-06 -1.55633e-05 0 -5.76258e-06 -3.69223e-05 0 -6.50825e-06 -4.86393e-05 0 + -9.55343e-07 1.50948e-06 0 -7.21251e-07 8.30707e-07 0 -2.96956e-07 4.42149e-07 0 3.08816e-08 2.99463e-07 0 + 2.87484e-07 2.50525e-07 0 5.25339e-07 2.46028e-07 0 7.71773e-07 2.62679e-07 0 1.03881e-06 2.88637e-07 0 + 1.33091e-06 3.19453e-07 0 1.65038e-06 3.55222e-07 0 2.001e-06 3.98374e-07 0 2.38768e-06 4.48326e-07 0 + 2.81202e-06 5.02039e-07 0 3.2691e-06 5.62913e-07 0 3.75328e-06 6.5711e-07 0 4.29915e-06 8.46047e-07 0 + 4.97252e-06 1.21992e-06 0 4.34482e-06 3.47348e-07 0 -1.93617e-06 -8.95462e-06 0 -1.42653e-05 -2.9126e-05 0 + -2.13171e-05 -4.62883e-05 0 -1.87466e-06 1.45501e-06 0 -1.27799e-06 5.96638e-07 0 -4.29354e-07 2.51962e-07 0 + -1.5537e-08 1.61836e-07 0 2.7788e-07 1.31568e-07 0 5.36606e-07 1.27147e-07 0 7.98908e-07 1.35143e-07 0 + 1.08322e-06 1.4916e-07 0 1.39924e-06 1.66847e-07 0 1.75448e-06 1.88376e-07 0 2.15751e-06 2.14629e-07 0 + 2.61758e-06 2.45419e-07 0 3.14366e-06 2.80641e-07 0 3.75159e-06 3.27262e-07 0 4.4875e-06 4.08617e-07 0 + 5.44488e-06 5.48714e-07 0 6.83759e-06 8.43932e-07 0 9.03267e-06 1.35106e-06 0 6.70511e-06 -3.67869e-06 0 + -1.90494e-05 -2.20747e-05 0 -4.11251e-05 -4.41406e-05 0 + </DataArray> + </PointData> + <CellData Scalars="process rank"> + <DataArray type="Float32" Name="process rank" 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 + </DataArray> + </CellData> + <Points> + <DataArray type="Float32" Name="Coordinates" NumberOfComponents="3" format="ascii"> + 0 0 0 10 0 0 0 10 0 10 10 0 + 20 0 0 20 10 0 30 0 0 30 10 0 + 40 0 0 40 10 0 50 0 0 50 10 0 + 60 0 0 60 10 0 70 0 0 70 10 0 + 80 0 0 80 10 0 90 0 0 90 10 0 + 100 0 0 100 10 0 110 0 0 110 10 0 + 120 0 0 120 10 0 130 0 0 130 10 0 + 140 0 0 140 10 0 150 0 0 150 10 0 + 160 0 0 160 10 0 170 0 0 170 10 0 + 180 0 0 180 10 0 190 0 0 190 10 0 + 200 0 0 200 10 0 0 20 0 10 20 0 + 20 20 0 30 20 0 40 20 0 50 20 0 + 60 20 0 70 20 0 80 20 0 90 20 0 + 100 20 0 110 20 0 120 20 0 130 20 0 + 140 20 0 150 20 0 160 20 0 170 20 0 + 180 20 0 190 20 0 200 20 0 0 30 0 + 10 30 0 20 30 0 30 30 0 40 30 0 + 50 30 0 60 30 0 70 30 0 80 30 0 + 90 30 0 100 30 0 110 30 0 120 30 0 + 130 30 0 140 30 0 150 30 0 160 30 0 + 170 30 0 180 30 0 190 30 0 200 30 0 + 0 40 0 10 40 0 20 40 0 30 40 0 + 40 40 0 50 40 0 60 40 0 70 40 0 + 80 40 0 90 40 0 100 40 0 110 40 0 + 120 40 0 130 40 0 140 40 0 150 40 0 + 160 40 0 170 40 0 180 40 0 190 40 0 + 200 40 0 0 50 0 10 50 0 20 50 0 + 30 50 0 40 50 0 50 50 0 60 50 0 + 70 50 0 80 50 0 90 50 0 100 50 0 + 110 50 0 120 50 0 130 50 0 140 50 0 + 150 50 0 160 50 0 170 50 0 180 50 0 + 190 50 0 200 50 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 2 3 43 42 + 3 5 44 43 5 7 45 44 7 9 46 45 + 9 11 47 46 11 13 48 47 13 15 49 48 + 15 17 50 49 17 19 51 50 19 21 52 51 + 21 23 53 52 23 25 54 53 25 27 55 54 + 27 29 56 55 29 31 57 56 31 33 58 57 + 33 35 59 58 35 37 60 59 37 39 61 60 + 39 41 62 61 42 43 64 63 43 44 65 64 + 44 45 66 65 45 46 67 66 46 47 68 67 + 47 48 69 68 48 49 70 69 49 50 71 70 + 50 51 72 71 51 52 73 72 52 53 74 73 + 53 54 75 74 54 55 76 75 55 56 77 76 + 56 57 78 77 57 58 79 78 58 59 80 79 + 59 60 81 80 60 61 82 81 61 62 83 82 + 63 64 85 84 64 65 86 85 65 66 87 86 + 66 67 88 87 67 68 89 88 68 69 90 89 + 69 70 91 90 70 71 92 91 71 72 93 92 + 72 73 94 93 73 74 95 94 74 75 96 95 + 75 76 97 96 76 77 98 97 77 78 99 98 + 78 79 100 99 79 80 101 100 80 81 102 101 + 81 82 103 102 82 83 104 103 84 85 106 105 + 85 86 107 106 86 87 108 107 87 88 109 108 + 88 89 110 109 89 90 111 110 90 91 112 111 + 91 92 113 112 92 93 114 113 93 94 115 114 + 94 95 116 115 95 96 117 116 96 97 118 117 + 97 98 119 118 98 99 120 119 99 100 121 120 + 100 101 122 121 101 102 123 122 102 103 124 123 + 103 104 125 124 + </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 + </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 + </DataArray> + </Cells> + </Piece> + </UnstructuredGrid> +</VTKFile>