Add an example program demonstrating the use of the ImplicitTransport solver.
Building contingent upon availability of both OPMPressure *and* UMFPACK.
This commit is contained in:
parent
b1f35c50b1
commit
72953ac126
29
examples/Makefile.am
Normal file
29
examples/Makefile.am
Normal file
@ -0,0 +1,29 @@
|
||||
# Additional definitions to ensure proper include paths
|
||||
|
||||
AM_CPPFLAGS = \
|
||||
-I$(top_srcdir)/src
|
||||
|
||||
AM_LDFLAGS = \
|
||||
$(LAPACK_LIBS) $(BLAS_LIBS)
|
||||
|
||||
#-----------------------------------------------------------------------
|
||||
|
||||
# Declare example programs
|
||||
noinst_PROGRAMS =
|
||||
|
||||
# "spu_2p" depends on availability of OPMPressure and UMFPACK
|
||||
if UMFPACK
|
||||
if OPMPRESSURE_SPARSE_SYS
|
||||
noinst_PROGRAMS += spu_2p
|
||||
endif
|
||||
endif
|
||||
|
||||
#-----------------------------------------------------------------------
|
||||
|
||||
# Example program sources
|
||||
|
||||
spu_2p_SOURCES = \
|
||||
spu_2p.cpp \
|
||||
call_umfpack.c \
|
||||
cart_grid.c \
|
||||
transport_source.c
|
289
examples/spu_2p.cpp
Normal file
289
examples/spu_2p.cpp
Normal file
@ -0,0 +1,289 @@
|
||||
/*===========================================================================
|
||||
//
|
||||
// File: spu_2p.cpp
|
||||
//
|
||||
// Created: 2011-10-05 10:29:01+0200
|
||||
//
|
||||
// Authors: Ingeborg S. Ligaarden <Ingeborg.Ligaarden@sintef.no>
|
||||
// Jostein R. Natvig <Jostein.R.Natvig@sintef.no>
|
||||
// Halvor M. Nilsen <HalvorMoll.Nilsen@sintef.no>
|
||||
// Atgeirr F. Rasmussen <atgeirr@sintef.no>
|
||||
// Bård Skaflestad <Bard.Skaflestad@sintef.no>
|
||||
//
|
||||
//==========================================================================*/
|
||||
|
||||
|
||||
/*
|
||||
Copyright 2011 SINTEF ICT, Applied Mathematics.
|
||||
Copyright 2011 Statoil ASA.
|
||||
|
||||
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 3 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/>.
|
||||
*/
|
||||
|
||||
#include <cassert>
|
||||
|
||||
#include <algorithm>
|
||||
#include <cstddef>
|
||||
#include <functional>
|
||||
#include <iostream>
|
||||
#include <iterator>
|
||||
#include <vector>
|
||||
|
||||
#include <ifs_tpfa.h>
|
||||
#include <trans_tpfa.h>
|
||||
#include <sparse_sys.h>
|
||||
|
||||
#include <transport_source.h>
|
||||
|
||||
#include <cart_grid.h>
|
||||
|
||||
#include <CSRMatrixUmfpackSolver.hpp>
|
||||
|
||||
#include <NormSupport.hpp>
|
||||
#include <ImplicitAssembly.hpp>
|
||||
#include <ImplicitTransport.hpp>
|
||||
#include <JacobianSystem.hpp>
|
||||
|
||||
#include <CSRMatrixBlockAssembler.hpp>
|
||||
|
||||
#include <SimpleFluid2p.hpp>
|
||||
#include <SinglePointUpwindTwoPhase.hpp>
|
||||
|
||||
template <class Ostream, class Collection>
|
||||
Ostream&
|
||||
operator<<(Ostream& os, const Collection& c)
|
||||
{
|
||||
typedef typename Collection::value_type VT;
|
||||
|
||||
os << "[ ";
|
||||
std::copy(c.begin(), c.end(), ::std::ostream_iterator<VT>(os, " "));
|
||||
os << "]";
|
||||
|
||||
return os;
|
||||
}
|
||||
|
||||
class Rock {
|
||||
public:
|
||||
Rock(::std::size_t nc, ::std::size_t dim)
|
||||
: dim_ (dim ),
|
||||
perm_(nc * dim * dim),
|
||||
poro_(nc ) {}
|
||||
|
||||
const ::std::vector<double>& perm() const { return perm_; }
|
||||
const ::std::vector<double>& poro() const { return poro_; }
|
||||
|
||||
void
|
||||
perm_homogeneous(double k) {
|
||||
setVector(0.0, perm_);
|
||||
|
||||
const ::std::size_t d2 = dim_ * dim_;
|
||||
|
||||
for (::std::size_t c = 0, nc = poro_.size(); c < nc; ++c) {
|
||||
for (::std::size_t i = 0; i < dim_; ++i) {
|
||||
perm_[c*d2 + i*(dim_ + 1)] = k;
|
||||
}
|
||||
}
|
||||
}
|
||||
|
||||
void
|
||||
poro_homogeneous(double phi) {
|
||||
setVector(phi, poro_);
|
||||
}
|
||||
|
||||
private:
|
||||
void
|
||||
setVector(double x, ::std::vector<double>& v) {
|
||||
::std::fill(v.begin(), v.end(), x);
|
||||
}
|
||||
|
||||
::std::size_t dim_ ;
|
||||
::std::vector<double> perm_;
|
||||
::std::vector<double> poro_;
|
||||
};
|
||||
|
||||
template <int np = 2>
|
||||
class ReservoirState {
|
||||
public:
|
||||
ReservoirState(const grid_t* g)
|
||||
: press_ (g->number_of_cells),
|
||||
fpress_(g->number_of_faces),
|
||||
flux_ (g->number_of_faces),
|
||||
sat_ (np * g->number_of_cells)
|
||||
{}
|
||||
|
||||
::std::vector<double>& pressure () { return press_ ; }
|
||||
::std::vector<double>& facepressure() { return fpress_; }
|
||||
::std::vector<double>& faceflux () { return flux_ ; }
|
||||
::std::vector<double>& saturation () { return sat_ ; }
|
||||
|
||||
const ::std::vector<double>& faceflux () const { return flux_; }
|
||||
const ::std::vector<double>& saturation () const { return sat_ ; }
|
||||
|
||||
private:
|
||||
::std::vector<double> press_ ;
|
||||
::std::vector<double> fpress_;
|
||||
::std::vector<double> flux_ ;
|
||||
::std::vector<double> sat_ ;
|
||||
};
|
||||
|
||||
class PressureSolver {
|
||||
public:
|
||||
PressureSolver(grid_t* g, const Rock& rock)
|
||||
: htrans_(g->cell_facepos[ g->number_of_cells ]),
|
||||
trans_ (g->number_of_faces),
|
||||
gpress_(g->cell_facepos[ g->number_of_cells ])
|
||||
{
|
||||
tpfa_htrans_compute(g, &rock.perm()[0], &htrans_[0]);
|
||||
|
||||
h_ = ifs_tpfa_construct(g);
|
||||
}
|
||||
|
||||
~PressureSolver() {
|
||||
ifs_tpfa_destroy(h_);
|
||||
}
|
||||
|
||||
template <class State>
|
||||
void
|
||||
solve(grid_t* g ,
|
||||
const ::std::vector<double>& totmob,
|
||||
const ::std::vector<double>& src ,
|
||||
State& state ) {
|
||||
|
||||
tpfa_eff_trans_compute(g, &totmob[0], &htrans_[0], &trans_[0]);
|
||||
|
||||
// No gravity
|
||||
::std::fill(gpress_.begin(), gpress_.end(), double(0.0));
|
||||
|
||||
ifs_tpfa_assemble(g, &trans_[0], &src[0], &gpress_[0], h_);
|
||||
|
||||
using Opm::ImplicitTransportLinAlgSupport::CSRMatrixUmfpackSolver;
|
||||
|
||||
CSRMatrixUmfpackSolver linsolve;
|
||||
linsolve.solve(h_->A, h_->b, h_->x);
|
||||
|
||||
ifs_tpfa_press_flux(g, &trans_[0], h_,
|
||||
&state.pressure()[0],
|
||||
&state.faceflux()[0]);
|
||||
}
|
||||
|
||||
private:
|
||||
::std::vector<double> htrans_;
|
||||
::std::vector<double> trans_ ;
|
||||
::std::vector<double> gpress_;
|
||||
|
||||
struct ifs_tpfa_data* h_;
|
||||
};
|
||||
|
||||
|
||||
typedef Opm::SimpleFluid2p<> TwophaseFluid;
|
||||
typedef Opm::SinglePointUpwindTwoPhase<TwophaseFluid> TransportModel;
|
||||
|
||||
using namespace Opm::ImplicitTransportDefault;
|
||||
|
||||
typedef NewtonVectorCollection< ::std::vector<double> > NVecColl;
|
||||
typedef JacobianSystem < struct CSRMatrix, NVecColl > JacSys;
|
||||
|
||||
template <class Vector>
|
||||
class MaxNorm {
|
||||
public:
|
||||
static double
|
||||
norm(const Vector& v) {
|
||||
return AccumulationNorm <Vector, MaxAbs>::norm(v);
|
||||
}
|
||||
};
|
||||
|
||||
typedef Opm::ImplicitTransport<TransportModel,
|
||||
JacSys,
|
||||
MaxNorm,
|
||||
VectorNegater,
|
||||
VectorZero> TransportSolver;
|
||||
|
||||
void
|
||||
compute_porevolume(const grid_t* g,
|
||||
const Rock& rock,
|
||||
std::vector<double>& porevol)
|
||||
{
|
||||
const ::std::vector<double>& poro = rock.poro();
|
||||
|
||||
#if 0
|
||||
assert (poro.size() == static_cast<::std::size_t>(g->number_of_cells));
|
||||
#endif
|
||||
|
||||
porevol.resize(rock.poro().size());
|
||||
|
||||
::std::transform(poro.begin(), poro.end(),
|
||||
g->cell_volumes,
|
||||
porevol.begin(),
|
||||
::std::multiplies<double>());
|
||||
}
|
||||
|
||||
int
|
||||
main()
|
||||
{
|
||||
grid_t* grid = create_cart_grid(2, 1, 1);
|
||||
|
||||
Rock rock(grid->number_of_cells, grid->dimensions);
|
||||
|
||||
rock.perm_homogeneous(1);
|
||||
rock.poro_homogeneous(1);
|
||||
|
||||
PressureSolver psolver(grid, rock);
|
||||
|
||||
std::vector<double> totmob(grid->number_of_cells, 1.0);
|
||||
std::vector<double> src (grid->number_of_cells, 0.0);
|
||||
|
||||
src[0] = 1.0;
|
||||
src[grid->number_of_cells - 1] = -1.0;
|
||||
|
||||
ReservoirState<> state(grid);
|
||||
|
||||
psolver.solve(grid, totmob, src, state);
|
||||
|
||||
TransportSource* tsrc = create_transport_source(2, 2);
|
||||
|
||||
double ssrc[] = { 1.0, 0.0 };
|
||||
double ssink[] = { 0.0, 1.0 };
|
||||
double zdummy[] = { 0.0, 0.0 };
|
||||
|
||||
append_transport_source(0, 2, 0, src[0], ssrc, zdummy, tsrc);
|
||||
append_transport_source(grid->number_of_cells - 1, 2, 0,
|
||||
src.back(), ssink, zdummy, tsrc);
|
||||
|
||||
Opm::ImplicitTransportDetails::NRReport rpt;
|
||||
Opm::ImplicitTransportDetails::NRControl ctrl;
|
||||
ctrl.max_it = 1;
|
||||
|
||||
using Opm::ImplicitTransportLinAlgSupport::CSRMatrixUmfpackSolver;
|
||||
CSRMatrixUmfpackSolver linsolve;
|
||||
|
||||
std::array<double, 2> mu = {{ 1.0, 1.0 }};
|
||||
std::array<double, 2> rho = {{ 0.0, 0.0 }};
|
||||
TwophaseFluid fluid(mu, rho);
|
||||
|
||||
std::vector<double> porevol;
|
||||
compute_porevolume(grid, rock, porevol);
|
||||
|
||||
TransportModel model (fluid, *grid, porevol);
|
||||
TransportSolver tsolver(model);
|
||||
|
||||
double dt = 1;
|
||||
tsolver.solve(*grid, tsrc, dt, ctrl, state, linsolve, rpt);
|
||||
|
||||
std::cerr << state.saturation() << '\n';
|
||||
|
||||
destroy_transport_source(tsrc);
|
||||
destroy_cart_grid(grid);
|
||||
}
|
Loading…
Reference in New Issue
Block a user