Merge pull request #26 from dr-robertk/PR/ewoms-can-use-dune-fem

Ewoms can use dune fem.
This commit is contained in:
Andreas Lauser 2016-01-09 12:26:26 +01:00
commit 0980cc5ef7
8 changed files with 742 additions and 518 deletions

View File

@ -27,15 +27,17 @@
#include <ewoms/common/start.hh>
#include <ewoms/models/immiscible/immisciblemodel.hh>
#include <ewoms/disc/ecfv/ecfvdiscretization.hh>
#include "problems/fingerproblem.hh"
namespace Ewoms {
namespace Properties {
NEW_TYPE_TAG(FingerProblem, INHERITS_FROM(ImmiscibleTwoPhaseModel, FingerBaseProblem));
NEW_TYPE_TAG(FingerProblemEcfv, INHERITS_FROM(ImmiscibleTwoPhaseModel, FingerBaseProblem));
SET_TAG_PROP(FingerProblemEcfv, SpatialDiscretizationSplice, EcfvDiscretization);
}}
int main(int argc, char **argv)
{
typedef TTAG(FingerProblem) ProblemTypeTag;
typedef TTAG(FingerProblemEcfv) ProblemTypeTag;
return Ewoms::start<ProblemTypeTag>(argc, argv);
}

View File

@ -0,0 +1,43 @@
// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
// vi: set et ts=4 sw=4 sts=4:
/*
Copyright (C) 2012-2013 by Andreas Lauser
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/>.
*/
/*!
* \file
*
* \brief Problem featuring a saturation overshoot.
*/
#include "config.h"
#include <ewoms/common/start.hh>
#include <ewoms/models/immiscible/immisciblemodel.hh>
#include <ewoms/disc/vcfv/vcfvdiscretization.hh>
#include "problems/fingerproblem.hh"
namespace Ewoms {
namespace Properties {
NEW_TYPE_TAG(FingerProblemVcfv, INHERITS_FROM(ImmiscibleTwoPhaseModel, FingerBaseProblem));
SET_TAG_PROP(FingerProblemVcfv, SpatialDiscretizationSplice, VcfvDiscretization);
}}
int main(int argc, char **argv)
{
typedef TTAG(FingerProblemVcfv) ProblemTypeTag;
return Ewoms::start<ProblemTypeTag>(argc, argv);
}

View File

@ -1,297 +0,0 @@
// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
// vi: set et ts=4 sw=4 sts=4:
/*
Copyright (C) 2012-2013 by Andreas Lauser
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/>.
*/
/*!
* \file
* \copydoc Ewoms::FingerGridManager
*/
#ifndef EWOMS_FINGER_GRID_MANAGER_HH
#define EWOMS_FINGER_GRID_MANAGER_HH
#include <ewoms/io/basegridmanager.hh>
#include <ewoms/common/propertysystem.hh>
#include <ewoms/common/parametersystem.hh>
#if HAVE_DUNE_ALUGRID
#include <dune/alugrid/grid.hh>
#else
#include <dune/grid/alugrid.hh>
#endif
#include <dune/common/fvector.hh>
#include <dune/common/version.hh>
#include <vector>
#include <memory>
// some hacky defines for the grid manager
#define FINGER_DIM 2
#define FINGER_CUBES 1
namespace Ewoms {
template <class TypeTag>
class FingerGridManager;
template <class TypeTag>
class FingerProblem;
namespace Properties {
// declare the properties required by the for the finger grid manager
NEW_TYPE_TAG(FingerGridManager);
NEW_PROP_TAG(Grid);
NEW_PROP_TAG(Scalar);
NEW_PROP_TAG(DomainSizeX);
NEW_PROP_TAG(DomainSizeY);
NEW_PROP_TAG(DomainSizeZ);
NEW_PROP_TAG(CellsX);
NEW_PROP_TAG(CellsY);
NEW_PROP_TAG(CellsZ);
NEW_PROP_TAG(GridGlobalRefinements);
SET_TYPE_PROP(FingerGridManager, Grid, Dune::ALUGrid<FINGER_DIM, FINGER_DIM, Dune::cube, Dune::nonconforming>);
SET_TYPE_PROP(FingerGridManager, GridManager, Ewoms::FingerGridManager<TypeTag>);
} // namespace Properties
/*!
* \brief Helper class for grid instantiation of the finger problem.
*/
template <class TypeTag>
class FingerGridManager : public BaseGridManager<TypeTag>
{
typedef BaseGridManager<TypeTag> ParentType;
typedef typename GET_PROP_TYPE(TypeTag, Scalar) Scalar;
typedef typename GET_PROP_TYPE(TypeTag, Simulator) Simulator;
typedef typename GET_PROP_TYPE(TypeTag, Grid) Grid;
typedef std::unique_ptr<Grid> GridPointer;
enum { dim = FINGER_DIM };
public:
/*!
* \brief Register all run-time parameters for the grid manager.
*/
static void registerParameters()
{
EWOMS_REGISTER_PARAM(TypeTag, unsigned, GridGlobalRefinements,
"The number of global refinements of the grid "
"executed after it was loaded");
EWOMS_REGISTER_PARAM(TypeTag, Scalar, DomainSizeX,
"The size of the domain in x direction");
EWOMS_REGISTER_PARAM(TypeTag, int, CellsX,
"The number of intervalls in x direction");
if (dim > 1) {
EWOMS_REGISTER_PARAM(TypeTag, Scalar, DomainSizeY,
"The size of the domain in y direction");
EWOMS_REGISTER_PARAM(TypeTag, int, CellsY,
"The number of intervalls in y direction");
}
if (dim > 2) {
EWOMS_REGISTER_PARAM(TypeTag, Scalar, DomainSizeZ,
"The size of the domain in z direction");
EWOMS_REGISTER_PARAM(TypeTag, int, CellsZ,
"The number of intervalls in z direction");
}
}
/*!
* \brief Create the grid for the finger problem
*/
FingerGridManager(Simulator &simulator)
: ParentType(simulator)
{
gridPtr_.reset(new Grid);
Dune::FieldVector<int, dim> cellRes;
Dune::FieldVector<Scalar, dim> upperRight;
Dune::FieldVector<Scalar, dim> lowerLeft;
lowerLeft = 0.0;
upperRight[0] = EWOMS_GET_PARAM(TypeTag, Scalar, DomainSizeX);
upperRight[1] = EWOMS_GET_PARAM(TypeTag, Scalar, DomainSizeY);
cellRes[0] = EWOMS_GET_PARAM(TypeTag, int, CellsX);
cellRes[1] = EWOMS_GET_PARAM(TypeTag, int, CellsY);
if (dim == 3) {
upperRight[2] = EWOMS_GET_PARAM(TypeTag, Scalar, DomainSizeZ);
cellRes[2] = EWOMS_GET_PARAM(TypeTag, int, CellsZ);
}
Dune::GridFactory<Grid> factory;
if (dim == 3) {
Dune::FieldVector<double, dim> pos;
for (int k = 0; k <= cellRes[0]; k++) {
pos[2] = upperRight[2] * double(k) / cellRes[2];
for (int j = 0; j <= cellRes[1]; j++) {
pos[1] = upperRight[1] * double(j) / cellRes[1];
for (int i = 0; i <= cellRes[0]; i++) {
pos[0] = upperRight[0] * double(i) / cellRes[0];
factory.insertVertex(pos);
}
}
}
}
else {
assert(dim == 2);
Dune::FieldVector<double, dim> pos;
for (int j = 0; j <= cellRes[1]; j++) {
pos[1] = upperRight[1] * double(j) / cellRes[1];
for (int i = 0; i <= cellRes[0]; i++) {
pos[0] = upperRight[0] * double(i) / cellRes[0];
factory.insertVertex(pos);
}
}
}
for (int i = 0; i < cellRes[0]; ++i) {
for (int j = 0; j < cellRes[1]; ++j) {
#if FINGER_CUBES
std::vector<unsigned int> v(1 << dim);
#else
std::vector<unsigned int> v(dim + 1);
#endif
if (dim == 3) {
int m = cellRes[0] + 1;
int n = cellRes[1] + 1;
for (int k = 0; k < cellRes[2]; ++k) {
int i0 = k * m * n + j * m + i;
int i1 = k * m * n + j * m + (i + 1);
int i2 = k * m * n + (j + 1) * m + i;
int i3 = k * m * n + (j + 1) * m + (i + 1);
int i4 = (k + 1) * m * n + j * m + i;
int i5 = (k + 1) * m * n + j * m + (i + 1);
int i6 = (k + 1) * m * n + (j + 1) * m + i;
int i7 = (k + 1) * m * n + (j + 1) * m + (i + 1);
#if FINGER_CUBES
v[0] = i0;
v[1] = i1;
v[2] = i2;
v[3] = i3;
v[4] = i4;
v[5] = i5;
v[6] = i6;
v[7] = i7;
factory.insertElement(Dune::GeometryType(Dune::GeometryType::cube, 3), v);
#else
v[0] = i0;
v[1] = i1;
v[2] = i2;
v[3] = i4;
factory.insertElement(Dune::GeometryType(Dune::GeometryType::simplex, 3), v);
v[0] = i4;
v[1] = i5;
v[2] = i6;
v[3] = i2;
factory.insertElement(Dune::GeometryType(Dune::GeometryType::simplex, 3), v);
v[0] = i2;
v[1] = i5;
v[2] = i4;
v[3] = i1;
factory.insertElement(Dune::GeometryType(Dune::GeometryType::simplex, 3), v);
v[0] = i2;
v[1] = i3;
v[2] = i7;
v[3] = i5;
factory.insertElement(Dune::GeometryType(Dune::GeometryType::simplex, 3), v);
v[0] = i5;
v[1] = i7;
v[2] = i6;
v[3] = i2;
factory.insertElement(Dune::GeometryType(Dune::GeometryType::simplex, 3), v);
v[0] = i1;
v[1] = i3;
v[2] = i5;
v[3] = i2;
factory.insertElement(Dune::GeometryType(Dune::GeometryType::simplex, 3), v);
#endif
}
}
else {
assert(dim == 2);
int m = cellRes[0] + 1;
int i0 = j * m + i;
int i1 = j * m + (i + 1);
int i2 = (j + 1) * m + i;
int i3 = (j + 1) * m + (i + 1);
#if FINGER_CUBES
v[0] = i0;
v[1] = i1;
v[2] = i2;
v[3] = i3;
factory.insertElement(Dune::GeometryType(Dune::GeometryType::cube, 2), v);
#else
v[0] = i0;
v[1] = i1;
v[2] = i2;
factory.insertElement(Dune::GeometryType(Dune::GeometryType::simplex, 2), v);
v[0] = i1;
v[1] = i3;
v[2] = i2;
factory.insertElement(Dune::GeometryType(Dune::GeometryType::simplex, 2), v);
#endif
}
}
}
gridPtr_.reset(factory.createGrid());
unsigned numRefinments = EWOMS_GET_PARAM(TypeTag, unsigned, GridGlobalRefinements);
gridPtr_->globalRefine(numRefinments);
this->finalizeInit_();
}
/*!
* \brief Return a reference to the grid.
*/
Grid& grid()
{ return *gridPtr_; }
/*!
* \brief Return a reference to the grid.
*/
const Grid& grid() const
{ return *gridPtr_; }
private:
GridPointer gridPtr_;
};
} // namespace Ewoms
#endif

View File

@ -26,7 +26,10 @@
#ifndef EWOMS_FINGER_PROBLEM_HH
#define EWOMS_FINGER_PROBLEM_HH
#include "fingergridmanager.hh"
// uncomment to run problem in 3d
// #define GRIDDIM 3
#include <ewoms/io/structuredgridmanager.hh>
#include <opm/material/fluidmatrixinteractions/RegularizedVanGenuchten.hpp>
#include <opm/material/fluidmatrixinteractions/LinearMaterial.hpp>
@ -40,10 +43,12 @@
#include <opm/material/components/Air.hpp>
#include <ewoms/models/immiscible/immiscibleproperties.hh>
#include <ewoms/disc/common/restrictprolong.hh>
#include <dune/common/version.hh>
#include <dune/common/fvector.hh>
#include <dune/common/fmatrix.hh>
#include <dune/grid/utility/persistentcontainer.hh>
#include <vector>
#include <string>
@ -53,7 +58,7 @@ template <class TypeTag>
class FingerProblem;
namespace Properties {
NEW_TYPE_TAG(FingerBaseProblem, INHERITS_FROM(FingerGridManager));
NEW_TYPE_TAG(FingerBaseProblem, INHERITS_FROM(StructuredGridManager));
// declare the properties used by the finger problem
NEW_PROP_TAG(InitialWaterSaturation);
@ -173,6 +178,8 @@ class FingerProblem : public GET_PROP_TYPE(TypeTag, BaseProblem)
};
typedef typename GET_PROP_TYPE(TypeTag, ElementContext) ElementContext;
typedef typename GET_PROP_TYPE(TypeTag, Stencil) Stencil;
enum { codim = Stencil::Entity::codimension };
typedef typename GET_PROP_TYPE(TypeTag, EqVector) EqVector;
typedef typename GET_PROP_TYPE(TypeTag, RateVector) RateVector;
typedef typename GET_PROP_TYPE(TypeTag, BoundaryRateVector) BoundaryRateVector;
@ -184,26 +191,47 @@ class FingerProblem : public GET_PROP_TYPE(TypeTag, BaseProblem)
typedef typename GridView::ctype CoordScalar;
typedef Dune::FieldVector<CoordScalar, dimWorld> GlobalPosition;
typedef Dune::FieldMatrix<Scalar, dimWorld, dimWorld> DimMatrix;
typedef typename GridView :: Grid Grid;
typedef Dune::PersistentContainer< Grid, std::shared_ptr< MaterialLawParams > > MaterialLawParamsContainer;
//!\endcond
public:
typedef CopyRestrictProlong< Grid, MaterialLawParamsContainer > RestrictProlongOperator;
/*!
* \copydoc Doxygen::defaultProblemConstructor
*/
FingerProblem(Simulator &simulator)
: ParentType(simulator)
{ }
: ParentType(simulator),
materialParams_( simulator.gridManager().grid(), codim )
{
}
/*!
* \name Auxiliary methods
*/
//! \{
/*!
* \brief \copydoc FvBaseProblem::restrictProlongOperator
*/
RestrictProlongOperator restrictProlongOperator()
{
return RestrictProlongOperator( materialParams_ );
}
/*!
* \copydoc FvBaseProblem::name
*/
std::string name() const
{ return std::string("finger_") + Model::name(); }
{ return
std::string("finger") +
"_" + Model::name() +
"_" + Model::discretizationName() +
(this->model().enableGridAdaptation()?"_adaptive":"");
}
/*!
* \copydoc FvBaseMultiPhaseProblem::registerParameters
@ -241,16 +269,22 @@ public:
mdcParams_.finalize();
// initialize the material parameter objects of the individual
// finite volumes
unsigned n = this->model().numGridDof();
materialParams_.resize(n);
for (unsigned i = 0; i < n; ++i) {
materialParams_[i].setMicParams(&micParams_);
materialParams_[i].setMdcParams(&mdcParams_);
materialParams_[i].setSwr(0.0);
materialParams_[i].setSnr(0.1);
materialParams_[i].finalize();
ParkerLenhard::reset(materialParams_[i]);
// finite volumes, resize will resize the container to the number of elements
materialParams_.resize();
for (auto it = materialParams_.begin(),
end = materialParams_.end(); it != end; ++it ) {
std::shared_ptr< MaterialLawParams >& materialParams = *it ;
if( ! materialParams )
{
materialParams.reset( new MaterialLawParams() );
materialParams->setMicParams(&micParams_);
materialParams->setMdcParams(&mdcParams_);
materialParams->setSwr(0.0);
materialParams->setSnr(0.1);
materialParams->finalize();
ParkerLenhard::reset(*materialParams);
}
}
K_ = this->toDimMatrix_(4.6e-10);
@ -284,11 +318,14 @@ public:
auto elemIt = this->gridView().template begin<0>();
const auto &elemEndIt = this->gridView().template end<0>();
for (; elemIt != elemEndIt; ++elemIt) {
elemCtx.updateAll(*elemIt);
for (unsigned scvIdx = 0; scvIdx < elemCtx.numDof(/*timeIdx=*/0); ++scvIdx) {
unsigned globalIdx = elemCtx.globalSpaceIndex(scvIdx, /*timeIdx=*/0);
const auto& elem = *elemIt;
elemCtx.updateAll( elem );
const int numDofs = elemCtx.numDof(/*timeIdx=*/0);
for (int scvIdx = 0; scvIdx < numDofs; ++scvIdx)
{
MaterialLawParams& materialParam = materialLawParams( elemCtx, scvIdx, /*timeIdx=*/0 );
const auto &fs = elemCtx.intensiveQuantities(scvIdx, /*timeIdx=*/0).fluidState();
ParkerLenhard::update(materialParams_[globalIdx], fs);
ParkerLenhard::update(materialParam, fs);
}
}
}
@ -326,11 +363,24 @@ public:
* \copydoc FvBaseMultiPhaseProblem::materialLawParams
*/
template <class Context>
const MaterialLawParams &materialLawParams(const Context &context,
unsigned spaceIdx, unsigned timeIdx) const
MaterialLawParams &materialLawParams(const Context &context,
const int spaceIdx, const int timeIdx)
{
unsigned globalSpaceIdx = context.globalSpaceIndex(spaceIdx, timeIdx);
return materialParams_[globalSpaceIdx];
const auto& entity = context.stencil(timeIdx).entity( spaceIdx );
assert( materialParams_[ entity ] );
return *(materialParams_[ entity ] );
}
/*!
* \copydoc FvBaseMultiPhaseProblem::materialLawParams
*/
template <class Context>
const MaterialLawParams &materialLawParams(const Context &context,
const int spaceIdx, const int timeIdx) const
{
const auto& entity = context.stencil(timeIdx).entity( spaceIdx );
assert( materialParams_[ entity ] );
return *(materialParams_[ entity ] );
}
//! \}
@ -347,12 +397,10 @@ public:
void boundary(BoundaryRateVector &values, const Context &context,
unsigned spaceIdx, unsigned timeIdx) const
{
const GlobalPosition &pos = context.cvCenter(spaceIdx, timeIdx);
const GlobalPosition &pos = context.pos(spaceIdx, timeIdx);
if (onLeftBoundary_(pos) || onRightBoundary_(pos)
|| onLowerBoundary_(pos)) {
if (onLeftBoundary_(pos) || onRightBoundary_(pos) || onLowerBoundary_(pos))
values.setNoFlow();
}
else {
assert(onUpperBoundary_(pos));
@ -468,7 +516,7 @@ private:
typename MaterialLawParams::VanGenuchtenParams micParams_;
typename MaterialLawParams::VanGenuchtenParams mdcParams_;
std::vector<MaterialLawParams> materialParams_;
MaterialLawParamsContainer materialParams_;
Opm::ImmiscibleFluidState<Scalar, FluidSystem> initialFluidState_;

View File

@ -1,175 +0,0 @@
// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
// vi: set et ts=4 sw=4 sts=4:
/*
Copyright (C) 2012-2013 by Andreas Lauser
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/>.
*/
/*!
* \file
* \copydoc Ewoms::LensGridManager
*/
#ifndef EWOMS_LENS_GRID_MANAGER_HH
#define EWOMS_LENS_GRID_MANAGER_HH
#include <ewoms/io/basegridmanager.hh>
#include <ewoms/common/propertysystem.hh>
#include <ewoms/common/parametersystem.hh>
#include <dune/grid/yaspgrid.hh>
#include <dune/grid/io/file/dgfparser/dgfyasp.hh>
#include <dune/common/fvector.hh>
#include <dune/common/version.hh>
#include <vector>
#include <memory>
namespace Ewoms {
template <class TypeTag>
class LensProblem;
template <class TypeTag>
class LensGridManager;
namespace Properties {
NEW_TYPE_TAG(LensGridManager);
// declare the properties required by the for the lens grid manager
NEW_PROP_TAG(Grid);
NEW_PROP_TAG(Scalar);
NEW_PROP_TAG(DomainSizeX);
NEW_PROP_TAG(DomainSizeY);
NEW_PROP_TAG(DomainSizeZ);
NEW_PROP_TAG(CellsX);
NEW_PROP_TAG(CellsY);
NEW_PROP_TAG(CellsZ);
NEW_PROP_TAG(GridGlobalRefinements);
// set the Grid and GridManager properties
SET_TYPE_PROP(LensGridManager, Grid, Dune::YaspGrid<2>);
SET_TYPE_PROP(LensGridManager, GridManager, Ewoms::LensGridManager<TypeTag>);
} // namespace Properties
/*!
* \ingroup TestProblems
*
* \brief Helper class for grid instantiation of the lens problem.
*/
template <class TypeTag>
class LensGridManager : public BaseGridManager<TypeTag>
{
typedef BaseGridManager<TypeTag> ParentType;
typedef typename GET_PROP_TYPE(TypeTag, Scalar) Scalar;
typedef typename GET_PROP_TYPE(TypeTag, Simulator) Simulator;
typedef typename GET_PROP_TYPE(TypeTag, Grid) Grid;
typedef std::unique_ptr<Grid> GridPointer;
static const int dim = Grid::dimension;
public:
/*!
* \brief Register all run-time parameters for the grid manager.
*/
static void registerParameters()
{
EWOMS_REGISTER_PARAM(TypeTag, unsigned, GridGlobalRefinements,
"The number of global refinements of the grid "
"executed after it was loaded");
EWOMS_REGISTER_PARAM(TypeTag, Scalar, DomainSizeX,
"The size of the domain in x direction");
EWOMS_REGISTER_PARAM(TypeTag, int, CellsX,
"The number of intervalls in x direction");
if (dim > 1) {
EWOMS_REGISTER_PARAM(TypeTag, Scalar, DomainSizeY,
"The size of the domain in y direction");
EWOMS_REGISTER_PARAM(TypeTag, int, CellsY,
"The number of intervalls in y direction");
}
if (dim > 2) {
EWOMS_REGISTER_PARAM(TypeTag, Scalar, DomainSizeZ,
"The size of the domain in z direction");
EWOMS_REGISTER_PARAM(TypeTag, int, CellsZ,
"The number of intervalls in z direction");
}
}
/*!
* \brief Create the grid for the lens problem
*/
LensGridManager(Simulator &simulator)
: ParentType(simulator)
{
Dune::FieldVector<int, dim> cellRes;
typedef double GridScalar;
Dune::FieldVector<GridScalar, dim> upperRight;
Dune::FieldVector<GridScalar, dim> lowerLeft( 0 );
upperRight[0] = EWOMS_GET_PARAM(TypeTag, Scalar, DomainSizeX);
upperRight[1] = EWOMS_GET_PARAM(TypeTag, Scalar, DomainSizeY);
cellRes[0] = EWOMS_GET_PARAM(TypeTag, int, CellsX);
cellRes[1] = EWOMS_GET_PARAM(TypeTag, int, CellsY);
if (dim == 3) {
upperRight[2] = EWOMS_GET_PARAM(TypeTag, Scalar, DomainSizeZ);
cellRes[2] = EWOMS_GET_PARAM(TypeTag, int, CellsZ);
}
std::stringstream dgffile;
dgffile << "DGF" << std::endl;
dgffile << "INTERVAL" << std::endl;
dgffile << lowerLeft << std::endl;
dgffile << upperRight << std::endl;
dgffile << cellRes << std::endl;
dgffile << "#" << std::endl;
dgffile << "GridParameter" << std::endl;
dgffile << "overlap 1" << std::endl;
dgffile << "#" << std::endl;
// use DGF parser to create a grid from interval block
gridPtr_.reset( Dune::GridPtr< Grid >( dgffile ).release() );
unsigned numRefinements = EWOMS_GET_PARAM(TypeTag, unsigned, GridGlobalRefinements);
gridPtr_->globalRefine(numRefinements);
this->finalizeInit_();
}
/*!
* \brief Return a reference to the grid object.
*/
Grid& grid()
{ return *gridPtr_; }
/*!
* \brief Return a constant reference to the grid object.
*/
const Grid& grid() const
{ return *gridPtr_; }
private:
GridPointer gridPtr_;
};
} // namespace Ewoms
#endif

View File

@ -26,7 +26,7 @@
#ifndef EWOMS_LENS_PROBLEM_HH
#define EWOMS_LENS_PROBLEM_HH
#include "lensgridmanager.hh"
#include <ewoms/io/structuredgridmanager.hh>
#include <ewoms/models/immiscible/immiscibleproperties.hh>
@ -39,12 +39,6 @@
#include <opm/material/components/SimpleH2O.hpp>
#include <opm/material/components/Dnapl.hpp>
//#define LENS_USE_ALUGRID 1
#if LENS_USE_ALUGRID
#include <dune/alugrid/grid.hh>
#include <dune/alugrid/dgf.hh>
#endif
#include <dune/common/version.hh>
#include <dune/common/fvector.hh>
#include <dune/common/fmatrix.hh>
@ -58,11 +52,7 @@ template <class TypeTag>
class LensProblem;
namespace Properties {
#if LENS_USE_ALUGRID
NEW_TYPE_TAG(LensBaseProblem);
#else
NEW_TYPE_TAG(LensBaseProblem, INHERITS_FROM(LensGridManager));
#endif
NEW_TYPE_TAG(LensBaseProblem, INHERITS_FROM(StructuredGridManager));
// declare the properties specific for the lens problem
NEW_PROP_TAG(LensLowerLeftX);
@ -95,10 +85,6 @@ public:
typedef Opm::LiquidPhase<Scalar, Opm::DNAPL<Scalar> > type;
};
#if LENS_USE_ALUGRID
SET_TYPE_PROP(LensBaseProblem, Grid, Dune::ALUGrid< 2, 2, Dune::cube, Dune::nonconforming > );
#endif
// Set the material Law
SET_PROP(LensBaseProblem, MaterialLaw)
{

View File

@ -0,0 +1,617 @@
<?xml version="1.0"?>
<VTKFile type="UnstructuredGrid" version="0.1" byte_order="LittleEndian">
<UnstructuredGrid>
<Piece NumberOfCells="350" NumberOfPoints="396">
<CellData Scalars="pressure_wetting">
<DataArray type="Float32" Name="pressure_wetting" NumberOfComponents="1" format="ascii">
99137.1 99080.8 99054.3 99045.2 99043.8 99046.8 99055.6 99073.7 99102.6 99139.4 99178.2 99214.5
99245.8 99271.6 99292.3 99308.7 99321.5 99331.5 99339.1 99345 99349.4 99352.7 99355.1 99356.8
99357.9 99358.6 99358.9 99358.8 99358.3 99357.3 99355.4 99352.4 99347.2 99338.3 99321.5 99137.1
99080.8 99054.3 99045.2 99043.8 99046.8 99055.6 99073.7 99102.6 99139.4 99178.3 99214.5 99245.8
99271.6 99292.4 99308.8 99321.6 99331.5 99339.2 99345.1 99349.5 99352.8 99355.3 99357.1 99358.4
99359.4 99360.1 99360.6 99361.1 99361.5 99361.9 99362.3 99362.3 99360.8 99353.8 99137.1 99080.8
99054.3 99045.2 99043.8 99046.8 99055.6 99073.7 99102.6 99139.4 99178.3 99214.5 99245.8 99271.6
99292.4 99308.8 99321.6 99331.6 99339.2 99345.1 99349.6 99352.9 99355.4 99357.3 99358.7 99359.9
99360.9 99361.9 99363 99364.7 99367.2 99371.1 99377.3 99387.2 99402.8 99137.1 99080.8 99054.3
99045.2 99043.8 99046.8 99055.6 99073.7 99102.6 99139.4 99178.3 99214.5 99245.8 99271.6 99292.4
99308.8 99321.6 99331.5 99339.2 99345.1 99349.5 99352.8 99355.3 99357.1 99358.4 99359.4 99360.1
99360.6 99361.1 99361.5 99361.9 99362.3 99362.3 99360.8 99353.8 99137.1 99080.8 99054.3 99045.2
99043.8 99046.8 99055.6 99073.7 99102.6 99139.4 99178.2 99214.5 99245.8 99271.6 99292.3 99308.7
99321.5 99331.5 99339.1 99345 99349.4 99352.7 99355.1 99356.8 99357.9 99358.6 99358.9 99358.8
99358.3 99357.3 99355.4 99352.4 99347.2 99338.3 99321.5 99137.1 99080.8 99054.3 99045.2 99043.8
99046.8 99055.6 99073.7 99102.6 99139.4 99178.2 99214.5 99245.8 99271.6 99292.3 99308.7 99321.5
99331.5 99339.1 99345 99349.4 99352.7 99355.1 99356.8 99357.9 99358.6 99358.9 99358.8 99358.3
99357.3 99355.4 99352.4 99347.2 99338.3 99321.5 99137.1 99080.8 99054.3 99045.2 99043.8 99046.8
99055.6 99073.7 99102.6 99139.4 99178.3 99214.5 99245.8 99271.6 99292.4 99308.8 99321.6 99331.5
99339.2 99345.1 99349.5 99352.8 99355.3 99357.1 99358.4 99359.4 99360.1 99360.6 99361.1 99361.5
99361.9 99362.3 99362.3 99360.8 99353.8 99137.1 99080.8 99054.3 99045.2 99043.8 99046.8 99055.6
99073.7 99102.6 99139.4 99178.3 99214.5 99245.8 99271.6 99292.4 99308.8 99321.6 99331.6 99339.2
99345.1 99349.6 99352.9 99355.4 99357.3 99358.7 99359.9 99360.9 99361.9 99363 99364.7 99367.2
99371.1 99377.3 99387.2 99402.8 99137.1 99080.8 99054.3 99045.2 99043.8 99046.8 99055.6 99073.7
99102.6 99139.4 99178.3 99214.5 99245.8 99271.6 99292.4 99308.8 99321.6 99331.5 99339.2 99345.1
99349.5 99352.8 99355.3 99357.1 99358.4 99359.4 99360.1 99360.6 99361.1 99361.5 99361.9 99362.3
99362.3 99360.8 99353.8 99137.1 99080.8 99054.3 99045.2 99043.8 99046.8 99055.6 99073.7 99102.6
99139.4 99178.2 99214.5 99245.8 99271.6 99292.3 99308.7 99321.5 99331.5 99339.1 99345 99349.4
99352.7 99355.1 99356.8 99357.9 99358.6 99358.9 99358.8 99358.3 99357.3 99355.4 99352.4 99347.2
99338.3 99321.5
</DataArray>
<DataArray type="Float32" Name="pressure_nonwetting" NumberOfComponents="1" format="ascii">
100003 100003 100003 100003 100003 100003 100003 100003 100003 100002 100002 100002
100002 100002 100002 100002 100002 100002 100002 100002 100001 100001 100001 100001
100001 100001 100001 100001 100001 100000 100000 100000 100000 100000 100000 100003
100003 100003 100003 100003 100003 100003 100003 100003 100002 100002 100002 100002
100002 100002 100002 100002 100002 100002 100002 100001 100001 100001 100001 100001
100001 100001 100001 100001 100000 100000 100000 100000 100000 100000 100003 100003
100003 100003 100003 100003 100003 100003 100003 100002 100002 100002 100002 100002
100002 100002 100002 100002 100002 100002 100001 100001 100001 100001 100001 100001
100001 100001 100001 100000 100000 100000 100000 100000 100000 100003 100003 100003
100003 100003 100003 100003 100003 100003 100002 100002 100002 100002 100002 100002
100002 100002 100002 100002 100002 100001 100001 100001 100001 100001 100001 100001
100001 100001 100000 100000 100000 100000 100000 100000 100003 100003 100003 100003
100003 100003 100003 100003 100003 100002 100002 100002 100002 100002 100002 100002
100002 100002 100002 100002 100001 100001 100001 100001 100001 100001 100001 100001
100001 100000 100000 100000 100000 100000 100000 100003 100003 100003 100003 100003
100003 100003 100003 100003 100002 100002 100002 100002 100002 100002 100002 100002
100002 100002 100002 100001 100001 100001 100001 100001 100001 100001 100001 100001
100000 100000 100000 100000 100000 100000 100003 100003 100003 100003 100003 100003
100003 100003 100003 100002 100002 100002 100002 100002 100002 100002 100002 100002
100002 100002 100001 100001 100001 100001 100001 100001 100001 100001 100001 100000
100000 100000 100000 100000 100000 100003 100003 100003 100003 100003 100003 100003
100003 100003 100002 100002 100002 100002 100002 100002 100002 100002 100002 100002
100002 100001 100001 100001 100001 100001 100001 100001 100001 100001 100000 100000
100000 100000 100000 100000 100003 100003 100003 100003 100003 100003 100003 100003
100003 100002 100002 100002 100002 100002 100002 100002 100002 100002 100002 100002
100001 100001 100001 100001 100001 100001 100001 100001 100001 100000 100000 100000
100000 100000 100000 100003 100003 100003 100003 100003 100003 100003 100003 100003
100002 100002 100002 100002 100002 100002 100002 100002 100002 100002 100002 100001
100001 100001 100001 100001 100001 100001 100001 100001 100000 100000 100000 100000
100000 100000
</DataArray>
<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
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000
1000 1000
</DataArray>
<DataArray type="Float32" Name="density_nonwetting" NumberOfComponents="1" format="ascii">
1.1882 1.1882 1.1882 1.18819 1.18819 1.18819 1.18819 1.18819 1.18819 1.18819 1.18819 1.18818
1.18818 1.18818 1.18818 1.18818 1.18818 1.18818 1.18818 1.18818 1.18817 1.18817 1.18817 1.18817
1.18817 1.18817 1.18817 1.18817 1.18816 1.18816 1.18816 1.18816 1.18816 1.18816 1.18816 1.1882
1.1882 1.1882 1.18819 1.18819 1.18819 1.18819 1.18819 1.18819 1.18819 1.18819 1.18818 1.18818
1.18818 1.18818 1.18818 1.18818 1.18818 1.18818 1.18818 1.18817 1.18817 1.18817 1.18817 1.18817
1.18817 1.18817 1.18817 1.18816 1.18816 1.18816 1.18816 1.18816 1.18816 1.18816 1.1882 1.1882
1.1882 1.18819 1.18819 1.18819 1.18819 1.18819 1.18819 1.18819 1.18819 1.18818 1.18818 1.18818
1.18818 1.18818 1.18818 1.18818 1.18818 1.18818 1.18817 1.18817 1.18817 1.18817 1.18817 1.18817
1.18817 1.18817 1.18816 1.18816 1.18816 1.18816 1.18816 1.18816 1.18816 1.1882 1.1882 1.1882
1.18819 1.18819 1.18819 1.18819 1.18819 1.18819 1.18819 1.18819 1.18818 1.18818 1.18818 1.18818
1.18818 1.18818 1.18818 1.18818 1.18818 1.18817 1.18817 1.18817 1.18817 1.18817 1.18817 1.18817
1.18817 1.18816 1.18816 1.18816 1.18816 1.18816 1.18816 1.18816 1.1882 1.1882 1.1882 1.18819
1.18819 1.18819 1.18819 1.18819 1.18819 1.18819 1.18819 1.18818 1.18818 1.18818 1.18818 1.18818
1.18818 1.18818 1.18818 1.18818 1.18817 1.18817 1.18817 1.18817 1.18817 1.18817 1.18817 1.18817
1.18816 1.18816 1.18816 1.18816 1.18816 1.18816 1.18816 1.1882 1.1882 1.1882 1.18819 1.18819
1.18819 1.18819 1.18819 1.18819 1.18819 1.18819 1.18818 1.18818 1.18818 1.18818 1.18818 1.18818
1.18818 1.18818 1.18818 1.18817 1.18817 1.18817 1.18817 1.18817 1.18817 1.18817 1.18817 1.18816
1.18816 1.18816 1.18816 1.18816 1.18816 1.18816 1.1882 1.1882 1.1882 1.18819 1.18819 1.18819
1.18819 1.18819 1.18819 1.18819 1.18819 1.18818 1.18818 1.18818 1.18818 1.18818 1.18818 1.18818
1.18818 1.18818 1.18817 1.18817 1.18817 1.18817 1.18817 1.18817 1.18817 1.18817 1.18816 1.18816
1.18816 1.18816 1.18816 1.18816 1.18816 1.1882 1.1882 1.1882 1.18819 1.18819 1.18819 1.18819
1.18819 1.18819 1.18819 1.18819 1.18818 1.18818 1.18818 1.18818 1.18818 1.18818 1.18818 1.18818
1.18818 1.18817 1.18817 1.18817 1.18817 1.18817 1.18817 1.18817 1.18817 1.18816 1.18816 1.18816
1.18816 1.18816 1.18816 1.18816 1.1882 1.1882 1.1882 1.18819 1.18819 1.18819 1.18819 1.18819
1.18819 1.18819 1.18819 1.18818 1.18818 1.18818 1.18818 1.18818 1.18818 1.18818 1.18818 1.18818
1.18817 1.18817 1.18817 1.18817 1.18817 1.18817 1.18817 1.18817 1.18816 1.18816 1.18816 1.18816
1.18816 1.18816 1.18816 1.1882 1.1882 1.1882 1.18819 1.18819 1.18819 1.18819 1.18819 1.18819
1.18819 1.18819 1.18818 1.18818 1.18818 1.18818 1.18818 1.18818 1.18818 1.18818 1.18818 1.18817
1.18817 1.18817 1.18817 1.18817 1.18817 1.18817 1.18817 1.18816 1.18816 1.18816 1.18816 1.18816
1.18816 1.18816
</DataArray>
<DataArray type="Float32" Name="saturation_wetting" NumberOfComponents="1" format="ascii">
0.0143897 0.0116184 0.0105581 0.0102062 0.0101541 0.0102782 0.0106269 0.011348 0.012632 0.0145697 0.0170844 0.0199837
0.0230399 0.0260461 0.028847 0.0313486 0.0335089 0.0353234 0.0368115 0.0380062 0.0389462 0.0396711 0.0402175 0.0406177
0.0408979 0.0410773 0.0411675 0.0411708 0.0410779 0.0408628 0.0404752 0.0398244 0.0387481 0.0369447 0.0338246 0.0143897
0.0116184 0.0105581 0.0102062 0.0101541 0.0102783 0.0106271 0.0113484 0.0126327 0.0145709 0.0170862 0.019986 0.023043
0.0260499 0.0288518 0.0313544 0.0335161 0.0353327 0.0368238 0.038023 0.0389699 0.0397053 0.040268 0.0406934 0.0410125
0.0412522 0.0414356 0.0415826 0.04171 0.0418312 0.0419519 0.0420582 0.0420798 0.0417687 0.040211 0.0143897 0.0116184
0.0105581 0.0102062 0.0101541 0.0102783 0.0106272 0.0113486 0.0126331 0.0145716 0.0170872 0.0199875 0.0230449 0.0260523
0.0288547 0.031358 0.0335206 0.0353385 0.0368315 0.0380335 0.0389847 0.0397267 0.0402998 0.0407415 0.0410863 0.0413668
0.0416156 0.0418685 0.0421701 0.0425828 0.043202 0.0441838 0.0457938 0.0485032 0.0534573 0.0143897 0.0116184 0.0105581
0.0102062 0.0101541 0.0102783 0.0106271 0.0113484 0.0126327 0.0145709 0.0170862 0.019986 0.023043 0.0260499 0.0288518
0.0313544 0.0335161 0.0353327 0.0368238 0.038023 0.0389699 0.0397053 0.040268 0.0406934 0.0410125 0.0412522 0.0414356
0.0415826 0.04171 0.0418312 0.0419519 0.0420582 0.0420798 0.0417687 0.040211 0.0143897 0.0116184 0.0105581 0.0102062
0.0101541 0.0102782 0.0106269 0.011348 0.012632 0.0145697 0.0170844 0.0199837 0.0230399 0.0260461 0.028847 0.0313486
0.0335089 0.0353234 0.0368115 0.0380062 0.0389462 0.0396711 0.0402175 0.0406177 0.0408979 0.0410773 0.0411675 0.0411708
0.0410779 0.0408628 0.0404752 0.0398244 0.0387481 0.0369447 0.0338246 0.0143897 0.0116184 0.0105581 0.0102062 0.0101541
0.0102782 0.0106269 0.011348 0.012632 0.0145697 0.0170844 0.0199837 0.0230399 0.0260461 0.028847 0.0313486 0.0335089
0.0353234 0.0368115 0.0380062 0.0389462 0.0396711 0.0402175 0.0406177 0.0408979 0.0410773 0.0411675 0.0411708 0.0410779
0.0408628 0.0404752 0.0398244 0.0387481 0.0369447 0.0338246 0.0143897 0.0116184 0.0105581 0.0102062 0.0101541 0.0102783
0.0106271 0.0113484 0.0126327 0.0145709 0.0170862 0.019986 0.023043 0.0260499 0.0288518 0.0313544 0.0335161 0.0353327
0.0368238 0.038023 0.0389699 0.0397053 0.040268 0.0406934 0.0410125 0.0412522 0.0414356 0.0415826 0.04171 0.0418312
0.0419519 0.0420582 0.0420798 0.0417687 0.040211 0.0143897 0.0116184 0.0105581 0.0102062 0.0101541 0.0102783 0.0106272
0.0113486 0.0126331 0.0145716 0.0170872 0.0199875 0.0230449 0.0260523 0.0288547 0.031358 0.0335206 0.0353385 0.0368315
0.0380335 0.0389847 0.0397267 0.0402998 0.0407415 0.0410863 0.0413668 0.0416156 0.0418685 0.0421701 0.0425828 0.043202
0.0441838 0.0457938 0.0485032 0.0534573 0.0143897 0.0116184 0.0105581 0.0102062 0.0101541 0.0102783 0.0106271 0.0113484
0.0126327 0.0145709 0.0170862 0.019986 0.023043 0.0260499 0.0288518 0.0313544 0.0335161 0.0353327 0.0368238 0.038023
0.0389699 0.0397053 0.040268 0.0406934 0.0410125 0.0412522 0.0414356 0.0415826 0.04171 0.0418312 0.0419519 0.0420582
0.0420798 0.0417687 0.040211 0.0143897 0.0116184 0.0105581 0.0102062 0.0101541 0.0102782 0.0106269 0.011348 0.012632
0.0145697 0.0170844 0.0199837 0.0230399 0.0260461 0.028847 0.0313486 0.0335089 0.0353234 0.0368115 0.0380062 0.0389462
0.0396711 0.0402175 0.0406177 0.0408979 0.0410773 0.0411675 0.0411708 0.0410779 0.0408628 0.0404752 0.0398244 0.0387481
0.0369447 0.0338246
</DataArray>
<DataArray type="Float32" Name="saturation_nonwetting" NumberOfComponents="1" format="ascii">
0.98561 0.988382 0.989442 0.989794 0.989846 0.989722 0.989373 0.988652 0.987368 0.98543 0.982916 0.980016
0.97696 0.973954 0.971153 0.968651 0.966491 0.964677 0.963188 0.961994 0.961054 0.960329 0.959782 0.959382
0.959102 0.958923 0.958833 0.958829 0.958922 0.959137 0.959525 0.960176 0.961252 0.963055 0.966175 0.98561
0.988382 0.989442 0.989794 0.989846 0.989722 0.989373 0.988652 0.987367 0.985429 0.982914 0.980014 0.976957
0.97395 0.971148 0.968646 0.966484 0.964667 0.963176 0.961977 0.96103 0.960295 0.959732 0.959307 0.958987
0.958748 0.958564 0.958417 0.95829 0.958169 0.958048 0.957942 0.95792 0.958231 0.959789 0.98561 0.988382
0.989442 0.989794 0.989846 0.989722 0.989373 0.988651 0.987367 0.985428 0.982913 0.980012 0.976955 0.973948
0.971145 0.968642 0.966479 0.964662 0.963169 0.961967 0.961015 0.960273 0.9597 0.959258 0.958914 0.958633
0.958384 0.958131 0.95783 0.957417 0.956798 0.955816 0.954206 0.951497 0.946543 0.98561 0.988382 0.989442
0.989794 0.989846 0.989722 0.989373 0.988652 0.987367 0.985429 0.982914 0.980014 0.976957 0.97395 0.971148
0.968646 0.966484 0.964667 0.963176 0.961977 0.96103 0.960295 0.959732 0.959307 0.958987 0.958748 0.958564
0.958417 0.95829 0.958169 0.958048 0.957942 0.95792 0.958231 0.959789 0.98561 0.988382 0.989442 0.989794
0.989846 0.989722 0.989373 0.988652 0.987368 0.98543 0.982916 0.980016 0.97696 0.973954 0.971153 0.968651
0.966491 0.964677 0.963188 0.961994 0.961054 0.960329 0.959782 0.959382 0.959102 0.958923 0.958833 0.958829
0.958922 0.959137 0.959525 0.960176 0.961252 0.963055 0.966175 0.98561 0.988382 0.989442 0.989794 0.989846
0.989722 0.989373 0.988652 0.987368 0.98543 0.982916 0.980016 0.97696 0.973954 0.971153 0.968651 0.966491
0.964677 0.963188 0.961994 0.961054 0.960329 0.959782 0.959382 0.959102 0.958923 0.958833 0.958829 0.958922
0.959137 0.959525 0.960176 0.961252 0.963055 0.966175 0.98561 0.988382 0.989442 0.989794 0.989846 0.989722
0.989373 0.988652 0.987367 0.985429 0.982914 0.980014 0.976957 0.97395 0.971148 0.968646 0.966484 0.964667
0.963176 0.961977 0.96103 0.960295 0.959732 0.959307 0.958987 0.958748 0.958564 0.958417 0.95829 0.958169
0.958048 0.957942 0.95792 0.958231 0.959789 0.98561 0.988382 0.989442 0.989794 0.989846 0.989722 0.989373
0.988651 0.987367 0.985428 0.982913 0.980012 0.976955 0.973948 0.971145 0.968642 0.966479 0.964662 0.963169
0.961967 0.961015 0.960273 0.9597 0.959258 0.958914 0.958633 0.958384 0.958131 0.95783 0.957417 0.956798
0.955816 0.954206 0.951497 0.946543 0.98561 0.988382 0.989442 0.989794 0.989846 0.989722 0.989373 0.988652
0.987367 0.985429 0.982914 0.980014 0.976957 0.97395 0.971148 0.968646 0.966484 0.964667 0.963176 0.961977
0.96103 0.960295 0.959732 0.959307 0.958987 0.958748 0.958564 0.958417 0.95829 0.958169 0.958048 0.957942
0.95792 0.958231 0.959789 0.98561 0.988382 0.989442 0.989794 0.989846 0.989722 0.989373 0.988652 0.987368
0.98543 0.982916 0.980016 0.97696 0.973954 0.971153 0.968651 0.966491 0.964677 0.963188 0.961994 0.961054
0.960329 0.959782 0.959382 0.959102 0.958923 0.958833 0.958829 0.958922 0.959137 0.959525 0.960176 0.961252
0.963055 0.966175
</DataArray>
<DataArray type="Float32" Name="relativePerm_wetting" NumberOfComponents="1" format="ascii">
1.72391e-06 8.51181e-07 6.17934e-07 5.51243e-07 5.41796e-07 5.64477e-07 6.31572e-07 7.86906e-07 1.12345e-06 1.79572e-06 3.01291e-06 4.98966e-06
7.85997e-06 1.16004e-05 1.60195e-05 2.08166e-05 2.56655e-05 3.02822e-05 3.44612e-05 3.80838e-05 4.11079e-05 4.35469e-05 4.54487e-05 4.68764e-05
4.78935e-05 4.85526e-05 4.88864e-05 4.88988e-05 4.85548e-05 4.77653e-05 4.63645e-05 4.4075e-05 4.04575e-05 3.48528e-05 2.63978e-05 1.72391e-06
8.51182e-07 6.17935e-07 5.51244e-07 5.418e-07 5.64487e-07 6.31602e-07 7.86985e-07 1.12365e-06 1.79618e-06 3.01389e-06 4.99156e-06 7.8633e-06
1.16058e-05 1.60278e-05 2.08287e-05 2.5683e-05 3.03073e-05 3.44973e-05 3.81366e-05 4.11861e-05 4.36644e-05 4.56273e-05 4.71498e-05 4.83141e-05
4.92013e-05 4.98874e-05 5.04418e-05 5.09259e-05 5.13891e-05 5.18533e-05 5.22646e-05 5.23482e-05 5.11497e-05 4.53738e-05 1.72391e-06 8.51182e-07
6.17935e-07 5.51245e-07 5.41802e-07 5.64494e-07 6.31621e-07 7.87035e-07 1.12378e-06 1.79647e-06 3.0145e-06 4.99273e-06 7.86536e-06 1.16092e-05
1.60329e-05 2.08362e-05 2.56938e-05 3.03228e-05 3.45197e-05 3.81694e-05 4.12349e-05 4.37381e-05 4.574e-05 4.7324e-05 4.85859e-05 4.96291e-05
5.05669e-05 5.15323e-05 5.26998e-05 5.43258e-05 5.68284e-05 6.09532e-05 6.81455e-05 8.14915e-05 0.000108502 1.72391e-06 8.51182e-07 6.17935e-07
5.51244e-07 5.418e-07 5.64487e-07 6.31602e-07 7.86985e-07 1.12365e-06 1.79618e-06 3.01389e-06 4.99156e-06 7.8633e-06 1.16058e-05 1.60278e-05
2.08287e-05 2.5683e-05 3.03073e-05 3.44973e-05 3.81366e-05 4.11861e-05 4.36644e-05 4.56273e-05 4.71498e-05 4.83141e-05 4.92013e-05 4.98874e-05
5.04418e-05 5.09259e-05 5.13891e-05 5.18533e-05 5.22646e-05 5.23482e-05 5.11497e-05 4.53738e-05 1.72391e-06 8.51181e-07 6.17934e-07 5.51243e-07
5.41796e-07 5.64477e-07 6.31572e-07 7.86906e-07 1.12345e-06 1.79572e-06 3.01291e-06 4.98966e-06 7.85997e-06 1.16004e-05 1.60195e-05 2.08166e-05
2.56655e-05 3.02822e-05 3.44612e-05 3.80838e-05 4.11079e-05 4.35469e-05 4.54487e-05 4.68764e-05 4.78935e-05 4.85526e-05 4.88864e-05 4.88988e-05
4.85548e-05 4.77653e-05 4.63645e-05 4.4075e-05 4.04575e-05 3.48528e-05 2.63978e-05 1.72391e-06 8.51181e-07 6.17934e-07 5.51243e-07 5.41796e-07
5.64477e-07 6.31572e-07 7.86906e-07 1.12345e-06 1.79572e-06 3.01291e-06 4.98966e-06 7.85997e-06 1.16004e-05 1.60195e-05 2.08166e-05 2.56655e-05
3.02822e-05 3.44612e-05 3.80838e-05 4.11079e-05 4.35469e-05 4.54487e-05 4.68764e-05 4.78935e-05 4.85526e-05 4.88864e-05 4.88988e-05 4.85548e-05
4.77653e-05 4.63645e-05 4.4075e-05 4.04575e-05 3.48528e-05 2.63978e-05 1.72391e-06 8.51182e-07 6.17935e-07 5.51244e-07 5.418e-07 5.64487e-07
6.31602e-07 7.86985e-07 1.12365e-06 1.79618e-06 3.01389e-06 4.99156e-06 7.8633e-06 1.16058e-05 1.60278e-05 2.08287e-05 2.5683e-05 3.03073e-05
3.44973e-05 3.81366e-05 4.11861e-05 4.36644e-05 4.56273e-05 4.71498e-05 4.83141e-05 4.92013e-05 4.98874e-05 5.04418e-05 5.09259e-05 5.13891e-05
5.18533e-05 5.22646e-05 5.23482e-05 5.11497e-05 4.53738e-05 1.72391e-06 8.51182e-07 6.17935e-07 5.51245e-07 5.41802e-07 5.64494e-07 6.31621e-07
7.87035e-07 1.12378e-06 1.79647e-06 3.0145e-06 4.99273e-06 7.86536e-06 1.16092e-05 1.60329e-05 2.08362e-05 2.56938e-05 3.03228e-05 3.45197e-05
3.81694e-05 4.12349e-05 4.37381e-05 4.574e-05 4.7324e-05 4.85859e-05 4.96291e-05 5.05669e-05 5.15323e-05 5.26998e-05 5.43258e-05 5.68284e-05
6.09532e-05 6.81455e-05 8.14915e-05 0.000108502 1.72391e-06 8.51182e-07 6.17935e-07 5.51244e-07 5.418e-07 5.64487e-07 6.31602e-07 7.86985e-07
1.12365e-06 1.79618e-06 3.01389e-06 4.99156e-06 7.8633e-06 1.16058e-05 1.60278e-05 2.08287e-05 2.5683e-05 3.03073e-05 3.44973e-05 3.81366e-05
4.11861e-05 4.36644e-05 4.56273e-05 4.71498e-05 4.83141e-05 4.92013e-05 4.98874e-05 5.04418e-05 5.09259e-05 5.13891e-05 5.18533e-05 5.22646e-05
5.23482e-05 5.11497e-05 4.53738e-05 1.72391e-06 8.51181e-07 6.17934e-07 5.51243e-07 5.41796e-07 5.64477e-07 6.31572e-07 7.86906e-07 1.12345e-06
1.79572e-06 3.01291e-06 4.98966e-06 7.85997e-06 1.16004e-05 1.60195e-05 2.08166e-05 2.56655e-05 3.02822e-05 3.44612e-05 3.80838e-05 4.11079e-05
4.35469e-05 4.54487e-05 4.68764e-05 4.78935e-05 4.85526e-05 4.88864e-05 4.88988e-05 4.85548e-05 4.77653e-05 4.63645e-05 4.4075e-05 4.04575e-05
3.48528e-05 2.63978e-05
</DataArray>
<DataArray type="Float32" Name="relativePerm_nonwetting" NumberOfComponents="1" format="ascii">
0.987548 0.990483 0.991573 0.991931 0.991984 0.991858 0.991503 0.990762 0.989422 0.987352 0.98459 0.981311
0.977759 0.97418 0.970777 0.967687 0.964982 0.962686 0.960788 0.959254 0.95804 0.957102 0.956392 0.955871
0.955506 0.955272 0.955154 0.955149 0.955271 0.955551 0.956056 0.956903 0.958297 0.960617 0.964602 0.987548
0.990483 0.991573 0.991931 0.991984 0.991858 0.991503 0.990762 0.989422 0.987351 0.984588 0.981308 0.977755
0.974175 0.970771 0.96768 0.964973 0.962674 0.960772 0.959232 0.95801 0.957057 0.956326 0.955772 0.955356
0.955043 0.954803 0.954611 0.954445 0.954286 0.954128 0.953988 0.95396 0.954368 0.956419 0.987548 0.990483
0.991573 0.991931 0.991983 0.991858 0.991503 0.990762 0.989421 0.98735 0.984587 0.981307 0.977753 0.974173
0.970768 0.967675 0.964967 0.962667 0.960762 0.959218 0.957991 0.957029 0.956285 0.95571 0.95526 0.954893
0.954568 0.954237 0.953842 0.9533 0.952486 0.95119 0.949055 0.945436 0.939104 0.987548 0.990483 0.991573
0.991931 0.991984 0.991858 0.991503 0.990762 0.989422 0.987351 0.984588 0.981308 0.977755 0.974175 0.970771
0.96768 0.964973 0.962674 0.960772 0.959232 0.95801 0.957057 0.956326 0.955772 0.955356 0.955043 0.954803
0.954611 0.954445 0.954286 0.954128 0.953988 0.95396 0.954368 0.956419 0.987548 0.990483 0.991573 0.991931
0.991984 0.991858 0.991503 0.990762 0.989422 0.987352 0.98459 0.981311 0.977759 0.97418 0.970777 0.967687
0.964982 0.962686 0.960788 0.959254 0.95804 0.957102 0.956392 0.955871 0.955506 0.955272 0.955154 0.955149
0.955271 0.955551 0.956056 0.956903 0.958297 0.960617 0.964602 0.987548 0.990483 0.991573 0.991931 0.991984
0.991858 0.991503 0.990762 0.989422 0.987352 0.98459 0.981311 0.977759 0.97418 0.970777 0.967687 0.964982
0.962686 0.960788 0.959254 0.95804 0.957102 0.956392 0.955871 0.955506 0.955272 0.955154 0.955149 0.955271
0.955551 0.956056 0.956903 0.958297 0.960617 0.964602 0.987548 0.990483 0.991573 0.991931 0.991984 0.991858
0.991503 0.990762 0.989422 0.987351 0.984588 0.981308 0.977755 0.974175 0.970771 0.96768 0.964973 0.962674
0.960772 0.959232 0.95801 0.957057 0.956326 0.955772 0.955356 0.955043 0.954803 0.954611 0.954445 0.954286
0.954128 0.953988 0.95396 0.954368 0.956419 0.987548 0.990483 0.991573 0.991931 0.991983 0.991858 0.991503
0.990762 0.989421 0.98735 0.984587 0.981307 0.977753 0.974173 0.970768 0.967675 0.964967 0.962667 0.960762
0.959218 0.957991 0.957029 0.956285 0.95571 0.95526 0.954893 0.954568 0.954237 0.953842 0.9533 0.952486
0.95119 0.949055 0.945436 0.939104 0.987548 0.990483 0.991573 0.991931 0.991984 0.991858 0.991503 0.990762
0.989422 0.987351 0.984588 0.981308 0.977755 0.974175 0.970771 0.96768 0.964973 0.962674 0.960772 0.959232
0.95801 0.957057 0.956326 0.955772 0.955356 0.955043 0.954803 0.954611 0.954445 0.954286 0.954128 0.953988
0.95396 0.954368 0.956419 0.987548 0.990483 0.991573 0.991931 0.991984 0.991858 0.991503 0.990762 0.989422
0.987352 0.98459 0.981311 0.977759 0.97418 0.970777 0.967687 0.964982 0.962686 0.960788 0.959254 0.95804
0.957102 0.956392 0.955871 0.955506 0.955272 0.955154 0.955149 0.955271 0.955551 0.956056 0.956903 0.958297
0.960617 0.964602
</DataArray>
<DataArray type="Float32" Name="porosity" NumberOfComponents="1" format="ascii">
0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4 0.4
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
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
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
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
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
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
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
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
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
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
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
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
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
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
0.4 0.4
</DataArray>
<DataArray type="Float32" Name="temperature" NumberOfComponents="1" format="ascii">
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15 293.15
293.15 293.15
</DataArray>
</CellData>
<Points>
<DataArray type="Float32" Name="Coordinates" NumberOfComponents="3" format="ascii">
0 0 0 0.01 0 0 0 0.00857143 0 0.01 0.00857143 0
0 0.0171429 0 0.01 0.0171429 0 0 0.0257143 0 0.01 0.0257143 0
0 0.0342857 0 0.01 0.0342857 0 0 0.0428571 0 0.01 0.0428571 0
0 0.0514286 0 0.01 0.0514286 0 0 0.06 0 0.01 0.06 0
0 0.0685714 0 0.01 0.0685714 0 0 0.0771429 0 0.01 0.0771429 0
0 0.0857143 0 0.01 0.0857143 0 0 0.0942857 0 0.01 0.0942857 0
0 0.102857 0 0.01 0.102857 0 0 0.111429 0 0.01 0.111429 0
0 0.12 0 0.01 0.12 0 0 0.128571 0 0.01 0.128571 0
0 0.137143 0 0.01 0.137143 0 0 0.145714 0 0.01 0.145714 0
0 0.154286 0 0.01 0.154286 0 0 0.162857 0 0.01 0.162857 0
0 0.171429 0 0.01 0.171429 0 0 0.18 0 0.01 0.18 0
0 0.188571 0 0.01 0.188571 0 0 0.197143 0 0.01 0.197143 0
0 0.205714 0 0.01 0.205714 0 0 0.214286 0 0.01 0.214286 0
0 0.222857 0 0.01 0.222857 0 0 0.231429 0 0.01 0.231429 0
0 0.24 0 0.01 0.24 0 0 0.248571 0 0.01 0.248571 0
0 0.257143 0 0.01 0.257143 0 0 0.265714 0 0.01 0.265714 0
0 0.274286 0 0.01 0.274286 0 0 0.282857 0 0.01 0.282857 0
0 0.291429 0 0.01 0.291429 0 0 0.3 0 0.01 0.3 0
0.02 0 0 0.02 0.00857143 0 0.02 0.0171429 0 0.02 0.0257143 0
0.02 0.0342857 0 0.02 0.0428571 0 0.02 0.0514286 0 0.02 0.06 0
0.02 0.0685714 0 0.02 0.0771429 0 0.02 0.0857143 0 0.02 0.0942857 0
0.02 0.102857 0 0.02 0.111429 0 0.02 0.12 0 0.02 0.128571 0
0.02 0.137143 0 0.02 0.145714 0 0.02 0.154286 0 0.02 0.162857 0
0.02 0.171429 0 0.02 0.18 0 0.02 0.188571 0 0.02 0.197143 0
0.02 0.205714 0 0.02 0.214286 0 0.02 0.222857 0 0.02 0.231429 0
0.02 0.24 0 0.02 0.248571 0 0.02 0.257143 0 0.02 0.265714 0
0.02 0.274286 0 0.02 0.282857 0 0.02 0.291429 0 0.02 0.3 0
0.03 0 0 0.03 0.00857143 0 0.03 0.0171429 0 0.03 0.0257143 0
0.03 0.0342857 0 0.03 0.0428571 0 0.03 0.0514286 0 0.03 0.06 0
0.03 0.0685714 0 0.03 0.0771429 0 0.03 0.0857143 0 0.03 0.0942857 0
0.03 0.102857 0 0.03 0.111429 0 0.03 0.12 0 0.03 0.128571 0
0.03 0.137143 0 0.03 0.145714 0 0.03 0.154286 0 0.03 0.162857 0
0.03 0.171429 0 0.03 0.18 0 0.03 0.188571 0 0.03 0.197143 0
0.03 0.205714 0 0.03 0.214286 0 0.03 0.222857 0 0.03 0.231429 0
0.03 0.24 0 0.03 0.248571 0 0.03 0.257143 0 0.03 0.265714 0
0.03 0.274286 0 0.03 0.282857 0 0.03 0.291429 0 0.03 0.3 0
0.04 0 0 0.04 0.00857143 0 0.04 0.0171429 0 0.04 0.0257143 0
0.04 0.0342857 0 0.04 0.0428571 0 0.04 0.0514286 0 0.04 0.06 0
0.04 0.0685714 0 0.04 0.0771429 0 0.04 0.0857143 0 0.04 0.0942857 0
0.04 0.102857 0 0.04 0.111429 0 0.04 0.12 0 0.04 0.128571 0
0.04 0.137143 0 0.04 0.145714 0 0.04 0.154286 0 0.04 0.162857 0
0.04 0.171429 0 0.04 0.18 0 0.04 0.188571 0 0.04 0.197143 0
0.04 0.205714 0 0.04 0.214286 0 0.04 0.222857 0 0.04 0.231429 0
0.04 0.24 0 0.04 0.248571 0 0.04 0.257143 0 0.04 0.265714 0
0.04 0.274286 0 0.04 0.282857 0 0.04 0.291429 0 0.04 0.3 0
0.05 0 0 0.05 0.00857143 0 0.05 0.0171429 0 0.05 0.0257143 0
0.05 0.0342857 0 0.05 0.0428571 0 0.05 0.0514286 0 0.05 0.06 0
0.05 0.0685714 0 0.05 0.0771429 0 0.05 0.0857143 0 0.05 0.0942857 0
0.05 0.102857 0 0.05 0.111429 0 0.05 0.12 0 0.05 0.128571 0
0.05 0.137143 0 0.05 0.145714 0 0.05 0.154286 0 0.05 0.162857 0
0.05 0.171429 0 0.05 0.18 0 0.05 0.188571 0 0.05 0.197143 0
0.05 0.205714 0 0.05 0.214286 0 0.05 0.222857 0 0.05 0.231429 0
0.05 0.24 0 0.05 0.248571 0 0.05 0.257143 0 0.05 0.265714 0
0.05 0.274286 0 0.05 0.282857 0 0.05 0.291429 0 0.05 0.3 0
0.06 0 0 0.06 0.00857143 0 0.06 0.0171429 0 0.06 0.0257143 0
0.06 0.0342857 0 0.06 0.0428571 0 0.06 0.0514286 0 0.06 0.06 0
0.06 0.0685714 0 0.06 0.0771429 0 0.06 0.0857143 0 0.06 0.0942857 0
0.06 0.102857 0 0.06 0.111429 0 0.06 0.12 0 0.06 0.128571 0
0.06 0.137143 0 0.06 0.145714 0 0.06 0.154286 0 0.06 0.162857 0
0.06 0.171429 0 0.06 0.18 0 0.06 0.188571 0 0.06 0.197143 0
0.06 0.205714 0 0.06 0.214286 0 0.06 0.222857 0 0.06 0.231429 0
0.06 0.24 0 0.06 0.248571 0 0.06 0.257143 0 0.06 0.265714 0
0.06 0.274286 0 0.06 0.282857 0 0.06 0.291429 0 0.06 0.3 0
0.07 0 0 0.07 0.00857143 0 0.07 0.0171429 0 0.07 0.0257143 0
0.07 0.0342857 0 0.07 0.0428571 0 0.07 0.0514286 0 0.07 0.06 0
0.07 0.0685714 0 0.07 0.0771429 0 0.07 0.0857143 0 0.07 0.0942857 0
0.07 0.102857 0 0.07 0.111429 0 0.07 0.12 0 0.07 0.128571 0
0.07 0.137143 0 0.07 0.145714 0 0.07 0.154286 0 0.07 0.162857 0
0.07 0.171429 0 0.07 0.18 0 0.07 0.188571 0 0.07 0.197143 0
0.07 0.205714 0 0.07 0.214286 0 0.07 0.222857 0 0.07 0.231429 0
0.07 0.24 0 0.07 0.248571 0 0.07 0.257143 0 0.07 0.265714 0
0.07 0.274286 0 0.07 0.282857 0 0.07 0.291429 0 0.07 0.3 0
0.08 0 0 0.08 0.00857143 0 0.08 0.0171429 0 0.08 0.0257143 0
0.08 0.0342857 0 0.08 0.0428571 0 0.08 0.0514286 0 0.08 0.06 0
0.08 0.0685714 0 0.08 0.0771429 0 0.08 0.0857143 0 0.08 0.0942857 0
0.08 0.102857 0 0.08 0.111429 0 0.08 0.12 0 0.08 0.128571 0
0.08 0.137143 0 0.08 0.145714 0 0.08 0.154286 0 0.08 0.162857 0
0.08 0.171429 0 0.08 0.18 0 0.08 0.188571 0 0.08 0.197143 0
0.08 0.205714 0 0.08 0.214286 0 0.08 0.222857 0 0.08 0.231429 0
0.08 0.24 0 0.08 0.248571 0 0.08 0.257143 0 0.08 0.265714 0
0.08 0.274286 0 0.08 0.282857 0 0.08 0.291429 0 0.08 0.3 0
0.09 0 0 0.09 0.00857143 0 0.09 0.0171429 0 0.09 0.0257143 0
0.09 0.0342857 0 0.09 0.0428571 0 0.09 0.0514286 0 0.09 0.06 0
0.09 0.0685714 0 0.09 0.0771429 0 0.09 0.0857143 0 0.09 0.0942857 0
0.09 0.102857 0 0.09 0.111429 0 0.09 0.12 0 0.09 0.128571 0
0.09 0.137143 0 0.09 0.145714 0 0.09 0.154286 0 0.09 0.162857 0
0.09 0.171429 0 0.09 0.18 0 0.09 0.188571 0 0.09 0.197143 0
0.09 0.205714 0 0.09 0.214286 0 0.09 0.222857 0 0.09 0.231429 0
0.09 0.24 0 0.09 0.248571 0 0.09 0.257143 0 0.09 0.265714 0
0.09 0.274286 0 0.09 0.282857 0 0.09 0.291429 0 0.09 0.3 0
0.1 0 0 0.1 0.00857143 0 0.1 0.0171429 0 0.1 0.0257143 0
0.1 0.0342857 0 0.1 0.0428571 0 0.1 0.0514286 0 0.1 0.06 0
0.1 0.0685714 0 0.1 0.0771429 0 0.1 0.0857143 0 0.1 0.0942857 0
0.1 0.102857 0 0.1 0.111429 0 0.1 0.12 0 0.1 0.128571 0
0.1 0.137143 0 0.1 0.145714 0 0.1 0.154286 0 0.1 0.162857 0
0.1 0.171429 0 0.1 0.18 0 0.1 0.188571 0 0.1 0.197143 0
0.1 0.205714 0 0.1 0.214286 0 0.1 0.222857 0 0.1 0.231429 0
0.1 0.24 0 0.1 0.248571 0 0.1 0.257143 0 0.1 0.265714 0
0.1 0.274286 0 0.1 0.282857 0 0.1 0.291429 0 0.1 0.3 0
</DataArray>
</Points>
<Cells>
<DataArray type="Int32" Name="connectivity" NumberOfComponents="1" format="ascii">
0 1 3 2 2 3 5 4 4 5 7 6
6 7 9 8 8 9 11 10 10 11 13 12
12 13 15 14 14 15 17 16 16 17 19 18
18 19 21 20 20 21 23 22 22 23 25 24
24 25 27 26 26 27 29 28 28 29 31 30
30 31 33 32 32 33 35 34 34 35 37 36
36 37 39 38 38 39 41 40 40 41 43 42
42 43 45 44 44 45 47 46 46 47 49 48
48 49 51 50 50 51 53 52 52 53 55 54
54 55 57 56 56 57 59 58 58 59 61 60
60 61 63 62 62 63 65 64 64 65 67 66
66 67 69 68 68 69 71 70 1 72 73 3
3 73 74 5 5 74 75 7 7 75 76 9
9 76 77 11 11 77 78 13 13 78 79 15
15 79 80 17 17 80 81 19 19 81 82 21
21 82 83 23 23 83 84 25 25 84 85 27
27 85 86 29 29 86 87 31 31 87 88 33
33 88 89 35 35 89 90 37 37 90 91 39
39 91 92 41 41 92 93 43 43 93 94 45
45 94 95 47 47 95 96 49 49 96 97 51
51 97 98 53 53 98 99 55 55 99 100 57
57 100 101 59 59 101 102 61 61 102 103 63
63 103 104 65 65 104 105 67 67 105 106 69
69 106 107 71 72 108 109 73 73 109 110 74
74 110 111 75 75 111 112 76 76 112 113 77
77 113 114 78 78 114 115 79 79 115 116 80
80 116 117 81 81 117 118 82 82 118 119 83
83 119 120 84 84 120 121 85 85 121 122 86
86 122 123 87 87 123 124 88 88 124 125 89
89 125 126 90 90 126 127 91 91 127 128 92
92 128 129 93 93 129 130 94 94 130 131 95
95 131 132 96 96 132 133 97 97 133 134 98
98 134 135 99 99 135 136 100 100 136 137 101
101 137 138 102 102 138 139 103 103 139 140 104
104 140 141 105 105 141 142 106 106 142 143 107
108 144 145 109 109 145 146 110 110 146 147 111
111 147 148 112 112 148 149 113 113 149 150 114
114 150 151 115 115 151 152 116 116 152 153 117
117 153 154 118 118 154 155 119 119 155 156 120
120 156 157 121 121 157 158 122 122 158 159 123
123 159 160 124 124 160 161 125 125 161 162 126
126 162 163 127 127 163 164 128 128 164 165 129
129 165 166 130 130 166 167 131 131 167 168 132
132 168 169 133 133 169 170 134 134 170 171 135
135 171 172 136 136 172 173 137 137 173 174 138
138 174 175 139 139 175 176 140 140 176 177 141
141 177 178 142 142 178 179 143 144 180 181 145
145 181 182 146 146 182 183 147 147 183 184 148
148 184 185 149 149 185 186 150 150 186 187 151
151 187 188 152 152 188 189 153 153 189 190 154
154 190 191 155 155 191 192 156 156 192 193 157
157 193 194 158 158 194 195 159 159 195 196 160
160 196 197 161 161 197 198 162 162 198 199 163
163 199 200 164 164 200 201 165 165 201 202 166
166 202 203 167 167 203 204 168 168 204 205 169
169 205 206 170 170 206 207 171 171 207 208 172
172 208 209 173 173 209 210 174 174 210 211 175
175 211 212 176 176 212 213 177 177 213 214 178
178 214 215 179 180 216 217 181 181 217 218 182
182 218 219 183 183 219 220 184 184 220 221 185
185 221 222 186 186 222 223 187 187 223 224 188
188 224 225 189 189 225 226 190 190 226 227 191
191 227 228 192 192 228 229 193 193 229 230 194
194 230 231 195 195 231 232 196 196 232 233 197
197 233 234 198 198 234 235 199 199 235 236 200
200 236 237 201 201 237 238 202 202 238 239 203
203 239 240 204 204 240 241 205 205 241 242 206
206 242 243 207 207 243 244 208 208 244 245 209
209 245 246 210 210 246 247 211 211 247 248 212
212 248 249 213 213 249 250 214 214 250 251 215
216 252 253 217 217 253 254 218 218 254 255 219
219 255 256 220 220 256 257 221 221 257 258 222
222 258 259 223 223 259 260 224 224 260 261 225
225 261 262 226 226 262 263 227 227 263 264 228
228 264 265 229 229 265 266 230 230 266 267 231
231 267 268 232 232 268 269 233 233 269 270 234
234 270 271 235 235 271 272 236 236 272 273 237
237 273 274 238 238 274 275 239 239 275 276 240
240 276 277 241 241 277 278 242 242 278 279 243
243 279 280 244 244 280 281 245 245 281 282 246
246 282 283 247 247 283 284 248 248 284 285 249
249 285 286 250 250 286 287 251 252 288 289 253
253 289 290 254 254 290 291 255 255 291 292 256
256 292 293 257 257 293 294 258 258 294 295 259
259 295 296 260 260 296 297 261 261 297 298 262
262 298 299 263 263 299 300 264 264 300 301 265
265 301 302 266 266 302 303 267 267 303 304 268
268 304 305 269 269 305 306 270 270 306 307 271
271 307 308 272 272 308 309 273 273 309 310 274
274 310 311 275 275 311 312 276 276 312 313 277
277 313 314 278 278 314 315 279 279 315 316 280
280 316 317 281 281 317 318 282 282 318 319 283
283 319 320 284 284 320 321 285 285 321 322 286
286 322 323 287 288 324 325 289 289 325 326 290
290 326 327 291 291 327 328 292 292 328 329 293
293 329 330 294 294 330 331 295 295 331 332 296
296 332 333 297 297 333 334 298 298 334 335 299
299 335 336 300 300 336 337 301 301 337 338 302
302 338 339 303 303 339 340 304 304 340 341 305
305 341 342 306 306 342 343 307 307 343 344 308
308 344 345 309 309 345 346 310 310 346 347 311
311 347 348 312 312 348 349 313 313 349 350 314
314 350 351 315 315 351 352 316 316 352 353 317
317 353 354 318 318 354 355 319 319 355 356 320
320 356 357 321 321 357 358 322 322 358 359 323
324 360 361 325 325 361 362 326 326 362 363 327
327 363 364 328 328 364 365 329 329 365 366 330
330 366 367 331 331 367 368 332 332 368 369 333
333 369 370 334 334 370 371 335 335 371 372 336
336 372 373 337 337 373 374 338 338 374 375 339
339 375 376 340 340 376 377 341 341 377 378 342
342 378 379 343 343 379 380 344 344 380 381 345
345 381 382 346 346 382 383 347 347 383 384 348
348 384 385 349 349 385 386 350 350 386 387 351
351 387 388 352 352 388 389 353 353 389 390 354
354 390 391 355 355 391 392 356 356 392 393 357
357 393 394 358 358 394 395 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
1300 1304 1308 1312 1316 1320 1324 1328 1332 1336 1340 1344
1348 1352 1356 1360 1364 1368 1372 1376 1380 1384 1388 1392
1396 1400
</DataArray>
<DataArray type="UInt8" Name="types" NumberOfComponents="1" format="ascii">
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9 9 9 9 9 9 9 9 9 9 9
9 9
</DataArray>
</Cells>
</Piece>
</UnstructuredGrid>
</VTKFile>