Merge pull request #162 from andlaus/vcfv_ad

make AD work for the vertex-centered finite volume discretization
This commit is contained in:
Andreas Lauser 2017-07-25 12:19:16 +02:00 committed by GitHub
commit 69ad7630d6
37 changed files with 1409 additions and 6078 deletions

View File

@ -23,8 +23,8 @@
/*! /*!
* \file * \file
* *
* \brief Two-phase test for the immiscible model which uses the * \brief Two-phase test for the immiscible model which uses the element-centered finite
* vertex-centered finite volume discretization * volume discretization in conjunction with automatic differentiation
*/ */
#include "config.h" #include "config.h"
@ -35,21 +35,21 @@
namespace Ewoms { namespace Ewoms {
namespace Properties { namespace Properties {
NEW_TYPE_TAG(LensProblemEcfv, INHERITS_FROM(ImmiscibleTwoPhaseModel, LensBaseProblem)); NEW_TYPE_TAG(LensProblemEcfvAd, INHERITS_FROM(ImmiscibleTwoPhaseModel, LensBaseProblem));
// use the element centered finite volume spatial discretization // use the element centered finite volume spatial discretization
SET_TAG_PROP(LensProblemEcfv, SpatialDiscretizationSplice, EcfvDiscretization); SET_TAG_PROP(LensProblemEcfvAd, SpatialDiscretizationSplice, EcfvDiscretization);
// use automatic differentiation for this simulator // use automatic differentiation for this simulator
SET_TAG_PROP(LensProblemEcfv, LocalLinearizerSplice, AutoDiffLocalLinearizer); SET_TAG_PROP(LensProblemEcfvAd, LocalLinearizerSplice, AutoDiffLocalLinearizer);
// this problem works fine if the linear solver uses single precision scalars // this problem works fine if the linear solver uses single precision scalars
SET_TYPE_PROP(LensProblemEcfv, LinearSolverScalar, float); SET_TYPE_PROP(LensProblemEcfvAd, LinearSolverScalar, float);
}} }}
int main(int argc, char **argv) int main(int argc, char **argv)
{ {
typedef TTAG(LensProblemEcfv) ProblemTypeTag; typedef TTAG(LensProblemEcfvAd) ProblemTypeTag;
return Ewoms::start<ProblemTypeTag>(argc, argv); return Ewoms::start<ProblemTypeTag>(argc, argv);
} }

View File

@ -34,17 +34,19 @@
namespace Ewoms { namespace Ewoms {
namespace Properties { namespace Properties {
NEW_TYPE_TAG(LensProblemVcfv, INHERITS_FROM(ImmiscibleTwoPhaseModel, LensBaseProblem)); NEW_TYPE_TAG(LensProblemVcfvAd, INHERITS_FROM(ImmiscibleTwoPhaseModel, LensBaseProblem));
// use automatic differentiation for this simulator
SET_TAG_PROP(LensProblemVcfvAd, LocalLinearizerSplice, AutoDiffLocalLinearizer);
// use linear finite element gradients if dune-localfunctions is available
#if HAVE_DUNE_LOCALFUNCTIONS #if HAVE_DUNE_LOCALFUNCTIONS
// for this test we use P1 finite element gradients (if they are available) SET_BOOL_PROP(LensProblemVcfvAd, UseP1FiniteElementGradients, true);
SET_BOOL_PROP(LensProblemVcfv, UseP1FiniteElementGradients, true); #endif
#endif // HAVE_DUNE_LOCALFUNCTIONS }}
}} // namespace Properties, Ewoms
int main(int argc, char **argv) int main(int argc, char **argv)
{ {
typedef TTAG(LensProblemVcfv) ProblemTypeTag; typedef TTAG(LensProblemVcfvAd) ProblemTypeTag;
return Ewoms::start<ProblemTypeTag>(argc, argv); return Ewoms::start<ProblemTypeTag>(argc, argv);
} }

View File

@ -0,0 +1,52 @@
// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
// vi: set et ts=4 sw=4 sts=4:
/*
This file is part of the Open Porous Media project (OPM).
OPM 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.
OPM 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 OPM. If not, see <http://www.gnu.org/licenses/>.
Consult the COPYING file in the top-level source directory of this
module for the precise wording of the license and the list of
copyright holders.
*/
/*!
* \file
*
* \brief Two-phase test for the immiscible model which uses the
* vertex-centered finite volume discretization
*/
#include "config.h"
#include <ewoms/common/start.hh>
#include <ewoms/models/immiscible/immisciblemodel.hh>
#include "problems/lensproblem.hh"
namespace Ewoms {
namespace Properties {
NEW_TYPE_TAG(LensProblemVcfvFd, INHERITS_FROM(ImmiscibleTwoPhaseModel, LensBaseProblem));
// use the finite difference methodfor this simulator
SET_TAG_PROP(LensProblemVcfvFd, LocalLinearizerSplice, FiniteDifferenceLocalLinearizer);
// use linear finite element gradients if dune-localfunctions is available
#if HAVE_DUNE_LOCALFUNCTIONS
SET_BOOL_PROP(LensProblemVcfvFd, UseP1FiniteElementGradients, true);
#endif
}}
int main(int argc, char **argv)
{
typedef TTAG(LensProblemVcfvFd) ProblemTypeTag;
return Ewoms::start<ProblemTypeTag>(argc, argv);
}

View File

@ -33,15 +33,16 @@
namespace Ewoms { namespace Ewoms {
namespace Properties { namespace Properties {
NEW_TYPE_TAG(PowerInjectionProblem, NEW_TYPE_TAG(PowerInjectionDarcyAdProblem,
INHERITS_FROM(ImmiscibleTwoPhaseModel, INHERITS_FROM(ImmiscibleTwoPhaseModel,
PowerInjectionBaseProblem)); PowerInjectionBaseProblem));
SET_TYPE_PROP(PowerInjectionProblem, FluxModule, Ewoms::DarcyFluxModule<TypeTag>); SET_TYPE_PROP(PowerInjectionDarcyAdProblem, FluxModule, Ewoms::DarcyFluxModule<TypeTag>);
SET_TAG_PROP(PowerInjectionDarcyAdProblem, LocalLinearizerSplice, AutoDiffLocalLinearizer);
}} }}
int main(int argc, char **argv) int main(int argc, char **argv)
{ {
typedef TTAG(PowerInjectionProblem) ProblemTypeTag; typedef TTAG(PowerInjectionDarcyAdProblem) ProblemTypeTag;
return Ewoms::start<ProblemTypeTag>(argc, argv); return Ewoms::start<ProblemTypeTag>(argc, argv);
} }

View File

@ -33,15 +33,16 @@
namespace Ewoms { namespace Ewoms {
namespace Properties { namespace Properties {
NEW_TYPE_TAG(PowerInjectionProblem, NEW_TYPE_TAG(PowerInjectionDarcyFdProblem,
INHERITS_FROM(ImmiscibleTwoPhaseModel, INHERITS_FROM(ImmiscibleTwoPhaseModel,
PowerInjectionBaseProblem)); PowerInjectionBaseProblem));
SET_TYPE_PROP(PowerInjectionProblem, FluxModule, Ewoms::ForchheimerFluxModule<TypeTag>); SET_TYPE_PROP(PowerInjectionDarcyFdProblem, FluxModule, Ewoms::DarcyFluxModule<TypeTag>);
SET_TAG_PROP(PowerInjectionDarcyFdProblem, LocalLinearizerSplice, FiniteDifferenceLocalLinearizer);
}} }}
int main(int argc, char **argv) int main(int argc, char **argv)
{ {
typedef TTAG(PowerInjectionProblem) ProblemTypeTag; typedef TTAG(PowerInjectionDarcyFdProblem) ProblemTypeTag;
return Ewoms::start<ProblemTypeTag>(argc, argv); return Ewoms::start<ProblemTypeTag>(argc, argv);
} }

View File

@ -23,15 +23,26 @@
/*! /*!
* \file * \file
* *
* \brief Test for the isothermal two-component Stokes VCVF discretization. * \brief Test for the Forchheimer velocity model
*/ */
#include "config.h" #include "config.h"
#include <ewoms/common/start.hh> #include <ewoms/common/start.hh>
#include "problems/stokes2ctestproblem.hh" #include <ewoms/models/immiscible/immisciblemodel.hh>
#include "problems/powerinjectionproblem.hh"
namespace Ewoms {
namespace Properties {
NEW_TYPE_TAG(PowerInjectionForchheimerAdProblem,
INHERITS_FROM(ImmiscibleTwoPhaseModel,
PowerInjectionBaseProblem));
SET_TYPE_PROP(PowerInjectionForchheimerAdProblem, FluxModule, Ewoms::ForchheimerFluxModule<TypeTag>);
SET_TAG_PROP(PowerInjectionForchheimerAdProblem, LocalLinearizerSplice, AutoDiffLocalLinearizer);
}}
int main(int argc, char **argv) int main(int argc, char **argv)
{ {
typedef TTAG(Stokes2cTestProblem) ProblemTypeTag; typedef TTAG(PowerInjectionForchheimerAdProblem) ProblemTypeTag;
return Ewoms::start<ProblemTypeTag>(argc, argv); return Ewoms::start<ProblemTypeTag>(argc, argv);
} }

View File

@ -0,0 +1,48 @@
// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
// vi: set et ts=4 sw=4 sts=4:
/*
This file is part of the Open Porous Media project (OPM).
OPM 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.
OPM 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 OPM. If not, see <http://www.gnu.org/licenses/>.
Consult the COPYING file in the top-level source directory of this
module for the precise wording of the license and the list of
copyright holders.
*/
/*!
* \file
*
* \brief Test for the Forchheimer velocity model
*/
#include "config.h"
#include <ewoms/common/start.hh>
#include <ewoms/models/immiscible/immisciblemodel.hh>
#include "problems/powerinjectionproblem.hh"
namespace Ewoms {
namespace Properties {
NEW_TYPE_TAG(PowerInjectionForchheimerFdProblem,
INHERITS_FROM(ImmiscibleTwoPhaseModel,
PowerInjectionBaseProblem));
SET_TYPE_PROP(PowerInjectionForchheimerFdProblem, FluxModule, Ewoms::ForchheimerFluxModule<TypeTag>);
SET_TAG_PROP(PowerInjectionForchheimerFdProblem, LocalLinearizerSplice, FiniteDifferenceLocalLinearizer);
}}
int main(int argc, char **argv)
{
typedef TTAG(PowerInjectionForchheimerFdProblem) ProblemTypeTag;
return Ewoms::start<ProblemTypeTag>(argc, argv);
}

View File

@ -210,7 +210,6 @@ class LensProblem : public GET_PROP_TYPE(TypeTag, BaseProblem)
typedef typename GET_PROP_TYPE(TypeTag, EqVector) EqVector; typedef typename GET_PROP_TYPE(TypeTag, EqVector) EqVector;
typedef typename GET_PROP_TYPE(TypeTag, RateVector) RateVector; typedef typename GET_PROP_TYPE(TypeTag, RateVector) RateVector;
typedef typename GET_PROP_TYPE(TypeTag, BoundaryRateVector) BoundaryRateVector; typedef typename GET_PROP_TYPE(TypeTag, BoundaryRateVector) BoundaryRateVector;
typedef typename GET_PROP_TYPE(TypeTag, MaterialLaw) MaterialLaw; typedef typename GET_PROP_TYPE(TypeTag, MaterialLaw) MaterialLaw;
typedef typename GET_PROP_TYPE(TypeTag, MaterialLawParams) MaterialLawParams; typedef typename GET_PROP_TYPE(TypeTag, MaterialLawParams) MaterialLawParams;
@ -365,9 +364,14 @@ public:
*/ */
std::string name() const std::string name() const
{ {
typedef typename GET_PROP_TYPE(TypeTag, LocalLinearizerSplice) LLS;
bool useAutoDiff = std::is_same<LLS, TTAG(AutoDiffLocalLinearizer)>::value;
std::ostringstream oss; std::ostringstream oss;
oss << "lens_" << Model::name() oss << "lens_" << Model::name()
<< "_" << Model::discretizationName(); << "_" << Model::discretizationName()
<< "_" << (useAutoDiff?"ad":"fd");
return oss.str(); return oss.str();
} }

View File

@ -239,6 +239,13 @@ public:
oss << "darcy"; oss << "darcy";
else else
oss << "forchheimer"; oss << "forchheimer";
if (std::is_same<typename GET_PROP_TYPE(TypeTag, LocalLinearizerSplice),
TTAG(AutoDiffLocalLinearizer)>::value)
oss << "_" << "ad";
else
oss << "_" << "fd";
return oss.str(); return oss.str();
} }

View File

@ -1,319 +0,0 @@
// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
// vi: set et ts=4 sw=4 sts=4:
/*
This file is part of the Open Porous Media project (OPM).
OPM 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.
OPM 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 OPM. If not, see <http://www.gnu.org/licenses/>.
Consult the COPYING file in the top-level source directory of this
module for the precise wording of the license and the list of
copyright holders.
*/
/*!
* \file
* \copydoc Ewoms::Stokes2cTestProblem
*/
#ifndef EWOMS_STOKES_2C_TEST_PROBLEM_HH
#define EWOMS_STOKES_2C_TEST_PROBLEM_HH
#include <ewoms/models/stokes/stokesmodel.hh>
#include <opm/material/fluidsystems/H2OAirFluidSystem.hpp>
#include <opm/common/Unused.hpp>
#include <dune/grid/yaspgrid.hh>
#include <dune/grid/io/file/dgfparser/dgfyasp.hh>
#include <dune/common/version.hh>
#include <dune/common/fvector.hh>
namespace Ewoms {
template <class TypeTag>
class Stokes2cTestProblem;
}
namespace Ewoms {
//////////
// Specify the properties for the stokes2c problem
//////////
namespace Properties {
NEW_TYPE_TAG(Stokes2cTestProblem, INHERITS_FROM(StokesModel));
// Set the grid type
SET_TYPE_PROP(Stokes2cTestProblem, Grid, Dune::YaspGrid<2>);
// Set the problem property
SET_TYPE_PROP(Stokes2cTestProblem, Problem, Ewoms::Stokes2cTestProblem<TypeTag>);
//! Select the fluid system
SET_TYPE_PROP(Stokes2cTestProblem, FluidSystem,
Opm::FluidSystems::H2OAir<typename GET_PROP_TYPE(TypeTag, Scalar)>);
//! Select the phase to be considered
SET_INT_PROP(Stokes2cTestProblem, StokesPhaseIndex,
GET_PROP_TYPE(TypeTag, FluidSystem)::gasPhaseIdx);
// Disable gravity
SET_BOOL_PROP(Stokes2cTestProblem, EnableGravity, false);
// Enable constraints
SET_BOOL_PROP(Stokes2cTestProblem, EnableConstraints, true);
// Default simulation end time [s]
SET_SCALAR_PROP(Stokes2cTestProblem, EndTime, 2.0);
// Default initial time step size [s]
SET_SCALAR_PROP(Stokes2cTestProblem, InitialTimeStepSize, 0.1);
// Default grid file to load
SET_STRING_PROP(Stokes2cTestProblem, GridFile, "data/test_stokes2c.dgf");
} // namespace Properties
} // namespace Ewoms
namespace Ewoms {
/*!
* \ingroup Stokes2cModel
* \ingroup TestProblems
*
* \brief Stokes transport problem with humid air flowing from the
* left to the right.
*
* The domain is sized 1m times 1m. The boundaries are specified using
* constraints, with finite volumes on the left side of the domain
* exhibiting slightly higher humitiy than the ones on the right.
*/
template <class TypeTag>
class Stokes2cTestProblem : public GET_PROP_TYPE(TypeTag, BaseProblem)
{
typedef typename GET_PROP_TYPE(TypeTag, BaseProblem) ParentType;
typedef typename GET_PROP_TYPE(TypeTag, GridView) GridView;
typedef typename GET_PROP_TYPE(TypeTag, Simulator) Simulator;
typedef typename GET_PROP_TYPE(TypeTag, Indices) Indices;
typedef typename GET_PROP_TYPE(TypeTag, FluidSystem) FluidSystem;
typedef typename GET_PROP_TYPE(TypeTag, EqVector) EqVector;
typedef typename GET_PROP_TYPE(TypeTag, BoundaryRateVector) BoundaryRateVector;
typedef typename GET_PROP_TYPE(TypeTag, RateVector) RateVector;
typedef typename GET_PROP_TYPE(TypeTag, PrimaryVariables) PrimaryVariables;
typedef typename GET_PROP_TYPE(TypeTag, Constraints) Constraints;
typedef typename GET_PROP_TYPE(TypeTag, Scalar) Scalar;
enum { dimWorld = GridView::dimensionworld };
enum { numComponents = FluidSystem::numComponents };
enum {
// copy some indices for convenience
conti0EqIdx = Indices::conti0EqIdx,
momentum0EqIdx = Indices::momentum0EqIdx,
velocity0Idx = Indices::velocity0Idx,
moleFrac1Idx = Indices::moleFrac1Idx,
pressureIdx = Indices::pressureIdx,
H2OIdx = FluidSystem::H2OIdx,
AirIdx = FluidSystem::AirIdx
};
typedef typename GridView::ctype CoordScalar;
typedef Dune::FieldVector<CoordScalar, dimWorld> GlobalPosition;
public:
/*!
* \copydoc Doxygen::defaultProblemConstructor
*/
Stokes2cTestProblem(Simulator& simulator)
: ParentType(simulator)
{ }
/*!
* \copydoc FvBaseProblem::finishInit
*/
void finishInit()
{
ParentType::finishInit();
eps_ = 1e-6;
// initialize the tables of the fluid system
FluidSystem::init();
}
/*!
* \name Problem parameters
*/
//! \{
/*!
* \copydoc FvBaseProblem::name
*/
std::string name() const
{ return "stokes2ctest"; }
/*!
* \copydoc FvBaseProblem::endTimeStep
*/
void endTimeStep()
{
#ifndef NDEBUG
// checkConservativeness() does not include the effect of constraints, so we
// disable it for this problem...
//this->model().checkConservativeness();
// Calculate storage terms
EqVector storage;
this->model().globalStorage(storage);
// Write mass balance information for rank 0
if (this->gridView().comm().rank() == 0) {
std::cout << "Storage: " << storage << std::endl << std::flush;
}
#endif // NDEBUG
}
/*!
* \brief StokesProblem::temperature
*
* This problem assumes a temperature of 10 degrees Celsius.
*/
template <class Context>
Scalar temperature(const Context& context OPM_UNUSED,
unsigned spaceIdx OPM_UNUSED,
unsigned timeIdx OPM_UNUSED) const
{ return 273.15 + 10; /* -> 10 deg C */ }
// \}
/*!
* \name Boundary conditions
*/
//! \{
/*!
* \copydoc FvBaseProblem::boundary
*
* This problem uses an out-flow boundary on the lower edge of the
* domain, no-flow on the left and right edges and constrains the
* upper edge.
*/
template <class Context>
void boundary(BoundaryRateVector& values,
const Context& context,
unsigned spaceIdx,
unsigned timeIdx) const
{
const GlobalPosition& pos = context.pos(spaceIdx, timeIdx);
if (onLowerBoundary_(pos))
values.setOutFlow(context, spaceIdx, timeIdx);
else if (onUpperBoundary_(pos))
// upper boundary is constraint!
values = 0.0;
else
// left and right boundaries
values.setNoFlow(context, spaceIdx, timeIdx);
}
//! \}
/*!
* \name Volumetric terms
*/
//! \{
/*!
* \copydoc FvBaseProblem::initial
*
* For this method a parabolic velocity profile from left to
* right, atmospheric pressure and a mole fraction of water of
* 0.5% is set.
*/
template <class Context>
void initial(PrimaryVariables& values,
const Context& context,
unsigned spaceIdx,
unsigned timeIdx) const
{
const GlobalPosition& globalPos = context.pos(spaceIdx, timeIdx);
values = 0.0;
// parabolic profile
const Scalar v1 = 1.0;
values[velocity0Idx + 1] =
- v1
* (globalPos[0] - this->boundingBoxMin()[0])
* (this->boundingBoxMax()[0] - globalPos[0])
/ (0.25
* (this->boundingBoxMax()[0] - this->boundingBoxMin()[0])
* (this->boundingBoxMax()[0] - this->boundingBoxMin()[0]));
Scalar moleFrac[numComponents];
if (onUpperBoundary_(globalPos))
moleFrac[H2OIdx] = 0.005;
else
moleFrac[H2OIdx] = 0.007;
moleFrac[AirIdx] = 1.0 - moleFrac[H2OIdx];
values[pressureIdx] = 1e5;
values[velocity0Idx + 0] = 0.0;
values[moleFrac1Idx] = moleFrac[1];
}
/*!
* \copydoc FvBaseProblem::source
*
* For this problem, the source term of all conserved quantities
* is 0 everywhere.
*/
template <class Context>
void source(RateVector& rate,
const Context& context OPM_UNUSED,
unsigned spaceIdx OPM_UNUSED,
unsigned timeIdx OPM_UNUSED) const
{ rate = Scalar(0.0); }
/*!
* \copydoc FvBaseProblem::constraints
*
* In this problem, the method sets the domain's lower edge to
* initial conditions.
*/
template <class Context>
void constraints(Constraints& constraints,
const Context& context,
unsigned spaceIdx,
unsigned timeIdx) const
{
const auto& pos = context.pos(spaceIdx, timeIdx);
if (onUpperBoundary_(pos)) {
constraints.setActive(true);
initial(constraints, context, spaceIdx, timeIdx);
}
}
//! \}
private:
bool onLeftBoundary_(const GlobalPosition& globalPos) const
{ return globalPos[0] < this->boundingBoxMin()[0] + eps_; }
bool onRightBoundary_(const GlobalPosition& globalPos) const
{ return globalPos[0] > this->boundingBoxMax()[0] - eps_; }
bool onLowerBoundary_(const GlobalPosition& globalPos) const
{ return globalPos[1] < this->boundingBoxMin()[1] + eps_; }
bool onUpperBoundary_(const GlobalPosition& globalPos) const
{ return globalPos[1] > this->boundingBoxMax()[1] - eps_; }
Scalar eps_;
};
} // namespace Ewoms
#endif

View File

@ -1,335 +0,0 @@
// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
// vi: set et ts=4 sw=4 sts=4:
/*
This file is part of the Open Porous Media project (OPM).
OPM 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.
OPM 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 OPM. If not, see <http://www.gnu.org/licenses/>.
Consult the COPYING file in the top-level source directory of this
module for the precise wording of the license and the list of
copyright holders.
*/
/*!
* \file
* \copydoc Ewoms::StokesNiTestProblem
*/
#ifndef EWOMS_STOKES_NI_TEST_PROBLEM_HH
#define EWOMS_STOKES_NI_TEST_PROBLEM_HH
#include <ewoms/models/stokes/stokesmodel.hh>
#include <ewoms/io/simplexgridmanager.hh>
#include <opm/material/fluidsystems/H2OAirFluidSystem.hpp>
#include <opm/common/Unused.hpp>
#include <dune/grid/yaspgrid.hh>
#include <dune/grid/io/file/dgfparser/dgfyasp.hh>
#include <dune/common/version.hh>
#include <dune/common/fvector.hh>
namespace Ewoms {
template <class TypeTag>
class StokesNiTestProblem;
}
namespace Ewoms {
namespace Properties {
NEW_TYPE_TAG(StokesNiTestProblem, INHERITS_FROM(StokesModel));
// Set the grid type
SET_TYPE_PROP(StokesNiTestProblem, Grid, Dune::YaspGrid<2>);
// Set the problem property
SET_TYPE_PROP(StokesNiTestProblem, Problem, Ewoms::StokesNiTestProblem<TypeTag>);
//! Select the fluid system
SET_TYPE_PROP(StokesNiTestProblem, FluidSystem,
Opm::FluidSystems::H2OAir<typename GET_PROP_TYPE(TypeTag, Scalar)>);
//! Select the phase to be considered
SET_INT_PROP(StokesNiTestProblem, StokesPhaseIndex,
GET_PROP_TYPE(TypeTag, FluidSystem)::gasPhaseIdx);
// Enable gravity
SET_BOOL_PROP(StokesNiTestProblem, EnableGravity, true);
// Enable the energy equation
SET_BOOL_PROP(StokesNiTestProblem, EnableEnergy, true);
// Enable constraints
SET_BOOL_PROP(StokesNiTestProblem, EnableConstraints, true);
// Default simulation end time [s]
SET_SCALAR_PROP(StokesNiTestProblem, EndTime, 3.0);
// Default initial time step size [s]
SET_SCALAR_PROP(StokesNiTestProblem, InitialTimeStepSize, 0.1);
// Increase the default raw tolerance of the Newton-Raphson method to 10^-4
SET_SCALAR_PROP(StokesNiTestProblem, NewtonRawTolerance, 1e-4);
// Default grid file to load
SET_STRING_PROP(StokesNiTestProblem, GridFile, "data/test_stokes2cni.dgf");
} // namespace Properties
} // namespace Ewoms
namespace Ewoms {
/*!
* \ingroup StokesNiModel
* \ingroup TestProblems
* \brief Non-isothermal test problem for the Stokes model with a gas
* (N2) flowing from the left to the right.
*
* The domain of this problem is 1m times 1m. The upper and the lower
* boundaries are fixed to the initial condition by means of
* constraints, the left and the right boundaries are no-slip
* conditions.
*/
template <class TypeTag>
class StokesNiTestProblem : public GET_PROP_TYPE(TypeTag, BaseProblem)
{
typedef typename GET_PROP_TYPE(TypeTag, BaseProblem) ParentType;
typedef typename GET_PROP_TYPE(TypeTag, GridView) GridView;
typedef typename GET_PROP_TYPE(TypeTag, Simulator) Simulator;
typedef typename GET_PROP_TYPE(TypeTag, Indices) Indices;
typedef typename GET_PROP_TYPE(TypeTag, FluidSystem) FluidSystem;
typedef typename GET_PROP_TYPE(TypeTag, Constraints) Constraints;
typedef typename GET_PROP_TYPE(TypeTag, EqVector) EqVector;
typedef typename GET_PROP_TYPE(TypeTag, RateVector) RateVector;
typedef typename GET_PROP_TYPE(TypeTag, BoundaryRateVector) BoundaryRateVector;
typedef typename GET_PROP_TYPE(TypeTag, PrimaryVariables) PrimaryVariables;
typedef typename GET_PROP_TYPE(TypeTag, Scalar) Scalar;
enum {
// Number of equations and grid dimension
dimWorld = GridView::dimensionworld,
// primary variable indices
pressureIdx = Indices::pressureIdx,
moleFrac1Idx = Indices::moleFrac1Idx,
velocity0Idx = Indices::velocity0Idx,
temperatureIdx = Indices::temperatureIdx,
// equation indices
conti0EqIdx = Indices::conti0EqIdx,
momentum0EqIdx = Indices::momentum0EqIdx,
energyEqIdx = Indices::energyEqIdx
};
enum { numComponents = FluidSystem::numComponents };
enum { H2OIdx = FluidSystem::H2OIdx };
enum { AirIdx = FluidSystem::AirIdx };
typedef typename GridView::ctype CoordScalar;
typedef Dune::FieldVector<CoordScalar, dimWorld> GlobalPosition;
typedef Dune::FieldVector<Scalar, dimWorld> DimVector;
public:
/*!
* \copydoc Doxygen::defaultProblemConstructor
*/
StokesNiTestProblem(Simulator& simulator)
: ParentType(simulator)
{ }
/*!
* \copydoc FvBaseProblem::finishInit
*/
void finishInit()
{
ParentType::finishInit();
eps_ = 1e-6;
// initialize the tables of the fluid system
FluidSystem::init(/*Tmin=*/280.0, /*Tmax=*/285, /*nT=*/10,
/*pmin=*/1e5, /*pmax=*/1e5 + 100, /*np=*/200);
}
/*!
* \name Problem parameters
*/
//! \{
/*!
* \copydoc FvBaseProblem::name
*/
std::string name() const
{ return "stokestest_ni"; }
/*!
* \copydoc FvBaseProblem::endTimeStep
*/
void endTimeStep()
{
#ifndef NDEBUG
// checkConservativeness() does not include the effect of constraints, so we
// disable it for this problem...
//this->model().checkConservativeness();
// Calculate storage terms
EqVector storage;
this->model().globalStorage(storage);
// Write mass balance information for rank 0
if (this->gridView().comm().rank() == 0) {
std::cout << "Storage: " << storage << std::endl << std::flush;
}
#endif // NDEBUG
}
//! \}
/*!
* \name Boundary conditions
*/
//! \{
/*!
* \copydoc FvBaseProblem::boundary
*/
template <class Context>
void boundary(BoundaryRateVector& values, const Context& context,
unsigned spaceIdx, unsigned timeIdx) const
{
const GlobalPosition& pos = context.pos(spaceIdx, timeIdx);
if (onUpperBoundary_(pos))
values.setOutFlow(context, spaceIdx, timeIdx);
else if (onLowerBoundary_(pos)) {
// lower boundary is constraint!
values = 0.0;
}
else {
// left and right
values.setNoFlow(context, spaceIdx, timeIdx);
}
}
//! \}
/*!
* \name Volumetric terms
*/
// \{
/*!
* \copydoc FvBaseProblem::initial
*/
template <class Context>
void initial(PrimaryVariables& values, const Context& context, unsigned spaceIdx,
unsigned timeIdx) const
{
const GlobalPosition& pos = context.pos(spaceIdx, timeIdx);
Scalar moleFrac[numComponents];
moleFrac[H2OIdx] = 1e-4;
Scalar temperature = 283.15;
if (inLens_(pos)) {
moleFrac[H2OIdx] = 0.9e-4;
temperature = 284.15;
}
moleFrac[AirIdx] = 1 - moleFrac[H2OIdx];
// parabolic velocity profile
Scalar y = this->boundingBoxMax()[1] - pos[1];
Scalar x = pos[0] - this->boundingBoxMin()[0];
Scalar width = this->boundingBoxMax()[0] - this->boundingBoxMin()[0];
// parabolic velocity profile
const Scalar maxVelocity = 1.0;
Scalar a = -4 * maxVelocity / (width * width);
Scalar b = -a * width;
Scalar c = 0;
DimVector velocity(0.0);
velocity[1] = a * x * x + b * x + c;
// hydrostatic pressure
Scalar rho = 1.189;
Scalar pressure = 1e5 - rho * this->gravity()[1] * y;
for (unsigned axisIdx = 0; axisIdx < dimWorld; ++axisIdx)
values[velocity0Idx + axisIdx] = velocity[axisIdx];
values[pressureIdx] = pressure;
values[moleFrac1Idx] = moleFrac[1];
values[temperatureIdx] = temperature;
}
/*!
* \copydoc FvBaseProblem::source
*
* For this problem, the source term of all conserved quantities
* is 0 everywhere.
*/
template <class Context>
void source(RateVector& rate,
const Context& context OPM_UNUSED,
unsigned spaceIdx OPM_UNUSED,
unsigned timeIdx OPM_UNUSED) const
{ rate = Scalar(0.0); }
/*!
* \copydoc FvBaseProblem::constraints
*
* This problem sets temperature constraints for the finite volumes
* adjacent to the inlet.
*/
template <class Context>
void constraints(Constraints& constraints,
const Context& context,
unsigned spaceIdx,
unsigned timeIdx) const
{
const auto& pos = context.pos(spaceIdx, timeIdx);
if (onLowerBoundary_(pos) || onUpperBoundary_(pos)) {
constraints.setActive(true);
initial(constraints, context, spaceIdx, timeIdx);
}
}
//! \}
private:
bool onLeftBoundary_(const GlobalPosition& pos) const
{ return pos[0] < this->boundingBoxMin()[0] + eps_; }
bool onRightBoundary_(const GlobalPosition& pos) const
{ return pos[0] > this->boundingBoxMax()[0] - eps_; }
bool onLowerBoundary_(const GlobalPosition& pos) const
{ return pos[1] < this->boundingBoxMin()[1] + eps_; }
bool onUpperBoundary_(const GlobalPosition& pos) const
{ return pos[1] > this->boundingBoxMax()[1] - eps_; }
bool onBoundary_(const GlobalPosition& pos) const
{
return onLeftBoundary_(pos) || onRightBoundary_(pos)
|| onLowerBoundary_(pos) || onUpperBoundary_(pos);
}
bool inLens_(const GlobalPosition& pos) const
{ return pos[0] < 0.75 && pos[0] > 0.25 && pos[1] < 0.75 && pos[1] > 0.25; }
Scalar eps_;
};
} // namespace Ewoms
#endif

View File

@ -1,322 +0,0 @@
// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
// vi: set et ts=4 sw=4 sts=4:
/*
This file is part of the Open Porous Media project (OPM).
OPM 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.
OPM 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 OPM. If not, see <http://www.gnu.org/licenses/>.
Consult the COPYING file in the top-level source directory of this
module for the precise wording of the license and the list of
copyright holders.
*/
/*!
* \file
*
* \copydoc Ewoms::StokesTestProblem
*/
#ifndef EWOMS_STOKES_TEST_PROBLEM_HH
#define EWOMS_STOKES_TEST_PROBLEM_HH
#include <ewoms/models/stokes/stokesmodel.hh>
#include <opm/material/fluidsystems/H2ON2FluidSystem.hpp>
#include <opm/material/fluidsystems/GasPhase.hpp>
#include <opm/common/Unused.hpp>
#include <dune/grid/yaspgrid.hh>
#include <dune/grid/io/file/dgfparser/dgfyasp.hh>
#include <dune/common/version.hh>
#include <dune/common/fvector.hh>
namespace Ewoms {
template <class TypeTag>
class StokesTestProblem;
}
namespace Ewoms {
namespace Properties {
NEW_TYPE_TAG(StokesTestProblem, INHERITS_FROM(StokesModel));
// Set the grid type
SET_TYPE_PROP(StokesTestProblem, Grid, Dune::YaspGrid<2>);
// Set the problem property
SET_TYPE_PROP(StokesTestProblem, Problem, Ewoms::StokesTestProblem<TypeTag>);
// Use the default fluid system of the Stokes model. It requires to
// specify a fluid, though.
SET_PROP(StokesTestProblem, Fluid)
{
private:
typedef typename GET_PROP_TYPE(TypeTag, Scalar) Scalar;
public:
typedef Opm::GasPhase<Scalar, Opm::N2<Scalar> > type;
};
// Disable gravity
SET_BOOL_PROP(StokesTestProblem, EnableGravity, false);
// Enable constraints
SET_BOOL_PROP(StokesTestProblem, EnableConstraints, true);
// Default simulation end time [s]
SET_SCALAR_PROP(StokesTestProblem, EndTime, 10.0);
// Default initial time step size [s]
SET_SCALAR_PROP(StokesTestProblem, InitialTimeStepSize, 10.0);
// Default grid file to load
SET_STRING_PROP(StokesTestProblem, GridFile, "data/test_stokes.dgf");
} // namespace Properties
} // namespace Ewoms
namespace Ewoms {
/*!
* \ingroup StokesModel
* \ingroup TestProblems
*
* \brief Stokes flow problem with nitrogen (\f$N_2\f$) flowing
* from the left to the right.
*
* The domain is sized 1m times 1m. The boundary conditions for the
* momentum balances are set to outflow on the right boundary and to
* no-flow at the top and bottom of the domain. For the mass balance
* equation, outflow boundary conditions are assumed on the right,
* free-flow on the left and no-flow at the top and bottom boundaries.
*/
template <class TypeTag>
class StokesTestProblem : public GET_PROP_TYPE(TypeTag, BaseProblem)
{
typedef typename GET_PROP_TYPE(TypeTag, BaseProblem) ParentType;
typedef typename GET_PROP_TYPE(TypeTag, GridView) GridView;
typedef typename GET_PROP_TYPE(TypeTag, Simulator) Simulator;
typedef typename GET_PROP_TYPE(TypeTag, Indices) Indices;
typedef typename GET_PROP_TYPE(TypeTag, EqVector) EqVector;
typedef typename GET_PROP_TYPE(TypeTag, RateVector) RateVector;
typedef typename GET_PROP_TYPE(TypeTag, BoundaryRateVector) BoundaryRateVector;
typedef typename GET_PROP_TYPE(TypeTag, PrimaryVariables) PrimaryVariables;
typedef typename GET_PROP_TYPE(TypeTag, Fluid) Fluid;
typedef typename GET_PROP_TYPE(TypeTag, Scalar) Scalar;
typedef typename GET_PROP_TYPE(TypeTag, Constraints) Constraints;
enum {
// Number of equations and grid dimension
dimWorld = GridView::dimensionworld,
// equation indices
conti0EqIdx = Indices::conti0EqIdx,
momentum0EqIdx = Indices::momentum0EqIdx,
// primary variable indices
velocity0Idx = Indices::velocity0Idx,
pressureIdx = Indices::pressureIdx
};
typedef typename GridView::ctype CoordScalar;
typedef Dune::FieldVector<CoordScalar, dimWorld> GlobalPosition;
typedef Dune::FieldVector<Scalar, dimWorld> DimVector;
public:
/*!
* \copydoc Doxygen::defaultProblemConstructor
*/
StokesTestProblem(Simulator& simulator)
: ParentType(simulator)
{ eps_ = 1e-6; }
/*!
* \name Problem parameters
*/
//! \{
/*!
* \copydoc FvBaseProblem::name
*/
std::string name() const
{ return "stokestest"; }
/*!
* \copydoc FvBaseProblem::endTimeStep
*/
void endTimeStep()
{
#ifndef NDEBUG
// checkConservativeness() does not include the effect of constraints, so we
// disable it for this problem...
//this->model().checkConservativeness();
// Calculate storage terms
EqVector storage;
this->model().globalStorage(storage);
// Write mass balance information for rank 0
if (this->gridView().comm().rank() == 0) {
std::cout << "Storage: " << storage << std::endl << std::flush;
}
#endif // NDEBUG
}
/*!
* \brief StokesProblem::temperature
*
* This problem assumes a constant temperature of 10 degrees Celsius.
*/
template <class Context>
Scalar temperature(const Context& context OPM_UNUSED,
unsigned spaceIdx OPM_UNUSED,
unsigned timeIdx OPM_UNUSED) const
{ return 273.15 + 10; } // -> 10 deg C
//! \}
/*!
* \name Boundary conditions
*/
//! \{
/*!
* \copydoc FvBaseProblem::boundary
*
* For this problem, we use an out-flow boundary on the right,
* no-flow at the top and at the bottom and the left boundary gets
* a parabolic velocity profile via constraints.
*/
template <class Context>
void boundary(BoundaryRateVector& values, const Context& context,
unsigned spaceIdx, unsigned timeIdx) const
{
const GlobalPosition& pos = context.pos(spaceIdx, timeIdx);
Scalar y = pos[1] - this->boundingBoxMin()[1];
Scalar height = this->boundingBoxMax()[1] - this->boundingBoxMin()[1];
// parabolic velocity profile
const Scalar maxVelocity = 1.0;
Scalar a = -4 * maxVelocity / (height * height);
Scalar b = -a * height;
Scalar c = 0;
DimVector velocity(0.0);
velocity[0] = a * y * y + b * y + c;
if (onRightBoundary_(pos))
values.setOutFlow(context, spaceIdx, timeIdx);
else if (onLeftBoundary_(pos)) {
// left boundary is constraint!
values = 0.0;
}
else {
// top and bottom
values.setNoFlow(context, spaceIdx, timeIdx);
}
}
//! \}
/*!
* \name Volumetric terms
*/
//! \{
/*!
* \copydoc FvBaseProblem::initial
*/
template <class Context>
void initial(PrimaryVariables& values, const Context& context, unsigned spaceIdx,
unsigned timeIdx) const
{
const auto& pos = context.pos(spaceIdx, timeIdx);
Scalar y = pos[1] - this->boundingBoxMin()[1];
Scalar height = this->boundingBoxMax()[1] - this->boundingBoxMin()[1];
// parabolic velocity profile on boundaries
const Scalar maxVelocity = 1.0;
Scalar a = -4 * maxVelocity / (height * height);
Scalar b = -a * height;
Scalar c = 0;
DimVector velocity(0.0);
velocity[0] = a * y * y + b * y + c;
for (unsigned axisIdx = 0; axisIdx < dimWorld; ++axisIdx)
values[velocity0Idx + axisIdx] = velocity[axisIdx];
values[pressureIdx] = 1e5;
}
/*!
* \copydoc FvBaseProblem::source
*
* For this problem, the source term of all conserved quantities
* is 0 everywhere.
*/
template <class Context>
void source(RateVector& rate,
const Context& context OPM_UNUSED,
unsigned spaceIdx OPM_UNUSED,
unsigned timeIdx OPM_UNUSED) const
{ rate = Scalar(0.0); }
/*!
* \copydoc FvBaseProblem::constraints
*
* For this problem, the left side of the domain gets a parabolic
* velocity profile using constraints.
*/
template <class Context>
void constraints(Constraints& constraints,
const Context& context,
unsigned spaceIdx,
unsigned timeIdx) const
{
const auto& pos = context.pos(spaceIdx, timeIdx);
if (onLeftBoundary_(pos) || onRightBoundary_(pos)) {
constraints.setActive(true);
initial(constraints, context, spaceIdx, timeIdx);
}
}
//! \}
private:
bool onLeftBoundary_(const GlobalPosition& pos) const
{ return pos[0] < this->boundingBoxMin()[0] + eps_; }
bool onRightBoundary_(const GlobalPosition& pos) const
{ return pos[0] > this->boundingBoxMax()[0] - eps_; }
bool onLowerBoundary_(const GlobalPosition& pos) const
{ return pos[1] < this->boundingBoxMin()[1] + eps_; }
bool onUpperBoundary_(const GlobalPosition& pos) const
{ return pos[1] > this->boundingBoxMax()[1] - eps_; }
bool onBoundary_(const GlobalPosition& pos) const
{
return onLeftBoundary_(pos) || onRightBoundary_(pos)
|| onLowerBoundary_(pos) || onUpperBoundary_(pos);
}
Scalar eps_;
};
} // namespace Ewoms
#endif

View File

@ -0,0 +1 @@
lens_immiscible_vcfv_fd-heuristix.vtu

View File

@ -0,0 +1 @@
powerinjection_darcy_fd-heuristix.vtp

View File

@ -0,0 +1 @@
powerinjection_forchheimer_fd-heuristix.vtp

View File

@ -0,0 +1 @@
s0004-p0000-lens_immiscible_vcfv_fd-heuristix.vtu

View File

@ -4,80 +4,80 @@
<Piece NumberOfCells="384" NumberOfPoints="425"> <Piece NumberOfCells="384" NumberOfPoints="425">
<PointData Scalars="pressure_wetting" Vectors="intrinsicPerm[0]"> <PointData Scalars="pressure_wetting" Vectors="intrinsicPerm[0]">
<DataArray type="Float32" Name="pressure_wetting" NumberOfComponents="1" format="ascii"> <DataArray type="Float32" Name="pressure_wetting" NumberOfComponents="1" format="ascii">
153058 152175 151770 150877 151421 150144 150772 149509 150201 148946 149689 148440 153287 152371 152004 151066 151588 150307 150918 149652 150331 149074 149806 148555
149225 147980 148799 147557 148406 147166 148039 146802 147695 146459 147370 146136 149331 148085 148896 147654 148495 147255 148121 146883 147771 146535 147440 146206
147061 145828 146765 145533 146481 145250 146206 144976 145939 144710 145680 144451 147126 145893 146825 145593 146536 145305 146258 145027 145987 144757 145724 144495
145426 144197 145177 143949 144933 143705 144693 143465 144456 143228 144222 142994 145467 144238 145215 143986 144967 143739 144724 143496 144484 143256 144247 143019
143991 142764 150193 149447 148774 148174 147634 147145 146697 146284 145901 145543 144013 142785 150384 149620 148928 148312 147758 147257 146800 146379 145988 145623
145205 144886 144582 144290 144009 143737 143473 143216 142963 142716 142473 142233 145280 144955 144646 144350 144064 143789 143521 143259 143004 142753 142507 142264
141997 141764 141533 148570 147932 147332 146780 146273 145808 145379 144982 144610 142025 141788 141555 148732 148084 147473 146908 146391 145916 145479 145073 144695
144262 143933 143621 143323 143036 142760 142491 142230 141975 141725 141479 141237 144341 144007 143689 143386 143095 142814 142542 142277 142019 141765 141516 141271
140999 140763 140530 140300 146928 146373 145840 145339 144871 144436 144031 143652 141029 140791 140555 140322 147069 146508 145967 145457 144981 144538 144126 143741
143297 142963 142645 142343 142052 141773 141502 141239 140981 140730 140482 140239 143379 143039 142716 142409 142114 141830 141556 141289 141028 140773 140522 140275
139999 139761 139527 139295 139065 145278 144789 144315 143863 143436 143033 142656 140032 139792 139554 139319 139086 145401 144909 144430 143972 143538 143129 142745
142300 141964 141646 141342 141051 140771 140500 140237 139979 139727 139480 139236 142384 142043 141719 141411 141116 140832 140557 140290 140029 139773 139522 139275
138995 138757 138521 138288 138056 137827 143621 143189 142768 142362 141975 141607 139031 138790 138551 138315 138080 137848 143729 143296 142871 142461 142069 141696
141258 140928 140614 140314 140027 139750 139482 139221 138965 138715 138469 138226 141342 141007 140688 140384 140093 139812 139540 139276 139017 138763 138514 138268
137986 137748 137513 137279 137047 136816 136587 141960 141579 141205 140842 140494 138024 137784 137545 137308 137073 136840 136608 142056 141674 141298 140932 140580
140160 139842 139539 139249 138970 138701 138439 138185 137935 137689 137447 137207 140243 139921 139613 139319 139037 138764 138499 138241 137988 137739 137494 137251
136970 136734 136500 136267 136035 135804 135575 135346 140297 139961 139630 139308 137011 136772 136534 136299 136064 135830 135598 135367 140382 140045 139713 139389
138997 138698 138412 138137 137872 137616 137367 137123 136883 136645 136410 136176 139076 138774 138484 138206 137939 137680 137427 137180 136937 136697 136459 136222
135943 135711 135480 135249 135019 134790 134561 134332 134104 138632 138336 138046 135986 135752 135517 135284 135051 134818 134586 134355 134124 138706 138411 138120
137762 137488 137224 136969 136724 136487 136256 136028 135802 135578 135354 135129 137835 137559 137293 137036 136789 136549 136316 136085 135857 135630 135404 135177
134904 134679 134453 134226 133999 133772 133544 133316 133089 132861 136965 136708 134949 134721 134492 134263 134033 133803 133572 133342 133111 132881 137030 136773
136455 136208 135969 135739 135518 135304 135096 134891 134687 134481 134273 134062 136520 136273 136033 135802 135579 135364 135154 134948 134741 134534 134324 134111
133849 133633 133414 133194 132972 132749 132524 132299 132072 131845 131618 135296 133895 133676 133456 133233 133008 132782 132555 132327 132097 131868 131637 135353
135075 134857 134645 134441 134245 134058 133878 133702 133526 133347 133162 132971 135132 134914 134702 134498 134302 134114 133934 133757 133579 133399 133212 133020
132774 132571 132364 132152 131937 131720 131500 131278 131054 130829 130603 130375 132821 132616 132406 132193 131975 131755 131532 131308 131082 130854 130625 130394
133627 133438 133253 133074 132903 132742 132591 132449 132309 132165 132013 131850 133675 133487 133303 133125 132954 132793 132642 132499 132359 132215 132062 131898
131675 131491 131298 131099 130894 130684 130470 130253 130033 129811 129587 129361 131722 131536 131342 131140 130933 130721 130504 130285 130062 129838 129611 129383
129134 131956 131798 131643 131495 131356 131228 131115 131015 130919 130814 130691 129153 131996 131840 131686 131539 131400 131273 131161 131061 130966 130861 130738
130549 130389 130217 130033 129840 129639 129433 129223 129008 128790 128570 128346 130595 130435 130261 130075 129880 129678 129470 129257 129040 128819 128596 128371
128121 127894 130284 130153 130027 129907 129796 129700 129624 129576 129541 129483 128143 127913 130317 130188 130063 129944 129834 129739 129664 129617 129584 129528
129388 129264 129117 128953 128776 128587 128391 128188 127980 127767 127550 127331 129434 129309 129162 128996 128817 128628 128429 128224 128013 127798 127579 127357
127108 126883 126656 128610 128505 128404 128309 128224 128153 128104 128101 128207 127132 126905 126675 128637 128534 128434 128340 128255 128186 128138 128137 128248
128190 128115 128002 127862 127703 127529 127343 127149 126948 126741 126529 126313 128233 128159 128046 127906 127746 127570 127383 127187 126984 126774 126560 126342
126094 125873 125648 125421 126936 126853 126774 126701 126637 126585 126551 126533 126121 125896 125669 125439 126957 126876 126798 126726 126662 126611 126578 126561
126653 126676 126614 126510 126378 126227 126062 125885 125699 125507 125308 125105 126685 126713 126652 126548 126417 126265 126098 125920 125733 125538 125338 125133
124898 124688 124474 124257 124036 124923 124710 124494 124275 124052
</DataArray> </DataArray>
<DataArray type="Float32" Name="pressure_nonwetting" NumberOfComponents="1" format="ascii"> <DataArray type="Float32" Name="pressure_nonwetting" NumberOfComponents="1" format="ascii">
153058 152175 151770 150877 151421 150144 150772 149509 150201 148946 149689 148440 153287 152371 152004 151066 151588 150307 150918 149652 150331 149074 149806 148555
149225 147980 148799 147557 148406 147166 148039 146802 147695 146459 147370 146136 149331 148085 148896 147654 148495 147255 148121 146883 147771 146535 147440 146206
147061 145828 146765 145533 146481 145250 146206 144976 145939 144710 145680 144451 147126 145893 146825 145593 146536 145305 146258 145027 145987 144757 145724 144495
145426 144197 145177 143949 144933 143705 144693 143465 144456 143228 144222 142994 145467 144238 145215 143986 144967 143739 144724 143496 144484 143256 144247 143019
143991 142764 150193 149447 148774 148174 147634 147145 146697 146284 145901 145543 144013 142785 150384 149620 148928 148312 147758 147257 146800 146379 145988 145623
145205 144886 144582 144290 144009 143737 143473 143216 142963 142716 142473 142233 145280 144955 144646 144350 144064 143789 143521 143259 143004 142753 142507 142264
141997 141764 141533 148570 147932 147332 146780 146273 145808 145379 144982 144610 142025 141788 141555 148732 148084 147473 146908 146391 145916 145479 145073 144695
144262 143933 143621 143323 143036 142760 142491 142230 141975 141725 141479 141237 144341 144007 143689 143386 143095 142814 142542 142277 142019 141765 141516 141271
140999 140763 140530 140300 146928 146373 145840 145339 144871 144436 144031 143652 141029 140791 140555 140322 147069 146508 145967 145457 144981 144538 144126 143741
143297 142963 142645 142343 142052 141773 141502 141239 140981 140730 140482 140239 143379 143039 142716 142409 142114 141830 141556 141289 141028 140773 140522 140275
139999 139761 139527 139295 139065 145278 144789 144315 143863 143436 143033 142656 140032 139792 139554 139319 139086 145401 144909 144430 143972 143538 143129 142745
142300 141964 141646 141342 141051 140771 140500 140237 139979 139727 139480 139236 142384 142043 141719 141411 141116 140832 140557 140290 140029 139773 139522 139275
138995 138757 138521 138288 138056 137827 143621 143189 142768 142362 141975 141607 139031 138790 138551 138315 138080 137848 143729 143296 142871 142461 142069 141696
141258 140928 140614 140314 140027 139750 139482 139221 138965 138715 138469 138226 141342 141007 140688 140384 140093 139812 139540 139276 139017 138763 138514 138268
137986 137748 137513 137279 137047 136816 136587 141960 141579 141205 140842 140494 138024 137784 137545 137308 137073 136840 136608 142056 141674 141298 140932 140580
140160 139842 139539 139249 138970 138701 138439 138185 137935 137689 137447 137207 140243 139921 139613 139319 139037 138764 138499 138241 137988 137739 137494 137251
136970 136734 136500 136267 136035 135804 135575 135346 140297 139961 139630 139308 137011 136772 136534 136299 136064 135830 135598 135367 140382 140045 139713 139389
138997 138698 138412 138137 137872 137616 137367 137123 136883 136645 136410 136176 139076 138774 138484 138206 137939 137680 137427 137180 136937 136697 136459 136222
135943 135711 135480 135249 135019 134790 134561 134332 134104 138632 138336 138046 135986 135752 135517 135284 135051 134818 134586 134355 134124 138706 138411 138120
137762 137488 137224 136969 136724 136487 136256 136028 135802 135578 135354 135129 137835 137559 137293 137036 136789 136549 136316 136085 135857 135630 135404 135177
134904 134679 134453 134226 133999 133772 133544 133316 133089 132861 136965 136708 134949 134721 134492 134263 134033 133803 133572 133342 133111 132881 137030 136773
136455 136208 135969 135739 135518 135304 135096 134891 134687 134481 134273 134062 136520 136273 136033 135802 135579 135364 135154 134948 134741 134534 134324 134111
133849 133633 133414 133194 132972 132749 132524 132299 132072 131845 131618 135296 133895 133676 133456 133233 133008 132782 132555 132327 132097 131868 131637 135353
135075 134857 134645 134441 134245 134058 133878 133702 133526 133347 133162 132971 135132 134914 134702 134498 134302 134114 133934 133757 133579 133399 133212 133020
132774 132571 132364 132152 131937 131720 131500 131278 131054 130829 130603 130375 132821 132616 132406 132193 131975 131755 131532 131308 131082 130854 130625 130394
133627 133438 133253 133074 132903 132742 132591 132449 132309 132165 132013 131850 133675 133487 133303 133125 132954 132793 132642 132499 132359 132215 132062 131898
131675 131491 131298 131099 130894 130684 130470 130253 130033 129811 129587 129361 131722 131536 131342 131140 130933 130721 130504 130285 130062 129838 129611 129383
129134 131956 131798 131643 131495 131356 131228 131115 131015 130919 130814 130691 129153 131996 131840 131686 131539 131400 131273 131161 131061 130966 130861 130738
130549 130389 130217 130033 129840 129639 129433 129223 129008 128790 128570 128346 130595 130435 130261 130075 129880 129678 129470 129257 129040 128819 128596 128371
128121 127894 130284 130153 130027 129907 129796 129700 129624 129576 129541 129483 128143 127913 130317 130188 130063 129944 129834 129739 129664 129617 129584 129528
129388 129264 129117 128953 128776 128587 128391 128188 127980 127767 127550 127331 129434 129309 129162 128996 128817 128628 128429 128224 128013 127798 127579 127357
127108 126883 126656 128610 128505 128404 128309 128224 128153 128104 128101 128207 127132 126905 126675 128637 128534 128434 128340 128255 128186 128138 128137 128248
128190 128115 128002 127862 127703 127529 127343 127149 126948 126741 126529 126313 128233 128159 128046 127906 127746 127570 127383 127187 126984 126774 126560 126342
126094 125873 125648 125421 126936 126853 126774 126701 126637 126585 126551 126533 126121 125896 125669 125439 126957 126876 126798 126726 126662 126611 126578 126561
126653 126676 126614 126510 126378 126227 126062 125885 125699 125507 125308 125105 126685 126713 126652 126548 126417 126265 126098 125920 125733 125538 125338 125133
124898 124688 124474 124257 124036 124923 124710 124494 124275 124052
</DataArray> </DataArray>
<DataArray type="Float32" Name="density_wetting" NumberOfComponents="1" format="ascii"> <DataArray type="Float32" Name="density_wetting" NumberOfComponents="1" format="ascii">
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000

View File

@ -0,0 +1 @@
s0004-p0001-lens_immiscible_vcfv_fd-heuristix.vtu

View File

@ -4,80 +4,80 @@
<Piece NumberOfCells="384" NumberOfPoints="425"> <Piece NumberOfCells="384" NumberOfPoints="425">
<PointData Scalars="pressure_wetting" Vectors="intrinsicPerm[0]"> <PointData Scalars="pressure_wetting" Vectors="intrinsicPerm[0]">
<DataArray type="Float32" Name="pressure_wetting" NumberOfComponents="1" format="ascii"> <DataArray type="Float32" Name="pressure_wetting" NumberOfComponents="1" format="ascii">
143991 143763 142764 142536 143538 142310 143315 142088 143095 141868 142878 141651 144013 143782 142785 142554 143554 142326 143328 142101 143106 141878 142886 141658
142664 141436 142453 141225 142245 141017 142040 140812 141839 140611 141641 140413 142669 141441 142455 141227 142244 141017 142037 140809 141833 140605 141632 140404
141446 140218 141254 140026 141066 139838 140880 139652 140697 139469 140516 139289 141435 140207 141241 140013 141050 139822 140861 139634 140676 139448 140492 139265
140337 139110 140160 138933 139983 138757 139805 138580 139624 138402 139428 138220 140311 139084 140131 138904 139951 138725 139770 138546 139585 138364 139382 138177
139129 138070 141533 141305 141080 140857 140637 140420 140206 139994 139786 139581 139047 138037 141555 141324 141096 140870 140647 140427 140210 139996 139785 139578
139380 139182 138987 138795 138607 138422 138240 138060 137882 137706 137531 137357 139374 139173 138976 138782 138591 138403 138218 138036 137856 137677 137499 137323
137184 137017 136862 140300 140072 139847 139624 139404 139186 138972 138760 138552 137148 136980 136824 140322 140091 139863 139637 139414 139194 138976 138762 138551
138347 138145 137947 137752 137561 137374 137189 137007 136828 136651 136477 136304 138343 138139 137938 137741 137548 137358 137170 136986 136805 136626 136448 136273
136133 135964 135800 135640 139065 138837 138612 138389 138168 137950 137735 137523 136099 135929 135763 135601 139086 138855 138627 138401 138178 137957 137739 137525
137314 137109 136907 136709 136514 136324 136137 135953 135772 135594 135419 135246 137313 137105 136901 136700 136503 136310 136121 135934 135751 135571 135393 135218
135075 134907 134740 134577 134415 137827 137599 137374 137151 136930 136711 136495 135045 134874 134705 134539 134376 137848 137618 137389 137163 136939 136718 136499
136282 136073 135867 135665 135467 135273 135083 134897 134714 134535 134358 134185 136284 136072 135863 135659 135458 135262 135069 134880 134695 134514 134335 134159
134014 133845 133678 133513 133350 133189 136587 136360 136134 135910 135688 135469 133986 133814 133645 133478 133313 133150 136608 136378 136149 135923 135698 135476
135252 135038 134828 134621 134419 134221 134027 133838 133653 133471 133294 133119 135256 135040 134827 134618 134413 134212 134016 133824 133637 133453 133273 133096
132948 132779 132612 132447 132284 132123 131963 135346 135119 134893 134668 134445 132922 132751 132582 132415 132250 132086 131923 135367 135136 134908 134680 134455
134224 134006 133791 133579 133372 133169 132971 132777 132589 132405 132225 132050 134231 134010 133792 133578 133368 133162 132962 132766 132575 132389 132207 132029
131877 131708 131541 131377 131215 131054 130894 130735 134104 133876 133650 133424 131854 131683 131514 131347 131183 131020 130858 130696 134124 133894 133664 133436
133200 132977 132757 132540 132326 132117 131914 131715 131522 131335 131153 130976 133209 132984 132761 132541 132325 132113 131907 131706 131511 131321 131137 130957
130802 130633 130466 130302 130140 129980 129822 129665 129508 132861 132633 132406 130782 130610 130441 130275 130111 129949 129788 129629 129470 132881 132650 132420
132179 131953 131728 131505 131285 131069 130858 130653 130454 130262 130076 129897 132190 131962 131734 131508 131286 131067 130853 130646 130445 130250 130062 129880
129722 129551 129385 129221 129060 128902 128745 128589 128435 128281 131618 131390 129703 129531 129362 129196 129033 128872 128713 128556 128399 128243 131637 131407
131161 130933 130704 130477 130250 130026 129807 129592 129385 129186 128995 128812 131175 130944 130713 130482 130253 130027 129804 129587 129378 129177 128983 128797
128635 128463 128297 128134 127974 127816 127661 127508 127355 127204 127053 130375 128618 128445 128276 128111 127949 127790 127632 127477 127322 127169 127016 130394
130147 129917 129687 129455 129224 128993 128764 128538 128320 128110 127911 127721 130163 129931 129698 129464 129229 128996 128764 128536 128314 128102 127900 127708
127541 127367 127200 127038 126879 126724 126571 126419 126269 126121 125973 125825 127526 127351 127181 127017 126857 126699 126544 126391 126239 126088 125938 125789
129134 128905 128674 128441 128207 127971 127734 127497 127264 127038 126824 126624 129153 128921 128687 128452 128215 127976 127736 127497 127260 127032 126815 126613
126438 126262 126094 125933 125776 125622 125471 125323 125176 125030 124885 124741 126425 126247 126077 125914 125755 125599 125447 125296 125148 125000 124853 124707
124597 127894 127664 127432 127198 126960 126719 126475 126228 125981 125743 125523 124561 127913 127680 127446 127208 126968 126724 126477 126227 125977 125736 125513
125325 125144 124975 124815 124661 124510 124362 124217 124073 123931 123790 123649 125313 125130 124960 124797 124641 124489 124340 124193 124047 123903 123760 123618
123509 123369 126656 126426 126193 125957 125717 125472 125220 124960 124691 124427 123476 123334 126675 126442 126206 125967 125724 125476 125221 124959 124686 124419
124198 124007 123838 123681 123530 123384 123241 123100 122961 122823 122685 122549 124187 123995 123824 123665 123512 123365 123220 123078 122937 122797 122658 122520
122412 122276 122140 125421 125191 124957 124720 124478 124230 123973 123701 123414 122382 122244 122107 125439 125206 124970 124730 124486 124235 123974 123699 123409
123052 122835 122672 122522 122380 122242 122105 121971 121837 121704 121571 121439 123043 122823 122658 122507 122363 122223 122085 121949 121814 121680 121546 121412
121307 121175 121044 120912 124036 123812 123584 123350 123109 122858 122589 122288 121279 121146 121012 120879 124052 123825 123594 123358 123114 122860 122588 122284
121885 121530 121444 121324 121200 121076 120951 120825 120699 120573 120446 120320 121876 121517 121430 121309 121184 121058 120931 120804 120677 120550 120422 120294
120193 120066 119938 119811 119684 120166 120038 119909 119781 119652
</DataArray> </DataArray>
<DataArray type="Float32" Name="pressure_nonwetting" NumberOfComponents="1" format="ascii"> <DataArray type="Float32" Name="pressure_nonwetting" NumberOfComponents="1" format="ascii">
143991 143763 142764 142536 143538 142310 143315 142088 143095 141868 142878 141651 144013 143782 142785 142554 143554 142326 143328 142101 143106 141878 142886 141658
142664 141436 142453 141225 142245 141017 142040 140812 141839 140611 141641 140413 142669 141441 142455 141227 142244 141017 142037 140809 141833 140605 141632 140404
141446 140218 141254 140026 141066 139838 140880 139652 140697 139469 140516 139289 141435 140207 141241 140013 141050 139822 140861 139634 140676 139448 140492 139265
140337 139110 140160 138933 139983 138757 139805 138580 139624 138402 139428 138220 140311 139084 140131 138904 139951 138725 139770 138546 139585 138364 139382 138177
139129 138070 141533 141305 141080 140857 140637 140420 140206 139994 139786 139581 139047 138037 141555 141324 141096 140870 140647 140427 140210 139996 139785 139578
139380 139182 138987 138795 138607 138422 138240 138060 137882 137706 137531 137357 139374 139173 138976 138782 138591 138403 138218 138036 137856 137677 137499 137323
137184 137017 136862 140300 140072 139847 139624 139404 139186 138972 138760 138552 137148 136980 136824 140322 140091 139863 139637 139414 139194 138976 138762 138551
138347 138145 137947 137752 137561 137374 137189 137007 136828 136651 136477 136304 138343 138139 137938 137741 137548 137358 137170 136986 136805 136626 136448 136273
136133 135964 135800 135640 139065 138837 138612 138389 138168 137950 137735 137523 136099 135929 135763 135601 139086 138855 138627 138401 138178 137957 137739 137525
137314 137109 136907 136709 136514 136324 136137 135953 135772 135594 135419 135246 137313 137105 136901 136700 136503 136310 136121 135934 135751 135571 135393 135218
135075 134907 134740 134577 134415 137827 137599 137374 137151 136930 136711 136495 135045 134874 134705 134539 134376 137848 137618 137389 137163 136939 136718 136499
136282 136073 135867 135665 135467 135273 135083 134897 134714 134535 134358 134185 136284 136072 135863 135659 135458 135262 135069 134880 134695 134514 134335 134159
134014 133845 133678 133513 133350 133189 136587 136360 136134 135910 135688 135469 133986 133814 133645 133478 133313 133150 136608 136378 136149 135923 135698 135476
135252 135038 134828 134621 134419 134221 134027 133838 133653 133471 133294 133119 135256 135040 134827 134618 134413 134212 134016 133824 133637 133453 133273 133096
132948 132779 132612 132447 132284 132123 131963 135346 135119 134893 134668 134445 132922 132751 132582 132415 132250 132086 131923 135367 135136 134908 134680 134455
134224 134006 133791 133579 133372 133169 132971 132777 132589 132405 132225 132050 134231 134010 133792 133578 133368 133162 132962 132766 132575 132389 132207 132029
131877 131708 131541 131377 131215 131054 130894 130735 134104 133876 133650 133424 131854 131683 131514 131347 131183 131020 130858 130696 134124 133894 133664 133436
133200 132977 132757 132540 132326 132117 131914 131715 131522 131335 131153 130976 133209 132984 132761 132541 132325 132113 131907 131706 131511 131321 131137 130957
130802 130633 130466 130302 130140 129980 129822 129665 129508 132861 132633 132406 130782 130610 130441 130275 130111 129949 129788 129629 129470 132881 132650 132420
132179 131953 131728 131505 131285 131069 130858 130653 130454 130262 130076 129897 132190 131962 131734 131508 131286 131067 130853 130646 130445 130250 130062 129880
129722 129551 129385 129221 129060 128902 128745 128589 128435 128281 131618 131390 129703 129531 129362 129196 129033 128872 128713 128556 128399 128243 131637 131407
131161 130933 130704 130477 130250 130026 129807 129592 129385 129186 128995 128812 131175 130944 130713 130482 130253 130027 129804 129587 129378 129177 128983 128797
128635 128463 128297 128134 127974 127816 127661 127508 127355 127204 127053 130375 128618 128445 128276 128111 127949 127790 127632 127477 127322 127169 127016 130394
130147 129917 129687 129455 129224 128993 128764 128538 128320 128110 127911 127721 130163 129931 129698 129464 129229 128996 128764 128536 128314 128102 127900 127708
127541 127367 127200 127038 126879 126724 126571 126419 126269 126121 125973 125825 127526 127351 127181 127017 126857 126699 126544 126391 126239 126088 125938 125789
129134 128905 128674 128441 128207 127971 127734 127497 127264 127038 126824 126624 129153 128921 128687 128452 128215 127976 127736 127497 127260 127032 126815 126613
126438 126262 126094 125933 125776 125622 125471 125323 125176 125030 124885 124741 126425 126247 126077 125914 125755 125599 125447 125296 125148 125000 124853 124707
124597 127894 127664 127432 127198 126960 126719 126475 126228 125981 125743 125523 124561 127913 127680 127446 127208 126968 126724 126477 126227 125977 125736 125513
125325 125144 124975 124815 124661 124510 124362 124217 124073 123931 123790 123649 125313 125130 124960 124797 124641 124489 124340 124193 124047 123903 123760 123618
123509 123369 126656 126426 126193 125957 125717 125472 125220 124960 124691 124427 123476 123334 126675 126442 126206 125967 125724 125476 125221 124959 124686 124419
124198 124007 123838 123681 123530 123384 123241 123100 122961 122823 122685 122549 124187 123995 123824 123665 123512 123365 123220 123078 122937 122797 122658 122520
122412 122276 122140 125421 125191 124957 124720 124478 124230 123973 123701 123414 122382 122244 122107 125439 125206 124970 124730 124486 124235 123974 123699 123409
123052 122835 122672 122522 122380 122242 122105 121971 121837 121704 121571 121439 123043 122823 122658 122507 122363 122223 122085 121949 121814 121680 121546 121412
121307 121175 121044 120912 124036 123812 123584 123350 123109 122858 122589 122288 121279 121146 121012 120879 124052 123825 123594 123358 123114 122860 122588 122284
121885 121530 121444 121324 121200 121076 120951 120825 120699 120573 120446 120320 121876 121517 121430 121309 121184 121058 120931 120804 120677 120550 120422 120294
120193 120066 119938 119811 119684 120166 120038 119909 119781 119652
</DataArray> </DataArray>
<DataArray type="Float32" Name="density_wetting" NumberOfComponents="1" format="ascii"> <DataArray type="Float32" Name="density_wetting" NumberOfComponents="1" format="ascii">
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000

View File

@ -0,0 +1 @@
s0004-p0002-lens_immiscible_vcfv_fd-heuristix.vtu

View File

@ -4,80 +4,80 @@
<Piece NumberOfCells="384" NumberOfPoints="425"> <Piece NumberOfCells="384" NumberOfPoints="425">
<PointData Scalars="pressure_wetting" Vectors="intrinsicPerm[0]"> <PointData Scalars="pressure_wetting" Vectors="intrinsicPerm[0]">
<DataArray type="Float32" Name="pressure_wetting" NumberOfComponents="1" format="ascii"> <DataArray type="Float32" Name="pressure_wetting" NumberOfComponents="1" format="ascii">
126936 126853 125260 125198 126774 125139 126701 125085 126637 125038 126585 125000 126957 126876 125276 125215 126798 125157 126726 125103 126662 125057 126611 125020
126551 124975 126533 124965 126653 124970 126676 124952 126614 124887 126510 124788 126578 124995 126561 124986 126685 124992 126713 124978 126652 124915 126548 124816
126378 124665 126227 124526 126062 124374 125885 124211 125699 124041 125507 123865 126417 124694 126265 124554 126098 124401 125920 124237 125733 124066 125538 123888
125308 123683 125105 123496 124898 123305 124688 123110 124474 122912 124257 122710 125338 123704 125133 123516 124923 123323 124710 123126 124494 122926 124275 122722
124036 122504 123584 123541 123500 123462 123429 123402 123384 123376 123344 123277 124052 122513 123595 123552 123512 123474 123442 123415 123398 123389 123359 123294
123193 123089 122969 122837 122695 122546 122389 122228 122061 121890 121716 121537 123211 123108 122988 122856 122713 122563 122406 122243 122075 121903 121726 121546
121354 121167 120976 121906 121881 121857 121834 121813 121796 121784 121777 121725 121362 121173 120980 121913 121888 121863 121840 121820 121803 121790 121784 121732
121624 121518 121405 121285 121158 121024 120886 120743 120596 120444 120289 120130 121633 121528 121415 121295 121167 121034 120895 120751 120603 120450 120294 120134
119967 119800 119629 119453 120229 120221 120212 120203 120194 120185 120177 120172 119970 119802 119629 119452 120231 120222 120213 120204 120194 120185 120178 120172
120105 119977 119852 119730 119607 119484 119359 119232 119101 118968 118831 118691 120105 119978 119853 119730 119608 119485 119359 119232 119101 118967 118830 118689
118548 118401 118251 118096 117937 118552 118561 118569 118573 118575 118573 118569 118545 118397 118246 118090 117930 118549 118557 118564 118568 118569 118567 118562
118564 118482 118327 118184 118053 117930 117812 117696 117580 117462 117343 117221 118558 118475 118320 118177 118045 117922 117804 117688 117571 117454 117334 117212
117097 116970 116839 116705 116568 116426 116876 116904 116928 116947 116959 116963 117087 116960 116829 116694 116556 116413 116868 116894 116917 116935 116946 116950
116961 116955 116851 116664 116504 116369 116249 116139 116033 115929 115826 115721 116948 116942 116837 116649 116488 116352 116232 116122 116016 115913 115809 115704
115614 115506 115394 115280 115164 115044 114920 115200 115250 115293 115328 115351 115598 115489 115377 115263 115146 115026 114902 115187 115234 115276 115309 115332
115360 115357 115346 115201 114968 114799 114669 114559 114461 114369 114279 114190 115341 115337 115325 115180 114944 114774 114643 114534 114435 114343 114254 114165
114100 114009 113917 113822 113725 113625 113523 113419 113527 113601 113667 113721 114076 113985 113893 113798 113701 113601 113500 113395 113507 113578 113643 113695
113757 113771 113761 113742 113459 113205 113059 112950 112859 112778 112702 112628 113731 113745 113734 113716 113428 113171 113025 112915 112824 112743 112668 112595
112555 112482 112407 112330 112251 112171 112089 112005 111920 111857 111961 112054 112523 112450 112375 112299 112221 112141 112059 111976 111891 111829 111930 112022
112131 112184 112208 112191 112095 111822 111669 111555 111464 111386 111316 111250 112098 112151 112175 112158 112060 111784 111630 111515 111424 111347 111277 111212
111185 111121 111056 110989 110921 110851 110779 110705 110631 110555 110190 110331 111148 111084 111020 110954 110886 110817 110745 110672 110598 110523 110152 110291
110458 110564 110641 110682 110678 110613 110502 110389 110295 110215 110143 110077 110417 110523 110600 110642 110638 110573 110461 110348 110255 110175 110103 110038
110013 109950 109887 109823 109757 109689 109619 109547 109474 109400 109324 108528 109975 109913 109851 109788 109722 109655 109585 109514 109441 109367 109292 108478
108715 108885 109026 109133 109200 109225 109206 109156 109090 109023 108958 108895 108664 108833 108976 109085 109154 109180 109163 109113 109048 108981 108917 108855
108835 108775 108716 108655 108593 108528 108460 108390 108318 108244 108169 108093 108796 108737 108678 108618 108557 108492 108425 108356 108284 108211 108136 108061
106873 107119 107340 107523 107664 107762 107818 107835 107823 107790 107747 107698 106808 107054 107277 107464 107609 107710 107769 107788 107777 107746 107704 107656
107646 107593 107538 107482 107424 107364 107299 107232 107162 107090 107016 106940 107605 107553 107499 107444 107387 107328 107264 107197 107127 107056 106982 106907
106863 105228 105551 105833 106063 106240 106367 106450 106495 106509 106500 106475 106830 105143 105470 105758 105995 106178 106310 106397 106445 106462 106454 106431
106440 106398 106351 106302 106250 106196 106137 106073 106005 105935 105863 105788 106397 106356 106311 106262 106211 106158 106101 106037 105970 105900 105829 105755
105711 105633 103603 104030 104381 104656 104865 105017 105122 105186 105218 105225 105678 105600 103490 103929 104294 104580 104797 104956 105065 105134 105169 105178
105213 105188 105154 105113 105068 105019 104968 104911 104847 104779 104709 104637 105169 105145 105112 105072 105028 104981 104931 104874 104811 104744 104674 104603
104562 104484 104404 102025 102597 103006 103314 103546 103715 103833 103910 103952 104528 104451 104371 101869 102480 102910 103232 103474 103651 103775 103856 103902
103969 103965 103946 103916 103879 103837 103791 103743 103686 103622 103554 103484 103921 103919 103902 103874 103838 103797 103752 103705 103649 103585 103519 103449
103411 103336 103257 103176 100736 101297 101727 102048 102288 102463 102586 102666 103377 103302 103224 103143 100586 101175 101628 101964 102215 102398 102527 102612
102713 102732 102731 102714 102686 102650 102609 102564 102517 102460 102396 102329 102662 102684 102685 102670 102644 102609 102569 102525 102480 102423 102360 102293
102258 102186 102110 102031 101949 102223 102151 102076 101998 101916
</DataArray> </DataArray>
<DataArray type="Float32" Name="pressure_nonwetting" NumberOfComponents="1" format="ascii"> <DataArray type="Float32" Name="pressure_nonwetting" NumberOfComponents="1" format="ascii">
126936 126853 125260 125198 126774 125139 126701 125085 126637 125038 126585 125000 126957 126876 125276 125215 126798 125157 126726 125103 126662 125057 126611 125020
126551 124975 126533 124965 126653 124970 126676 124952 126614 124887 126510 124788 126578 124995 126561 124986 126685 124992 126713 124978 126652 124915 126548 124816
126378 124665 126227 124526 126062 124374 125885 124211 125699 124041 125507 123865 126417 124694 126265 124554 126098 124401 125920 124237 125733 124066 125538 123888
125308 123683 125105 123496 124898 123305 124688 123110 124474 122912 124257 122710 125338 123704 125133 123516 124923 123323 124710 123126 124494 122926 124275 122722
124036 122504 123584 123541 123500 123462 123429 123402 123384 123376 123344 123277 124052 122513 123595 123552 123512 123474 123442 123415 123398 123389 123359 123294
123193 123089 122969 122837 122695 122546 122389 122228 122061 121890 121716 121537 123211 123108 122988 122856 122713 122563 122406 122243 122075 121903 121726 121546
121354 121167 120976 121906 121881 121857 121834 121813 121796 121784 121777 121725 121362 121173 120980 121913 121888 121863 121840 121820 121803 121790 121784 121732
121624 121518 121405 121285 121158 121024 120886 120743 120596 120444 120289 120130 121633 121528 121415 121295 121167 121034 120895 120751 120603 120450 120294 120134
119967 119800 119629 119453 120229 120221 120212 120203 120194 120185 120177 120172 119970 119802 119629 119452 120231 120222 120213 120204 120194 120185 120178 120172
120105 119977 119852 119730 119607 119484 119359 119232 119101 118968 118831 118691 120105 119978 119853 119730 119608 119485 119359 119232 119101 118967 118830 118689
118548 118401 118251 118096 117937 118552 118561 118569 118573 118575 118573 118569 118545 118397 118246 118090 117930 118549 118557 118564 118568 118569 118567 118562
118564 118482 118327 118184 118053 117930 117812 117696 117580 117462 117343 117221 118558 118475 118320 118177 118045 117922 117804 117688 117571 117454 117334 117212
117097 116970 116839 116705 116568 116426 116876 116904 116928 116947 116959 116963 117087 116960 116829 116694 116556 116413 116868 116894 116917 116935 116946 116950
116961 116955 116851 116664 116504 116369 116249 116139 116033 115929 115826 115721 116948 116942 116837 116649 116488 116352 116232 116122 116016 115913 115809 115704
115614 115506 115394 115280 115164 115044 114920 115200 115250 115293 115328 115351 115598 115489 115377 115263 115146 115026 114902 115187 115234 115276 115309 115332
115360 115357 115346 115201 114968 114799 114669 114559 114461 114369 114279 114190 115341 115337 115325 115180 114944 114774 114643 114534 114435 114343 114254 114165
114100 114009 113917 113822 113725 113625 113523 113419 113527 113601 113667 113721 114076 113985 113893 113798 113701 113601 113500 113395 113507 113578 113643 113695
113757 113771 113761 113742 113459 113205 113059 112950 112859 112778 112702 112628 113731 113745 113734 113716 113428 113171 113025 112915 112824 112743 112668 112595
112555 112482 112407 112330 112251 112171 112089 112005 111920 111857 111961 112054 112523 112450 112375 112299 112221 112141 112059 111976 111891 111829 111930 112022
112131 112184 112208 112191 112095 111822 111669 111555 111464 111386 111316 111250 112098 112151 112175 112158 112060 111784 111630 111515 111424 111347 111277 111212
111185 111121 111056 110990 110921 110851 110779 110706 110631 110555 110190 110331 111148 111084 111020 110955 110888 110818 110747 110674 110599 110523 110152 110291
110458 110564 110641 110682 110678 110613 110502 110389 110295 110215 110143 110077 110417 110523 110600 110642 110638 110573 110461 110348 110255 110175 110103 110038
110013 109950 109887 109830 109770 109704 109634 109562 109489 109411 109325 108528 109975 109913 109851 109799 109743 109678 109609 109538 109465 109387 109294 108478
108715 108885 109026 109133 109200 109225 109206 109156 109090 109023 108958 108895 108664 108833 108976 109085 109154 109180 109163 109113 109048 108981 108917 108855
108835 108775 108716 108657 108640 108589 108525 108456 108384 108310 108230 108111 108796 108737 108678 108622 108615 108566 108502 108433 108362 108289 108209 108087
106873 107119 107340 107523 107664 107762 107818 107835 107823 107790 107747 107698 106808 107054 107277 107464 107609 107710 107769 107788 107777 107746 107704 107656
107646 107593 107538 107482 107450 107465 107406 107339 107270 107198 107123 107046 107605 107553 107499 107444 107420 107433 107374 107308 107239 107167 107094 107017
106931 105228 105551 105833 106063 106240 106367 106450 106495 106509 106500 106475 106908 105143 105470 105758 105995 106178 106310 106397 106445 106462 106454 106431
106440 106398 106351 106302 106251 106278 106257 106196 106129 106059 105987 105912 106397 106356 106311 106262 106214 106246 106222 106162 106096 106026 105955 105881
105834 105740 103603 104030 104381 104656 104865 105017 105122 105186 105218 105225 105803 105710 103490 103929 104294 104580 104797 104956 105065 105134 105169 105178
105213 105188 105154 105113 105068 105033 105082 105045 104983 104916 104846 104773 105169 105145 105112 105072 105028 104997 105046 105009 104948 104882 104812 104740
104698 104620 104526 102025 102597 103006 103314 103546 103715 103833 103910 103952 104666 104588 104495 101869 102480 102910 103232 103474 103651 103775 103856 103902
103969 103965 103946 103916 103879 103837 103826 103871 103831 103768 103701 103631 103921 103919 103902 103874 103838 103797 103790 103834 103795 103733 103666 103597
103558 103483 103404 103309 100736 101297 101727 102048 102288 102463 102586 102666 103525 103450 103372 103278 100586 101175 101628 101964 102215 102398 102527 102612
102713 102732 102731 102714 102686 102650 102609 102615 102659 102616 102552 102485 102662 102684 102685 102670 102644 102609 102569 102578 102621 102579 102516 102449
102415 102342 102266 102187 102092 102380 102308 102233 102154 102060
</DataArray> </DataArray>
<DataArray type="Float32" Name="density_wetting" NumberOfComponents="1" format="ascii"> <DataArray type="Float32" Name="density_wetting" NumberOfComponents="1" format="ascii">
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
@ -176,22 +176,22 @@
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 0.999995 0.999981 0.999975 0.999973 0.999973 0.999974 0.999982 1 1 1 1 1 0.999984 0.999948 0.999932 0.999928 0.999928 0.999929 0.99995 0.999999 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 0.999687 0.999398 0.999305 0.999284 0.999283 0.999292 0.999422 0.999959 1 1 1 0.999999 0.999476 0.999041 0.998902 0.99887 0.998866 0.99888 0.999065 0.999903 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 0.999914 0.997439 0.9964 0.996122 0.996064 0.996059 0.996086 0.996473 0.999137 1 1 1 0.999856 0.996801 0.995596 0.995268 0.995196 0.995188 0.995219 0.995657 0.998734
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 0.998692 0.991936 0.990124 0.989676 0.989588 0.989581 0.989624 0.990262 1 1 1 0.999999 0.998374 0.991155 0.989214 0.988731 0.988633 0.988623 0.988667 0.989333
0.995893 1 1 1 1 1 1 1 1 1 1 1 0.995195 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 0.999927 0.994557 0.983222 0.98087 0.980391 0.980308 0.980302 0.980343 1 1 1 1 0.999888 0.994129 0.982765 0.980397 0.979912 0.979825 0.979818 0.979858
0.981077 0.98996 1 1 1 1 1 1 1 1 1 1 0.980579 0.989324 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 0.99933 0.987072 0.972194 0.969828 0.969435 0.969375 0.969371 1 1 1 1 1 0.999236 0.986912 0.972438 0.970126 0.969737 0.969676 0.969672
0.969403 0.970084 0.981743 1 1 1 1 1 1 1 1 1 0.969702 0.970367 0.981601 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 0.998169 0.976744 0.959366 0.957482 0.957244 0.957214 1 1 1 1 1 1 0.998105 0.977263 0.960591 0.958775 0.958543 0.958514
0.957212 0.957229 0.957774 0.972204 1 1 1 1 1 1 1 1 0.958512 0.958529 0.959055 0.972841 1 1 1 1 1 1 1 1
1 1 1 1 1 1 0.999999 0.997169 0.964168 0.945082 0.944169 0.944099 1 1 1 1 1 1 0.999997 0.997202 0.965658 0.947487 0.94662 0.946553
0.944092 0.944092 0.944098 0.944365 0.961864 0.946547 0.946546 0.946552 0.946808 0.963457
</DataArray> </DataArray>
<DataArray type="Float32" Name="saturation_nonwetting" NumberOfComponents="1" format="ascii"> <DataArray type="Float32" Name="saturation_nonwetting" 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
@ -212,24 +212,24 @@
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 6.03686e-11 6.84135e-10 1.1886e-09 1.3534e-09 1.39611e-09 1.35567e-09 6.58939e-10 4.69624e-14 0 0 0 0 5.29106e-10 5.02096e-09 8.49983e-09 9.68729e-09 1.00277e-08 9.78437e-09 5.11514e-09 1.41798e-12 0 0 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 2.20083e-11 5.46176e-06 1.92599e-05 2.54279e-05 2.69106e-05 2.70449e-05 2.63306e-05 1.78347e-05 1.18193e-07 0 0 0 1.91592e-10 1.62724e-05 5.22328e-05 6.79867e-05 7.19592e-05 7.24299e-05 7.06825e-05 4.97464e-05 6.71839e-07 0 0
0 0 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.67773e-07 0.000312692 0.000602164 0.000695057 0.000715537 0.000717284 0.000707532 0.000578475 4.14445e-05 0 0 0 1.38095e-06 0.000524423 0.000959283 0.00109821 0.00113038 0.001134 0.00112008 0.000935327 9.71863e-05 0
0 0 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.22515e-11 8.62217e-05 0.00256061 0.00360008 0.00387843 0.00393649 0.00394128 0.0039142 0.00352713 0.00086277 0 0 7.55117e-11 0.00014425 0.00319919 0.00440369 0.0047321 0.00480403 0.00481177 0.00478069 0.00434298 0.00126585
0 0 0 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.43517e-07 0.00130794 0.0080637 0.00987605 0.0103243 0.0104121 0.0104189 0.0103764 0.00973769 0 0 0 8.46194e-07 0.00162617 0.00884466 0.0107862 0.0112689 0.0113668 0.0113766 0.0113327 0.0106671
0.004107 0 0 0 0 0 0 0 0 0 0 0 0.00480471 0 0 0 0 0 0 0 0 0 0 0
0 0 0 0 7.32147e-05 0.00544297 0.0167779 0.01913 0.0196088 0.019692 0.0196976 0.0196566 0 0 0 0 0.000111544 0.00587123 0.0172347 0.0196026 0.0200879 0.0201748 0.0201822 0.0201421
0.0189233 0.0100401 0 0 0 0 0 0 0 0 0 0 0.0194211 0.0106763 0 0 0 0 0 0 0 0 0 0
0 0 0 0 0 0.000669943 0.0129278 0.0278064 0.0301715 0.0305651 0.0306249 0.0306286 0 0 0 0 2.22045e-16 0.000764233 0.0130876 0.0275619 0.0298744 0.0302635 0.0303238 0.0303284
0.0305966 0.0299163 0.0182574 0 0 0 0 0 0 0 0 0 0.0302975 0.0296329 0.0183991 0 0 0 0 0 0 0 0 0
0 0 0 0 0 1.72005e-10 0.00183125 0.0232558 0.0406338 0.0425178 0.0427564 0.0427864 0 0 0 0 0 1.0408e-09 0.00189482 0.0227365 0.0394093 0.0412252 0.0414567 0.0414862
0.0427884 0.0427706 0.0422259 0.0277962 0 0 0 0 0 0 0 0 0.0414885 0.0414714 0.0409448 0.0271594 0 0 0 0 0 0 0 0
0 0 0 0 0 0 1.36562e-06 0.00283148 0.0358319 0.054918 0.0558309 0.0559014 0 0 0 0 0 0 3.33375e-06 0.00279813 0.0343417 0.0525127 0.0533799 0.053447
0.0559079 0.0559084 0.0559022 0.055635 0.0381361 0.0534533 0.0534537 0.0534477 0.0531924 0.0365426
</DataArray> </DataArray>
<DataArray type="Float32" Name="relativePerm_wetting" NumberOfComponents="1" format="ascii"> <DataArray type="Float32" Name="relativePerm_wetting" NumberOfComponents="1" format="ascii">
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
@ -252,22 +252,22 @@
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 0.999824 0.999522 0.999404 0.999377 0.999375 0.999388 0.99955 0.999991 1 1 1 1 0.999564 0.998903 0.998648 0.998586 0.998578 0.998606 0.998944 0.999965 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 0.999975 0.995645 0.992672 0.991787 0.991596 0.991579 0.99167 0.992902 0.999123 1 1 1 0.999938 0.993161 0.98895 0.987697 0.987412 0.98738 0.987503 0.98917 0.998205 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 0.998433 0.976866 0.969689 0.967847 0.967466 0.967435 0.967612 0.970177 0.990249 1 1 1 0.997545 0.971252 0.962971 0.960802 0.960332 0.960281 0.960484 0.963376 0.986228
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 0.99998 0.986429 0.942662 0.932746 0.93036 0.929896 0.92986 0.930085 0.933488 1 1 1 0.999958 0.983196 0.935794 0.924967 0.922348 0.92182 0.921768 0.922004 0.925618
0.966355 1 1 1 1 1 1 1 1 1 1 1 0.960327 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 0.998623 0.957955 0.898204 0.887285 0.885105 0.884728 0.884702 0.884888 1 1 1 1 0.997998 0.953515 0.89183 0.880481 0.878199 0.877792 0.877757 0.877945
0.888231 0.93187 1 1 1 1 1 1 1 1 1 1 0.881337 0.925567 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 0.992024 0.916937 0.849629 0.839949 0.838359 0.838118 0.838103 1 1 1 1 1 0.990776 0.912704 0.844665 0.834818 0.833183 0.83293 0.832911
0.838232 0.840983 0.891295 1 1 1 1 1 1 1 1 1 0.83304 0.835836 0.886202 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 0.982271 0.868918 0.799465 0.792527 0.791655 0.791546 1 1 1 1 1 1 0.981027 0.865987 0.796324 0.789329 0.788445 0.788332
0.791538 0.791603 0.793595 0.849671 1 1 1 1 1 1 1 1 0.788324 0.788389 0.790403 0.846402 1 1 1 1 1 1 1 1
1 1 1 1 1 1 0.999941 0.974945 0.817609 0.749077 0.746015 0.74578 1 1 1 1 1 1 0.999876 0.974149 0.816389 0.747873 0.744818 0.744583
0.745758 0.745756 0.745777 0.746671 0.808817 0.744561 0.744559 0.74458 0.745477 0.807572
</DataArray> </DataArray>
<DataArray type="Float32" Name="relativePerm_nonwetting" NumberOfComponents="1" format="ascii"> <DataArray type="Float32" Name="relativePerm_nonwetting" 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
@ -288,24 +288,24 @@
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 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.16262e-21 1.72459e-19 5.37915e-19 7.0282e-19 7.49256e-19 7.05245e-19 1.59634e-19 4.59773e-28 0 0 0 0 1.52881e-19 1.57344e-17 4.6523e-17 6.09009e-17 6.53904e-17 6.21644e-17 1.63482e-17 7.72573e-25 0 0 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 6.78189e-21 1.32879e-10 1.47108e-09 2.49933e-09 2.78471e-09 2.81128e-09 2.67132e-09 1.27039e-09 8.86051e-14 0 0 0 4.64285e-19 1.17619e-09 1.08833e-08 1.79956e-08 2.00547e-08 2.03057e-08 1.93813e-08 9.91634e-09 2.68985e-12 0 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0 1.22255e-12 2.99869e-07 1.04679e-06 1.37632e-06 1.45471e-06 1.4615e-06 1.42382e-06 9.69638e-07 6.34708e-09 0 0 0 1.06341e-11 8.86816e-07 2.80634e-06 3.63237e-06 3.83804e-06 3.86153e-06 3.77161e-06 2.67417e-06 3.5581e-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 2.21828e-21 2.56766e-08 1.65569e-05 3.17085e-05 3.65474e-05 3.75978e-05 3.76851e-05 3.7193e-05 3.04945e-05 2.07873e-06 0 0 7.85853e-20 7.55824e-08 2.79177e-05 5.13478e-05 5.88957e-05 6.06145e-05 6.08008e-05 6.00541e-05 5.00064e-05 4.76297e-06
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0 0 6.7835e-13 4.5971e-06 0.000147543 0.000217135 0.000236301 0.000240143 0.000240443 0.000238576 0.000211374 0 0 0 4.17733e-12 7.68031e-06 0.00019404 0.000283224 0.000307865 0.000312979 0.00031349 0.00031119 0.000277294
4.07644e-05 0 0 0 0 0 0 0 0 0 0 0 6.06308e-05 0 0 0 0 0 0 0 0 0 0 0
0 0 0 0 1.87953e-08 6.97433e-05 0.000595902 0.000764995 0.000801848 0.000808341 0.00080878 0.000805575 0 0 0 0 4.62788e-08 8.8856e-05 0.000691514 0.000883554 0.000925653 0.000933288 0.000933943 0.000930412
0.000749332 0.000224059 0 0 0 0 0 0 0 0 0 0 0.000868051 0.000277753 0 0 0 0 0 0 0 0 0 0
0 0 0 0 0 1.28301e-06 0.000362701 0.00155857 0.00182029 0.0018657 0.00187264 0.00187308 0 0 0 0 2.63507e-30 1.81895e-06 0.000409399 0.00168965 0.00196934 0.00201838 0.00202603 0.00202661
0.00186936 0.00179112 0.000699931 0 0 0 0 0 0 0 0 0 0.0020227 0.00193918 0.000783169 0 0 0 0 0 0 0 0 0
0 0 0 0 0 3.42715e-19 8.7353e-06 0.00110938 0.00320488 0.00349289 0.00353019 0.0035349 0 0 0 0 0 1.17219e-17 1.0281e-05 0.00117168 0.00333332 0.00363096 0.00366976 0.00367472
0.00353521 0.00353242 0.0034475 0.00155749 0 0 0 0 0 0 0 0 0.00367509 0.00367222 0.00358421 0.00164303 0 0 0 0 0 0 0 0
0 0 0 0 0 0 9.43957e-12 2.00571e-05 0.00252387 0.00567602 0.00585621 0.00587023 0 0 0 0 0 0 5.71377e-11 2.16241e-05 0.00256649 0.00574646 0.00592767 0.0059418
0.00587153 0.00587162 0.00587038 0.00581732 0.0028411 0.00594313 0.00594323 0.00594196 0.00588826 0.00288794
</DataArray> </DataArray>
<DataArray type="Float32" Name="porosity" NumberOfComponents="1" format="ascii"> <DataArray type="Float32" Name="porosity" NumberOfComponents="1" format="ascii">
0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4

View File

@ -0,0 +1 @@
s0004-p0003-lens_immiscible_vcfv_fd-heuristix.vtu

View File

@ -4,80 +4,80 @@
<Piece NumberOfCells="384" NumberOfPoints="425"> <Piece NumberOfCells="384" NumberOfPoints="425">
<PointData Scalars="pressure_wetting" Vectors="intrinsicPerm[0]"> <PointData Scalars="pressure_wetting" Vectors="intrinsicPerm[0]">
<DataArray type="Float32" Name="pressure_wetting" NumberOfComponents="1" format="ascii"> <DataArray type="Float32" Name="pressure_wetting" NumberOfComponents="1" format="ascii">
124036 123812 122504 122292 123584 122075 123350 121849 123109 121613 122858 121360 124052 123825 122513 122300 123594 122080 123358 121852 123114 121613 122860 121358
122589 121082 122288 120760 121885 120362 121530 120120 121444 120063 121324 119979 122588 121077 122284 120751 121876 120349 121517 120104 121430 120047 121309 119962
121200 119879 121076 119772 120951 119660 120825 119545 120699 119428 120573 119309 121184 119861 121058 119753 120931 119640 120804 119524 120677 119406 120550 119286
120446 119189 120320 119068 120193 118946 120066 118824 119938 118701 119811 118578 120422 119165 120294 119043 120166 118920 120038 118797 119909 118673 119781 118549
119684 118455 120976 120778 120573 120359 120132 119887 119615 119306 118952 118750 119652 118425 120980 120780 120574 120358 120128 119880 119606 119295 118937 118733
118710 118646 118565 118472 118372 118267 118158 118046 117933 117817 117701 117583 118693 118628 118546 118452 118352 118246 118136 118023 117908 117792 117674 117556
117465 117346 117227 119453 119271 119081 118882 118669 118438 118185 117902 117588 117437 117317 117197 119452 119268 119077 118875 118661 118428 118172 117888 117571
117414 117382 117330 117261 117180 117089 116993 116891 116786 116678 116568 116456 117395 117363 117310 117241 117159 117068 116971 116868 116762 116654 116543 116430
116343 116229 116114 115999 117937 117771 117599 117417 117223 117013 116783 116531 116316 116201 116086 115970 117930 117763 117589 117406 117211 116999 116768 116514
116255 116102 116075 116030 115969 115896 115813 115723 115628 115528 115425 115320 116236 116082 116055 116009 115948 115875 115791 115701 115605 115505 115401 115295
115212 115103 114993 114882 114771 116426 116279 116126 115964 115792 115607 115406 115187 115077 114966 114855 114743 116413 116266 116111 115949 115776 115590 115388
115185 114944 114811 114787 114745 114689 114621 114544 114459 114369 114274 114175 115166 114924 114790 114766 114724 114668 114599 114522 114436 114345 114250 114151
114074 113970 113865 113758 113651 113543 114920 114793 114660 114521 114375 114217 114049 113945 113839 113732 113624 113516 114902 114774 114641 114502 114355 114197
114047 113861 113655 113540 113516 113476 113421 113356 113282 113201 113114 113023 114027 113840 113633 113518 113494 113454 113399 113334 113259 113178 113090 112999
112928 112830 112730 112628 112524 112420 112315 113419 113312 113201 113087 112967 112903 112805 112705 112602 112499 112394 112289 113395 113288 113178 113063 112943
112841 112705 112556 112387 112288 112262 112220 112164 112099 112027 111948 111864 112817 112682 112533 112364 112265 112240 112197 112141 112076 112004 111924 111840
111775 111683 111588 111491 111392 111291 111190 111087 111920 111834 111746 111657 111751 111659 111564 111466 111367 111266 111164 111062 111891 111805 111718 111629
111566 111473 111375 111272 111149 111059 111026 110976 110917 110850 110778 110700 111539 111446 111349 111246 111124 111035 111002 110952 110893 110827 110754 110676
110618 110531 110442 110349 110254 110158 110059 109960 109860 110555 110480 110404 110594 110507 110417 110325 110230 110133 110035 109935 109835 110523 110448 110373
110328 110252 110176 110099 110022 109947 109865 109800 109740 109676 109608 109534 110298 110223 110147 110071 109995 109921 109840 109776 109716 109652 109584 109511
109457 109375 109291 109203 109112 109020 108925 108829 108731 108633 109324 109249 109433 109351 109267 109179 109088 108995 108900 108804 108707 108608 109292 109217
109174 109099 109023 108948 108872 108796 108721 108647 108577 108509 108441 108369 109143 109068 108994 108919 108844 108769 108694 108621 108552 108484 108416 108345
108295 108217 108137 108053 107966 107878 107787 107694 107599 107503 107406 108093 108271 108193 108113 108029 107942 107853 107762 107669 107575 107479 107382 108061
108018 107944 107869 107794 107720 107645 107570 107496 107422 107350 107279 107208 107986 107912 107839 107765 107691 107617 107543 107469 107396 107325 107254 107183
107135 107059 106981 106901 106818 106733 106645 106556 106464 106371 106276 106180 107110 107035 106957 106877 106794 106709 106621 106532 106440 106347 106252 106155
106863 106787 106713 106640 106566 106492 106418 106343 106270 106196 106123 106050 106830 106755 106682 106609 106536 106463 106389 106316 106243 106170 106097 106025
105977 105902 105826 105748 105667 105585 105501 105415 105327 105237 105145 105051 105952 105878 105802 105724 105643 105561 105477 105391 105303 105213 105121 105026
104954 105633 105556 105483 105410 105337 105264 105190 105117 105043 104969 104896 104929 105600 105524 105452 105380 105308 105235 105162 105089 105016 104943 104870
104822 104747 104672 104595 104516 104436 104354 104271 104186 104099 104012 103922 104796 104722 104647 104570 104492 104412 104330 104247 104162 104076 103988 103898
103828 103729 104404 104326 104253 104181 104109 104037 103963 103890 103816 103742 103803 103704 104371 104294 104222 104151 104079 104007 103935 103862 103789 103716
103668 103594 103519 103443 103365 103287 103207 103125 103042 102958 102874 102788 103642 103568 103493 103418 103341 103262 103182 103101 103019 102935 102850 102765
102702 102610 102507 103176 103097 103024 102953 102882 102809 102736 102663 102589 102679 102587 102481 103143 103065 102993 102923 102852 102780 102708 102635 102562
102516 102441 102367 102291 102215 102137 102058 101978 101897 101815 101732 101648 102489 102415 102341 102266 102190 102113 102034 101954 101873 101791 101708 101625
101565 101485 101408 101299 101949 101869 101797 101727 101655 101583 101510 101437 101543 101464 101389 101269 101916 101837 101766 101696 101625 101554 101481 101409
101363 101289 101215 101140 101064 100988 100910 100832 100752 100670 100588 100505 101336 101262 101189 101114 101039 100963 100886 100807 100727 100647 100565 100482
100422 100341 100263 100200 100240 100400 100319 100243 100184 100258
</DataArray> </DataArray>
<DataArray type="Float32" Name="pressure_nonwetting" NumberOfComponents="1" format="ascii"> <DataArray type="Float32" Name="pressure_nonwetting" NumberOfComponents="1" format="ascii">
124036 123812 122504 122292 123584 122075 123350 121849 123109 121613 122858 121360 124052 123825 122513 122300 123594 122080 123358 121852 123114 121613 122860 121358
122589 121082 122288 120760 121885 120362 121530 120120 121444 120063 121324 119979 122588 121077 122284 120751 121876 120349 121517 120104 121430 120047 121309 119962
121200 119879 121076 119772 120951 119660 120825 119545 120699 119428 120573 119309 121184 119861 121058 119753 120931 119640 120804 119524 120677 119406 120550 119286
120446 119189 120320 119068 120193 118946 120066 118824 119938 118701 119811 118578 120422 119165 120294 119043 120166 118920 120038 118797 119909 118673 119781 118549
119684 118455 120976 120778 120573 120359 120132 119887 119615 119306 118952 118750 119652 118425 120980 120780 120574 120358 120128 119880 119606 119295 118937 118733
118710 118646 118565 118472 118372 118267 118158 118046 117933 117817 117701 117583 118693 118628 118546 118452 118352 118246 118136 118023 117908 117792 117674 117556
117465 117346 117227 119453 119271 119081 118882 118669 118438 118185 117902 117588 117437 117317 117197 119452 119268 119077 118875 118661 118428 118172 117888 117571
117414 117382 117330 117261 117180 117089 116993 116891 116786 116678 116568 116456 117395 117363 117310 117241 117159 117068 116971 116868 116762 116654 116543 116430
116343 116229 116114 115999 117937 117771 117599 117417 117223 117013 116783 116531 116316 116201 116086 115970 117930 117763 117589 117406 117211 116999 116768 116514
116255 116102 116075 116030 115969 115896 115813 115723 115628 115528 115425 115320 116236 116082 116055 116009 115948 115875 115791 115701 115605 115505 115401 115295
115212 115103 114993 114882 114771 116426 116279 116126 115964 115792 115607 115406 115187 115077 114966 114855 114743 116413 116266 116111 115949 115776 115590 115388
115185 114944 114811 114787 114745 114689 114621 114544 114459 114369 114274 114175 115166 114924 114790 114766 114724 114668 114599 114522 114436 114345 114250 114151
114074 113970 113865 113758 113651 113543 114920 114793 114660 114521 114375 114217 114049 113945 113839 113732 113624 113516 114902 114774 114641 114502 114355 114197
114047 113861 113655 113540 113516 113476 113421 113356 113282 113201 113114 113023 114027 113840 113633 113518 113494 113454 113399 113334 113259 113178 113090 112999
112928 112830 112730 112628 112524 112420 112315 113419 113312 113201 113087 112967 112903 112805 112705 112602 112499 112394 112289 113395 113288 113178 113063 112943
112841 112705 112556 112387 112288 112262 112220 112164 112099 112027 111948 111864 112817 112682 112533 112364 112265 112240 112197 112141 112076 112004 111924 111840
111775 111683 111588 111491 111392 111291 111190 111087 111920 111834 111746 111657 111751 111659 111564 111466 111367 111266 111164 111062 111891 111805 111718 111629
111566 111473 111375 111272 111149 111059 111026 110976 110917 110850 110778 110700 111539 111446 111349 111246 111124 111035 111002 110952 110893 110827 110754 110676
110618 110531 110442 110349 110254 110158 110059 109960 109860 110555 110480 110404 110594 110507 110417 110325 110230 110133 110035 109935 109835 110523 110448 110373
110328 110252 110176 110099 110022 109947 109865 109800 109740 109676 109608 109534 110298 110223 110147 110071 109995 109921 109840 109776 109716 109652 109584 109511
109457 109375 109291 109203 109112 109020 108925 108829 108731 108633 109325 109249 109433 109351 109267 109179 109088 108995 108900 108804 108707 108608 109294 109217
109174 109099 109023 108948 108872 108796 108721 108647 108577 108509 108441 108369 109143 109068 108994 108919 108844 108769 108694 108621 108552 108484 108416 108345
108295 108217 108137 108053 107966 107878 107787 107694 107599 107503 107406 108111 108271 108193 108113 108029 107942 107853 107762 107669 107575 107479 107382 108087
108018 107944 107869 107794 107720 107645 107570 107496 107422 107350 107279 107208 107987 107912 107839 107765 107691 107617 107543 107469 107396 107325 107254 107183
107135 107059 106981 106901 106818 106733 106645 106556 106464 106371 106276 106180 107110 107035 106957 106877 106794 106709 106621 106532 106440 106347 106252 106155
106931 106793 106713 106640 106566 106492 106418 106343 106270 106196 106123 106050 106908 106765 106682 106609 106536 106463 106389 106316 106243 106170 106097 106025
105977 105902 105826 105748 105667 105585 105501 105415 105327 105237 105145 105051 105952 105878 105802 105724 105643 105561 105477 105391 105303 105213 105121 105026
104954 105740 105588 105483 105410 105337 105264 105190 105117 105043 104969 104896 104929 105710 105562 105452 105380 105308 105235 105162 105089 105016 104943 104870
104822 104747 104672 104595 104516 104436 104354 104271 104186 104099 104012 103922 104796 104722 104647 104570 104492 104412 104330 104247 104162 104076 103988 103898
103828 103729 104526 104391 104257 104181 104109 104037 103963 103890 103816 103742 103803 103704 104495 104365 104226 104151 104079 104007 103935 103862 103789 103716
103668 103594 103519 103443 103365 103287 103207 103125 103042 102958 102874 102788 103642 103568 103493 103418 103341 103262 103182 103101 103019 102935 102850 102765
102702 102610 102507 103309 103186 103033 102953 102882 102809 102736 102663 102589 102679 102587 102481 103278 103156 103004 102923 102852 102780 102708 102635 102562
102516 102441 102367 102291 102215 102137 102058 101978 101897 101815 101732 101648 102489 102415 102341 102266 102190 102113 102034 101954 101873 101791 101708 101625
101565 101485 101408 101299 102092 101963 101808 101727 101655 101583 101510 101437 101543 101464 101389 101269 102060 101932 101778 101696 101625 101554 101481 101409
101363 101289 101215 101140 101064 100988 100910 100832 100752 100670 100588 100505 101336 101262 101189 101114 101039 100963 100886 100807 100727 100647 100565 100482
100422 100341 100263 100200 100240 100400 100319 100243 100184 100258
</DataArray> </DataArray>
<DataArray type="Float32" Name="density_wetting" NumberOfComponents="1" format="ascii"> <DataArray type="Float32" Name="density_wetting" NumberOfComponents="1" format="ascii">
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
@ -174,22 +174,22 @@
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 0.999999 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 0.999903 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 0.999959 1 1 1 1 1 1 1 1 1 1 1 1 0.998734
0.999972 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 0.999137 0.995195 0.999543 0.999998 1 1 1 1 1 1 1 1 1
0.999988 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
0.995893 0.9997 0.999999 1 1 1 1 1 1 1 1 1 1 0.989324 0.998071 0.999959 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 0.98996 0.998383 0.999975 1 1 1 1 1 1 1 1 1 1 0.981601 0.995847 0.999786 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 0.981743 0.996105 0.999833 1 1 1 1 1 1 1 1 1 1 0.972841 0.993688 0.999502 0.999998 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 0.972204 0.993759 0.999557 0.999999 1 1 1 1 1 1 1 1 1 0.963457 0.993162 0.999448 0.999997 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 0.961864 0.992999 0.99947 0.999998 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1
</DataArray> </DataArray>
@ -210,24 +210,24 @@
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0 0 0 0 0 0 0 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.69624e-14 0 0 0 0 0 0 0 0 0 0 0 1.41798e-12 0 0 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0 0 0 0 0 0 0 0 1.18193e-07 3.09086e-13 0 0 0 0 0 0 0 0 0 0 6.71839e-07 9.5266e-12 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0 0 0 0 0 0 0 0 0 4.14445e-05 2.60014e-08 0 0 0 0 0 0 0 0 0 0 9.71863e-05 1.52786e-07
1.23235e-14 0 0 0 0 0 0 0 0 0 0 0 3.95683e-13 0 0 0 0 0 0 0 0 0 0 0
0 0 0 0 0 0 0 0 0 0 0 0.00086277 0 0 0 0 0 0 0 0 0 0 0 0.00126585
1.15243e-05 1.40371e-09 0 0 0 0 0 0 0 0 0 0 2.83273e-05 8.64332e-09 1.55431e-15 0 0 0 0 0 0 0 0 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0.004107 0.000299831 7.80027e-07 7.71738e-12 0 0 0 0 0 0 0 0 0.00480471 0.000457082 2.00121e-06 5.0876e-11 0 0 0 0 0 0 0 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0.0100401 0.00161751 2.49693e-05 5.7285e-09 6.66134e-16 0 0 0 0 0 0 0 0.0106763 0.00192911 4.06127e-05 1.591e-08 4.996e-15 0 0 0 0 0 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0 0.0182574 0.00389469 0.000167121 2.21379e-07 6.84008e-13 0 0 0 0 0 0 0 0.0183991 0.00415257 0.000213546 3.91888e-07 2.21956e-12 0 0 0 0 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0 0 0.0277962 0.00624061 0.000442566 1.49469e-06 2.59467e-11 0 0 0 0 0 0 0 0.0271594 0.00631231 0.000497714 2.08255e-06 5.33367e-11 0 0 0 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0 0 0 0.0381361 0.00700067 0.000530002 2.147e-06 5.16345e-11 0 0 0 0 0 0 0 0.0365426 0.00683837 0.000551566 2.56915e-06 7.94053e-11 0 0 0
0 0 0 0 0 0 0 0 0 0 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>
@ -250,22 +250,22 @@
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 0.999991 1 1 1 1 1 1 1 1 1 1 1 0.999965 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 0.999123 0.999997 1 1 1 1 1 1 1 1 1 1 0.998205 0.999989
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 0.990249 1 1 1 1 1 1 1 1 1 1 1 0.986228
0.999682 1 1 1 1 1 1 1 1 1 1 1 0.999324 0.999999 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
0.966355 0.995788 0.999962 1 1 1 1 1 1 1 1 1 0.960327 0.993868 0.999917 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 0.93187 0.983935 0.999413 0.999999 1 1 1 1 1 1 1 1 0.925567 0.980755 0.999101 0.999998 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 0.891295 0.96774 0.997351 0.999986 1 1 1 1 1 1 1 1 0.886202 0.964653 0.996649 0.999977 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 0.849671 0.953157 0.994262 0.999937 1 1 1 1 1 1 1 1 0.846402 0.950779 0.993439 0.999914 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 0.808817 0.948709 0.993378 0.999916 1 1 1 1 1 1 1 1 0.807572 0.94757 0.992881 0.999899 1 1 1 1
1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1 1
1 1 1 1 1 1 1 1 1 1
</DataArray> </DataArray>
@ -286,24 +286,24 @@
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0 0 0 0 0 0 0 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.59773e-28 0 0 0 0 0 0 0 0 0 0 0 7.72573e-25 0 0 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0 0 0 0 0 0 0 0 8.86051e-14 1.98177e-24 0 0 0 0 0 0 0 0 0 0 2.68985e-12 1.51385e-21 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0 0 0 0 0 0 0 0 0 6.34708e-09 4.93063e-15 0 0 0 0 0 0 0 0 0 0 3.5581e-08 1.59464e-13
4.24094e-27 0 0 0 0 0 0 0 0 0 0 0 3.50229e-24 0 0 0 0 0 0 0 0 0 0 0
0 0 0 0 0 0 0 0 0 0 0 2.07873e-06 0 0 0 0 0 0 0 0 0 0 0 4.76297e-06
5.5223e-10 1.88081e-17 0 0 0 0 0 0 0 0 0 0 3.38678e-09 6.65071e-16 9.21798e-29 0 0 0 0 0 0 0 0 0
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.07644e-05 2.76779e-07 3.24294e-12 9.18503e-22 0 0 0 0 0 0 0 0 6.06308e-05 6.82289e-07 2.15814e-11 3.69956e-20 0 0 0 0 0 0 0 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0.000224059 6.89392e-06 2.41404e-09 2.75144e-16 1.75017e-29 0 0 0 0 0 0 0 0.000277753 1.06387e-05 6.73402e-09 2.13019e-15 8.31667e-28 0 0 0 0 0 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0 0.000699931 3.68401e-05 9.0753e-08 2.93375e-13 9.02157e-24 0 0 0 0 0 0 0 0.000783169 4.59089e-05 1.59757e-07 9.61844e-13 9.39885e-23 0 0 0 0 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0 0 0.00155749 9.05179e-05 5.81744e-07 1.12145e-11 9.28435e-21 0 0 0 0 0 0 0 0.00164303 0.000102014 8.0265e-07 2.32857e-11 4.04842e-20 0 0 0 0
0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
0 0 0 0 0.0028411 0.00011269 8.20548e-07 2.23791e-11 3.45075e-20 0 0 0 0 0 0 0 0.00288794 0.000118832 9.76431e-07 3.4759e-11 8.64964e-20 0 0 0
0 0 0 0 0 0 0 0 0 0 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>

File diff suppressed because it is too large Load Diff

File diff suppressed because it is too large Load Diff

View File

@ -1,565 +0,0 @@
<?xml version="1.0"?>
<VTKFile type="UnstructuredGrid" version="0.1" byte_order="LittleEndian">
<UnstructuredGrid>
<Piece NumberOfCells="324" NumberOfPoints="361">
<PointData Scalars="pressure_gas" Vectors="velocity_gas">
<DataArray type="Float32" Name="pressure_gas" NumberOfComponents="1" format="ascii">
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012 100012
100012 100012 100012 100012 100012 100012 100000 100000 100000 100000 100000 100000
100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000
100000
</DataArray>
<DataArray type="Float32" Name="density_gas" NumberOfComponents="1" format="ascii">
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23021
1.23021 1.23021 1.23021 1.23021 1.23021 1.23021 1.23007 1.23007 1.23007 1.23007 1.23007 1.23007
1.23007 1.23007 1.23007 1.23007 1.23007 1.23007 1.23007 1.23007 1.23007 1.23007 1.23007 1.23007
1.23007
</DataArray>
<DataArray type="Float32" Name="moleFraction_gas^H2O" NumberOfComponents="1" format="ascii">
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001 0.0001
0.0001
</DataArray>
<DataArray type="Float32" Name="moleFraction_gas^Air" NumberOfComponents="1" format="ascii">
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999 0.9999
0.9999
</DataArray>
<DataArray type="Float32" Name="temperature_gas" NumberOfComponents="1" format="ascii">
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15 283.15
283.15
</DataArray>
<DataArray type="Float32" Name="viscosity_gas" NumberOfComponents="1" format="ascii">
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05 1.75174e-05
1.75174e-05
</DataArray>
<DataArray type="Float32" Name="velocity_gas" NumberOfComponents="3" format="ascii">
0 283.15 0 0 283.15 0 -9.34234e-12 283.15 0 6.94956e-12 283.15 0
0 283.15 0 -5.91933e-12 283.15 0 0 283.15 0 2.55285e-12 283.15 0
0 283.15 0 -3.93677e-12 283.15 0 0 283.15 0 4.33284e-12 283.15 0
0 283.15 0 7.89245e-14 283.15 0 0 283.15 0 -1.32122e-13 283.15 0
0 283.15 0 2.42691e-12 283.15 0 0 283.15 0 1.45822e-12 283.15 0
0 283.15 0 3.47669e-12 283.15 0 0 283.15 0 6.68674e-12 283.15 0
0 283.15 0 6.19553e-12 283.15 0 0 283.15 0 2.51506e-12 283.15 0
0 283.15 0 7.18554e-12 283.15 0 0 283.15 0 -9.96618e-13 283.15 0
0 283.15 0 8.09853e-12 283.15 0 0 283.15 0 -6.41453e-12 283.15 0
0 283.15 0 8.56303e-12 283.15 0 2.42206e-11 283.15 0 -2.01125e-11 283.15 0
2.06664e-11 283.15 0 -1.29094e-11 283.15 0 1.3723e-11 283.15 0 -1.2409e-11 283.15 0
7.82057e-12 283.15 0 -5.07934e-12 283.15 0 -8.62738e-13 283.15 0 3.31115e-13 283.15 0
-7.46838e-12 283.15 0 -4.02189e-12 283.15 0 -1.71064e-11 283.15 0 3.08786e-12 283.15 0
-2.23285e-11 283.15 0 9.17363e-12 283.15 0 -2.22778e-11 283.15 0 1.69678e-11 283.15 0
-1.92007e-11 283.15 0 -2.21387e-11 283.15 0 1.90215e-11 283.15 0 -2.1644e-11 283.15 0
1.5938e-11 283.15 0 -1.75391e-11 283.15 0 1.60578e-11 283.15 0 -1.18034e-11 283.15 0
1.00551e-11 283.15 0 -2.19985e-12 283.15 0 -2.309e-12 283.15 0 6.06526e-12 283.15 0
-3.6266e-12 283.15 0 1.64118e-11 283.15 0 -9.65718e-12 283.15 0 1.94252e-11 283.15 0
-1.48859e-11 283.15 0 2.37558e-11 283.15 0 -1.98603e-11 283.15 0 1.88032e-11 283.15 0
3.60572e-12 283.15 0 -1.67972e-12 283.15 0 5.70084e-12 283.15 0 -7.31931e-12 283.15 0
7.99461e-12 283.15 0 -7.52631e-12 283.15 0 6.08172e-12 283.15 0 -6.85051e-12 283.15 0
3.37909e-12 283.15 0 1.76456e-12 283.15 0 1.4629e-12 283.15 0 5.25793e-12 283.15 0
-4.20283e-12 283.15 0 6.2833e-12 283.15 0 -3.57983e-12 283.15 0 6.60406e-12 283.15 0
-1.07334e-11 283.15 0 7.84279e-12 283.15 0 -6.66374e-12 283.15 0 6.98254e-12 283.15 0
-9.35063e-12 283.15 0 5.36073e-12 283.15 0 -6.17563e-13 283.15 0 1.18593e-12 283.15 0
-2.32858e-12 283.15 0 9.89246e-13 283.15 0 3.18172e-12 283.15 0 -2.76546e-12 283.15 0
1.03572e-13 283.15 0 -6.28375e-12 283.15 0 -4.12993e-12 283.15 0 -8.82064e-13 283.15 0
-2.95844e-12 283.15 0 -1.10496e-12 283.15 0 4.40898e-12 283.15 0 -1.33755e-12 283.15 0
6.99289e-12 283.15 0 -6.54003e-12 283.15 0 -6.56839e-12 283.15 0 1.01564e-11 283.15 0
-6.85346e-12 283.15 0 2.19777e-12 283.15 0 -3.03684e-12 283.15 0 2.61223e-12 283.15 0
-5.76709e-12 283.15 0 -4.62245e-12 283.15 0 7.80738e-13 283.15 0 -4.67807e-12 283.15 0
3.46235e-12 283.15 0 -1.58672e-12 283.15 0 -2.81206e-12 283.15 0 4.12948e-12 283.15 0
-4.40559e-12 283.15 0 -8.94473e-12 283.15 0 2.67833e-12 283.15 0 -1.16616e-11 283.15 0
1.27916e-11 283.15 0 -3.55544e-13 283.15 0 -2.5639e-12 283.15 0 -5.36857e-13 283.15 0
4.89206e-12 283.15 0 9.14505e-13 283.15 0 1.55982e-12 283.15 0 3.39594e-12 283.15 0
5.12985e-12 283.15 0 -2.08072e-12 283.15 0 6.14589e-12 283.15 0 3.02139e-12 283.15 0
7.67471e-12 283.15 0 6.72067e-12 283.15 0 -4.34874e-12 283.15 0 1.18808e-11 283.15 0
3.36392e-12 283.15 0 5.94235e-12 283.15 0 3.52351e-12 283.15 0 -6.65344e-12 283.15 0
4.39244e-12 283.15 0 -2.89844e-12 283.15 0 6.0459e-12 283.15 0 -8.58814e-12 283.15 0
-1.16428e-12 283.15 0 -3.65039e-12 283.15 0 1.86995e-12 283.15 0 -5.19177e-13 283.15 0
3.94475e-12 283.15 0 -3.66062e-12 283.15 0 -8.6376e-12 283.15 0 -6.61594e-12 283.15 0
-5.88334e-12 283.15 0 6.71051e-15 283.15 0 -1.15572e-11 283.15 0 1.92201e-12 283.15 0
-8.21321e-12 283.15 0 2.59854e-12 283.15 0 -7.30511e-13 283.15 0 7.02476e-13 283.15 0
-2.56757e-12 283.15 0 -4.57061e-12 283.15 0 1.5805e-12 283.15 0 4.85656e-12 283.15 0
1.41783e-12 283.15 0 -3.0258e-12 283.15 0 -3.73231e-12 283.15 0 -4.84821e-12 283.15 0
4.41535e-12 283.15 0 8.12172e-12 283.15 0 6.53746e-12 283.15 0 3.02737e-12 283.15 0
7.31541e-12 283.15 0 9.80125e-12 283.15 0 2.60291e-12 283.15 0 4.13454e-12 283.15 0
1.67714e-13 283.15 0 4.40858e-13 283.15 0 -9.22785e-12 283.15 0 1.0477e-11 283.15 0
5.19675e-13 283.15 0 7.4754e-12 283.15 0 -8.25683e-12 283.15 0 6.69229e-12 283.15 0
-2.13003e-13 283.15 0 6.7765e-12 283.15 0 3.87947e-12 283.15 0 -3.92799e-12 283.15 0
-4.29701e-12 283.15 0 -7.42851e-12 283.15 0 -6.60417e-13 283.15 0 -1.3597e-11 283.15 0
-6.13514e-12 283.15 0 -1.25468e-11 283.15 0 2.85547e-12 283.15 0 -6.94254e-12 283.15 0
6.96418e-12 283.15 0 1.544e-11 283.15 0 -1.53217e-11 283.15 0 9.14507e-12 283.15 0
-1.06433e-11 283.15 0 1.25767e-11 283.15 0 -1.12955e-11 283.15 0 9.41679e-12 283.15 0
-6.68124e-12 283.15 0 1.1116e-12 283.15 0 2.30518e-12 283.15 0 -9.64253e-13 283.15 0
4.74163e-12 283.15 0 -3.77214e-12 283.15 0 1.46388e-11 283.15 0 -6.11537e-12 283.15 0
1.95638e-11 283.15 0 -1.19929e-11 283.15 0 1.16358e-11 283.15 0 -1.43412e-11 283.15 0
-1.70264e-11 283.15 0 1.46128e-11 283.15 0 -1.79667e-11 283.15 0 1.0922e-11 283.15 0
-1.60946e-11 283.15 0 9.29026e-12 283.15 0 -1.4173e-11 283.15 0 3.34644e-12 283.15 0
-1.57261e-12 283.15 0 -1.46973e-12 283.15 0 1.1477e-11 283.15 0 -3.4822e-12 283.15 0
1.09507e-11 283.15 0 -1.13087e-11 283.15 0 1.13638e-11 283.15 0 -1.54774e-11 283.15 0
1.4293e-11 283.15 0 -9.43871e-12 283.15 0 1.27749e-11 283.15 0 1.08551e-11 283.15 0
-6.81863e-12 283.15 0 1.52126e-11 283.15 0 -7.2053e-12 283.15 0 1.09015e-11 283.15 0
-2.93099e-12 283.15 0 7.53453e-12 283.15 0 1.76369e-12 283.15 0 -5.0395e-15 283.15 0
2.28792e-12 283.15 0 -1.07331e-11 283.15 0 4.03672e-12 283.15 0 -9.97662e-12 283.15 0
5.92513e-12 283.15 0 -3.8107e-12 283.15 0 4.52762e-12 283.15 0 -8.68524e-12 283.15 0
2.00911e-12 283.15 0 -4.56256e-12 283.15 0 -3.72051e-12 283.15 0 2.01503e-12 283.15 0
-8.39464e-12 283.15 0 -3.51472e-13 283.15 0 -7.15741e-12 283.15 0 -3.83782e-12 283.15 0
-4.20016e-12 283.15 0 -5.99553e-12 283.15 0 -7.08219e-13 283.15 0 -4.95739e-12 283.15 0
-3.64921e-13 283.15 0 -1.6552e-12 283.15 0 2.67181e-12 283.15 0 2.1796e-12 283.15 0
-3.50266e-15 283.15 0 1.53187e-12 283.15 0 7.43411e-12 283.15 0 -3.8475e-13 283.15 0
2.77053e-12 283.15 0 -6.22464e-12 283.15 0 6.51266e-12 283.15 0 -5.12936e-12 283.15 0
7.45868e-12 283.15 0 2.06103e-12 283.15 0 4.70228e-12 283.15 0 2.02191e-12 283.15 0
1.88213e-12 283.15 0 1.53742e-12 283.15 0 7.39526e-13 283.15 0 3.96078e-12 283.15 0
-3.47226e-12 283.15 0 3.34877e-12 283.15 0 -7.40323e-12 283.15 0 4.91082e-12 283.15 0
-5.14561e-12 283.15 0 -3.54486e-12 283.15 0 -2.66627e-13 283.15 0 -1.45556e-12 283.15 0
1.22676e-11 283.15 0 -1.31526e-11 283.15 0 1.65321e-11 283.15 0 -7.94821e-12 283.15 0
6.63904e-12 283.15 0 -4.64077e-12 283.15 0 4.03579e-12 283.15 0 6.23212e-12 283.15 0
-4.02478e-12 283.15 0 5.16945e-12 283.15 0 -1.0969e-12 283.15 0 4.61058e-12 283.15 0
-6.48414e-12 283.15 0 5.93622e-12 283.15 0 -8.8131e-12 283.15 0 8.76568e-12 283.15 0
-2.37713e-12 283.15 0 5.02734e-12 283.15 0 -3.65402e-12 283.15 0 -5.74785e-12 283.15 0
5.65205e-12 283.15 0 -9.9641e-12 283.15 0 4.776e-13 283.15 0 -4.08303e-12 283.15 0
5.11683e-12 283.15 0 -4.28183e-12 283.15 0 -7.33718e-12 283.15 0 4.63138e-12 283.15 0
-3.65277e-12 283.15 0 -1.33995e-12 283.15 0 9.75541e-14 283.15 0 1.60728e-12 283.15 0
-1.29657e-12 283.15 0 1.13303e-12 283.15 0 -5.8871e-12 283.15 0 6.28182e-14 283.15 0
-6.03234e-12 283.15 0 6.28376e-12 283.15 0 0 283.15 0 0 283.15 0
0 283.15 0 0 283.15 0 0 283.15 0 0 283.15 0
0 283.15 0 0 283.15 0 0 283.15 0 0 283.15 0
0 283.15 0 0 283.15 0 0 283.15 0 0 283.15 0
0 283.15 0 0 283.15 0 0 283.15 0 0 283.15 0
0 283.15 0
</DataArray>
</PointData>
<Points>
<DataArray type="Float32" Name="Coordinates" NumberOfComponents="3" format="ascii">
0 0 0 0.0555556 0 0 0 0.0555556 0 0.0555556 0.0555556 0
0.111111 0 0 0.111111 0.0555556 0 0.166667 0 0 0.166667 0.0555556 0
0.222222 0 0 0.222222 0.0555556 0 0.277778 0 0 0.277778 0.0555556 0
0.333333 0 0 0.333333 0.0555556 0 0.388889 0 0 0.388889 0.0555556 0
0.444444 0 0 0.444444 0.0555556 0 0.5 0 0 0.5 0.0555556 0
0.555556 0 0 0.555556 0.0555556 0 0.611111 0 0 0.611111 0.0555556 0
0.666667 0 0 0.666667 0.0555556 0 0.722222 0 0 0.722222 0.0555556 0
0.777778 0 0 0.777778 0.0555556 0 0.833333 0 0 0.833333 0.0555556 0
0.888889 0 0 0.888889 0.0555556 0 0.944444 0 0 0.944444 0.0555556 0
1 0 0 1 0.0555556 0 0 0.111111 0 0.0555556 0.111111 0
0.111111 0.111111 0 0.166667 0.111111 0 0.222222 0.111111 0 0.277778 0.111111 0
0.333333 0.111111 0 0.388889 0.111111 0 0.444444 0.111111 0 0.5 0.111111 0
0.555556 0.111111 0 0.611111 0.111111 0 0.666667 0.111111 0 0.722222 0.111111 0
0.777778 0.111111 0 0.833333 0.111111 0 0.888889 0.111111 0 0.944444 0.111111 0
1 0.111111 0 0 0.166667 0 0.0555556 0.166667 0 0.111111 0.166667 0
0.166667 0.166667 0 0.222222 0.166667 0 0.277778 0.166667 0 0.333333 0.166667 0
0.388889 0.166667 0 0.444444 0.166667 0 0.5 0.166667 0 0.555556 0.166667 0
0.611111 0.166667 0 0.666667 0.166667 0 0.722222 0.166667 0 0.777778 0.166667 0
0.833333 0.166667 0 0.888889 0.166667 0 0.944444 0.166667 0 1 0.166667 0
0 0.222222 0 0.0555556 0.222222 0 0.111111 0.222222 0 0.166667 0.222222 0
0.222222 0.222222 0 0.277778 0.222222 0 0.333333 0.222222 0 0.388889 0.222222 0
0.444444 0.222222 0 0.5 0.222222 0 0.555556 0.222222 0 0.611111 0.222222 0
0.666667 0.222222 0 0.722222 0.222222 0 0.777778 0.222222 0 0.833333 0.222222 0
0.888889 0.222222 0 0.944444 0.222222 0 1 0.222222 0 0 0.277778 0
0.0555556 0.277778 0 0.111111 0.277778 0 0.166667 0.277778 0 0.222222 0.277778 0
0.277778 0.277778 0 0.333333 0.277778 0 0.388889 0.277778 0 0.444444 0.277778 0
0.5 0.277778 0 0.555556 0.277778 0 0.611111 0.277778 0 0.666667 0.277778 0
0.722222 0.277778 0 0.777778 0.277778 0 0.833333 0.277778 0 0.888889 0.277778 0
0.944444 0.277778 0 1 0.277778 0 0 0.333333 0 0.0555556 0.333333 0
0.111111 0.333333 0 0.166667 0.333333 0 0.222222 0.333333 0 0.277778 0.333333 0
0.333333 0.333333 0 0.388889 0.333333 0 0.444444 0.333333 0 0.5 0.333333 0
0.555556 0.333333 0 0.611111 0.333333 0 0.666667 0.333333 0 0.722222 0.333333 0
0.777778 0.333333 0 0.833333 0.333333 0 0.888889 0.333333 0 0.944444 0.333333 0
1 0.333333 0 0 0.388889 0 0.0555556 0.388889 0 0.111111 0.388889 0
0.166667 0.388889 0 0.222222 0.388889 0 0.277778 0.388889 0 0.333333 0.388889 0
0.388889 0.388889 0 0.444444 0.388889 0 0.5 0.388889 0 0.555556 0.388889 0
0.611111 0.388889 0 0.666667 0.388889 0 0.722222 0.388889 0 0.777778 0.388889 0
0.833333 0.388889 0 0.888889 0.388889 0 0.944444 0.388889 0 1 0.388889 0
0 0.444444 0 0.0555556 0.444444 0 0.111111 0.444444 0 0.166667 0.444444 0
0.222222 0.444444 0 0.277778 0.444444 0 0.333333 0.444444 0 0.388889 0.444444 0
0.444444 0.444444 0 0.5 0.444444 0 0.555556 0.444444 0 0.611111 0.444444 0
0.666667 0.444444 0 0.722222 0.444444 0 0.777778 0.444444 0 0.833333 0.444444 0
0.888889 0.444444 0 0.944444 0.444444 0 1 0.444444 0 0 0.5 0
0.0555556 0.5 0 0.111111 0.5 0 0.166667 0.5 0 0.222222 0.5 0
0.277778 0.5 0 0.333333 0.5 0 0.388889 0.5 0 0.444444 0.5 0
0.5 0.5 0 0.555556 0.5 0 0.611111 0.5 0 0.666667 0.5 0
0.722222 0.5 0 0.777778 0.5 0 0.833333 0.5 0 0.888889 0.5 0
0.944444 0.5 0 1 0.5 0 0 0.555556 0 0.0555556 0.555556 0
0.111111 0.555556 0 0.166667 0.555556 0 0.222222 0.555556 0 0.277778 0.555556 0
0.333333 0.555556 0 0.388889 0.555556 0 0.444444 0.555556 0 0.5 0.555556 0
0.555556 0.555556 0 0.611111 0.555556 0 0.666667 0.555556 0 0.722222 0.555556 0
0.777778 0.555556 0 0.833333 0.555556 0 0.888889 0.555556 0 0.944444 0.555556 0
1 0.555556 0 0 0.611111 0 0.0555556 0.611111 0 0.111111 0.611111 0
0.166667 0.611111 0 0.222222 0.611111 0 0.277778 0.611111 0 0.333333 0.611111 0
0.388889 0.611111 0 0.444444 0.611111 0 0.5 0.611111 0 0.555556 0.611111 0
0.611111 0.611111 0 0.666667 0.611111 0 0.722222 0.611111 0 0.777778 0.611111 0
0.833333 0.611111 0 0.888889 0.611111 0 0.944444 0.611111 0 1 0.611111 0
0 0.666667 0 0.0555556 0.666667 0 0.111111 0.666667 0 0.166667 0.666667 0
0.222222 0.666667 0 0.277778 0.666667 0 0.333333 0.666667 0 0.388889 0.666667 0
0.444444 0.666667 0 0.5 0.666667 0 0.555556 0.666667 0 0.611111 0.666667 0
0.666667 0.666667 0 0.722222 0.666667 0 0.777778 0.666667 0 0.833333 0.666667 0
0.888889 0.666667 0 0.944444 0.666667 0 1 0.666667 0 0 0.722222 0
0.0555556 0.722222 0 0.111111 0.722222 0 0.166667 0.722222 0 0.222222 0.722222 0
0.277778 0.722222 0 0.333333 0.722222 0 0.388889 0.722222 0 0.444444 0.722222 0
0.5 0.722222 0 0.555556 0.722222 0 0.611111 0.722222 0 0.666667 0.722222 0
0.722222 0.722222 0 0.777778 0.722222 0 0.833333 0.722222 0 0.888889 0.722222 0
0.944444 0.722222 0 1 0.722222 0 0 0.777778 0 0.0555556 0.777778 0
0.111111 0.777778 0 0.166667 0.777778 0 0.222222 0.777778 0 0.277778 0.777778 0
0.333333 0.777778 0 0.388889 0.777778 0 0.444444 0.777778 0 0.5 0.777778 0
0.555556 0.777778 0 0.611111 0.777778 0 0.666667 0.777778 0 0.722222 0.777778 0
0.777778 0.777778 0 0.833333 0.777778 0 0.888889 0.777778 0 0.944444 0.777778 0
1 0.777778 0 0 0.833333 0 0.0555556 0.833333 0 0.111111 0.833333 0
0.166667 0.833333 0 0.222222 0.833333 0 0.277778 0.833333 0 0.333333 0.833333 0
0.388889 0.833333 0 0.444444 0.833333 0 0.5 0.833333 0 0.555556 0.833333 0
0.611111 0.833333 0 0.666667 0.833333 0 0.722222 0.833333 0 0.777778 0.833333 0
0.833333 0.833333 0 0.888889 0.833333 0 0.944444 0.833333 0 1 0.833333 0
0 0.888889 0 0.0555556 0.888889 0 0.111111 0.888889 0 0.166667 0.888889 0
0.222222 0.888889 0 0.277778 0.888889 0 0.333333 0.888889 0 0.388889 0.888889 0
0.444444 0.888889 0 0.5 0.888889 0 0.555556 0.888889 0 0.611111 0.888889 0
0.666667 0.888889 0 0.722222 0.888889 0 0.777778 0.888889 0 0.833333 0.888889 0
0.888889 0.888889 0 0.944444 0.888889 0 1 0.888889 0 0 0.944444 0
0.0555556 0.944444 0 0.111111 0.944444 0 0.166667 0.944444 0 0.222222 0.944444 0
0.277778 0.944444 0 0.333333 0.944444 0 0.388889 0.944444 0 0.444444 0.944444 0
0.5 0.944444 0 0.555556 0.944444 0 0.611111 0.944444 0 0.666667 0.944444 0
0.722222 0.944444 0 0.777778 0.944444 0 0.833333 0.944444 0 0.888889 0.944444 0
0.944444 0.944444 0 1 0.944444 0 0 1 0 0.0555556 1 0
0.111111 1 0 0.166667 1 0 0.222222 1 0 0.277778 1 0
0.333333 1 0 0.388889 1 0 0.444444 1 0 0.5 1 0
0.555556 1 0 0.611111 1 0 0.666667 1 0 0.722222 1 0
0.777778 1 0 0.833333 1 0 0.888889 1 0 0.944444 1 0
1 1 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
2 3 39 38 3 5 40 39 5 7 41 40
7 9 42 41 9 11 43 42 11 13 44 43
13 15 45 44 15 17 46 45 17 19 47 46
19 21 48 47 21 23 49 48 23 25 50 49
25 27 51 50 27 29 52 51 29 31 53 52
31 33 54 53 33 35 55 54 35 37 56 55
38 39 58 57 39 40 59 58 40 41 60 59
41 42 61 60 42 43 62 61 43 44 63 62
44 45 64 63 45 46 65 64 46 47 66 65
47 48 67 66 48 49 68 67 49 50 69 68
50 51 70 69 51 52 71 70 52 53 72 71
53 54 73 72 54 55 74 73 55 56 75 74
57 58 77 76 58 59 78 77 59 60 79 78
60 61 80 79 61 62 81 80 62 63 82 81
63 64 83 82 64 65 84 83 65 66 85 84
66 67 86 85 67 68 87 86 68 69 88 87
69 70 89 88 70 71 90 89 71 72 91 90
72 73 92 91 73 74 93 92 74 75 94 93
76 77 96 95 77 78 97 96 78 79 98 97
79 80 99 98 80 81 100 99 81 82 101 100
82 83 102 101 83 84 103 102 84 85 104 103
85 86 105 104 86 87 106 105 87 88 107 106
88 89 108 107 89 90 109 108 90 91 110 109
91 92 111 110 92 93 112 111 93 94 113 112
95 96 115 114 96 97 116 115 97 98 117 116
98 99 118 117 99 100 119 118 100 101 120 119
101 102 121 120 102 103 122 121 103 104 123 122
104 105 124 123 105 106 125 124 106 107 126 125
107 108 127 126 108 109 128 127 109 110 129 128
110 111 130 129 111 112 131 130 112 113 132 131
114 115 134 133 115 116 135 134 116 117 136 135
117 118 137 136 118 119 138 137 119 120 139 138
120 121 140 139 121 122 141 140 122 123 142 141
123 124 143 142 124 125 144 143 125 126 145 144
126 127 146 145 127 128 147 146 128 129 148 147
129 130 149 148 130 131 150 149 131 132 151 150
133 134 153 152 134 135 154 153 135 136 155 154
136 137 156 155 137 138 157 156 138 139 158 157
139 140 159 158 140 141 160 159 141 142 161 160
142 143 162 161 143 144 163 162 144 145 164 163
145 146 165 164 146 147 166 165 147 148 167 166
148 149 168 167 149 150 169 168 150 151 170 169
152 153 172 171 153 154 173 172 154 155 174 173
155 156 175 174 156 157 176 175 157 158 177 176
158 159 178 177 159 160 179 178 160 161 180 179
161 162 181 180 162 163 182 181 163 164 183 182
164 165 184 183 165 166 185 184 166 167 186 185
167 168 187 186 168 169 188 187 169 170 189 188
171 172 191 190 172 173 192 191 173 174 193 192
174 175 194 193 175 176 195 194 176 177 196 195
177 178 197 196 178 179 198 197 179 180 199 198
180 181 200 199 181 182 201 200 182 183 202 201
183 184 203 202 184 185 204 203 185 186 205 204
186 187 206 205 187 188 207 206 188 189 208 207
190 191 210 209 191 192 211 210 192 193 212 211
193 194 213 212 194 195 214 213 195 196 215 214
196 197 216 215 197 198 217 216 198 199 218 217
199 200 219 218 200 201 220 219 201 202 221 220
202 203 222 221 203 204 223 222 204 205 224 223
205 206 225 224 206 207 226 225 207 208 227 226
209 210 229 228 210 211 230 229 211 212 231 230
212 213 232 231 213 214 233 232 214 215 234 233
215 216 235 234 216 217 236 235 217 218 237 236
218 219 238 237 219 220 239 238 220 221 240 239
221 222 241 240 222 223 242 241 223 224 243 242
224 225 244 243 225 226 245 244 226 227 246 245
228 229 248 247 229 230 249 248 230 231 250 249
231 232 251 250 232 233 252 251 233 234 253 252
234 235 254 253 235 236 255 254 236 237 256 255
237 238 257 256 238 239 258 257 239 240 259 258
240 241 260 259 241 242 261 260 242 243 262 261
243 244 263 262 244 245 264 263 245 246 265 264
247 248 267 266 248 249 268 267 249 250 269 268
250 251 270 269 251 252 271 270 252 253 272 271
253 254 273 272 254 255 274 273 255 256 275 274
256 257 276 275 257 258 277 276 258 259 278 277
259 260 279 278 260 261 280 279 261 262 281 280
262 263 282 281 263 264 283 282 264 265 284 283
266 267 286 285 267 268 287 286 268 269 288 287
269 270 289 288 270 271 290 289 271 272 291 290
272 273 292 291 273 274 293 292 274 275 294 293
275 276 295 294 276 277 296 295 277 278 297 296
278 279 298 297 279 280 299 298 280 281 300 299
281 282 301 300 282 283 302 301 283 284 303 302
285 286 305 304 286 287 306 305 287 288 307 306
288 289 308 307 289 290 309 308 290 291 310 309
291 292 311 310 292 293 312 311 293 294 313 312
294 295 314 313 295 296 315 314 296 297 316 315
297 298 317 316 298 299 318 317 299 300 319 318
300 301 320 319 301 302 321 320 302 303 322 321
304 305 324 323 305 306 325 324 306 307 326 325
307 308 327 326 308 309 328 327 309 310 329 328
310 311 330 329 311 312 331 330 312 313 332 331
313 314 333 332 314 315 334 333 315 316 335 334
316 317 336 335 317 318 337 336 318 319 338 337
319 320 339 338 320 321 340 339 321 322 341 340
323 324 343 342 324 325 344 343 325 326 345 344
326 327 346 345 327 328 347 346 328 329 348 347
329 330 349 348 330 331 350 349 331 332 351 350
332 333 352 351 333 334 353 352 334 335 354 353
335 336 355 354 336 337 356 355 337 338 357 356
338 339 358 357 339 340 359 358 340 341 360 359
</DataArray>
<DataArray type="Int32" Name="offsets" NumberOfComponents="1" format="ascii">
4 8 12 16 20 24 28 32 36 40 44 48
52 56 60 64 68 72 76 80 84 88 92 96
100 104 108 112 116 120 124 128 132 136 140 144
148 152 156 160 164 168 172 176 180 184 188 192
196 200 204 208 212 216 220 224 228 232 236 240
244 248 252 256 260 264 268 272 276 280 284 288
292 296 300 304 308 312 316 320 324 328 332 336
340 344 348 352 356 360 364 368 372 376 380 384
388 392 396 400 404 408 412 416 420 424 428 432
436 440 444 448 452 456 460 464 468 472 476 480
484 488 492 496 500 504 508 512 516 520 524 528
532 536 540 544 548 552 556 560 564 568 572 576
580 584 588 592 596 600 604 608 612 616 620 624
628 632 636 640 644 648 652 656 660 664 668 672
676 680 684 688 692 696 700 704 708 712 716 720
724 728 732 736 740 744 748 752 756 760 764 768
772 776 780 784 788 792 796 800 804 808 812 816
820 824 828 832 836 840 844 848 852 856 860 864
868 872 876 880 884 888 892 896 900 904 908 912
916 920 924 928 932 936 940 944 948 952 956 960
964 968 972 976 980 984 988 992 996 1000 1004 1008
1012 1016 1020 1024 1028 1032 1036 1040 1044 1048 1052 1056
1060 1064 1068 1072 1076 1080 1084 1088 1092 1096 1100 1104
1108 1112 1116 1120 1124 1128 1132 1136 1140 1144 1148 1152
1156 1160 1164 1168 1172 1176 1180 1184 1188 1192 1196 1200
1204 1208 1212 1216 1220 1224 1228 1232 1236 1240 1244 1248
1252 1256 1260 1264 1268 1272 1276 1280 1284 1288 1292 1296
</DataArray>
<DataArray type="UInt8" Name="types" NumberOfComponents="1" format="ascii">
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
</DataArray>
</Cells>
</Piece>
</UnstructuredGrid>
</VTKFile>

View File

@ -1,36 +0,0 @@
// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
// vi: set et ts=4 sw=4 sts=4:
/*
This file is part of the Open Porous Media project (OPM).
OPM 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.
OPM 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 OPM. If not, see <http://www.gnu.org/licenses/>.
Consult the COPYING file in the top-level source directory of this
module for the precise wording of the license and the list of
copyright holders.
*/
/*!
* \file
*
* \brief Test for the isothermal Stokes VCVF discretization.
*/
#include "config.h"
#include <ewoms/common/start.hh>
#include "problems/stokestestproblem.hh"
int main(int argc, char **argv)
{
typedef TTAG(StokesTestProblem) ProblemTypeTag;
return Ewoms::start<ProblemTypeTag>(argc, argv);
}

View File

@ -1,36 +0,0 @@
// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
// vi: set et ts=4 sw=4 sts=4:
/*
This file is part of the Open Porous Media project (OPM).
OPM 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.
OPM 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 OPM. If not, see <http://www.gnu.org/licenses/>.
Consult the COPYING file in the top-level source directory of this
module for the precise wording of the license and the list of
copyright holders.
*/
/*!
* \file
*
* \brief Test for the non-isothermal two-component Stokes VCVF discretization.
*/
#include "config.h"
#include <ewoms/common/start.hh>
#include "problems/stokesnitestproblem.hh"
int main(int argc, char **argv)
{
typedef TTAG(StokesNiTestProblem) ProblemTypeTag;
return Ewoms::start<ProblemTypeTag>(argc, argv);
}