From 96d4410fb1af4e8b962886dbf4226b9df5f03a11 Mon Sep 17 00:00:00 2001 From: Christoph Grueninger <christoph.grueninger@iws.uni-stuttgart.de> Date: Thu, 2 Jul 2015 06:58:49 +0000 Subject: [PATCH] [cleanup] Whitespace cleanup in dumux/decoupled. - remove trailing whitespace - replace tabs by spaces - remove pointless returns - remove superfluous semicolons - use an auto (reviewed by fetzer) git-svn-id: svn://svn.iws.uni-stuttgart.de/DUMUX/dumux/trunk@14999 2fb0f335-1f38-0410-981e-8018bf24f1b0 --- .../1p/diffusion/fv/fvpressurevelocity1p.hh | 4 +- .../decoupled/2p/diffusion/fv/fvpressure2p.hh | 9 +- .../2p/diffusion/fv/fvpressure2padaptive.hh | 50 +++--- .../2p/diffusion/fv/fvpressurevelocity2p.hh | 4 +- .../decoupled/2p/diffusion/fv/fvvelocity2p.hh | 2 +- .../fvmpfa/lmethod/fvmpfal2dpressure2p.hh | 6 +- .../lmethod/fvmpfal2dpressure2padaptive.hh | 4 +- .../fvmpfa/lmethod/fvmpfal2dvelocity2p.hh | 12 +- .../fvmpfa/omethod/fvmpfao2dpressure2p.hh | 2 +- .../2p/diffusion/mimetic/croperator2p.hh | 4 +- .../2p/diffusion/mimetic/mimetic2p.hh | 6 +- .../impes/gridadaptionindicator2plocalflux.hh | 2 +- .../2p/transport/fv/convectivepart.hh | 7 +- .../2p/transport/fv/diffusivepart.hh | 8 +- .../decoupled/2p/transport/fv/evalcflflux.hh | 3 +- .../2p/transport/fv/evalcflfluxcoats.hh | 154 +++++++++--------- .../2p/transport/fv/evalcflfluxdefault.hh | 2 +- .../2p/transport/fv/fvsaturation2p.hh | 12 +- dumux/decoupled/2p2c/2p2cfluidstate.hh | 4 +- dumux/decoupled/2p2c/2p2cproblem.hh | 5 +- dumux/decoupled/2p2c/2p2cproperties.hh | 2 +- dumux/decoupled/2p2c/fluxdata2p2c.hh | 2 +- .../2p2c/fv2dpressure2p2cadaptive.hh | 10 +- .../2p2c/fv2dtransport2p2cadaptive.hh | 8 +- .../2p2c/fv3dpressure2p2cadaptive.hh | 12 +- .../2p2c/fv3dtransport2p2cadaptive.hh | 10 +- .../2p2c/fvpressure2p2cmultiphysics.hh | 10 +- dumux/decoupled/2p2c/fvtransport2p2c.hh | 23 ++- .../2p2c/fvtransport2p2cmultiphysics.hh | 22 +-- dumux/decoupled/2p2c/pseudo1p2cfluidstate.hh | 6 +- .../2p2c/variableclass2p2cadaptive.hh | 51 +++--- dumux/decoupled/common/decoupledproperties.hh | 2 +- dumux/decoupled/common/fv/fvpressure.hh | 38 ++--- .../decoupled/common/fv/fvvelocitydefault.hh | 3 +- .../fv/mpfa/fvmpfavelocityintransport.hh | 3 +- .../fv/mpfa/mpfalinteractionvolume3d.hh | 4 +- .../mpfa/mpfalinteractionvolume3dadaptive.hh | 2 +- dumux/decoupled/common/gridadapt.hh | 12 +- .../gridadaptinitializationindicator.hh | 2 +- ...gridadaptinitializationindicatordefault.hh | 2 +- dumux/decoupled/common/impet.hh | 2 +- dumux/decoupled/common/impetproblem.hh | 10 +- dumux/decoupled/common/onemodelproblem.hh | 12 +- dumux/decoupled/common/variableclass.hh | 2 +- 44 files changed, 265 insertions(+), 285 deletions(-) diff --git a/dumux/decoupled/1p/diffusion/fv/fvpressurevelocity1p.hh b/dumux/decoupled/1p/diffusion/fv/fvpressurevelocity1p.hh index d1411fc0f9..d3b6afdd2e 100644 --- a/dumux/decoupled/1p/diffusion/fv/fvpressurevelocity1p.hh +++ b/dumux/decoupled/1p/diffusion/fv/fvpressurevelocity1p.hh @@ -89,8 +89,8 @@ public: template<class MultiWriter> void addOutputVtkFields(MultiWriter &writer) { - ParentType::addOutputVtkFields(writer); - velocity_.addOutputVtkFields(writer); + ParentType::addOutputVtkFields(writer); + velocity_.addOutputVtkFields(writer); } //! Constructs a FVPressure1P object diff --git a/dumux/decoupled/2p/diffusion/fv/fvpressure2p.hh b/dumux/decoupled/2p/diffusion/fv/fvpressure2p.hh index fef5b51e0f..4a69c039d6 100644 --- a/dumux/decoupled/2p/diffusion/fv/fvpressure2p.hh +++ b/dumux/decoupled/2p/diffusion/fv/fvpressure2p.hh @@ -91,7 +91,7 @@ namespace Dumux * In the IMPES models the default setting is: * * - formulation: \f$ p_w-S_w \f$ (Property: \a Formulation defined as \a DecoupledTwoPCommonIndices::pwsw) - * + * * - compressibility: disabled (Property: \a EnableCompressibility set to \a false) * * \tparam TypeTag The Type Tag @@ -285,8 +285,7 @@ public: /*! \brief Velocity update * - * Reset the velocities in the cellData - * + * Reset the velocities in the cellData */ void updateVelocity() { @@ -301,9 +300,7 @@ public: } } - /*! \brief Globally stores the pressure solution - * - */ + //! \brief Globally stores the pressure solution void storePressureSolution() { // iterate through leaf grid diff --git a/dumux/decoupled/2p/diffusion/fv/fvpressure2padaptive.hh b/dumux/decoupled/2p/diffusion/fv/fvpressure2padaptive.hh index db4aa45a3f..d411b77519 100644 --- a/dumux/decoupled/2p/diffusion/fv/fvpressure2padaptive.hh +++ b/dumux/decoupled/2p/diffusion/fv/fvpressure2padaptive.hh @@ -133,30 +133,30 @@ public: // update RHS vector, matrix if (problem_.gridAdapt().wasAdapted()) { - this->A_.setSize(gridSize, gridSize); // - this->f_.resize(gridSize); - this->pressure().resize(gridSize); - - - for (int i = 0; i < gridSize; i++) - { - CellData& cellData = problem_.variables().cellData(i); - - switch (pressureType_) - { - case pw: - this->pressure()[i] = cellData.pressure(wPhaseIdx); - break; - case pn: - this->pressure()[i] = cellData.pressure(nPhaseIdx); - break; - case pGlobal: - this->pressure()[i] = cellData.globalPressure(); - break; - } - } - - ParentType::initializeMatrix(); + this->A_.setSize(gridSize, gridSize); // + this->f_.resize(gridSize); + this->pressure().resize(gridSize); + + + for (int i = 0; i < gridSize; i++) + { + CellData& cellData = problem_.variables().cellData(i); + + switch (pressureType_) + { + case pw: + this->pressure()[i] = cellData.pressure(wPhaseIdx); + break; + case pn: + this->pressure()[i] = cellData.pressure(nPhaseIdx); + break; + case pGlobal: + this->pressure()[i] = cellData.globalPressure(); + break; + } + } + + ParentType::initializeMatrix(); } @@ -172,7 +172,7 @@ public: */ void calculateVelocity() { - velocity_.calculateVelocity(); + velocity_.calculateVelocity(); } /*! \brief Velocity update diff --git a/dumux/decoupled/2p/diffusion/fv/fvpressurevelocity2p.hh b/dumux/decoupled/2p/diffusion/fv/fvpressurevelocity2p.hh index 5da346f64d..110ad4be0f 100644 --- a/dumux/decoupled/2p/diffusion/fv/fvpressurevelocity2p.hh +++ b/dumux/decoupled/2p/diffusion/fv/fvpressurevelocity2p.hh @@ -78,8 +78,8 @@ public: template<class MultiWriter> void addOutputVtkFields(MultiWriter &writer) { - ParentType::addOutputVtkFields(writer); - velocity_.addOutputVtkFields(writer); + ParentType::addOutputVtkFields(writer); + velocity_.addOutputVtkFields(writer); } //! Constructs a FVPressure2P object diff --git a/dumux/decoupled/2p/diffusion/fv/fvvelocity2p.hh b/dumux/decoupled/2p/diffusion/fv/fvvelocity2p.hh index 95caa1c972..1bd508bd85 100644 --- a/dumux/decoupled/2p/diffusion/fv/fvvelocity2p.hh +++ b/dumux/decoupled/2p/diffusion/fv/fvvelocity2p.hh @@ -293,7 +293,7 @@ public: //switch velocities if (velocityType_ == vt) { - writer.attachCellData(velocity, "total velocity", dim); + writer.attachCellData(velocity, "total velocity", dim); } else { diff --git a/dumux/decoupled/2p/diffusion/fvmpfa/lmethod/fvmpfal2dpressure2p.hh b/dumux/decoupled/2p/diffusion/fvmpfa/lmethod/fvmpfal2dpressure2p.hh index d6d552ebca..4b5390835a 100644 --- a/dumux/decoupled/2p/diffusion/fvmpfa/lmethod/fvmpfal2dpressure2p.hh +++ b/dumux/decoupled/2p/diffusion/fvmpfa/lmethod/fvmpfal2dpressure2p.hh @@ -843,7 +843,7 @@ void FvMpfaL2dPressure2p<TypeTag>::storeInteractionVolumeInfo() // *((*eIt).template subEntity < dim > (localVertIdx12corner))); #if DUNE_VERSION_NEWER(DUNE_COMMON, 2, 4) int globalVertIdx12corner = problem_.variables().vertexMapper().subIndex(*eIt, localVertIdx12corner, dim); -#else +#else int globalVertIdx12corner = problem_.variables().vertexMapper().map(*eIt, localVertIdx12corner, dim); #endif // std::cout<<"globalVertIdx12corner = "<<globalVertIdx12corner<<"\n"; @@ -1934,7 +1934,7 @@ void FvMpfaL2dPressure2p<TypeTag>::assemble() { if (eIt->partitionType() == Dune::InteriorEntity) continue; - + // get the global index of the cell int eIdxGlobalI = problem_.variables().index(*eIt); @@ -1943,7 +1943,7 @@ void FvMpfaL2dPressure2p<TypeTag>::assemble() this->f_[eIdxGlobalI] = this->pressure()[eIdxGlobalI]; } } - + return; } diff --git a/dumux/decoupled/2p/diffusion/fvmpfa/lmethod/fvmpfal2dpressure2padaptive.hh b/dumux/decoupled/2p/diffusion/fvmpfa/lmethod/fvmpfal2dpressure2padaptive.hh index a8c406a456..418c35d95b 100644 --- a/dumux/decoupled/2p/diffusion/fvmpfa/lmethod/fvmpfal2dpressure2padaptive.hh +++ b/dumux/decoupled/2p/diffusion/fvmpfa/lmethod/fvmpfal2dpressure2padaptive.hh @@ -464,7 +464,7 @@ public: { DUNE_THROW(Dune::NotImplemented, "Compressibility not supported!"); } - #endif + #endif if (dim != 2) { DUNE_THROW(Dune::NotImplemented, "Dimension not supported!"); @@ -2620,7 +2620,7 @@ void FvMpfaL2dPressure2pAdaptive<TypeTag>::assemble() { if (eIt->partitionType() == Dune::InteriorEntity) continue; - + // get the global index of the cell int eIdxGlobalI = problem_.variables().index(*eIt); diff --git a/dumux/decoupled/2p/diffusion/fvmpfa/lmethod/fvmpfal2dvelocity2p.hh b/dumux/decoupled/2p/diffusion/fvmpfa/lmethod/fvmpfal2dvelocity2p.hh index 738935664a..348ea5a2fc 100644 --- a/dumux/decoupled/2p/diffusion/fvmpfa/lmethod/fvmpfal2dvelocity2p.hh +++ b/dumux/decoupled/2p/diffusion/fvmpfa/lmethod/fvmpfal2dvelocity2p.hh @@ -141,8 +141,8 @@ public: } //calculate velocities for flux faces of an interaction volume - void calculateInnerInteractionVolumeVelocity(InteractionVolume& interactionVolume, - CellData& cellData1, CellData& cellData2, CellData& cellData3, CellData& cellData4, + void calculateInnerInteractionVolumeVelocity(InteractionVolume& interactionVolume, + CellData& cellData1, CellData& cellData2, CellData& cellData3, CellData& cellData4, InnerBoundaryVolumeFaces& innerBoundaryVolumeFaces); void calculateBoundaryInteractionVolumeVelocity(InteractionVolume& interactionVolume, CellData& cellData, int elemIdx); @@ -180,10 +180,10 @@ public: { if (vtkOutputLevel_ > 0) { - Dune::BlockVector < DimVector > &velocityWetting - = *(writer.template allocateManagedBuffer<Scalar,dim>(problem_.gridView().size(0))); - Dune::BlockVector < DimVector > &velocityNonwetting - = *(writer.template allocateManagedBuffer<Scalar,dim>(problem_.gridView().size(0))); + Dune::BlockVector < DimVector > &velocityWetting + = *(writer.template allocateManagedBuffer<Scalar,dim>(problem_.gridView().size(0))); + Dune::BlockVector < DimVector > &velocityNonwetting + = *(writer.template allocateManagedBuffer<Scalar,dim>(problem_.gridView().size(0))); // compute update vector ElementIterator eEndIt = problem_.gridView().template end<0>(); diff --git a/dumux/decoupled/2p/diffusion/fvmpfa/omethod/fvmpfao2dpressure2p.hh b/dumux/decoupled/2p/diffusion/fvmpfa/omethod/fvmpfao2dpressure2p.hh index 31c3892408..c899dcb671 100644 --- a/dumux/decoupled/2p/diffusion/fvmpfa/omethod/fvmpfao2dpressure2p.hh +++ b/dumux/decoupled/2p/diffusion/fvmpfa/omethod/fvmpfao2dpressure2p.hh @@ -2006,7 +2006,7 @@ void FvMpfaO2dPressure2p<TypeTag>::assemble() { if (eIt->partitionType() == Dune::InteriorEntity) continue; - + // get the global index of the cell int eIdxGlobalI = problem_.variables().index(*eIt); diff --git a/dumux/decoupled/2p/diffusion/mimetic/croperator2p.hh b/dumux/decoupled/2p/diffusion/mimetic/croperator2p.hh index 53ea122115..13930e7489 100644 --- a/dumux/decoupled/2p/diffusion/mimetic/croperator2p.hh +++ b/dumux/decoupled/2p/diffusion/mimetic/croperator2p.hh @@ -157,7 +157,7 @@ public: // std::cout << "increment row " << index << std::endl; } A_.incrementrowsize(index, numFaces - 1); - // std::cout << "increment row " << index + // std::cout << "increment row " << index // << " by " << numFaces - 1 << std::endl; } } @@ -329,7 +329,7 @@ public: int alpha = faceMapper_.subIndex(*eIt, k, 1); #else int alpha = faceMapper_.map(*eIt, k, 1); -#endif +#endif local2Global[k] = alpha; } loc.completeRHS(*eIt, local2Global, f); diff --git a/dumux/decoupled/2p/diffusion/mimetic/mimetic2p.hh b/dumux/decoupled/2p/diffusion/mimetic/mimetic2p.hh index 352bf4f11a..80cffd3985 100644 --- a/dumux/decoupled/2p/diffusion/mimetic/mimetic2p.hh +++ b/dumux/decoupled/2p/diffusion/mimetic/mimetic2p.hh @@ -312,9 +312,9 @@ public: vel += W_[eIdxGlobal][fIdx][j]*faceVol[j]*(press - pressTrace[j]); } - void computeReconstructionMatrices(const Element& element, - const Dune::FieldMatrix<Scalar, 2 * dim, 2 * dim>& W, - Dune::FieldVector<Scalar, 2 * dim>& F, Scalar& dInv) + void computeReconstructionMatrices(const Element& element, + const Dune::FieldMatrix<Scalar, 2 * dim, 2 * dim>& W, + Dune::FieldVector<Scalar, 2 * dim>& F, Scalar& dInv) { Dune::FieldVector<Scalar, 2 * dim> c(0); Dune::FieldMatrix<Scalar, 2 * dim, 2 * dim> Pi(0); diff --git a/dumux/decoupled/2p/impes/gridadaptionindicator2plocalflux.hh b/dumux/decoupled/2p/impes/gridadaptionindicator2plocalflux.hh index f51fed4524..eba02a1947 100644 --- a/dumux/decoupled/2p/impes/gridadaptionindicator2plocalflux.hh +++ b/dumux/decoupled/2p/impes/gridadaptionindicator2plocalflux.hh @@ -597,7 +597,7 @@ public: indicatorVectorSat_.resize(size, -1e100); if (useFluxInd_) indicatorVectorFlux_.resize(size, -1e100); - }; + } /*! \brief Function for changing the indicatorVector values for refinement * diff --git a/dumux/decoupled/2p/transport/fv/convectivepart.hh b/dumux/decoupled/2p/transport/fv/convectivepart.hh index 9892dc0e9f..af612848ef 100644 --- a/dumux/decoupled/2p/transport/fv/convectivepart.hh +++ b/dumux/decoupled/2p/transport/fv/convectivepart.hh @@ -48,7 +48,8 @@ private: public: //! For initialization - void initialize(){}; + void initialize() + {} /*! \brief Returns convective term for current element face * \param intersection Intersection of two grid elements/global boundary @@ -70,8 +71,8 @@ public: void getFlux(DimVector& flux, const Intersection& intersection, const Scalar satI, const Scalar satJ) const {} - //! Constructs a ConvectivePart object - /* + /*! Constructs a ConvectivePart object + * * \param problem A problem class object */ ConvectivePart(Problem& problem) diff --git a/dumux/decoupled/2p/transport/fv/diffusivepart.hh b/dumux/decoupled/2p/transport/fv/diffusivepart.hh index fb16789226..4b63cf4528 100644 --- a/dumux/decoupled/2p/transport/fv/diffusivepart.hh +++ b/dumux/decoupled/2p/transport/fv/diffusivepart.hh @@ -47,7 +47,8 @@ private: public: //! For initialization - void initialize(){}; + void initialize() + {} /*! \brief Returns diffusive term for current element face * @@ -87,9 +88,8 @@ public: Scalar satI, Scalar satJ) const {} - - //! Constructs a DiffusivePart object - /* + /*! Constructs a DiffusivePart object + * * \param A problem class object */ DiffusivePart(Problem& problem) diff --git a/dumux/decoupled/2p/transport/fv/evalcflflux.hh b/dumux/decoupled/2p/transport/fv/evalcflflux.hh index 0bd22c6364..bd5ef82d5a 100644 --- a/dumux/decoupled/2p/transport/fv/evalcflflux.hh +++ b/dumux/decoupled/2p/transport/fv/evalcflflux.hh @@ -59,7 +59,8 @@ private: public: //! For initialization - void initialize(){}; + void initialize() + {} /*! \brief adds a flux to the cfl-criterion evaluation * diff --git a/dumux/decoupled/2p/transport/fv/evalcflfluxcoats.hh b/dumux/decoupled/2p/transport/fv/evalcflfluxcoats.hh index cf0e3733b2..5aa2f5213e 100644 --- a/dumux/decoupled/2p/transport/fv/evalcflfluxcoats.hh +++ b/dumux/decoupled/2p/transport/fv/evalcflfluxcoats.hh @@ -25,7 +25,7 @@ */ #include <dune/common/float_cmp.hh> -#include <dumux/decoupled/common/impetproperties.hh> +#include <dumux/decoupled/common/impetproperties.hh> #include "evalcflflux.hh" namespace Dumux @@ -127,10 +127,10 @@ public: */ Scalar getCflFluxFunction(const Element& element) { - Scalar cflFluxDefault = getCflFluxFunctionDefault(); + Scalar cflFluxDefault = getCflFluxFunctionDefault(); if (rejectForTimeStepping_) - return 0.99 / cflFluxDefault; + return 0.99 / cflFluxDefault; if (std::isnan(cflFluxFunctionCoatsOut_) || std::isinf(cflFluxFunctionCoatsOut_)){cflFluxFunctionCoatsOut_ = 0.0;} if (std::isnan(cflFluxFunctionCoatsIn_) || std::isinf(cflFluxFunctionCoatsIn_)){cflFluxFunctionCoatsIn_ = 0.0;} @@ -143,7 +143,7 @@ public: } else if (cflFluxDefault > cflFluxFunctionCoats) { - return 0.99 / cflFluxDefault; + return 0.99 / cflFluxDefault; } else { @@ -478,7 +478,7 @@ void EvalCflFluxCoats<TypeTag>::addCoatsFlux(Scalar& lambdaW, Scalar& lambdaNw, } else { - cflFluxFunctionCoatsIn_ += cflFlux; + cflFluxFunctionCoatsIn_ += cflFlux; } } else @@ -502,11 +502,11 @@ void EvalCflFluxCoats<TypeTag>::addCoatsFlux(Scalar& lambdaW, Scalar& lambdaNw, Dune::FieldVector<Scalar, dim> permeability(0); DimMatrix perm(0); problem_.spatialParams().meanK(perm, problem_.spatialParams().intrinsicPermeability(*element)); - perm.mv(unitOuterNormal, permeability); - - Scalar faceArea = intersection.geometry().volume(); + perm.mv(unitOuterNormal, permeability); - Scalar transmissibility = (unitOuterNormal * permeability) * faceArea / dist; + Scalar faceArea = intersection.geometry().volume(); + + Scalar transmissibility = (unitOuterNormal * permeability) * faceArea / dist; Scalar satWBound = cellDataI.saturation(wPhaseIdx); if (bcType.isDirichlet(eqIdxSat)) @@ -515,90 +515,88 @@ void EvalCflFluxCoats<TypeTag>::addCoatsFlux(Scalar& lambdaW, Scalar& lambdaNw, problem_.dirichlet(bcValues, intersection); switch (saturationType_) { - case sw: + case sw: { satWBound = bcValues[eqIdxSat]; break; } - case sn: + case sn: { satWBound = 1 - bcValues[eqIdxSat]; break; } - default: + default: { DUNE_THROW(Dune::RangeError, "saturation type not implemented"); - break; } } } - + Scalar potWBound = cellDataI.potential(wPhaseIdx); - Scalar potNwBound = cellDataI.potential(nPhaseIdx); - Scalar gdeltaZ = (problem_.bBoxMax()-globalPosFace) * problem_.gravity(); - if (bcType.isDirichlet(eqIdxPress)) - { - PrimaryVariables bcValues; - problem_.dirichlet(bcValues, intersection); - switch (pressureType_) - { - case pw: - { - potWBound = bcValues[eqIdxPress] + density_[wPhaseIdx] * gdeltaZ; - potNwBound = bcValues[eqIdxPress] + MaterialLaw::pc(problem_.spatialParams().materialLawParams(*element), satWBound) - + density_[nPhaseIdx] * gdeltaZ; - break; - } - case pn: - { - potWBound = bcValues[eqIdxPress] - MaterialLaw::pc(problem_.spatialParams().materialLawParams(*element),satWBound) - + density_[wPhaseIdx] * gdeltaZ; - potNwBound = bcValues[eqIdxPress] + density_[nPhaseIdx] * gdeltaZ; - break; - } - default: - { - DUNE_THROW(Dune::RangeError, "pressure type not implemented"); - break; - } - } - } - else if (bcType.isNeumann(eqIdxPress) && bcType.isDirichlet(eqIdxSat)) - { - PrimaryVariables bcValues; - problem_.neumann(bcValues, intersection); - - bcValues[wPhaseIdx] /= density_[wPhaseIdx]; - bcValues[nPhaseIdx] /= density_[nPhaseIdx]; - - bcValues[wPhaseIdx] *= faceArea; - bcValues[nPhaseIdx] *= faceArea; - - bool hasPotWBound = false; - if (Dune::FloatCmp::ne<Scalar, Dune::FloatCmp::absolute>(lambdaW, 0.0, 1.0e-30) && Dune::FloatCmp::ne<Scalar, Dune::FloatCmp::absolute>(bcValues[wPhaseIdx], 0.0, 1.0e-30)) - { - potWBound -= bcValues[wPhaseIdx] / (transmissibility * lambdaW); - hasPotWBound = true; - } - bool hasPotNwBound = false; - if (Dune::FloatCmp::ne<Scalar, Dune::FloatCmp::absolute>(lambdaNw, 0.0, 1.0e-30) && Dune::FloatCmp::ne<Scalar, Dune::FloatCmp::absolute>(bcValues[nPhaseIdx], 0.0, 1.0e-30)) - { - potNwBound -= bcValues[nPhaseIdx] / (transmissibility * lambdaNw); - hasPotNwBound = true; - } - - if (hasPotWBound && !hasPotNwBound) - { - potNwBound = potWBound + MaterialLaw::pc(problem_.spatialParams().materialLawParams(*element),satWBound) - + (density_[nPhaseIdx] - density_[wPhaseIdx]) * gdeltaZ; - } - else if (!hasPotWBound && hasPotNwBound) - { + Scalar potNwBound = cellDataI.potential(nPhaseIdx); + Scalar gdeltaZ = (problem_.bBoxMax()-globalPosFace) * problem_.gravity(); + if (bcType.isDirichlet(eqIdxPress)) + { + PrimaryVariables bcValues; + problem_.dirichlet(bcValues, intersection); + switch (pressureType_) + { + case pw: + { + potWBound = bcValues[eqIdxPress] + density_[wPhaseIdx] * gdeltaZ; + potNwBound = bcValues[eqIdxPress] + MaterialLaw::pc(problem_.spatialParams().materialLawParams(*element), satWBound) + + density_[nPhaseIdx] * gdeltaZ; + break; + } + case pn: + { + potWBound = bcValues[eqIdxPress] - MaterialLaw::pc(problem_.spatialParams().materialLawParams(*element),satWBound) + + density_[wPhaseIdx] * gdeltaZ; + potNwBound = bcValues[eqIdxPress] + density_[nPhaseIdx] * gdeltaZ; + break; + } + default: + { + DUNE_THROW(Dune::RangeError, "pressure type not implemented"); + } + } + } + else if (bcType.isNeumann(eqIdxPress) && bcType.isDirichlet(eqIdxSat)) + { + PrimaryVariables bcValues; + problem_.neumann(bcValues, intersection); + + bcValues[wPhaseIdx] /= density_[wPhaseIdx]; + bcValues[nPhaseIdx] /= density_[nPhaseIdx]; + + bcValues[wPhaseIdx] *= faceArea; + bcValues[nPhaseIdx] *= faceArea; + + bool hasPotWBound = false; + if (Dune::FloatCmp::ne<Scalar, Dune::FloatCmp::absolute>(lambdaW, 0.0, 1.0e-30) && Dune::FloatCmp::ne<Scalar, Dune::FloatCmp::absolute>(bcValues[wPhaseIdx], 0.0, 1.0e-30)) + { + potWBound -= bcValues[wPhaseIdx] / (transmissibility * lambdaW); + hasPotWBound = true; + } + bool hasPotNwBound = false; + if (Dune::FloatCmp::ne<Scalar, Dune::FloatCmp::absolute>(lambdaNw, 0.0, 1.0e-30) && Dune::FloatCmp::ne<Scalar, Dune::FloatCmp::absolute>(bcValues[nPhaseIdx], 0.0, 1.0e-30)) + { + potNwBound -= bcValues[nPhaseIdx] / (transmissibility * lambdaNw); + hasPotNwBound = true; + } + + if (hasPotWBound && !hasPotNwBound) + { + potNwBound = potWBound + MaterialLaw::pc(problem_.spatialParams().materialLawParams(*element),satWBound) + + (density_[nPhaseIdx] - density_[wPhaseIdx]) * gdeltaZ; + } + else if (!hasPotWBound && hasPotNwBound) + { potWBound = potNwBound - MaterialLaw::pc(problem_.spatialParams().materialLawParams(*element),satWBound) - + (density_[nPhaseIdx] - density_[wPhaseIdx]) * gdeltaZ; - } - } + + (density_[nPhaseIdx] - density_[wPhaseIdx]) * gdeltaZ; + } + } else if (bcType.isNeumann(eqIdxPress)) { PrimaryVariables bcValues; @@ -720,7 +718,7 @@ void EvalCflFluxCoats<TypeTag>::addCoatsFlux(Scalar& lambdaW, Scalar& lambdaNw, } else { - cflFluxFunctionCoatsIn_ += cflFlux; + cflFluxFunctionCoatsIn_ += cflFlux; } } } diff --git a/dumux/decoupled/2p/transport/fv/evalcflfluxdefault.hh b/dumux/decoupled/2p/transport/fv/evalcflfluxdefault.hh index 33746f4e77..62d11d8301 100644 --- a/dumux/decoupled/2p/transport/fv/evalcflfluxdefault.hh +++ b/dumux/decoupled/2p/transport/fv/evalcflfluxdefault.hh @@ -24,7 +24,7 @@ * @brief Fluxes to evaluate a CFL-Condition */ -#include <dumux/decoupled/common/impetproperties.hh> +#include <dumux/decoupled/common/impetproperties.hh> #include "evalcflflux.hh" namespace Dumux diff --git a/dumux/decoupled/2p/transport/fv/fvsaturation2p.hh b/dumux/decoupled/2p/transport/fv/fvsaturation2p.hh index 1efca5fc54..bbd204dcf2 100644 --- a/dumux/decoupled/2p/transport/fv/fvsaturation2p.hh +++ b/dumux/decoupled/2p/transport/fv/fvsaturation2p.hh @@ -64,7 +64,7 @@ namespace Dumux * In the IMPES models the default setting is: * * formulation: \f$ p_w \f$ - \f$ S_w \f$ (Property: \a Formulation defined as \a DecoupledTwoPCommonIndices::pwsw) - * + * * compressibility: disabled (Property: \a EnableCompressibility set to \a false) * * \tparam TypeTag The Type Tag @@ -251,7 +251,7 @@ public: template<class DataEntry> bool inPhysicalRange(DataEntry& entry) { - return (entry > -1e-6 && entry < 1.0 + 1e-6); + return (entry > -1e-6 && entry < 1.0 + 1e-6); } /*! \brief Updates the primary transport variable. @@ -260,10 +260,10 @@ public: */ void updateTransportedQuantity(TransportSolutionType& updateVec) { - if (this->enableLocalTimeStepping()) - this->innerUpdate(updateVec); - else - updateSaturationSolution(updateVec); + if (this->enableLocalTimeStepping()) + this->innerUpdate(updateVec); + else + updateSaturationSolution(updateVec); } /*! \brief Updates the primary transport variable. diff --git a/dumux/decoupled/2p2c/2p2cfluidstate.hh b/dumux/decoupled/2p2c/2p2cfluidstate.hh index 959a0c1052..d1bc72d5a8 100644 --- a/dumux/decoupled/2p2c/2p2cfluidstate.hh +++ b/dumux/decoupled/2p2c/2p2cfluidstate.hh @@ -76,7 +76,7 @@ public: return sw_; else return Scalar(1.0) - sw_; - }; + } /*! * \brief Returns the mass fraction of a component in a phase. @@ -156,7 +156,7 @@ public: * and the rock matrix exhibit the same temperature. */ Scalar temperature(int phaseIdx = 0) const - { return temperature_; }; + { return temperature_; } /*! * \brief Return the average molar mass of a phase. diff --git a/dumux/decoupled/2p2c/2p2cproblem.hh b/dumux/decoupled/2p2c/2p2cproblem.hh index 9e77d83ee1..966b1d5d04 100644 --- a/dumux/decoupled/2p2c/2p2cproblem.hh +++ b/dumux/decoupled/2p2c/2p2cproblem.hh @@ -127,7 +127,7 @@ public: { ParentType::postTimeStep(); asImp_().pressureModel().updateMaterialLaws(true); - }; + } /*! * \name Problem parameters */ @@ -171,10 +171,8 @@ public: { DUNE_THROW(Dune::NotImplemented, "please specify initial Concentration in the problem" " using an initConcentrationAtPos() method!"); - return NAN; } // \} - // \} private: //! Returns the implementation of the problem (i.e. static polymorphism) @@ -187,7 +185,6 @@ private: protected: //! Sets entries of the primary variable vector to zero - // void setZero(typename GET_PROP_TYPE(TypeTag, PrimaryVariables) &values, const int equation = -1) const { if (equation == Indices::pressureEqIdx) diff --git a/dumux/decoupled/2p2c/2p2cproperties.hh b/dumux/decoupled/2p2c/2p2cproperties.hh index 309138a7b7..f4f52d27b8 100644 --- a/dumux/decoupled/2p2c/2p2cproperties.hh +++ b/dumux/decoupled/2p2c/2p2cproperties.hh @@ -158,7 +158,7 @@ SET_TYPE_PROP(DecoupledTwoPTwoC, CellData, CellData2P2C<TypeTag>); SET_TYPE_PROP(DecoupledTwoPTwoC, FluidState, TwoPTwoCFluidState<TypeTag>); -//! The spatial parameters to be employed. +//! The spatial parameters to be employed. SET_TYPE_PROP(DecoupledTwoPTwoC, SpatialParams, FVSpatialParams<TypeTag>); //! Switch off permeability regularization at Dirichlet boundaries by default. SET_BOOL_PROP(DecoupledTwoPTwoC, RegulateBoundaryPermeability, false); diff --git a/dumux/decoupled/2p2c/fluxdata2p2c.hh b/dumux/decoupled/2p2c/fluxdata2p2c.hh index a0c1fc29b9..851d9c548b 100644 --- a/dumux/decoupled/2p2c/fluxdata2p2c.hh +++ b/dumux/decoupled/2p2c/fluxdata2p2c.hh @@ -59,7 +59,7 @@ private: enum { - wPhaseIdx = Indices::wPhaseIdx, + wPhaseIdx = Indices::wPhaseIdx, nPhaseIdx = Indices::nPhaseIdx }; diff --git a/dumux/decoupled/2p2c/fv2dpressure2p2cadaptive.hh b/dumux/decoupled/2p2c/fv2dpressure2p2cadaptive.hh index 68e98facd4..f4c1e33fad 100644 --- a/dumux/decoupled/2p2c/fv2dpressure2p2cadaptive.hh +++ b/dumux/decoupled/2p2c/fv2dpressure2p2cadaptive.hh @@ -405,9 +405,9 @@ void FV2dPressure2P2CAdaptive<TypeTag>::assemble(bool first) //take a hanging node never from the element with smaller level! bool haveSameLevel = (eIt->level() == elementNeighbor->level()); // calculate only from one side, but add matrix entries for both sides - // the last condition is needed to properly assemble in the presence + // the last condition is needed to properly assemble in the presence // of ghost elements - if (GET_PROP_VALUE(TypeTag, VisitFacesOnlyOnce) + if (GET_PROP_VALUE(TypeTag, VisitFacesOnlyOnce) && (globalIdxI > globalIdxJ) && haveSameLevel && elementNeighbor->partitionType() == Dune::InteriorEntity) continue; @@ -432,7 +432,7 @@ void FV2dPressure2P2CAdaptive<TypeTag>::assemble(bool first) this->A_[globalIdxI][globalIdxJ] -= entries[matrix]; // The second condition is needed to not spoil the ghost element entries - if (GET_PROP_VALUE(TypeTag, VisitFacesOnlyOnce) + if (GET_PROP_VALUE(TypeTag, VisitFacesOnlyOnce) && elementNeighbor->partitionType() == Dune::InteriorEntity) { this->f_[globalIdxJ] += entries[rhs]; @@ -465,7 +465,7 @@ void FV2dPressure2P2CAdaptive<TypeTag>::assemble(bool first) this->A_[globalIdxI][globalIdxI] += entries[matrix]; } // assemble overlap and ghost element contributions - else + else { this->A_[globalIdxI] = 0.0; this->A_[globalIdxI][globalIdxI] = 1.0; @@ -593,7 +593,7 @@ void FV2dPressure2P2CAdaptive<TypeTag>::getMpfaFlux(const IntersectionIterator& int halfedgesStored = problem().variables().getMpfaData(*intersectionIterator, additionalIsIt, T, additionalT, globalPos3, globalIdx3 ); - if (halfedgesStored == 0) + if (halfedgesStored == 0) halfedgesStored = problem().pressureModel().computeTransmissibilities(intersectionIterator, additionalIsIt, T, additionalT, globalPos3, globalIdx3 ); diff --git a/dumux/decoupled/2p2c/fv2dtransport2p2cadaptive.hh b/dumux/decoupled/2p2c/fv2dtransport2p2cadaptive.hh index 2b6bb69961..1247f407b9 100644 --- a/dumux/decoupled/2p2c/fv2dtransport2p2cadaptive.hh +++ b/dumux/decoupled/2p2c/fv2dtransport2p2cadaptive.hh @@ -94,7 +94,7 @@ class FV2dTransport2P2CAdaptive : public FVTransport2P2C<TypeTag> //! Acess function for the current problem Problem& problem() - {return problem_;}; + { return problem_; } typedef typename FVTransport2P2C<TypeTag>::LocalTimesteppingData LocalTimesteppingData; @@ -301,7 +301,7 @@ void FV2dTransport2P2CAdaptive<TypeTag>::update(const Scalar t, Scalar& dt, Tran } } // end grid traversal -#if HAVE_MPI +#if HAVE_MPI // communicate updated values typedef typename GET_PROP(TypeTag, SolutionTypes) SolutionTypes; typedef typename SolutionTypes::ElementMapper ElementMapper; @@ -309,8 +309,8 @@ void FV2dTransport2P2CAdaptive<TypeTag>::update(const Scalar t, Scalar& dt, Tran for (int i = 0; i < updateVec.size(); i++) { DataHandle dataHandle(problem_.variables().elementMapper(), updateVec[i]); - problem_.gridView().template communicate<DataHandle>(dataHandle, - Dune::InteriorBorder_All_Interface, + problem_.gridView().template communicate<DataHandle>(dataHandle, + Dune::InteriorBorder_All_Interface, Dune::ForwardCommunication); } dt = problem_.gridView().comm().min(dt); diff --git a/dumux/decoupled/2p2c/fv3dpressure2p2cadaptive.hh b/dumux/decoupled/2p2c/fv3dpressure2p2cadaptive.hh index 6158360a5e..93d19eaa67 100644 --- a/dumux/decoupled/2p2c/fv3dpressure2p2cadaptive.hh +++ b/dumux/decoupled/2p2c/fv3dpressure2p2cadaptive.hh @@ -195,7 +195,7 @@ public: interactionVolumesContainer_->update(); } ParentType::initialize(solveTwice); - }; + } //function which assembles the system of equations to be solved void assemble(bool first); @@ -701,9 +701,9 @@ void FV3dPressure2P2CAdaptive<TypeTag>::assemble(bool first) //take a hanging node never from the element with smaller level! bool haveSameLevel = (eIt->level() == elementNeighbor->level()); // calculate only from one side, but add matrix entries for both sides - // the last condition is needed to properly assemble in the presence + // the last condition is needed to properly assemble in the presence // of ghost elements - if (GET_PROP_VALUE(TypeTag, VisitFacesOnlyOnce) + if (GET_PROP_VALUE(TypeTag, VisitFacesOnlyOnce) && (eIdxGlobalI > eIdxGlobalJ) && haveSameLevel && elementNeighbor->partitionType() == Dune::InteriorEntity) continue; @@ -738,7 +738,7 @@ void FV3dPressure2P2CAdaptive<TypeTag>::assemble(bool first) this->A_[eIdxGlobalI][eIdxGlobalJ] -= entries[matrix]; // The second condition is needed to not spoil the ghost element entries - if (GET_PROP_VALUE(TypeTag, VisitFacesOnlyOnce) + if (GET_PROP_VALUE(TypeTag, VisitFacesOnlyOnce) && elementNeighbor->partitionType() == Dune::InteriorEntity) { this->f_[eIdxGlobalJ] += entries[rhs]; @@ -949,7 +949,7 @@ void FV3dPressure2P2CAdaptive<TypeTag>::getMpfaFlux(const IntersectionIterator& } } } - + // initialize convenience shortcuts PhaseVector lambda(0.), dV(0.), gV(0.); @@ -1654,7 +1654,7 @@ int FV3dPressure2P2CAdaptive<TypeTag>::computeTransmissibilities(const Intersect /** 4) Store and/or calculate additional half edges *******/ if(maxInteractionVolumes ==1) { - T *= isIt->geometry().volume()/subFaceArea12 ; + T *= isIt->geometry().volume()/subFaceArea12 ; // set your map entry problem().variables().storeMpfaData3D(*isIt, T, globalPos4, eIdxGlobal4, globalPos6, eIdxGlobal6); diff --git a/dumux/decoupled/2p2c/fv3dtransport2p2cadaptive.hh b/dumux/decoupled/2p2c/fv3dtransport2p2cadaptive.hh index a9645ef941..4e0f2d828e 100644 --- a/dumux/decoupled/2p2c/fv3dtransport2p2cadaptive.hh +++ b/dumux/decoupled/2p2c/fv3dtransport2p2cadaptive.hh @@ -103,7 +103,7 @@ class FV3dTransport2P2CAdaptive : public FVTransport2P2C<TypeTag> //! Acess function for the current problem Problem& problem() - {return problem_;}; + { return problem_; } public: virtual void update(const Scalar t, Scalar& dt, TransportSolutionType& updateVec, @@ -296,8 +296,8 @@ void FV3dTransport2P2CAdaptive<TypeTag>::update(const Scalar t, Scalar& dt, } } } // end grid traversal - -#if HAVE_MPI + +#if HAVE_MPI // communicate updated values typedef typename GET_PROP(TypeTag, SolutionTypes) SolutionTypes; typedef typename SolutionTypes::ElementMapper ElementMapper; @@ -305,8 +305,8 @@ void FV3dTransport2P2CAdaptive<TypeTag>::update(const Scalar t, Scalar& dt, for (int i = 0; i < updateVec.size(); i++) { DataHandle dataHandle(problem().variables().elementMapper(), updateVec[i]); - problem_.gridView().template communicate<DataHandle>(dataHandle, - Dune::InteriorBorder_All_Interface, + problem_.gridView().template communicate<DataHandle>(dataHandle, + Dune::InteriorBorder_All_Interface, Dune::ForwardCommunication); } dt = problem().gridView().comm().min(dt); diff --git a/dumux/decoupled/2p2c/fvpressure2p2cmultiphysics.hh b/dumux/decoupled/2p2c/fvpressure2p2cmultiphysics.hh index 4b7685fb70..c2a95ec80c 100644 --- a/dumux/decoupled/2p2c/fvpressure2p2cmultiphysics.hh +++ b/dumux/decoupled/2p2c/fvpressure2p2cmultiphysics.hh @@ -339,7 +339,7 @@ void FVPressure2P2CMultiPhysics<TypeTag>::assemble(bool first) this->A_[eIdxGlobalI][eIdxGlobalI] += entries[matrix]; } // assemble overlap and ghost element contributions - else + else { this->A_[eIdxGlobalI] = 0.0; this->A_[eIdxGlobalI][eIdxGlobalI] = 1.0; @@ -808,7 +808,7 @@ void FVPressure2P2CMultiPhysics<TypeTag>::updateMaterialLaws(bool postTimeStep) problem().source(source, *eIt); if ((cellData.saturation(wPhaseIdx) > 0.0 && cellData.saturation(wPhaseIdx) < 1.0) - || Dune::FloatCmp::ne<Scalar, Dune::FloatCmp::absolute>(source.one_norm(), 0.0, 1.0e-30)) // cell still 2p + || Dune::FloatCmp::ne<Scalar, Dune::FloatCmp::absolute>(source.one_norm(), 0.0, 1.0e-30)) // cell still 2p { // mark this element nextSubdomain[eIdxGlobal] = 2; @@ -873,7 +873,7 @@ void FVPressure2P2CMultiPhysics<TypeTag>::updateMaterialLaws(bool postTimeStep) else if(oldSubdomainI != 2 && nextSubdomain[eIdxGlobal] != 2) // will be simple and was simple { - // perform simple update + // perform simple update this->update1pMaterialLawsInElement(*eIt, cellData, postTimeStep); } //else @@ -886,9 +886,9 @@ void FVPressure2P2CMultiPhysics<TypeTag>::updateMaterialLaws(bool postTimeStep) this->maxError_ = maxError/problem().timeManager().timeStepSize(); timer_.stop(); - + if(problem().timeManager().willBeFinished() or problem().timeManager().episodeWillBeOver()) - Dune::dinfo << "Subdomain routines took " << timer_.elapsed() << " seconds" << std::endl; + Dune::dinfo << "Subdomain routines took " << timer_.elapsed() << " seconds" << std::endl; return; } diff --git a/dumux/decoupled/2p2c/fvtransport2p2c.hh b/dumux/decoupled/2p2c/fvtransport2p2c.hh index 24b8e1b3e7..dc1e8fc74a 100644 --- a/dumux/decoupled/2p2c/fvtransport2p2c.hh +++ b/dumux/decoupled/2p2c/fvtransport2p2c.hh @@ -97,7 +97,7 @@ class FVTransport2P2C wPhaseIdx = Indices::wPhaseIdx, nPhaseIdx = Indices::nPhaseIdx, wCompIdx = Indices::wPhaseIdx, nCompIdx = Indices::nPhaseIdx, contiWEqIdx=Indices::contiWEqIdx, contiNEqIdx=Indices::contiNEqIdx, - NumPhases = GET_PROP_VALUE(TypeTag, NumPhases), + NumPhases = GET_PROP_VALUE(TypeTag, NumPhases), NumComponents = GET_PROP_VALUE(TypeTag, NumComponents) }; @@ -130,7 +130,7 @@ protected: //! Acess function for the current problem Problem& problem() - {return problem_;}; + { return problem_; } void innerUpdate(TransportSolutionType& updateVec); @@ -167,7 +167,7 @@ public: totalConcentration_[eqNumber].resize(problem().gridView().size(0)); totalConcentration_[eqNumber] = 0; } - }; + } //! \brief Write transport variables into the output files /* \param writer applied VTK-writer */ @@ -360,7 +360,7 @@ private: */ template<class TypeTag> void FVTransport2P2C<TypeTag>::update(const Scalar t, Scalar& dt, - TransportSolutionType& updateVec, bool impet) + TransportSolutionType& updateVec, bool impet) { // initialize dt very large dt = 1E100; @@ -474,7 +474,7 @@ void FVTransport2P2C<TypeTag>::update(const Scalar t, Scalar& dt, } } } // end grid traversal - + #if HAVE_MPI // communicate updated values typedef typename GET_PROP(TypeTag, SolutionTypes) SolutionTypes; @@ -483,8 +483,8 @@ void FVTransport2P2C<TypeTag>::update(const Scalar t, Scalar& dt, for (int i = 0; i < updateVec.size(); i++) { DataHandle dataHandle(problem_.variables().elementMapper(), updateVec[i]); - problem_.gridView().template communicate<DataHandle>(dataHandle, - Dune::InteriorBorder_All_Interface, + problem_.gridView().template communicate<DataHandle>(dataHandle, + Dune::InteriorBorder_All_Interface, Dune::ForwardCommunication); } @@ -500,17 +500,16 @@ void FVTransport2P2C<TypeTag>::update(const Scalar t, Scalar& dt, dt = problem_.gridView().comm().min(dt); #endif - + if(impet) { Dune::dinfo << "Timestep restricted by CellIdx " << restrictingCell << " leads to dt = " <<dt * GET_PARAM_FROM_GROUP(TypeTag, Scalar, Impet, CFLFactor)<< std::endl; - if(averagedFaces_ != 0) + if (averagedFaces_ != 0) Dune::dinfo << " Averageing done for " << averagedFaces_ << " faces. "<< std::endl; } - return; } -/* Updates the transported quantity once an update is calculated. +/* Updates the transported quantity once an update is calculated. * This method updates both, the internal transport solution vector and the entries in the cellData. * \param updateVec Update vector, or update estimate for secants, resp. Here in \f$\mathrm{[kg/m^3]}\f$ * @@ -1136,7 +1135,7 @@ void FVTransport2P2C<TypeTag>::evalBoundary(GlobalPosition globalPosFace, pressBound[wPhaseIdx] = pressBound[nPhaseIdx] = primaryVariablesOnBoundary[Indices::pressureEqIdx]; Scalar Z1Bound = primaryVariablesOnBoundary[contiWEqIdx]; flashSolver.concentrationFlash2p2c(BCfluidState, Z1Bound, pressBound, - problem().spatialParams().porosity(*eIt), problem().temperatureAtPos(globalPosFace)); + problem().spatialParams().porosity(*eIt), problem().temperatureAtPos(globalPosFace)); if(GET_PROP_VALUE(TypeTag, EnableCapillarity)) { diff --git a/dumux/decoupled/2p2c/fvtransport2p2cmultiphysics.hh b/dumux/decoupled/2p2c/fvtransport2p2cmultiphysics.hh index 5126a2e5aa..6119687c10 100644 --- a/dumux/decoupled/2p2c/fvtransport2p2cmultiphysics.hh +++ b/dumux/decoupled/2p2c/fvtransport2p2cmultiphysics.hh @@ -82,7 +82,7 @@ class FVTransport2P2CMultiPhysics : public FVTransport2P2C<TypeTag> //! Acess function for the current problem Problem& problem() - {return this->problem_;}; + { return this->problem_; } typedef typename FVTransport2P2C<TypeTag>::LocalTimesteppingData LocalTimesteppingData; @@ -97,7 +97,7 @@ public: {} virtual ~FVTransport2P2CMultiPhysics() - { } + {} }; //! \brief Calculate the update vector and determine timestep size @@ -132,7 +132,7 @@ void FVTransport2P2CMultiPhysics<TypeTag>::update(const Scalar t, Scalar& dt, Tr // store if we do update Estimate for flux functions this->impet_ = impet; this->averagedFaces_ = 0.; - + // resize update vector and set to zero updateVec.resize(GET_PROP_VALUE(TypeTag, NumComponents)); updateVec[wCompIdx].resize(problem().gridView().size(0)); @@ -164,11 +164,11 @@ void FVTransport2P2CMultiPhysics<TypeTag>::update(const Scalar t, Scalar& dt, Tr { int indexInInside = isIt->indexInInside(); - /****** interior face *****************/ + /****** interior face *****************/ if (isIt->neighbor()) this->getFlux(entries, timestepFlux, *isIt, cellDataI); - /****** Boundary Face *****************/ + /****** Boundary Face *****************/ if (isIt->boundary()) this->getFluxOnBoundary(entries, timestepFlux, *isIt, cellDataI); @@ -210,7 +210,7 @@ void FVTransport2P2CMultiPhysics<TypeTag>::update(const Scalar t, Scalar& dt, Tr updateVec[wCompIdx][globalIdxI] += q[Indices::contiWEqIdx]; updateVec[nCompIdx][globalIdxI] += q[Indices::contiNEqIdx]; - // account for porosity in fluxes for time-step + // account for porosity in fluxes for time-step sumfactorin = std::max(sumfactorin,sumfactorout) / problem().spatialParams().porosity(*eIt); @@ -234,8 +234,8 @@ void FVTransport2P2CMultiPhysics<TypeTag>::update(const Scalar t, Scalar& dt, Tr } } } // end grid traversal - -#if HAVE_MPI + +#if HAVE_MPI // communicate updated values typedef typename GET_PROP(TypeTag, SolutionTypes) SolutionTypes; typedef typename SolutionTypes::ElementMapper ElementMapper; @@ -243,13 +243,13 @@ void FVTransport2P2CMultiPhysics<TypeTag>::update(const Scalar t, Scalar& dt, Tr for (int i = 0; i < updateVec.size(); i++) { DataHandle dataHandle(problem().variables().elementMapper(), updateVec[i]); - problem().gridView().template communicate<DataHandle>(dataHandle, - Dune::InteriorBorder_All_Interface, + problem().gridView().template communicate<DataHandle>(dataHandle, + Dune::InteriorBorder_All_Interface, Dune::ForwardCommunication); } dt = problem().gridView().comm().min(dt); #endif - + if(impet) { Dune::dinfo << "Timestep restricted by CellIdx " << restrictingCell << diff --git a/dumux/decoupled/2p2c/pseudo1p2cfluidstate.hh b/dumux/decoupled/2p2c/pseudo1p2cfluidstate.hh index ec160bdea8..d73c24b499 100644 --- a/dumux/decoupled/2p2c/pseudo1p2cfluidstate.hh +++ b/dumux/decoupled/2p2c/pseudo1p2cfluidstate.hh @@ -70,7 +70,7 @@ public: return 1.; else return 0.; - }; + } //! \brief Returns the index of the phase that is present in that cell. int presentPhaseIdx() const @@ -196,7 +196,7 @@ public: * and the rock matrix exhibit the same temperature. */ Scalar temperature(int phaseIdx) const - { return temperature_; }; + { return temperature_; } //@} /*! @@ -290,7 +290,7 @@ public: void setPressure(int phaseIdx, Scalar value) { pressure_[phaseIdx] = value; - }; + } /*! * \brief Sets phase enthalpy diff --git a/dumux/decoupled/2p2c/variableclass2p2cadaptive.hh b/dumux/decoupled/2p2c/variableclass2p2cadaptive.hh index 713e964994..9f9224d01a 100644 --- a/dumux/decoupled/2p2c/variableclass2p2cadaptive.hh +++ b/dumux/decoupled/2p2c/variableclass2p2cadaptive.hh @@ -112,12 +112,12 @@ protected: { secondHalfEdgeIntersection_.push_back(is23); interactionRegionsStored = 2; - }; + } //! Acess method to the stored intersection (only 2D) const IntersectionIterator& getIntersection() { return secondHalfEdgeIntersection_[0]; - }; + } }; std::map<IdType, mpfaData> irregularInterfaceMap_; //!< Storage container for mpfa information const Grid& grid_; //!< The grid @@ -171,32 +171,30 @@ public: * \param globalIdx3 The index of the 3rd cell of the interaction region */ void storeMpfaData(const typename GridView::Intersection & irregularIs, - const TransmissivityMatrix& T1, - const GlobalPosition& globalPos3, - const int& globalIdx3) + const TransmissivityMatrix& T1, + const GlobalPosition& globalPos3, + const int& globalIdx3) { - IdType intersectionID - = grid_.localIdSet().subId(*irregularIs.inside(), - irregularIs.indexInInside(), 1); - // mapping is only unique from smaller cell (if *inside and not *outside) - if (irregularIs.inside()->level() < irregularIs.outside()->level()) - { - // IS is regarded from larger cell: get the unique number as seen from smaller - intersectionID - = grid_.localIdSet().subId(*irregularIs.outside(), - irregularIs.indexInOutside(), 1); - - // store as if it was seen from smaller: change i & j - irregularInterfaceMap_[intersectionID].T1_[first][2] = - T1[0]; - irregularInterfaceMap_[intersectionID].T1_[first][1] = - T1[1]; - irregularInterfaceMap_[intersectionID].T1_[first][0] = - T1[2]; - } + IdType intersectionID = grid_.localIdSet().subId( + *irregularIs.inside(), irregularIs.indexInInside(), 1); + // mapping is only unique from smaller cell (if *inside and not *outside) + if (irregularIs.inside()->level() < irregularIs.outside()->level()) + { + // IS is regarded from larger cell: get the unique number as seen from smaller + intersectionID = grid_.localIdSet().subId( + *irregularIs.outside(), irregularIs.indexInOutside(), 1); + + // store as if it was seen from smaller: change i & j + irregularInterfaceMap_[intersectionID].T1_[first][2] = - T1[0]; + irregularInterfaceMap_[intersectionID].T1_[first][1] = - T1[1]; + irregularInterfaceMap_[intersectionID].T1_[first][0] = - T1[2]; + } else // we look from smaller cell = unique interface // proceed with numbering according to Aavatsmark, seen from cell i irregularInterfaceMap_[intersectionID].T1_[first] = T1; - irregularInterfaceMap_[intersectionID].globalPos3_[0] = globalPos3; - irregularInterfaceMap_[intersectionID].globalIdx3_[0] = globalIdx3; + irregularInterfaceMap_[intersectionID].globalPos3_[0] = globalPos3; + irregularInterfaceMap_[intersectionID].globalIdx3_[0] = globalIdx3; } @@ -254,9 +252,6 @@ public: irregularInterfaceMap_[intersectionID].globalIdx3_[0] = globalIdx3; // second half edge irregularInterfaceMap_[intersectionID].setIntersection(secondHalfEdgeIntersectionIt); - - - return; } //! Stores 3D Mpfa Data on an intersection @@ -319,8 +314,6 @@ public: irregularInterfaceMap_[intersectionID].interactionRegionsStored = std::max(irregularInterfaceMap_[intersectionID].interactionRegionsStored, subFaceIdx+1); - - return; } //! Weigths the transmissivity coefficient by the flux area (3D) @@ -511,7 +504,7 @@ public: return irregularInterfaceMap_[intersectionID].interactionRegionsStored; } - //@} + //@} }; } diff --git a/dumux/decoupled/common/decoupledproperties.hh b/dumux/decoupled/common/decoupledproperties.hh index 349fdbe1cb..a812741734 100644 --- a/dumux/decoupled/common/decoupledproperties.hh +++ b/dumux/decoupled/common/decoupledproperties.hh @@ -80,7 +80,7 @@ namespace Dumux template<class TypeTag> class GridAdaptInitializationIndicatorDefault; - + template<class TypeTag> class VariableClass; diff --git a/dumux/decoupled/common/fv/fvpressure.hh b/dumux/decoupled/common/fv/fvpressure.hh index 3173f13fcd..bbb32ff64d 100644 --- a/dumux/decoupled/common/fv/fvpressure.hh +++ b/dumux/decoupled/common/fv/fvpressure.hh @@ -237,7 +237,7 @@ public: void calculateVelocity() { - DUNE_THROW(Dune::NotImplemented,"Velocity calculation not implemented in pressure model!"); + DUNE_THROW(Dune::NotImplemented,"Velocity calculation not implemented in pressure model!"); } void updateVelocity() @@ -291,12 +291,12 @@ public: */ void unsetFixPressureAtIndex(int eIdxGlobal) { - fixPressure_.erase(eIdxGlobal); + fixPressure_.erase(eIdxGlobal); } void resetFixPressureAtIndex() { - fixPressure_.clear(); + fixPressure_.clear(); } /*! \brief Constructs a FVPressure object @@ -333,9 +333,9 @@ private: template<class TypeTag> void FVPressure<TypeTag>::initializeMatrix() { - initializeMatrixRowSize(); + initializeMatrixRowSize(); A_.endrowsizes(); - initializeMatrixIndices(); + initializeMatrixIndices(); A_.endindices(); } @@ -362,8 +362,6 @@ void FVPressure<TypeTag>::initializeMatrixRowSize() } A_.setrowsize(eIdxGlobalI, rowSize); } - - return; } //!Initialize the global matrix of the system of equations to solve @@ -393,8 +391,6 @@ void FVPressure<TypeTag>::initializeMatrixIndices() A_.addindex(eIdxGlobalI, eIdxGlobalJ); } } - - return; } @@ -449,9 +445,9 @@ void FVPressure<TypeTag>::assemble(bool first) // take a hanging node never from the element with smaller level! bool haveSameLevel = (eIt->level() == elementNeighbor->level()); // calculate only from one side, but add matrix entries for both sides - // the last condition is needed to properly assemble in the presence + // the last condition is needed to properly assemble in the presence // of ghost elements - if (GET_PROP_VALUE(TypeTag, VisitFacesOnlyOnce) + if (GET_PROP_VALUE(TypeTag, VisitFacesOnlyOnce) && (eIdxGlobalI > eIdxGlobalJ) && haveSameLevel && elementNeighbor->partitionType() == Dune::InteriorEntity) continue; @@ -470,7 +466,7 @@ void FVPressure<TypeTag>::assemble(bool first) A_[eIdxGlobalI][eIdxGlobalJ] -= entries[matrix]; // The second condition is needed to not spoil the ghost element entries - if (GET_PROP_VALUE(TypeTag, VisitFacesOnlyOnce) + if (GET_PROP_VALUE(TypeTag, VisitFacesOnlyOnce) && elementNeighbor->partitionType() == Dune::InteriorEntity) { f_[eIdxGlobalJ] += entries[rhs]; @@ -502,7 +498,7 @@ void FVPressure<TypeTag>::assemble(bool first) A_[eIdxGlobalI][eIdxGlobalI] += entries[matrix]; } // assemble overlap and ghost element contributions - else + else { A_[eIdxGlobalI] = 0.0; A_[eIdxGlobalI][eIdxGlobalI] = 1.0; @@ -511,7 +507,6 @@ void FVPressure<TypeTag>::assemble(bool first) } // end grid traversal // printmatrix(std::cout, A_, "global stiffness matrix after assempling", "row", 11,3); // printvector(std::cout, f_, "right hand side", "row", 10); - return; } //!Solves the global system of equations to get the spatial distribution of the pressure @@ -528,13 +523,12 @@ void FVPressure<TypeTag>::solve() //set a fixed pressure for a certain cell if (fixPressure_.size() > 0) { - typename std::map<int, Scalar>::iterator it = fixPressure_.begin(); - for (;it != fixPressure_.end();++it) - { - A_[it->first] = 0; - A_[it->first][it->first] = 1; - f_[it->first] = it->second; - } + for (auto it = fixPressure_.begin(); it != fixPressure_.end(); ++it) + { + A_[it->first] = 0; + A_[it->first][it->first] = 1; + f_[it->first] = it->second; + } } // printmatrix(std::cout, A_, "global stiffness matrix", "row", 11, 3); @@ -544,8 +538,6 @@ void FVPressure<TypeTag>::solve() solver.solve(A_, pressure_, f_); // printvector(std::cout, pressure_, "pressure", "row", 200, 1, 3); - - return; } } //end namespace Dumux diff --git a/dumux/decoupled/common/fv/fvvelocitydefault.hh b/dumux/decoupled/common/fv/fvvelocitydefault.hh index e959fc1438..aed7fde98e 100644 --- a/dumux/decoupled/common/fv/fvvelocitydefault.hh +++ b/dumux/decoupled/common/fv/fvvelocitydefault.hh @@ -56,7 +56,8 @@ public: {} //! For initialization - void initialize(){}; + void initialize() + {} //! Local velocity calculation void calculateVelocity(const Intersection& intersection, CellData& cellData) diff --git a/dumux/decoupled/common/fv/mpfa/fvmpfavelocityintransport.hh b/dumux/decoupled/common/fv/mpfa/fvmpfavelocityintransport.hh index a22c754aa7..62360dc93b 100644 --- a/dumux/decoupled/common/fv/mpfa/fvmpfavelocityintransport.hh +++ b/dumux/decoupled/common/fv/mpfa/fvmpfavelocityintransport.hh @@ -59,7 +59,8 @@ public: } //! For initialization - void initialize(){}; + void initialize() + {} //! Local velocity calculation void calculateVelocity(const Intersection& intersection, CellData& cellData) diff --git a/dumux/decoupled/common/fv/mpfa/mpfalinteractionvolume3d.hh b/dumux/decoupled/common/fv/mpfa/mpfalinteractionvolume3d.hh index e2ba9e6a6a..84c346f192 100644 --- a/dumux/decoupled/common/fv/mpfa/mpfalinteractionvolume3d.hh +++ b/dumux/decoupled/common/fv/mpfa/mpfalinteractionvolume3d.hh @@ -120,7 +120,7 @@ private: enum { - dim = GridView::dimension, + dim = GridView::dimension, dimWorld = GridView::dimensionworld, }; @@ -521,7 +521,7 @@ public: DimVector& getEdgePosition(int subVolumeIdx, int subVolumeFaceIdx, int subVolumeEdgeIdx) { return edgePos_[IndexTranslator::getEdgeIndexFromSubVolumeFace(subVolumeIdx, subVolumeFaceIdx, subVolumeEdgeIdx)]; - } + } //! The interaction volume flux face area /*! diff --git a/dumux/decoupled/common/fv/mpfa/mpfalinteractionvolume3dadaptive.hh b/dumux/decoupled/common/fv/mpfa/mpfalinteractionvolume3dadaptive.hh index 28055fc65c..bafaadbcc6 100644 --- a/dumux/decoupled/common/fv/mpfa/mpfalinteractionvolume3dadaptive.hh +++ b/dumux/decoupled/common/fv/mpfa/mpfalinteractionvolume3dadaptive.hh @@ -198,7 +198,7 @@ private: enum { - dim = GridView::dimension, + dim = GridView::dimension, dimWorld = GridView::dimensionworld, }; diff --git a/dumux/decoupled/common/gridadapt.hh b/dumux/decoupled/common/gridadapt.hh index 4c5276fccc..e9c72b41df 100644 --- a/dumux/decoupled/common/gridadapt.hh +++ b/dumux/decoupled/common/gridadapt.hh @@ -385,7 +385,7 @@ private: } } return true; - }; + } /*! @@ -472,20 +472,20 @@ class GridAdapt<TypeTag, false> public: void init() - {}; + {} void adaptGrid() - {}; + {} bool wasAdapted() { return false; } void setLevels(int, int) - {}; + {} void setTolerance(int, int) - {}; + {} const void setIndicator(const ScalarSolutionType&, const Scalar&, const Scalar&) - {}; + {} GridAdapt (Problem& problem) {} }; diff --git a/dumux/decoupled/common/gridadaptinitializationindicator.hh b/dumux/decoupled/common/gridadaptinitializationindicator.hh index fc46d83d28..15598bb314 100644 --- a/dumux/decoupled/common/gridadaptinitializationindicator.hh +++ b/dumux/decoupled/common/gridadaptinitializationindicator.hh @@ -359,7 +359,7 @@ public: /*! \brief Initializes the adaption indicator class */ void init() - {}; + {} bool initializeModel() { diff --git a/dumux/decoupled/common/gridadaptinitializationindicatordefault.hh b/dumux/decoupled/common/gridadaptinitializationindicatordefault.hh index 485ab2ff84..e1eaa27262 100644 --- a/dumux/decoupled/common/gridadaptinitializationindicatordefault.hh +++ b/dumux/decoupled/common/gridadaptinitializationindicatordefault.hh @@ -82,7 +82,7 @@ public: /*! \brief Initializes the adaption indicator class*/ void init() - {}; + {} /*! \brief Returns true if the IMPET-Model needs to be initialized*/ bool initializeModel() diff --git a/dumux/decoupled/common/impet.hh b/dumux/decoupled/common/impet.hh index c2ffa2ce46..295b260804 100644 --- a/dumux/decoupled/common/impet.hh +++ b/dumux/decoupled/common/impet.hh @@ -200,7 +200,7 @@ public: const ElementMapper &dofMapper() const { return problem_.elementMapper(); - } + } //! Constructs an IMPET object /** diff --git a/dumux/decoupled/common/impetproblem.hh b/dumux/decoupled/common/impetproblem.hh index 3b130cb566..73496e3f47 100644 --- a/dumux/decoupled/common/impetproblem.hh +++ b/dumux/decoupled/common/impetproblem.hh @@ -373,8 +373,8 @@ public: dt = std::min(dt, timeManager().episodeMaxTimeStepSize()); // check if we are in first TS and an initialDt was assigned - if (Dune::FloatCmp::eq<Scalar, Dune::FloatCmp::absolute>(t, 0.0, 1.0e-30) - && Dune::FloatCmp::ne<Scalar, Dune::FloatCmp::absolute>(timeManager().timeStepSize(), 0.0, 1.0e-30)) + if (Dune::FloatCmp::eq<Scalar, Dune::FloatCmp::absolute>(t, 0.0, 1.0e-30) + && Dune::FloatCmp::ne<Scalar, Dune::FloatCmp::absolute>(timeManager().timeStepSize(), 0.0, 1.0e-30)) { if (this->gridView().comm().size() > 1) dt = this->gridView().comm().min(dt); @@ -411,7 +411,7 @@ public: * current solution to disk. */ void postTimeStep() - {}; + {} /*! * \brief Called by the time manager after everything which can be @@ -533,7 +533,7 @@ public: << "does not override the episodeEnd() method. " << "Doing nothing!\n"; } - }; + } // \} @@ -784,7 +784,7 @@ public: pressureModel().updateMaterialLaws(); res.deserializeEnd(); - }; + } void addOutputVtkFields() { diff --git a/dumux/decoupled/common/onemodelproblem.hh b/dumux/decoupled/common/onemodelproblem.hh index 88623d431e..79d355bd97 100644 --- a/dumux/decoupled/common/onemodelproblem.hh +++ b/dumux/decoupled/common/onemodelproblem.hh @@ -134,7 +134,7 @@ public: bBoxMax_[i] = std::max(bBoxMax_[i], vIt->geometry().center()[i]); } } - + timeManager_ = Dune::stackobject_to_shared_ptr<TimeManager>(timeManager); model_ = Dune::make_shared<Model>(asImp_()) ; @@ -332,14 +332,14 @@ public: * integration. */ void preTimeStep() - { }; + {} /*! * \brief Called by Dumux::TimeManager in order to do a time * integration on the model. */ void timeIntegration() - { }; + {} /*! * \brief Called by Dumux::TimeManager whenever a solution for a @@ -350,7 +350,7 @@ public: * current solution to disk. */ void postTimeStep() - { }; + {} /*! * \brief Called by the time manager after everything which can be @@ -473,7 +473,7 @@ public: << "does not override the episodeEnd() method. " << "Doing nothing!\n"; } - }; + } // \} @@ -619,7 +619,7 @@ public: res.template deserializeEntities<0> (model(), gridView_); res.deserializeEnd(); - }; + } // \} diff --git a/dumux/decoupled/common/variableclass.hh b/dumux/decoupled/common/variableclass.hh index c9f5930a71..039ecea598 100644 --- a/dumux/decoupled/common/variableclass.hh +++ b/dumux/decoupled/common/variableclass.hh @@ -33,7 +33,7 @@ namespace Dumux { - + /*! * \ingroup Sequential */ -- GitLab