Skip to content
Snippets Groups Projects
Commit f1f9ad62 authored by Thomas Fetzer's avatar Thomas Fetzer
Browse files

[multidomain,localoperator] Outsource boundaryLayerModel and massTransferModel.

This has the following advantages:
 - reuse the BL model in the non-isothermal case
 - possible move of the functions to more problem specific place (due to the use of runtime parameters)
 - better comparison of what is actually done in the code

Update reference solution, because for the BL Model the gas viscosity from Darcy was used.
parent a739ff23
No related branches found
No related tags found
2 merge requests!38Cleanup/multidomain,!34Cleanup/multidomain
......@@ -190,13 +190,15 @@ public:
typedef TwoCStokesTwoPTwoCLocalOperator<TypeTag> ParentType;
// multidomain flags
static const bool doAlphaCoupling = true;
static const bool doPatternCoupling = true;
TwoCNIStokesTwoPTwoCNILocalOperator(GlobalProblem& globalProblem)
: ParentType(globalProblem)
{ }
static const bool doAlphaCoupling = true;
static const bool doPatternCoupling = true;
public:
//! \copydoc Dumux::TwoCStokesTwoPTwoCLocalOperator::evalCoupling12()
template<typename LFSU1, typename LFSU2, typename RES1, typename RES2, typename CParams>
void evalCoupling12(const LFSU1& lfsu_s, const LFSU2& lfsu_n,
......@@ -222,85 +224,35 @@ public:
if (cParams.boundaryTypes2.isCouplingNeumann(energyEqIdx2))
{
unsigned int blModel = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, int, BoundaryLayer, Model);
// only enter here, if a boundary layer model is used for the computation of the diffusive fluxes
if (blModel)
// only enter here, if a boundary layer model is used for the computation of the diffusive fluxes
if (ParentType::blModel_)
{
// convective energy flux
const Scalar convectiveFlux =
normalMassFlux1 *
cParams.elemVolVarsCur1[vertInElem1].enthalpy();
// diffusive transported energy
const Scalar massFractionOut = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, FreeFlow, RefMassfrac);
const Scalar M1 = FluidSystem::molarMass(transportCompIdx1);
const Scalar M2 = FluidSystem::molarMass(phaseCompIdx1);
const Scalar X2 = 1.0 - massFractionOut;
const Scalar massToMoleDenominator = M2 + X2*(M1 - M2);
const Scalar moleFractionOut = massFractionOut * M2 /massToMoleDenominator;
Scalar normalMoleFracGrad =
cParams.elemVolVarsCur1[vertInElem1].moleFraction(transportCompIdx1) -
moleFractionOut;
const Scalar velocity = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, FreeFlow, RefVelocity);
// current position + additional virtual runup distance
const Scalar distance = globalPos1[0] + GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, BoundaryLayer, Offset);
const Scalar kinematicViscosity = cParams.elemVolVarsCur1[vertInElem2].kinematicViscosity();
BoundaryLayerModel<TypeTag> boundaryLayerModel(velocity, distance, kinematicViscosity, blModel);
if (blModel == 1)
boundaryLayerModel.setConstThickness(GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, BoundaryLayer, ConstThickness));
if (blModel >= 4)
boundaryLayerModel.setYPlus(GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, BoundaryLayer, YPlus));
if (blModel >= 5)
boundaryLayerModel.setRoughnessLength(GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, BoundaryLayer, RoughnessLength));
if (blModel == 7)
boundaryLayerModel.setHydraulicDiameter(GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, BoundaryLayer, HydraulicDiameter));
normalMoleFracGrad /= boundaryLayerModel.massBoundaryLayerThickness();
Scalar diffusiveFlux =
bfNormal1.two_norm() *
normalMoleFracGrad *
(boundaryVars1.diffusionCoeff(transportCompIdx1) + boundaryVars1.eddyDiffusivity()) *
boundaryVars1.molarDensity();
const Scalar convectiveFlux = normalMassFlux1
* cParams.elemVolVarsCur1[vertInElem1].enthalpy();
// enthalpy transported by diffusive fluxes
// multiply the diffusive flux with the mass transfer coefficient
unsigned int mtModel = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, int, MassTransfer, Model);
if (mtModel != 0)
{
MassTransferModel<TypeTag> massTransferModel(cParams.elemVolVarsCur2[vertInElem2].saturation(wPhaseIdx2),
cParams.elemVolVarsCur2[vertInElem2].porosity(),
boundaryLayerModel.massBoundaryLayerThickness(),
mtModel);
if (mtModel == 1)
massTransferModel.setMassTransferCoeff(GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, MassTransfer, Coefficient));
if (mtModel == 2 || mtModel == 4)
massTransferModel.setCharPoreRadius(GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, MassTransfer, CharPoreRadius));
if (mtModel == 3)
massTransferModel.setCapillaryPressure(cParams.elemVolVarsCur2[vertInElem2].capillaryPressure());
diffusiveFlux *= massTransferModel.massTransferCoefficient();
}
// the boundary layer models only work for two components
assert(numComponents == 2);
static_assert(numComponents == 2,
"This coupling condition is only implemented for two components.");
Scalar diffusiveEnergyFlux = 0.0;
Scalar diffusiveFlux = bfNormal1.two_norm()
* ParentType::template evalBoundaryLayerConcentrationGradient<CParams>(cParams, vertInElem1)
* (boundaryVars1.diffusionCoeff(transportCompIdx1)
+ boundaryVars1.eddyDiffusivity())
* boundaryVars1.molarDensity()
* ParentType::template evalMassTransferCoefficient<CParams>(cParams, vertInElem1, vertInElem2);
diffusiveEnergyFlux += diffusiveFlux * FluidSystem::molarMass(transportCompIdx1)
* boundaryVars1.componentEnthalpy(transportCompIdx1);
diffusiveEnergyFlux -= diffusiveFlux * FluidSystem::molarMass(phaseCompIdx1)
* boundaryVars1.componentEnthalpy(phaseCompIdx1);
// conductive transported energy
const Scalar temperatureOut = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, FreeFlow, RefTemperature);
Scalar normalTemperatureGrad =
cParams.elemVolVarsCur1[vertInElem1].temperature() -
temperatureOut;
normalTemperatureGrad /= boundaryLayerModel.thermalBoundaryLayerThickness();
const Scalar conductiveFlux =
bfNormal1.two_norm() *
normalTemperatureGrad *
(boundaryVars1.thermalConductivity() + boundaryVars1.thermalEddyConductivity());
const Scalar conductiveFlux = bfNormal1.two_norm()
* evalBoundaryLayerTemperatureGradient(cParams, vertInElem1)
* (boundaryVars1.thermalConductivity()
+ boundaryVars1.thermalEddyConductivity());
couplingRes2.accumulate(lfsu_n.child(energyEqIdx2), vertInElem2,
-(convectiveFlux - diffusiveEnergyFlux - conductiveFlux));
......@@ -405,6 +357,25 @@ public:
}
}
}
/*!
* \brief Returns the temperature gradient through the boundary layer
*
* \todo This function could be moved to a more model specific place, because
* of its runtime parameters.
*
* \param cParams a parameter container
* \param scvIdx1 The local index of the sub-control volume of the Stokes domain
*/
template<typename CParams>
Scalar evalBoundaryLayerTemperatureGradient(CParams cParams, const int scvIdx) const
{
const Scalar temperatureOut = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, FreeFlow, RefTemperature);
Scalar normalTemperatureGrad = cParams.elemVolVarsCur1[scvIdx].temperature()
- temperatureOut;
return normalTemperatureGrad
/ ParentType::template evalBoundaryLayerModel(cParams, scvIdx).thermalBoundaryLayerThickness();
}
};
} // end namespace Dumux
......
......@@ -132,7 +132,7 @@ class TwoCStokesTwoPTwoCLocalOperator :
public Dune::PDELab::MultiDomain::FullCouplingPattern,
public Dune::PDELab::InstationaryLocalOperatorDefaultMethods<double>
{
public:
public:
typedef typename GET_PROP_TYPE(TypeTag, Problem) GlobalProblem;
typedef typename GET_PROP_TYPE(TypeTag, MultiDomainCouplingLocalOperator) Implementation;
......@@ -154,6 +154,8 @@ class TwoCStokesTwoPTwoCLocalOperator :
typedef typename GET_PROP_TYPE(Stokes2cTypeTag, FVElementGeometry) FVElementGeometry1;
typedef typename GET_PROP_TYPE(TwoPTwoCTypeTag, FVElementGeometry) FVElementGeometry2;
// typedef typename GET_PROP_TYPE(Stokes2cTypeTag, PrimaryVariables) PrimaryVariables;
// Multidomain Grid types
typedef typename GET_PROP_TYPE(TypeTag, MultiDomainGrid) MDGrid;
typedef typename MDGrid::Traits::template Codim<0>::Entity MDElement;
......@@ -213,6 +215,11 @@ class TwoCStokesTwoPTwoCLocalOperator :
typedef typename Stokes2cGridView::template Codim<dim>::EntityPointer VertexPointer1;
typedef typename TwoPTwoCGridView::template Codim<dim>::EntityPointer VertexPointer2;
// multidomain flags
static const bool doAlphaCoupling = true;
static const bool doPatternCoupling = true;
public:
//! \brief The constructor
TwoCStokesTwoPTwoCLocalOperator(GlobalProblem& globalProblem)
: globalProblem_(globalProblem)
......@@ -229,10 +236,6 @@ class TwoCStokesTwoPTwoCLocalOperator :
std::cout << "Using mass transfer model " << massTransferModel_ << std::endl;
}
// multidomain flags
static const bool doAlphaCoupling = true;
static const bool doPatternCoupling = true;
/*!
* \brief Do the coupling. The unknowns are transferred from dune-multidomain.
* Based on them, a coupling residual is calculated and added at the
......@@ -436,72 +439,33 @@ class TwoCStokesTwoPTwoCLocalOperator :
if (cParams.boundaryTypes2.isCouplingNeumann(contiWEqIdx2))
{
// only enter here, if a BOUNDARY LAYER MODEL is used for the computation of the diffusive fluxes
// only enter here, if a boundary layer model is used for the computation of the diffusive fluxes
if (blModel_)
{
static_assert(!GET_PROP_VALUE(Stokes2cTypeTag, UseMoles),
"Boundary layer and mass transfer models are only implemented for mass fraction formulation.");
const Scalar massFractionOut = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, FreeFlow, RefMassfrac);
const Scalar M1 = FluidSystem::molarMass(transportCompIdx1);
const Scalar M2 = FluidSystem::molarMass(phaseCompIdx1);
const Scalar X2 = 1.0 - massFractionOut;
const Scalar massToMoleDenominator = M2 + X2*(M1 - M2);
const Scalar moleFractionOut = massFractionOut * M2 /massToMoleDenominator;
const Scalar advectiveFlux =
normalMassFlux *
cParams.elemVolVarsCur1[vertInElem1].massFraction(transportCompIdx1);
Scalar normalMoleFracGrad =
cParams.elemVolVarsCur1[vertInElem1].moleFraction(transportCompIdx1) -
moleFractionOut;
const Scalar velocity = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, FreeFlow, RefVelocity);
// current position + additional virtual runup distance
const Scalar distance = globalPos1[0] + GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, BoundaryLayer, Offset);
const Scalar kinematicViscosity = cParams.elemVolVarsCur1[vertInElem2].kinematicViscosity();
BoundaryLayerModel<TypeTag> boundaryLayerModel(velocity, distance, kinematicViscosity, blModel_);
if (blModel_ == 1)
boundaryLayerModel.setConstThickness(GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, BoundaryLayer, ConstThickness));
if (blModel_ >= 4)
boundaryLayerModel.setYPlus(GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, BoundaryLayer, YPlus));
if (blModel_ >= 5)
boundaryLayerModel.setRoughnessLength(GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, BoundaryLayer, RoughnessLength));
if (blModel_ == 7)
boundaryLayerModel.setHydraulicDiameter(GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, BoundaryLayer, HydraulicDiameter));
normalMoleFracGrad /= boundaryLayerModel.massBoundaryLayerThickness();
const Scalar diffusiveFlux =
bfNormal1.two_norm() *
normalMoleFracGrad *
(boundaryVars1.diffusionCoeff(transportCompIdx1) + boundaryVars1.eddyDiffusivity()) *
boundaryVars1.molarDensity() *
FluidSystem::molarMass(transportCompIdx1);
bfNormal1.two_norm()
* evalBoundaryLayerConcentrationGradient<CParams>(cParams, vertInElem1)
* (boundaryVars1.diffusionCoeff(transportCompIdx1)
+ boundaryVars1.eddyDiffusivity())
* boundaryVars1.molarDensity()
* FluidSystem::molarMass(transportCompIdx1);
Scalar advectiveFlux = normalMassFlux * cParams.elemVolVarsCur1[vertInElem1].massFraction(transportCompIdx1);
// TODO: use or remove
// PrimaryVariables flux(0.0);
// globalProblem_.localResidual1().computeAdvectiveFlux(flux, boundaryVars1);
// advectiveFlux = flux[transportEqIdx1];
if (massTransferModel_ == 0)
{
couplingRes2.accumulate(lfsu_n.child(contiWEqIdx2), vertInElem2,
-(advectiveFlux - diffusiveFlux));
}
// transition from the mass transfer coefficient concept to the coupling via the local residual,
// when saturations become small; only diffusive fluxes are scaled!
// transition from the mass transfer coefficient concept to the coupling via
// the local residual; only diffusive fluxes are scaled!
else
{
MassTransferModel<TypeTag> massTransferModel(cParams.elemVolVarsCur2[vertInElem2].saturation(wPhaseIdx2),
cParams.elemVolVarsCur2[vertInElem2].porosity(),
boundaryLayerModel.massBoundaryLayerThickness(),
massTransferModel_);
if (massTransferModel_ == 1)
massTransferModel.setMassTransferCoeff(GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, MassTransfer, Coefficient));
if (massTransferModel_ == 2 || massTransferModel_ == 4)
massTransferModel.setCharPoreRadius(GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, MassTransfer, CharPoreRadius));
if (massTransferModel_ == 3)
massTransferModel.setCapillaryPressure(cParams.elemVolVarsCur2[vertInElem2].capillaryPressure());
const Scalar massTransferCoeff = massTransferModel.massTransferCoefficient();
if (massTransferCoeff > 1.0 || massTransferCoeff < 0.0)
std::cout << "MTC out of bounds, should be in between 0.0 and 1.0! >>> " << massTransferCoeff << std::endl;
const Scalar massTransferCoeff = evalMassTransferCoefficient<CParams>(cParams, vertInElem1, vertInElem2);
if (globalProblem_.sdProblem1().isCornerPoint(globalPos1))
{
......@@ -690,6 +654,110 @@ class TwoCStokesTwoPTwoCLocalOperator :
std::cerr << "Upwind PM -> FF does not work for the transport equation for a 2-phase system!" << std::endl;
}
/*!
* \brief Returns a BoundaryLayerModel object
*
* This function is reused in Child LocalOperators and used for extracting
* the respective boundary layer thickness.<br>
* \todo This function could be moved to a more model specific place, because
* of its runtime parameters.
*
* \param cParams a parameter container
* \param scvIdx1 The local index of the sub-control volume of the Stokes domain
*/
template<typename CParams>
BoundaryLayerModel<TypeTag> evalBoundaryLayerModel(CParams cParams, const int scvIdx1) const
{
static_assert(!GET_PROP_VALUE(Stokes2cTypeTag, UseMoles),
"Boundary layer and mass transfer models are only implemented for mass fraction formulation.");
const Scalar velocity = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, FreeFlow, RefVelocity);
// current position + additional virtual runup distance
const Scalar distance = cParams.fvGeometry1.subContVol[scvIdx1].global[0]
+ GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, BoundaryLayer, Offset);
const Scalar kinematicViscosity = cParams.elemVolVarsCur1[scvIdx1].kinematicViscosity();
BoundaryLayerModel<TypeTag> boundaryLayerModel(velocity, distance, kinematicViscosity, blModel_);
if (blModel_ == 1)
boundaryLayerModel.setConstThickness(GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, BoundaryLayer, ConstThickness));
if (blModel_ >= 4)
boundaryLayerModel.setYPlus(GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, BoundaryLayer, YPlus));
if (blModel_ >= 5)
boundaryLayerModel.setRoughnessLength(GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, BoundaryLayer, RoughnessLength));
if (blModel_ == 7)
boundaryLayerModel.setHydraulicDiameter(GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, BoundaryLayer, HydraulicDiameter));
return boundaryLayerModel;
}
/*!
* \brief Returns the concentration gradient through the boundary layer
*
* \todo This function could be moved to a more model specific place, because
* of its runtime parameters.
*
* \param cParams a parameter container
* \param scvIdx1 The local index of the sub-control volume of the Stokes domain
*/
template<typename CParams>
Scalar evalBoundaryLayerConcentrationGradient(CParams cParams, const int scvIdx1) const
{
Scalar massFractionOut = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, FreeFlow, RefMassfrac);
Scalar M1 = FluidSystem::molarMass(transportCompIdx1);
Scalar M2 = FluidSystem::molarMass(phaseCompIdx1);
Scalar X2 = 1.0 - massFractionOut;
Scalar massToMoleDenominator = M2 + X2*(M1 - M2);
Scalar moleFractionOut = massFractionOut * M2 /massToMoleDenominator;
// TODO: use or remove
// typedef typename GET_PROP_TYPE(Stokes2cTypeTag, FluidState) FluidState;
// FluidState fluidState;
// fluidState.setTemperature(GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, FreeFlow, RefTemperature));
// fluidState.setPressure(nPhaseIdx1, GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, FreeFlow, RefPressure));
// // setMassFraction() has only to be called 1-numComponents times
// fluidState.setMassFraction(nPhaseIdx1, transportCompIdx1, GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, FreeFlow, RefMassfrac));
// std::cout << "moleFraction " << moleFractionOut << " ";
// moleFractionOut = fluidState.moleFraction(nPhaseIdx1, transportCompIdx1);
// std::cout << "moleFraction " << moleFractionOut << std::endl;
Scalar normalMoleFracGrad = cParams.elemVolVarsCur1[scvIdx1].moleFraction(transportCompIdx1)
- moleFractionOut;
return normalMoleFracGrad / evalBoundaryLayerModel<CParams>(cParams, scvIdx1).massBoundaryLayerThickness();
}
/*!
* \brief Returns the mass transfer coefficient
*
* This function is reused in Child LocalOperators.
* \todo This function could be moved to a more model specific place, because
* of its runtime parameters.
*
* \param cParams a parameter container
* \param scvIdx1 The local index of the sub-control volume of the Stokes domain
* \param scvIdx1 The local index of the sub-control volume of the Darcy domain
*/
template<typename CParams>
Scalar evalMassTransferCoefficient(CParams cParams, const int scvIdx1, const int scvIdx2) const
{
if (massTransferModel_ == 0)
return 1.0;
MassTransferModel<TypeTag> massTransferModel(cParams.elemVolVarsCur2[scvIdx2].saturation(wPhaseIdx2),
cParams.elemVolVarsCur2[scvIdx2].porosity(),
evalBoundaryLayerModel<CParams>(cParams, scvIdx1).massBoundaryLayerThickness(),
massTransferModel_);
if (massTransferModel_ == 1)
massTransferModel.setMassTransferCoeff(GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, MassTransfer, Coefficient));
if (massTransferModel_ == 2 || massTransferModel_ == 4)
massTransferModel.setCharPoreRadius(GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, MassTransfer, CharPoreRadius));
if (massTransferModel_ == 3)
massTransferModel.setCapillaryPressure(cParams.elemVolVarsCur2[scvIdx2].capillaryPressure());
Scalar massTransferCoeff = massTransferModel.massTransferCoefficient();
// assert the massTransferCoeff is inside the validity range
assert(!(massTransferCoeff > 1.0 || massTransferCoeff < 0.0));
return massTransferCoeff;
}
protected:
GlobalProblem& globalProblem() const
{ return globalProblem_; }
......@@ -699,6 +767,9 @@ class TwoCStokesTwoPTwoCLocalOperator :
const Implementation *asImp_() const
{ return static_cast<const Implementation *> (this); }
unsigned int blModel_;
unsigned int massTransferModel_;
private:
/*!
* \brief A struct that contains data of the FF and PM including boundary types,
......@@ -716,9 +787,6 @@ class TwoCStokesTwoPTwoCLocalOperator :
FVElementGeometry2 fvGeometry2;
};
unsigned int blModel_;
unsigned int massTransferModel_;
GlobalProblem& globalProblem_;
};
......
......@@ -4,8 +4,8 @@
<Piece NumberOfCells="48" NumberOfPoints="63">
<PointData Scalars="temperature" Vectors="v">
<DataArray type="Float32" Name="temperature" NumberOfComponents="1" format="ascii">
295.777 295.77 298.15 298.141 295.762 298.133 295.755 298.124 295.749 298.115 295.744 298.106
295.741 298.1 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15
295.785 295.777 298.15 298.141 295.769 298.133 295.763 298.124 295.757 298.115 295.751 298.106
295.748 298.101 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15
298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15
298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15
298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15
......@@ -20,85 +20,85 @@
100000 100000 100000
</DataArray>
<DataArray type="Float32" Name="delP" NumberOfComponents="1" format="ascii">
0.00201785 0.00169588 0.00200655 0.00168459 0.00135425 0.00134799 0.00101546 0.00101279 0.000676934 0.000674742 0.000338453 0.000337543
0 0 0.00203022 0.00169113 0.00135307 0.00101496 0.00067667 0.00033832 0 0.0020249 0.00168644 0.0013497
0.00101226 0.000674926 0.000337433 0 0.00203044 0.00169167 0.00135338 0.00101491 0.000676636 0.000338305 0 0.00202712
0.00168831 0.00135073 0.00101277 0.000675252 0.000337628 0 0.00202988 0.00169127 0.00135299 0.00101457 0.000676386 0.000338198
0 0.00202748 0.00168909 0.00135121 0.00101317 0.000675482 0.000337743 0 0.0020284 0.00169001 0.00135195 0.00101372
0.000675849 0.000337922 0
0.00201786 0.00169587 0.00200658 0.0016846 0.00135425 0.001348 0.00101546 0.00101279 0.000676932 0.000674745 0.000338452 0.000337545
0 0 0.00203022 0.00169113 0.00135307 0.00101496 0.000676669 0.00033832 0 0.0020249 0.00168645 0.00134971
0.00101226 0.000674928 0.000337434 0 0.00203043 0.00169167 0.00135338 0.00101491 0.000676635 0.000338305 0 0.00202712
0.00168831 0.00135073 0.00101277 0.000675254 0.000337629 0 0.00202988 0.00169127 0.00135299 0.00101457 0.000676386 0.000338197
0 0.00202749 0.00168909 0.00135121 0.00101317 0.000675484 0.000337744 0 0.0020284 0.00169001 0.00135195 0.00101373
0.000675849 0.000337923 0
</DataArray>
<DataArray type="Float32" Name="x_gas^H2O" NumberOfComponents="1" format="ascii">
0.0274806 0.0274681 0.0127981 0.0128556 0.0274555 0.0129131 0.0274443 0.0129714 0.0274345 0.0130295 0.0274262 0.0130874
0.02742 0.0131159 0.0127981 0.0127981 0.0127982 0.0127984 0.0127985 0.0127988 0.0127988 0.0127981 0.0127981 0.0127981
0.0274932 0.0274805 0.0127981 0.0128556 0.0274677 0.0129132 0.0274563 0.0129716 0.0274463 0.0130298 0.0274377 0.0130877
0.0274314 0.0131162 0.0127981 0.0127981 0.0127982 0.0127984 0.0127985 0.0127988 0.0127988 0.0127981 0.0127981 0.0127981
0.0127981 0.0127981 0.0127981 0.012798 0.0127981 0.0127981 0.0127981 0.0127981 0.0127981 0.0127981 0.0127981 0.0127981
0.0127981 0.0127981 0.0127981 0.0127981 0.0127981 0.0127982 0.0127981 0.0127981 0.0127981 0.0127981 0.0127981 0.0127981
0.0127982 0.0127981 0.0127981 0.0127983 0.0127985 0.0127987 0.0127989 0.0127991 0.0127981 0.0128196 0.0128364 0.0128483
0.0128552 0.0128575 0.0127981
0.0127982 0.0127981 0.0127981 0.0127983 0.0127985 0.0127987 0.0127989 0.0127991 0.0127981 0.0128195 0.0128364 0.0128483
0.0128551 0.0128574 0.0127981
</DataArray>
<DataArray type="Float32" Name="X_gas^H2O" NumberOfComponents="1" format="ascii">
0.0172743 0.0172664 0.008 0.00803612 0.0172584 0.00807226 0.0172513 0.00810889 0.017245 0.00814541 0.0172397 0.00818178
0.0172358 0.00819967 0.008 0.00800003 0.00800009 0.00800018 0.0080003 0.00800045 0.00800043 0.008 0.008 0.008
0.0172823 0.0172743 0.008 0.00803615 0.0172661 0.00807233 0.0172588 0.00810899 0.0172525 0.00814555 0.0172471 0.00818195
0.017243 0.00819986 0.008 0.00800003 0.00800009 0.00800018 0.0080003 0.00800045 0.00800043 0.008 0.008 0.008
0.008 0.008 0.008 0.00799996 0.008 0.008 0.008 0.008 0.008 0.008 0.00800002 0.008
0.008 0.008 0.008 0.008 0.008 0.00800006 0.008 0.008 0.008 0.008 0.008 0.008
0.00800008 0.008 0.00800005 0.00800014 0.00800026 0.0080004 0.00800053 0.00800066 0.008 0.00801351 0.0080241 0.00803158
0.00803588 0.00803734 0.008
0.00800008 0.008 0.00800005 0.00800014 0.00800026 0.0080004 0.00800052 0.00800066 0.008 0.00801349 0.00802406 0.00803154
0.00803582 0.00803728 0.008
</DataArray>
<DataArray type="Float32" Name="x_gas^Air" NumberOfComponents="1" format="ascii">
0.972519 0.972532 0.987202 0.987144 0.972544 0.987087 0.972556 0.987029 0.972565 0.98697 0.972574 0.986913
0.97258 0.986884 0.987202 0.987202 0.987202 0.987202 0.987201 0.987201 0.987201 0.987202 0.987202 0.987202
0.972507 0.972519 0.987202 0.987144 0.972532 0.987087 0.972544 0.987028 0.972554 0.98697 0.972562 0.986912
0.972569 0.986884 0.987202 0.987202 0.987202 0.987202 0.987201 0.987201 0.987201 0.987202 0.987202 0.987202
0.987202 0.987202 0.987202 0.987202 0.987202 0.987202 0.987202 0.987202 0.987202 0.987202 0.987202 0.987202
0.987202 0.987202 0.987202 0.987202 0.987202 0.987202 0.987202 0.987202 0.987202 0.987202 0.987202 0.987202
0.987202 0.987202 0.987202 0.987202 0.987202 0.987201 0.987201 0.987201 0.987202 0.98718 0.987164 0.987152
0.987145 0.987143 0.987202
</DataArray>
<DataArray type="Float32" Name="X_gas^Air" NumberOfComponents="1" format="ascii">
0.982726 0.982734 0.992 0.991964 0.982742 0.991928 0.982749 0.991891 0.982755 0.991855 0.98276 0.991818
0.982764 0.9918 0.992 0.992 0.992 0.992 0.992 0.992 0.992 0.992 0.992 0.992
0.982718 0.982726 0.992 0.991964 0.982734 0.991928 0.982741 0.991891 0.982747 0.991854 0.982753 0.991818
0.982757 0.9918 0.992 0.992 0.992 0.992 0.992 0.992 0.992 0.992 0.992 0.992
0.992 0.992 0.992 0.992 0.992 0.992 0.992 0.992 0.992 0.992 0.992 0.992
0.992 0.992 0.992 0.992 0.992 0.992 0.992 0.992 0.992 0.992 0.992 0.992
0.992 0.992 0.992 0.992 0.992 0.992 0.991999 0.991999 0.992 0.991987 0.991976 0.991968
0.991964 0.991963 0.992
</DataArray>
<DataArray type="Float32" Name="h" NumberOfComponents="1" format="ascii">
65316.4 65289.1 44886.1 44966.4 65261.4 45046.7 65236.8 45128 65215.4 45209.1 65197.1 45289.8
65183.5 45328.7 44886.1 44886.2 44886.3 44886.5 44886.8 44887.1 44886.7 44886.1 44886.1 44886.1
65344 65316.2 44886.1 44966.5 65288.1 45046.9 65263 45128.4 65241.1 45209.5 65222.4 45290.3
65208.5 45329.3 44886.1 44886.2 44886.3 44886.5 44886.8 44887.1 44886.7 44886.1 44886.1 44886.1
44886.1 44886.1 44886.1 44885.9 44886.1 44886.1 44886.1 44886.1 44886.1 44886.1 44886.2 44886.1
44886.1 44886.1 44886.1 44886.1 44886.1 44886.4 44886.1 44886.1 44886.1 44886.1 44886.1 44886.1
44886.6 44886.1 44886.2 44886.4 44886.7 44887.1 44887.4 44888.1 44886.1 44919.5 44945.6 44964.1
44974.7 44978.3 44886.1
44886.6 44886.1 44886.2 44886.4 44886.7 44887.1 44887.4 44888.1 44886.1 44919.4 44945.5 44964
44974.6 44978.2 44886.1
</DataArray>
<DataArray type="Float32" Name="rho" NumberOfComponents="1" format="ascii">
1.1654 1.16544 1.16259 1.1626 1.16547 1.1626 1.16551 1.16261 1.16553 1.16262 1.16556 1.16263
1.16557 1.16264 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259
1.16537 1.1654 1.16259 1.1626 1.16544 1.1626 1.16547 1.16261 1.1655 1.16262 1.16552 1.16263
1.16554 1.16264 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259
1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259
1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259
1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16259 1.16258 1.16257 1.16257
1.16256 1.16256 1.16259
</DataArray>
<DataArray type="Float32" Name="mu" NumberOfComponents="1" format="ascii">
1.78769e-05 1.78767e-05 1.81222e-05 1.81213e-05 1.78764e-05 1.81204e-05 1.78762e-05 1.81194e-05 1.7876e-05 1.81185e-05 1.78759e-05 1.81175e-05
1.78757e-05 1.8117e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05
1.78772e-05 1.78769e-05 1.81222e-05 1.81213e-05 1.78767e-05 1.81204e-05 1.78764e-05 1.81194e-05 1.78763e-05 1.81185e-05 1.78761e-05 1.81175e-05
1.7876e-05 1.8117e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05
1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05
1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05
1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.81222e-05 1.8122e-05 1.81219e-05 1.81218e-05
1.81217e-05 1.81217e-05 1.81222e-05
</DataArray>
<DataArray type="Float32" Name="v" NumberOfComponents="3" format="ascii">
0.000848957 6.66768e-05 0 0.000853193 6.60301e-05 0 0.809861 0 0 0.811318 -0.000107295 0
0.00085682 6.56793e-05 0 0.813044 -3.35829e-05 0 0.000856984 6.54521e-05 0 0.813398 4.20886e-05 0
0.000857581 6.52393e-05 0 0.813694 4.6671e-05 0 0.000857802 6.50234e-05 0 0.813736 5.91948e-05 0
0.000857901 6.50043e-05 0 0.813821 5.87047e-05 0 1.82383 0 0 1.82427 -0.00138789 0
1.82518 -0.000760972 0 1.82578 -0.000165872 0 1.82614 -9.80019e-05 0 1.8263 4.88346e-06 0
1.82641 3.72861e-05 0 2.89743 0 0 2.89719 -0.00112731 0 2.89709 -0.0010362 0
2.89742 -0.000538664 0 2.89766 -0.000271377 0 2.89782 -0.000110682 0 2.89791 -3.62697e-07 0
3.50134 0 0 3.50113 -0.00104869 0 3.50075 -0.00104697 0 3.50054 -0.000726474 0
3.50045 -0.000429876 0 3.50043 -0.000213722 0 3.50041 -3.11169e-05 0 2.89743 0 0
2.89713 -0.00025512 0 2.89659 -0.000353343 0 2.89622 -0.000277651 0 2.89594 -0.000170709 0
2.89582 -8.9147e-05 0 2.89574 -1.94412e-05 0 1.82383 0 0 1.82366 -0.000132838 0
1.82334 -0.000144551 0 1.82306 -0.000124505 0 1.82284 -7.67316e-05 0 1.82274 -3.92422e-05 0
1.82267 -3.21447e-06 0 0.809861 0 0 0.809771 0.000145283 0 0.809618 9.09373e-05 0
0.809485 7.15883e-05 0 0.809368 4.66837e-05 0 0.809325 2.34056e-05 0 0.809289 1.79708e-06 0
0.00134 0 0 0.00134 0 0 0.00134 1.14235e-37 0 0.00134 0 0
0.000848729 6.69021e-05 0 0.000852973 6.62443e-05 0 0.809861 0 0 0.811316 -0.000106896 0
0.000856591 6.5898e-05 0 0.813041 -3.33125e-05 0 0.000856756 6.56704e-05 0 0.813394 4.22838e-05 0
0.000857352 6.54581e-05 0 0.81369 4.68623e-05 0 0.000857574 6.52413e-05 0 0.813732 5.93717e-05 0
0.000857666 6.52293e-05 0 0.813817 5.89199e-05 0 1.82383 0 0 1.82427 -0.00138601 0
1.82518 -0.000759833 0 1.82578 -0.000165395 0 1.82614 -9.76135e-05 0 1.8263 5.15954e-06 0
1.82641 3.74937e-05 0 2.89743 0 0 2.89719 -0.00112596 0 2.89709 -0.00103494 0
2.89742 -0.000537942 0 2.89766 -0.00027095 0 2.89782 -0.000110416 0 2.89791 -1.69109e-07 0
3.50134 0 0 3.50113 -0.00104743 0 3.50075 -0.00104572 0 3.50055 -0.000725561 0
3.50045 -0.000429295 0 3.50043 -0.000213369 0 3.50041 -3.09635e-05 0 2.89743 0 0
2.89713 -0.000254869 0 2.89659 -0.000352968 0 2.89622 -0.00027735 0 2.89594 -0.000170513 0
2.89582 -8.90144e-05 0 2.89574 -1.93633e-05 0 1.82383 0 0 1.82366 -0.000132684 0
1.82334 -0.000144382 0 1.82306 -0.000124357 0 1.82284 -7.66365e-05 0 1.82274 -3.91801e-05 0
1.82267 -3.19218e-06 0 0.809861 0 0 0.809771 0.000145064 0 0.809618 9.07926e-05 0
0.809485 7.14699e-05 0 0.809369 4.66043e-05 0 0.809325 2.33665e-05 0 0.809289 1.79975e-06 0
0.00134 0 0 0.00134 0 0 0.00134 5.67569e-37 0 0.00134 0 0
0.00134 0 0 0.00134 0 0 0.00134 0 0
</DataArray>
</PointData>
......
......@@ -4,14 +4,14 @@
<Piece NumberOfCells="24" NumberOfPoints="35">
<PointData Scalars="Sn" Vectors="velocityW">
<DataArray type="Float32" Name="Sn" NumberOfComponents="1" format="ascii">
0.0100962 0.0100962 0.0103541 0.0103541 0.0100962 0.0103541 0.0100962 0.0103541 0.0100962 0.010354 0.0100962 0.010354
0.0100962 0.010354 0.0136448 0.0136448 0.0136448 0.0136448 0.0136448 0.0136448 0.0136448 0.029998 0.0299979 0.0299978
0.0299978 0.0299977 0.0299977 0.0299976 0.155596 0.155596 0.155596 0.155596 0.155596 0.155596 0.155595
0.0100962 0.0100962 0.0103542 0.0103542 0.0100962 0.0103542 0.0100962 0.0103541 0.0100962 0.0103541 0.0100962 0.0103541
0.0100962 0.0103541 0.0136457 0.0136457 0.0136457 0.0136457 0.0136457 0.0136457 0.0136457 0.0300134 0.0300133 0.0300132
0.0300132 0.0300131 0.0300131 0.030013 0.15567 0.155669 0.155669 0.155669 0.155669 0.155669 0.155669
</DataArray>
<DataArray type="Float32" Name="Sw" NumberOfComponents="1" format="ascii">
0.989904 0.989904 0.989646 0.989646 0.989904 0.989646 0.989904 0.989646 0.989904 0.989646 0.989904 0.989646
0.989904 0.989646 0.986355 0.986355 0.986355 0.986355 0.986355 0.986355 0.986355 0.970002 0.970002 0.970002
0.970002 0.970002 0.970002 0.970002 0.844404 0.844404 0.844404 0.844404 0.844404 0.844404 0.844405
0.989904 0.989646 0.986354 0.986354 0.986354 0.986354 0.986354 0.986354 0.986354 0.969987 0.969987 0.969987
0.969987 0.969987 0.969987 0.969987 0.84433 0.844331 0.844331 0.84433 0.84433 0.844331 0.844331
</DataArray>
<DataArray type="Float32" Name="pn" NumberOfComponents="1" format="ascii">
101179 101179 100209 100209 101179 100209 101179 100209 101179 100209 101179 100209
......@@ -19,34 +19,34 @@
100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000
</DataArray>
<DataArray type="Float32" Name="pw" NumberOfComponents="1" format="ascii">
101162 101162 100146 100146 101162 100146 101162 100146 101162 100146 101162 100146
101162 100146 99468.6 99468.6 99468.6 99468.6 99468.6 99468.6 99468.6 99017.1 99017.1 99017.1
99017.1 99017.1 99017.1 99017.1 98716 98716 98716 98716 98716 98716 98716
101161 101161 100146 100146 101161 100146 101161 100146 101161 100146 101161 100146
101161 100146 99468.5 99468.5 99468.5 99468.5 99468.5 99468.5 99468.5 99017 99017 99017
99017 99017 99017 99017 98715.9 98715.9 98715.9 98715.9 98715.9 98715.9 98715.9
</DataArray>
<DataArray type="Float32" Name="pc" NumberOfComponents="1" format="ascii">
17.4504 17.4505 63.3108 63.3137 17.4505 63.3073 17.4496 63.3059 17.4496 63.3027 17.4496 63.3008
17.45 63.3003 532.263 532.262 532.262 532.261 532.261 532.261 532.26 983.283 983.282 983.282
983.282 983.281 983.281 983.28 1284.03 1284.03 1284.03 1284.03 1284.03 1284.03 1284.03
17.4518 17.4517 63.3252 63.324 17.4518 63.323 17.4512 63.3198 17.4513 63.3176 17.4511 63.3157
17.4512 63.3149 532.36 532.359 532.359 532.358 532.358 532.358 532.357 983.379 983.379 983.378
983.378 983.378 983.378 983.377 1284.13 1284.13 1284.13 1284.13 1284.13 1284.13 1284.13
</DataArray>
<DataArray type="Float32" Name="rhoW" NumberOfComponents="1" format="ascii">
997.056 997.056 997.076 997.076 997.056 997.076 997.056 997.076 997.056 997.076 997.056 997.076
997.056 997.076 997.18 997.18 997.18 997.18 997.18 997.181 997.181 997.402 997.403 997.403
997.404 997.405 997.405 997.406 997.636 997.638 997.64 997.641 997.643 997.644 997.645
997.056 997.076 997.18 997.18 997.18 997.18 997.18 997.18 997.18 997.401 997.402 997.403
997.403 997.404 997.405 997.405 997.634 997.636 997.638 997.64 997.641 997.642 997.643
</DataArray>
<DataArray type="Float32" Name="rhoN" NumberOfComponents="1" format="ascii">
1.16805 1.16805 1.15708 1.15708 1.16805 1.15708 1.16805 1.15708 1.16805 1.15708 1.16805 1.15708
1.16805 1.15708 1.15658 1.15658 1.15659 1.15659 1.1566 1.1566 1.1566 1.1608 1.16081 1.16082
1.16084 1.16085 1.16086 1.16087 1.1654 1.16544 1.16547 1.16551 1.16553 1.16556 1.16557
1.16805 1.15708 1.15658 1.15658 1.15658 1.15659 1.15659 1.15659 1.15659 1.16078 1.16079 1.16081
1.16082 1.16084 1.16085 1.16085 1.16537 1.1654 1.16544 1.16547 1.1655 1.16552 1.16554
</DataArray>
<DataArray type="Float32" Name="mobW" NumberOfComponents="1" format="ascii">
1123.57 1123.57 1121.57 1121.57 1123.57 1121.57 1123.57 1121.57 1123.57 1121.57 1123.57 1121.57
1123.57 1121.57 1110.04 1110.04 1110.02 1110 1109.98 1109.96 1109.96 1060.65 1060.61 1060.53
1060.45 1060.39 1060.33 1060.31 614.332 614.225 614.115 614.018 613.933 613.86 613.807
1123.57 1123.57 1121.58 1121.58 1123.57 1121.57 1123.57 1121.57 1123.57 1121.57 1123.57 1121.57
1123.57 1121.57 1110.06 1110.05 1110.04 1110.02 1110 1109.98 1109.98 1060.7 1060.65 1060.57
1060.49 1060.42 1060.37 1060.34 614.273 614.163 614.052 613.953 613.866 613.792 613.738
</DataArray>
<DataArray type="Float32" Name="mobN" NumberOfComponents="1" format="ascii">
0.000310596 0.000310601 0.00469607 0.00469654 0.0003106 0.00469553 0.000310565 0.00469532 0.000310566 0.00469481 0.000310566 0.0046945
0.000310581 0.00469443 0.604501 0.604499 0.604499 0.604498 0.604498 0.604497 0.604495 20.9598 20.9597 20.9597
20.9597 20.9597 20.9597 20.9595 1291.2 1291.21 1291.23 1291.25 1291.26 1291.27 1291.27
0.000310649 0.000310643 0.00469836 0.00469816 0.000310648 0.00469801 0.000310627 0.0046975 0.000310629 0.00469715 0.000310623 0.00469685
0.000310626 0.00469672 0.604801 0.6048 0.604799 0.604799 0.604798 0.604797 0.604795 20.9933 20.9931 20.9931
20.9932 20.9932 20.9931 20.993 1292.53 1292.55 1292.56 1292.58 1292.59 1292.61 1292.61
</DataArray>
<DataArray type="Float32" Name="X_liquid^H2O" NumberOfComponents="1" format="ascii">
0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978
......@@ -54,19 +54,19 @@
0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978
</DataArray>
<DataArray type="Float32" Name="X_liquid^Air" NumberOfComponents="1" format="ascii">
2.18092e-05 2.18092e-05 2.16227e-05 2.16228e-05 2.18092e-05 2.16227e-05 2.18092e-05 2.16228e-05 2.18092e-05 2.16228e-05 2.18092e-05 2.16228e-05
2.18092e-05 2.16228e-05 2.17332e-05 2.17333e-05 2.17336e-05 2.17339e-05 2.17342e-05 2.17344e-05 2.17344e-05 2.20846e-05 2.20853e-05 2.20866e-05
2.20878e-05 2.20889e-05 2.20898e-05 2.20902e-05 2.24826e-05 2.24857e-05 2.24888e-05 2.24916e-05 2.2494e-05 2.24961e-05 2.24976e-05
2.18092e-05 2.18092e-05 2.16226e-05 2.16226e-05 2.18092e-05 2.16227e-05 2.18092e-05 2.16227e-05 2.18092e-05 2.16227e-05 2.18092e-05 2.16228e-05
2.18092e-05 2.16228e-05 2.17329e-05 2.1733e-05 2.17333e-05 2.17336e-05 2.17339e-05 2.17341e-05 2.17341e-05 2.20832e-05 2.2084e-05 2.20853e-05
2.20866e-05 2.20877e-05 2.20885e-05 2.2089e-05 2.24795e-05 2.24826e-05 2.24858e-05 2.24886e-05 2.24911e-05 2.24932e-05 2.24948e-05
</DataArray>
<DataArray type="Float32" Name="X_gas^H2O" NumberOfComponents="1" format="ascii">
0.0197215 0.0197215 0.0198218 0.0198216 0.0197215 0.0198217 0.0197215 0.0198216 0.0197215 0.0198215 0.0197215 0.0198215
0.0197215 0.0198214 0.0193754 0.0193753 0.0193742 0.0193733 0.0193725 0.0193719 0.0193717 0.018345 0.018343 0.0183393
0.0183359 0.0183329 0.0183304 0.0183293 0.0172743 0.0172664 0.0172584 0.0172513 0.017245 0.0172397 0.0172358
0.0197216 0.0197216 0.019822 0.019822 0.0197216 0.0198219 0.0197216 0.0198218 0.0197216 0.0198217 0.0197216 0.0198216
0.0197216 0.0198216 0.0193764 0.0193759 0.0193752 0.0193743 0.0193734 0.0193728 0.0193726 0.0183488 0.0183467 0.018343
0.0183395 0.0183364 0.0183339 0.0183327 0.0172823 0.0172743 0.0172661 0.0172588 0.0172525 0.0172471 0.017243
</DataArray>
<DataArray type="Float32" Name="X_gas^Air" NumberOfComponents="1" format="ascii">
0.980278 0.980278 0.980178 0.980178 0.980278 0.980178 0.980278 0.980178 0.980278 0.980178 0.980278 0.980179
0.980278 0.980179 0.980625 0.980625 0.980626 0.980627 0.980628 0.980628 0.980628 0.981655 0.981657 0.981661
0.981664 0.981667 0.98167 0.981671 0.982726 0.982734 0.982742 0.982749 0.982755 0.98276 0.982764
0.980278 0.980278 0.980178 0.980178 0.980278 0.980178 0.980278 0.980178 0.980278 0.980178 0.980278 0.980178
0.980278 0.980178 0.980624 0.980624 0.980625 0.980626 0.980627 0.980627 0.980627 0.981651 0.981653 0.981657
0.98166 0.981664 0.981666 0.981667 0.982718 0.982726 0.982734 0.982741 0.982747 0.982753 0.982757
</DataArray>
<DataArray type="Float32" Name="x_liquid^H2O" NumberOfComponents="1" format="ascii">
0.999986 0.999986 0.999987 0.999987 0.999986 0.999987 0.999986 0.999987 0.999986 0.999987 0.999986 0.999987
......@@ -74,19 +74,19 @@
0.999986 0.999986 0.999986 0.999986 0.999986 0.999986 0.999986 0.999986 0.999986 0.999986 0.999986
</DataArray>
<DataArray type="Float32" Name="x_liquid^Air" NumberOfComponents="1" format="ascii">
1.3567e-05 1.3567e-05 1.3451e-05 1.3451e-05 1.3567e-05 1.3451e-05 1.3567e-05 1.3451e-05 1.3567e-05 1.3451e-05 1.3567e-05 1.3451e-05
1.3567e-05 1.3451e-05 1.35197e-05 1.35197e-05 1.352e-05 1.35202e-05 1.35203e-05 1.35204e-05 1.35205e-05 1.37383e-05 1.37388e-05 1.37396e-05
1.37403e-05 1.3741e-05 1.37415e-05 1.37418e-05 1.39859e-05 1.39878e-05 1.39898e-05 1.39915e-05 1.3993e-05 1.39943e-05 1.39952e-05
1.3567e-05 1.3567e-05 1.34509e-05 1.34509e-05 1.3567e-05 1.3451e-05 1.3567e-05 1.3451e-05 1.3567e-05 1.3451e-05 1.3567e-05 1.3451e-05
1.3567e-05 1.3451e-05 1.35195e-05 1.35196e-05 1.35198e-05 1.352e-05 1.35201e-05 1.35202e-05 1.35203e-05 1.37375e-05 1.37379e-05 1.37387e-05
1.37395e-05 1.37402e-05 1.37408e-05 1.3741e-05 1.3984e-05 1.39859e-05 1.39879e-05 1.39896e-05 1.39912e-05 1.39925e-05 1.39935e-05
</DataArray>
<DataArray type="Float32" Name="x_gas^H2O" NumberOfComponents="1" format="ascii">
0.0313277 0.0313277 0.0314851 0.0314847 0.0313277 0.0314849 0.0313277 0.0314848 0.0313277 0.0314846 0.0313277 0.0314846
0.0313277 0.0314845 0.0307842 0.030784 0.0307824 0.0307809 0.0307797 0.0307787 0.0307784 0.0291652 0.0291619 0.0291563
0.0291508 0.0291461 0.0291422 0.0291404 0.0274806 0.0274681 0.0274555 0.0274443 0.0274345 0.0274262 0.02742
0.0313277 0.0313277 0.0314853 0.0314854 0.0313277 0.0314851 0.0313277 0.031485 0.0313277 0.0314849 0.0313277 0.0314848
0.0313277 0.0314847 0.0307857 0.0307851 0.0307839 0.0307824 0.0307811 0.0307802 0.0307798 0.0291711 0.0291679 0.0291621
0.0291565 0.0291516 0.0291477 0.0291458 0.0274932 0.0274805 0.0274677 0.0274563 0.0274463 0.0274377 0.0274314
</DataArray>
<DataArray type="Float32" Name="x_gas^Air" NumberOfComponents="1" format="ascii">
0.968672 0.968672 0.968515 0.968515 0.968672 0.968515 0.968672 0.968515 0.968672 0.968515 0.968672 0.968515
0.968672 0.968516 0.969216 0.969216 0.969218 0.969219 0.96922 0.969221 0.969222 0.970835 0.970838 0.970844
0.970849 0.970854 0.970858 0.97086 0.972519 0.972532 0.972544 0.972556 0.972565 0.972574 0.97258
0.968672 0.968515 0.969214 0.969215 0.969216 0.969218 0.969219 0.96922 0.96922 0.970829 0.970832 0.970838
0.970843 0.970848 0.970852 0.970854 0.972507 0.972519 0.972532 0.972544 0.972554 0.972562 0.972569
</DataArray>
<DataArray type="Float32" Name="porosity" NumberOfComponents="1" format="ascii">
0.41 0.41 0.41 0.41 0.41 0.41 0.41 0.41 0.41 0.41 0.41 0.41
......@@ -94,9 +94,9 @@
0.41 0.41 0.41 0.41 0.41 0.41 0.41 0.41 0.41 0.41 0.41
</DataArray>
<DataArray type="Float32" Name="temperature" NumberOfComponents="1" format="ascii">
298.15 298.15 298.073 298.072 298.15 298.072 298.15 298.072 298.15 298.072 298.15 298.072
298.15 298.072 297.661 297.661 297.66 297.659 297.658 297.658 297.658 296.761 296.759 296.756
296.753 296.75 296.748 296.747 295.777 295.77 295.762 295.755 295.749 295.744 295.741
298.15 298.15 298.073 298.073 298.15 298.073 298.15 298.072 298.15 298.072 298.15 298.072
298.15 298.072 297.662 297.661 297.661 297.66 297.659 297.659 297.658 296.764 296.762 296.759
296.756 296.753 296.751 296.75 295.785 295.777 295.769 295.763 295.757 295.751 295.748
</DataArray>
<DataArray type="Float32" Name="phase presence" NumberOfComponents="1" format="ascii">
3 3 3 3 3 3 3 3 3 3 3 3
......@@ -104,26 +104,26 @@
3 3 3 3 3 3 3 3 3 3 3
</DataArray>
<DataArray type="Float32" Name="velocityW" NumberOfComponents="3" format="ascii">
-1.04259e-10 -4.0445e-10 0 -1.72222e-10 -4.94918e-10 0 -1.508e-10 -1.93225e-09 0 -2.82687e-10 -2.05701e-09 0
-2.87126e-10 -5.47324e-10 0 -4.57865e-10 -2.2863e-09 0 -3.32034e-10 -6.69327e-10 0 -4.8384e-10 -2.53465e-09 0
-2.84366e-10 -7.77995e-10 0 -4.00854e-10 -2.74503e-09 0 -1.63386e-10 -8.52068e-10 0 -2.29038e-10 -2.90188e-09 0
-8.80414e-11 -8.83728e-10 0 -1.22889e-10 -2.96632e-09 0 -2.58097e-10 -2.4516e-09 0 -3.71514e-10 -2.79538e-09 0
-4.81354e-10 -3.37231e-09 0 -4.45175e-10 -3.79386e-09 0 -3.64719e-10 -4.13226e-09 0 -2.30251e-10 -4.43021e-09 0
-1.43637e-10 -4.60213e-09 0 9.92193e-12 1.19774e-08 0 2.00312e-10 1.12455e-08 0 4.55293e-10 1.06005e-08 0
5.06283e-10 1.01966e-08 0 4.27484e-10 9.87505e-09 0 2.39403e-10 9.56674e-09 0 1.1652e-10 9.29334e-09 0
7.34693e-10 2.53979e-08 0 9.14005e-10 2.44626e-08 0 1.11842e-09 2.39203e-08 0 1.08283e-09 2.3581e-08 0
9.19048e-10 2.33026e-08 0 6.56997e-10 2.30422e-08 0 4.98033e-10 2.2742e-08 0
-9.58175e-11 -4.2546e-10 0 -1.81911e-10 -4.49609e-10 0 -1.63525e-10 -1.92698e-09 0 -2.8296e-10 -2.03582e-09 0
-3.08578e-10 -5.63133e-10 0 -4.53465e-10 -2.28574e-09 0 -3.4457e-10 -6.7563e-10 0 -4.89316e-10 -2.53587e-09 0
-2.92234e-10 -7.83235e-10 0 -4.08145e-10 -2.75011e-09 0 -1.66588e-10 -8.58339e-10 0 -2.34515e-10 -2.91054e-09 0
-8.86966e-11 -8.85282e-10 0 -1.26835e-10 -2.97501e-09 0 -2.69547e-10 -2.39849e-09 0 -3.74168e-10 -2.80675e-09 0
-4.79685e-10 -3.34372e-09 0 -4.48735e-10 -3.78399e-09 0 -3.68919e-10 -4.13262e-09 0 -2.33728e-10 -4.43756e-09 0
-1.46506e-10 -4.61757e-09 0 2.98484e-11 1.2079e-08 0 2.02847e-10 1.12857e-08 0 4.53404e-10 1.06743e-08 0
5.20395e-10 1.0256e-08 0 4.43935e-10 9.92635e-09 0 2.51573e-10 9.61285e-09 0 1.25101e-10 9.332e-09 0
7.56158e-10 2.55265e-08 0 9.30427e-10 2.45628e-08 0 1.13512e-09 2.40277e-08 0 1.10738e-09 2.36838e-08 0
9.4487e-10 2.3401e-08 0 6.7723e-10 2.31381e-08 0 5.13928e-10 2.28344e-08 0
</DataArray>
<DataArray type="Float32" Name="velocityN" NumberOfComponents="3" format="ascii">
-1.68666e-15 7.67784e-10 0 7.37758e-16 7.67796e-10 0 -6.40493e-14 2.24854e-09 0 3.95948e-14 2.24875e-09 0
2.54636e-15 7.67796e-10 0 8.83519e-14 2.24831e-09 0 1.70496e-15 7.67712e-10 0 5.25696e-14 2.24816e-09 0
1.17661e-15 7.67716e-10 0 5.76081e-14 2.24794e-09 0 2.58946e-16 7.67718e-10 0 2.73881e-14 2.24781e-09 0
-3.55959e-16 7.67755e-10 0 1.12342e-14 2.2478e-09 0 1.04943e-12 1.74939e-09 0 2.46231e-12 1.74587e-09 0
2.96714e-12 1.74879e-09 0 2.34187e-12 1.74425e-09 0 2.41466e-12 1.74277e-09 0 2.2128e-12 1.74083e-09 0
2.22091e-12 1.74303e-09 0 8.69231e-11 -1.49028e-08 0 6.55309e-11 -1.48117e-08 0 4.52764e-11 -1.48299e-08 0
4.54162e-11 -1.484e-08 0 4.55163e-11 -1.48482e-08 0 6.65953e-11 -1.48717e-08 0 8.65763e-11 -1.47711e-08 0
5.42893e-09 -2.9575e-08 0 4.12853e-09 -2.93855e-08 0 2.80452e-09 -2.94286e-08 0 2.77627e-09 -2.94398e-08 0
2.78334e-09 -2.94537e-08 0 4.1901e-09 -2.94971e-08 0 5.58515e-09 -2.93004e-08 0
8.2456e-16 7.67906e-10 0 5.07216e-16 7.67892e-10 0 3.02122e-14 2.24876e-09 0 2.55256e-14 2.24867e-09 0
1.27307e-15 7.67906e-10 0 4.75043e-14 2.24861e-09 0 1.63519e-15 7.67854e-10 0 6.1894e-14 2.24836e-09 0
1.00968e-15 7.67862e-10 0 4.62091e-14 2.24821e-09 0 6.87663e-16 7.67848e-10 0 3.1429e-14 2.24807e-09 0
2.70063e-16 7.67856e-10 0 2.00584e-14 2.24802e-09 0 2.40055e-12 1.74641e-09 0 2.12686e-12 1.74973e-09 0
2.24766e-12 1.74615e-09 0 2.46124e-12 1.74471e-09 0 2.21766e-12 1.74218e-09 0 2.25344e-12 1.74032e-09 0
2.35189e-12 1.74301e-09 0 8.32294e-11 -1.49414e-08 0 6.54632e-11 -1.48446e-08 0 4.61632e-11 -1.48703e-08 0
4.49127e-11 -1.48792e-08 0 4.58852e-11 -1.48882e-08 0 6.65314e-11 -1.49122e-08 0 8.64886e-11 -1.48107e-08 0
5.4352e-09 -2.9646e-08 0 4.13295e-09 -2.94592e-08 0 2.80761e-09 -2.95036e-08 0 2.77917e-09 -2.95189e-08 0
2.78594e-09 -2.95322e-08 0 4.19428e-09 -2.95767e-08 0 5.5905e-09 -2.93793e-08 0
</DataArray>
</PointData>
<CellData Scalars="process rank">
......
0% Loading or .
You are about to add 0 people to the discussion. Proceed with caution.
Finish editing this message first!
Please register or to comment