24#ifndef DUMUX_FVPRESSURE2P2C_MULTIPHYSICS_HH
25#define DUMUX_FVPRESSURE2P2C_MULTIPHYSICS_HH
27#include <dune/common/float_cmp.hh>
70template<
class TypeTag>
90 dim = GridView::dimension, dimWorld = GridView::dimensionworld
94 pw = Indices::pressureW
98 wPhaseIdx = Indices::wPhaseIdx, nPhaseIdx = Indices::nPhaseIdx,
99 wCompIdx = Indices::wPhaseIdx, nCompIdx = Indices::nPhaseIdx,
100 contiWEqIdx = Indices::contiWEqIdx, contiNEqIdx = Indices::contiNEqIdx
104 using Element =
typename GridView::Traits::template Codim<0>::Entity;
105 using Grid =
typename GridView::Grid;
106 using Intersection =
typename GridView::Intersection;
109 using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>;
110 using DimMatrix = Dune::FieldMatrix<Scalar, dim, dim>;
111 using PhaseVector = Dune::FieldVector<Scalar, getPropValue<TypeTag, Properties::NumPhases>()>;
115 using EntryType = Dune::FieldVector<Scalar, 2>;
119 const Problem& problem()
const
130 const CellData& cellDataI);
133 const Intersection& intersection,
134 const CellData& cellDataI);
140 int size = this->problem().gridView().size(0);
141 for (
int i = 0; i < size; i++)
143 CellData& cellData = this->problem().variables().cellData(i);
144 cellData.subdomain() = 2;
161 int eIdxGlobal = problem().variables().index(element);
162 CellData& cellData = problem().variables().cellData(eIdxGlobal);
163 outstream <<
" "<< cellData.subdomain();
178 int eIdxGlobal = problem().variables().index(element);
179 CellData& cellData = problem().variables().cellData(eIdxGlobal);
181 instream >> subdomainIdx;
182 cellData.setSubdomainAndFluidStateType(subdomainIdx);
195 template<
class MultiWriter>
200 if(problem().vtkOutputLevel()>=1)
202 int size = problem().gridView().size(0);
204 Dune::BlockVector<Dune::FieldVector<int,1> >* subdomainPtr = writer.template allocateManagedBuffer<int, 1> (size);
205 for (
int i = 0; i < size; i++)
207 CellData& cellData = problem().variables().cellData(i);
208 (*subdomainPtr)[i] = cellData.subdomain();
210 writer.attachCellData(*subdomainPtr,
"subdomain");
234 static constexpr int pressureType = getPropValue<TypeTag, Properties::PressureFormulation>();
264template<
class TypeTag>
269 ParentType::assemble(
true);
276 for (
const auto& element : elements(problem().gridView()))
279 int eIdxGlobalI = problem().variables().index(element);
282 if (element.partitionType() == Dune::InteriorEntity)
285 CellData& cellDataI = problem().variables().cellData(eIdxGlobalI);
287 Dune::FieldVector<Scalar, 2> entries(0.);
290 if(cellDataI.subdomain() != 2)
291 problem().pressureModel().get1pSource(entries,element, cellDataI);
293 problem().pressureModel().getSource(entries,element, cellDataI, first);
295 this->f_[eIdxGlobalI] = entries[rhs];
299 for (
const auto& intersection : intersections(problem().gridView(), element))
302 if (intersection.neighbor())
304 int eIdxGlobalJ = problem().variables().index(intersection.outside());
306 if (cellDataI.subdomain() != 2
307 or problem().variables().cellData(eIdxGlobalJ).subdomain() != 2)
308 get1pFlux(entries, intersection, cellDataI);
310 problem().pressureModel().getFlux(entries, intersection, cellDataI, first);
313 this->f_[eIdxGlobalI] -= entries[rhs];
315 this->A_[eIdxGlobalI][eIdxGlobalI] += entries[matrix];
317 this->A_[eIdxGlobalI][eIdxGlobalJ] = -entries[matrix];
324 if (cellDataI.subdomain() != 2)
325 problem().pressureModel().get1pFluxOnBoundary(entries, intersection, cellDataI);
327 problem().pressureModel().getFluxOnBoundary(entries, intersection, cellDataI, first);
330 this->f_[eIdxGlobalI] += entries[rhs];
332 this->A_[eIdxGlobalI][eIdxGlobalI] += entries[matrix];
338 if (cellDataI.subdomain() != 2)
339 problem().pressureModel().get1pStorage(entries, element, cellDataI);
341 problem().pressureModel().getStorage(entries, element, cellDataI, first);
343 this->f_[eIdxGlobalI] += entries[rhs];
345 this->A_[eIdxGlobalI][eIdxGlobalI] += entries[matrix];
350 this->A_[eIdxGlobalI] = 0.0;
351 this->A_[eIdxGlobalI][eIdxGlobalI] = 1.0;
352 this->f_[eIdxGlobalI] = this->
pressure()[eIdxGlobalI];
371template<
class TypeTag>
373 const Element& elementI,
const CellData& cellDataI)
378 Scalar volume = elementI.geometry().volume();
379 int subdomainIdx = cellDataI.subdomain();
382 PrimaryVariables source(NAN);
383 problem().source(source, elementI);
384 source[1+subdomainIdx] /= cellDataI.density(subdomainIdx);
386 sourceEntry[1] = volume * source[1+subdomainIdx];
404template<
class TypeTag>
406 const Element& elementI,
411 int eIdxGlobalI = problem().variables().index(elementI);
412 int presentPhaseIdx = cellDataI.subdomain();
413 Scalar volume = elementI.geometry().volume();
416 Scalar timestep_ = problem().timeManager().timeStepSize();
421 Scalar& incp = this->incp_;
424 PhaseVector p_(incp);
425 p_[nPhaseIdx] += cellDataI.pressure(nPhaseIdx);
426 p_[wPhaseIdx] += cellDataI.pressure(wPhaseIdx);
428 Scalar sumC = (cellDataI.massConcentration(wCompIdx) + cellDataI.massConcentration(nCompIdx));
429 Scalar Z0 = cellDataI.massConcentration(wCompIdx) / sumC;
436 Scalar v_ = 1. / pseudoFluidState.
density(presentPhaseIdx);
437 cellDataI.dv_dp() = (sumC * ( v_ - (1. /cellDataI.density(presentPhaseIdx)))) /incp;
439 if (cellDataI.dv_dp()>0)
442 Dune::dinfo <<
"dv_dp larger 0 at Idx " << eIdxGlobalI <<
" , try and invert secant"<< std::endl;
447 v_ = 1. / pseudoFluidState.
density(presentPhaseIdx);
448 cellDataI.dv_dp() = (sumC * ( v_ - (1. /cellDataI.density(presentPhaseIdx)))) /incp;
450 if (cellDataI.dv_dp()>0)
452 Dune::dinfo <<__FILE__<<
"dv_dp still larger 0 after inverting secant. regularize"<< std::endl;
453 cellDataI.dv_dp() *= -1;
458 Scalar compress_term = cellDataI.dv_dp() / timestep_;
460 storageEntry[matrix] -= compress_term*volume;
461 storageEntry[rhs] -= cellDataI.pressure(pressureType) * compress_term * volume;
465 if (isnan(compress_term) ||isinf(compress_term))
466 DUNE_THROW(Dune::MathError,
"Compressibility term leads to NAN matrix entry at index " << eIdxGlobalI);
468 if(!getPropValue<TypeTag, Properties::EnableCompressibility>())
469 DUNE_THROW(Dune::NotImplemented,
"Compressibility is switched off???");
474 if( problem().timeManager().episodeWillBeFinished()
475 || problem().timeManager().willBeFinished())
477 problem().variables().cellData(eIdxGlobalI).errorCorrection() = 0.;
483 problem().variables().cellData(eIdxGlobalI).volumeError() /= timestep_;
484 Scalar maxError = this->maxError_;
485 Scalar erri = fabs(cellDataI.volumeError());
486 Scalar x_lo = this->ErrorTermLowerBound_;
487 Scalar x_mi = this->ErrorTermUpperBound_;
488 Scalar fac = this->ErrorTermFactor_;
489 if (pressureType == pw)
490 fac = 0.1*this->ErrorTermFactor_;
494 if ((erri*timestep_ > 5e-5) && (erri > x_lo * maxError) && (!problem().timeManager().willBeFinished()))
496 if (erri <= x_mi * maxError)
498 problem().variables().cellData(eIdxGlobalI).errorCorrection() =
499 fac* (1-x_mi*(lofac-1)/(x_lo-x_mi) + (lofac-1)/(x_lo-x_mi)*erri/maxError)
500 * cellDataI.volumeError() * volume;
503 problem().variables().cellData(eIdxGlobalI).errorCorrection() =
504 fac * (1 + x_mi - hifac*x_mi/(1-x_mi) + (hifac/(1-x_mi)-1)*erri/maxError)
505 * cellDataI.volumeError() * volume;
508 problem().variables().cellData(eIdxGlobalI).errorCorrection()=0 ;
527template<
class TypeTag>
529 const Intersection& intersection,
const CellData& cellDataI)
532 auto elementI = intersection.inside();
535 const GlobalPosition& globalPos = elementI.geometry().center();
538 DimMatrix permeabilityI(problem().spatialParams().intrinsicPermeability(elementI));
541 const GlobalPosition& unitOuterNormal = intersection.centerUnitOuterNormal();
544 Scalar faceArea = intersection.geometry().volume();
547 auto neighbor = intersection.outside();
548 int eIdxGlobalJ = problem().variables().index(neighbor);
549 CellData& cellDataJ = problem().variables().cellData(eIdxGlobalJ);
552 const GlobalPosition& globalPosNeighbor = neighbor.geometry().center();
555 GlobalPosition distVec = globalPosNeighbor - globalPos;
558 Scalar dist = distVec.two_norm();
560 GlobalPosition unitDistVec(distVec);
563 DimMatrix permeabilityJ
564 = problem().spatialParams().intrinsicPermeability(neighbor);
567 DimMatrix meanPermeability(0);
576 int phaseIdx = min(cellDataI.subdomain(), cellDataJ.subdomain());
578 Scalar rhoMean = 0.5 * (cellDataI.density(phaseIdx) + cellDataJ.density(phaseIdx));
581 Scalar potential = (cellDataI.pressure(phaseIdx) - cellDataJ.pressure(phaseIdx)) / dist;
583 potential += rhoMean * (unitDistVec * gravity_);
589 lambda = cellDataI.mobility(phaseIdx);
590 cellDataJ.setUpwindCell(intersection.indexInOutside(), contiWEqIdx,
false);
591 cellDataJ.setUpwindCell(intersection.indexInOutside(), contiNEqIdx,
false);
593 else if (potential < 0.)
595 lambda = cellDataJ.mobility(phaseIdx);
596 cellDataJ.setUpwindCell(intersection.indexInOutside(), contiWEqIdx,
true);
597 cellDataJ.setUpwindCell(intersection.indexInOutside(), contiNEqIdx,
true);
601 lambda =
harmonicMean(cellDataI.mobility(phaseIdx) , cellDataJ.mobility(phaseIdx));
602 cellDataJ.setUpwindCell(intersection.indexInOutside(), contiWEqIdx,
false);
603 cellDataJ.setUpwindCell(intersection.indexInOutside(), contiNEqIdx,
false);
606 entries[0] = lambda * faceArea * fabs(
permeability * unitOuterNormal) / (dist);
607 entries[1] = rhoMean * lambda;
608 entries[1] *= faceArea * fabs(
permeability * unitOuterNormal) * (unitDistVec * gravity_);
630template<
class TypeTag>
632 const Intersection& intersection,
const CellData& cellDataI)
636 auto elementI = intersection.inside();
637 const GlobalPosition& globalPos = elementI.geometry().center();
639 int phaseIdx = cellDataI.subdomain();
642 const GlobalPosition& unitOuterNormal = intersection.centerUnitOuterNormal();
644 Scalar faceArea = intersection.geometry().volume();
647 const GlobalPosition& globalPosFace = intersection.geometry().center();
650 GlobalPosition distVec(globalPosFace - globalPos);
651 Scalar dist = distVec.two_norm();
652 GlobalPosition unitDistVec(distVec);
656 BoundaryTypes bcType;
657 problem().boundaryTypes(bcType, intersection);
660 PhaseVector pressBC(0.);
663 if (bcType.isDirichlet(Indices::pressureEqIdx))
666 DimMatrix permeabilityI(problem().spatialParams().intrinsicPermeability(elementI));
667 if(this->regulateBoundaryPermeability)
669 int axis = intersection.indexInInside() / 2;
670 if(permeabilityI[axis][axis] < this->minimalBoundaryPermeability)
671 permeabilityI[axis][axis] = this->minimalBoundaryPermeability;
674 Scalar lambdaI = cellDataI.mobility(phaseIdx);
681 FluidState BCfluidState;
684 PrimaryVariables primaryVariablesOnBoundary(NAN);
685 problem().dirichlet(primaryVariablesOnBoundary, intersection);
689 problem().transportModel().evalBoundary(globalPosFace,
695 Scalar densityBound =
697 Scalar viscosityBound =
701 Scalar lambdaBound = 0.;
702 switch (getPropValue<TypeTag, Properties::BoundaryMobility>())
704 case Indices::satDependent:
706 lambdaBound = BCfluidState.saturation(phaseIdx) / viscosityBound;
709 case Indices::permDependent:
714 const auto fluidMatrixInteraction = Deprecated::makePcKrSw(Scalar{}, problem().spatialParams(), elementI);
716 if (phaseIdx == wPhaseIdx)
717 lambdaBound = fluidMatrixInteraction.krw(BCfluidState.saturation(wPhaseIdx)) / viscosityBound;
719 lambdaBound = fluidMatrixInteraction.krn(BCfluidState.saturation(wPhaseIdx)) / viscosityBound;
723 Scalar rhoMean = 0.5 * (cellDataI.density(phaseIdx) + densityBound);
725 Scalar potential = 0;
728 potential = (cellDataI.pressure(phaseIdx) - pressBC[phaseIdx]) / dist;
730 potential += rhoMean * (unitDistVec * gravity_);
734 if (Dune::FloatCmp::eq<Scalar, Dune::FloatCmp::absolute>(potential, 0.0, 1.0e-30))
736 lambda = 0.5*(lambdaI + lambdaBound);
738 else if (potential > 0.)
744 lambda = lambdaBound;
748 Scalar entry(0.), rightEntry(0.);
749 entry = lambda * (fabs(
permeability * unitOuterNormal) / dist) * faceArea;
752 rightEntry = lambda * rhoMean * fabs(
permeability * unitOuterNormal)
757 entries[1] += entry * primaryVariablesOnBoundary[Indices::pressureEqIdx];
758 entries[1] -= rightEntry * (gravity_ * unitDistVec);
765 else if(bcType.isNeumann(Indices::pressureEqIdx))
767 PrimaryVariables J(NAN);
768 problem().neumann(J, intersection);
769 J[1+phaseIdx] /= cellDataI.density(phaseIdx);
771 entries[1] -= J[1+phaseIdx] * faceArea;
774 DUNE_THROW(Dune::NotImplemented,
"Boundary Condition neither Dirichlet nor Neumann!");
792template<
class TypeTag>
796 Scalar maxError = 0.;
799 if (Dune::FloatCmp::eq<Scalar, Dune::FloatCmp::absolute>(problem().timeManager().time(), 0.0, 1.0e-30))
805 for (
const auto& element : elements(problem().gridView()))
808 int eIdxGlobal = problem().variables().index(element);
809 CellData& cellData = problem().variables().cellData(eIdxGlobal);
811 if(cellData.subdomain() == 2)
813 this->updateMaterialLawsInElement(element, postTimeStep);
819 PrimaryVariables source(NAN);
820 problem().source(source, element);
822 if ((cellData.saturation(wPhaseIdx) > 0.0 && cellData.saturation(wPhaseIdx) < 1.0)
823 || Dune::FloatCmp::ne<Scalar, Dune::FloatCmp::absolute>(source.one_norm(), 0.0, 1.0e-30))
826 nextSubdomain[eIdxGlobal] = 2;
829 for (
const auto& intersection : intersections(problem().gridView(), element))
831 if (intersection.neighbor())
833 int eIdxGlobalJ = problem().variables().index(intersection.outside());
835 nextSubdomain[eIdxGlobalJ] = 2;
839 else if(nextSubdomain[eIdxGlobal] != 2)
841 if(Dune::FloatCmp::ne<Scalar, Dune::FloatCmp::absolute>(cellData.saturation(wPhaseIdx), 0.0, 1.0e-30))
842 nextSubdomain[eIdxGlobal] = wPhaseIdx;
843 else if (Dune::FloatCmp::ne<Scalar, Dune::FloatCmp::absolute>(cellData.saturation(nPhaseIdx), 0.0, 1.0e-30))
844 nextSubdomain[eIdxGlobal] = nPhaseIdx;
849 else if (nextSubdomain[eIdxGlobal] != 2)
850 nextSubdomain[eIdxGlobal] = cellData.subdomain();
858 DataHandle dataHandle(problem().variables().elementMapper(), nextSubdomain);
859 problem().gridView().template communicate<DataHandle>(dataHandle,
860 Dune::InteriorBorder_All_Interface,
861 Dune::ForwardCommunication);
866 for (
const auto& element : elements(problem().gridView()))
868 int eIdxGlobal = problem().variables().index(element);
869 CellData& cellData = problem().variables().cellData(eIdxGlobal);
872 int oldSubdomainI = cellData.subdomain();
873 cellData.subdomain() = nextSubdomain[eIdxGlobal];
876 if(oldSubdomainI != 2
877 && nextSubdomain[eIdxGlobal] == 2)
881 this->updateMaterialLawsInElement(element, postTimeStep);
884 else if(oldSubdomainI != 2
885 && nextSubdomain[eIdxGlobal] != 2)
888 this->update1pMaterialLawsInElement(element, cellData, postTimeStep);
896 maxError = max(maxError, fabs(cellData.volumeError()));
898 this->maxError_ = maxError/problem().timeManager().timeStepSize();
902 if(problem().timeManager().willBeFinished() or problem().timeManager().episodeWillBeFinished())
903 Dune::dinfo <<
"Subdomain routines took " << timer_.elapsed() <<
" seconds" << std::endl;
918template<
class TypeTag>
922 GlobalPosition globalPos = elementI.geometry().center();
923 int eIdxGlobal = problem().variables().index(elementI);
926 int presentPhaseIdx = cellData.subdomain();
933 auto& pseudoFluidState = cellData.manipulateSimpleFluidState();
938 const auto fluidMatrixInteraction = Deprecated::makePcKrSw(Scalar{}, problem().spatialParams(), elementI);
945 if(getPropValue<TypeTag, Properties::EnableCapillarity>())
946 pc = fluidMatrixInteraction.pc(((presentPhaseIdx == wPhaseIdx) ? 1. : 0.));
947 if(pressureType == wPhaseIdx)
959 Scalar sumConc = cellData.massConcentration(wCompIdx)
960 + cellData.massConcentration(nCompIdx);
961 Scalar Z0 = cellData.massConcentration(wCompIdx)/ sumConc;
967 assert(presentPhaseIdx == pseudoFluidState.presentPhaseIdx());
975 if(presentPhaseIdx == wPhaseIdx)
977 cellData.setMobility(wPhaseIdx,
978 fluidMatrixInteraction.krw(pseudoFluidState.saturation(wPhaseIdx)) / cellData.viscosity(wPhaseIdx));
979 cellData.setMobility(nPhaseIdx, 0.);
983 cellData.setMobility(nPhaseIdx,
984 fluidMatrixInteraction.krn(pseudoFluidState.saturation(wPhaseIdx)) / cellData.viscosity(nPhaseIdx));
985 cellData.setMobility(wPhaseIdx, 0.);
990 vol = sumConc / pseudoFluidState.density(presentPhaseIdx);
992 if (Dune::FloatCmp::ne<Scalar, Dune::FloatCmp::absolute>(problem().timeManager().timeStepSize(), 0.0, 1.0e-30))
993 cellData.volumeError() = (vol - problem().spatialParams().porosity(elementI));
Determines the pressures and saturations of all fluid phases given the total mass of all components.
Contains a class to exchange entries of a vector.
Finite volume 2p2c pressure model.
constexpr Scalar harmonicMean(Scalar x, Scalar y, Scalar wx=1.0, Scalar wy=1.0) noexcept
Calculate the (weighted) harmonic mean of two scalar values.
Definition: math.hh:68
void harmonicMeanMatrix(Dune::FieldMatrix< Scalar, m, n > &K, const Dune::FieldMatrix< Scalar, m, n > &Ki, const Dune::FieldMatrix< Scalar, m, n > &Kj)
Calculate the harmonic mean of a fixed-size matrix.
Definition: math.hh:108
typename Properties::Detail::GetPropImpl< TypeTag, Property >::type GetProp
get the type of a property (equivalent to old macro GET_PROP(...))
Definition: propertysystem.hh:140
typename Properties::Detail::GetPropImpl< TypeTag, Property >::type::type GetPropType
get the type alias defined in the property (equivalent to old macro GET_PROP_TYPE(....
Definition: propertysystem.hh:149
std::string viscosity(int phaseIdx) noexcept
I/O name of viscosity for multiphase systems.
Definition: name.hh:74
std::string permeability() noexcept
I/O name of permeability.
Definition: name.hh:143
std::string pressure(int phaseIdx) noexcept
I/O name of pressure for multiphase systems.
Definition: name.hh:34
std::string density(int phaseIdx) noexcept
I/O name of density for multiphase systems.
Definition: name.hh:65
Flash calculation routines for compositional sequential models.
Definition: compositionalflash.hh:51
static void concentrationFlash1p2c(FluidState1p2c &fluidState, const Scalar &Z0, const Dune::FieldVector< Scalar, numPhases > phasePressure, const int presentPhaseIdx, const Scalar &temperature)
The simplest possible update routine for 1p2c "flash" calculations.
Definition: compositionalflash.hh:191
Container for compositional variables in a 1p2c situation.
Definition: pseudo1p2c.hh:44
Scalar density(int phaseIdx) const
Set the density of a phase .
Definition: pseudo1p2c.hh:109
Scalar temperature(int phaseIdx) const
Returns the temperature of the fluids .
Definition: pseudo1p2c.hh:189
A data handle class to exchange entries of a vector.
Definition: vectorcommdatahandle.hh:78
The finite volume model for the solution of the compositional pressure equation.
Definition: fvpressure.hh:75
Problem & problem_
Definition: fvpressure.hh:183
Dune::FieldVector< Scalar, 2 > EntryType
Definition: fvpressure.hh:137
void addOutputVtkFields(MultiWriter &writer)
Write data files.
Definition: fvpressurecompositional.hh:171
The finite volume model for the solution of the compositional pressure equation.
Definition: fvpressuremultiphysics.hh:72
Dune::BlockVector< Dune::FieldVector< int, 1 > > nextSubdomain
vector holding next subdomain
Definition: fvpressuremultiphysics.hh:231
void get1pFluxOnBoundary(EntryType &entries, const Intersection &intersection, const CellData &cellDataI)
The compositional single-phase flux in the multiphysics framework.
Definition: fvpressuremultiphysics.hh:631
const GlobalPosition & gravity_
Definition: fvpressuremultiphysics.hh:232
@ rhs
index for the right hand side entry
Definition: fvpressuremultiphysics.hh:246
@ matrix
index for the global matrix entry
Definition: fvpressuremultiphysics.hh:247
void update1pMaterialLawsInElement(const Element &elementI, CellData &cellData, bool postTimeStep)
updates secondary variables of one single phase cell
Definition: fvpressuremultiphysics.hh:919
void assemble(bool first)
function which assembles the system of equations to be solved
Definition: fvpressuremultiphysics.hh:265
void addOutputVtkFields(MultiWriter &writer)
Write data files.
Definition: fvpressuremultiphysics.hh:196
FVPressure2P2CMultiPhysics(Problem &problem)
Constructs a FVPressure2P2CPC object.
Definition: fvpressuremultiphysics.hh:220
void get1pStorage(EntryType &storageEntry, const Element &elementI, CellData &cellDataI)
Assembles the storage term for a 1p cell in a multiphysics framework.
Definition: fvpressuremultiphysics.hh:405
void updateMaterialLaws(bool postTimeStep=false)
constitutive functions are updated once if new concentrations are calculated and stored in the variab...
Definition: fvpressuremultiphysics.hh:793
void get1pSource(EntryType &sourceEntry, const Element &elementI, const CellData &cellDataI)
Assembles the source term.
Definition: fvpressuremultiphysics.hh:372
Dune::Timer timer_
A timer for the time spent on the multiphysics framework.
Definition: fvpressuremultiphysics.hh:235
void serializeEntity(std::ostream &outstream, const Element &element)
Function for serialization of the pressure field.
Definition: fvpressuremultiphysics.hh:158
void deserializeEntity(std::istream &instream, const Element &element)
Function for deserialization of the pressure field.
Definition: fvpressuremultiphysics.hh:174
static constexpr int pressureType
gives kind of pressure used ( , , )
Definition: fvpressuremultiphysics.hh:234
void initialize(bool solveTwice=false)
Definition: fvpressuremultiphysics.hh:137
typename SolutionTypes::ElementMapper ElementMapper
Definition: fvpressuremultiphysics.hh:226
void get1pFlux(EntryType &entries, const Intersection &intersection, const CellData &cellDataI)
The compositional single-phase flux in the multiphysics framework.
Definition: fvpressuremultiphysics.hh:528
The finite volume base class for the solution of a pressure equation.
Definition: sequential/cellcentered/pressure.hh:49
void initialize()
Initialize pressure model.
Definition: sequential/cellcentered/pressure.hh:213
void deserializeEntity(std::istream &instream, const Element &element)
Function for deserialization of the pressure field.
Definition: sequential/cellcentered/pressure.hh:264
void serializeEntity(std::ostream &outstream, const Element &element)
Function for serialization of the pressure field.
Definition: sequential/cellcentered/pressure.hh:251