diff --git a/dumux/adaptive/initializationindicator.hh b/dumux/adaptive/initializationindicator.hh index c073f9d2ff9abd970a01a2217dae5d3accd8da52..885def68414a3525c5fed00886f5103c9e6a189e 100644 --- a/dumux/adaptive/initializationindicator.hh +++ b/dumux/adaptive/initializationindicator.hh @@ -49,7 +49,7 @@ class GridAdaptInitializationIndicator using Element = typename GridView::Traits::template Codim<0>::Entity; using GridVariables = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using BoundaryTypes = GetPropType; static constexpr bool isBox = GetPropType::discMethod == DiscretizationMethod::box; @@ -66,14 +66,14 @@ public: * - Adaptive.RefineAtSource If to refine where source terms are specified (default: true) * - Adaptive.BCRefinementThreshold The threshold above which fluxes are treated as non-zero (default: 1e-10) * \param problem The problem object - * \param fvGridGeometry The finite volume geometry of the grid + * \param gridGeometry The finite volume geometry of the grid * \param gridVariables The secondary variables on the grid */ GridAdaptInitializationIndicator(std::shared_ptr problem, - std::shared_ptr fvGridGeometry, + std::shared_ptr gridGeometry, std::shared_ptr gridVariables) : problem_(problem) - , fvGridGeometry_(fvGridGeometry) + , gridGeometry_(gridGeometry) , gridVariables_(gridVariables) , minLevel_(getParamFromGroup(problem->paramGroup(), "Adaptive.MinLevel")) , maxLevel_(getParamFromGroup(problem->paramGroup(), "Adaptive.MaxLevel")) @@ -141,11 +141,11 @@ public: void calculate(const SolutionVector& sol) { //! prepare an indicator for refinement - indicatorVector_.assign(fvGridGeometry_->gridView().size(0), false); + indicatorVector_.assign(gridGeometry_->gridView().size(0), false); - for (const auto& element : elements(fvGridGeometry_->gridView())) + for (const auto& element : elements(gridGeometry_->gridView())) { - const auto eIdx = fvGridGeometry_->elementMapper().index(element); + const auto eIdx = gridGeometry_->elementMapper().index(element); //! refine any element being below the minimum level if (element.level() < minLevel_) @@ -163,7 +163,7 @@ public: continue; // get the fvGeometry and elementVolVars needed for the bc and source interfaces - auto fvGeometry = localView(*fvGridGeometry_); + auto fvGeometry = localView(*gridGeometry_); fvGeometry.bind(element); auto elemVolVars = localView(gridVariables_->curGridVolVars()); @@ -274,14 +274,14 @@ public: */ int operator() (const Element& element) const { - if (indicatorVector_[fvGridGeometry_->elementMapper().index(element)]) + if (indicatorVector_[gridGeometry_->elementMapper().index(element)]) return 1; return 0; } private: std::shared_ptr problem_; //!< The problem to be solved - std::shared_ptr fvGridGeometry_; //!< The finite volume grid geometry + std::shared_ptr gridGeometry_; //!< The finite volume grid geometry std::shared_ptr gridVariables_; //!< The secondary variables on the grid std::vector indicatorVector_; //!< Indicator for BCs/sources diff --git a/dumux/assembly/cclocalassembler.hh b/dumux/assembly/cclocalassembler.hh index 633f8668b78b6eb10d078e396acfdd1e11c88b25..025f89feb66dc04e03f535ca9a5d475fe94b56eb 100644 --- a/dumux/assembly/cclocalassembler.hh +++ b/dumux/assembly/cclocalassembler.hh @@ -137,8 +137,8 @@ class CCLocalAssembler; using NumEqVector = GetPropType; using Element = typename GetPropType::template Codim<0>::Entity; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; using GridVariables = GetPropType; using JacobianMatrix = GetPropType; @@ -146,7 +146,7 @@ class CCLocalAssembler::dimension }; using FluxStencil = Dumux::FluxStencil; - static constexpr int maxElementStencilSize = FVGridGeometry::maxElementStencilSize; + static constexpr int maxElementStencilSize = GridGeometry::maxElementStencilSize; static constexpr bool enableGridFluxVarsCache = getPropValue(); public: @@ -170,13 +170,13 @@ public: // get some aliases for convenience const auto& element = this->element(); const auto& fvGeometry = this->fvGeometry(); - const auto& fvGridGeometry = this->assembler().gridGeometry(); + const auto& gridGeometry = this->assembler().gridGeometry(); auto&& curElemVolVars = this->curElemVolVars(); auto&& elemFluxVarsCache = this->elemFluxVarsCache(); // get stencil informations - const auto globalI = fvGridGeometry.elementMapper().index(element); - const auto& connectivityMap = fvGridGeometry.connectivityMap(); + const auto globalI = gridGeometry.elementMapper().index(element); + const auto& connectivityMap = gridGeometry.connectivityMap(); const auto numNeighbors = connectivityMap[globalI].size(); // container to store the neighboring elements @@ -203,7 +203,7 @@ public: unsigned int j = 1; for (const auto& dataJ : connectivityMap[globalI]) { - neighborElements[j-1] = fvGridGeometry.element(dataJ.globalJ); + neighborElements[j-1] = gridGeometry.element(dataJ.globalJ); for (const auto scvfIdx : dataJ.scvfsJ) origResiduals[j] += evalNeighborFlux(neighborElements[j-1], fvGeometry.scvf(scvfIdx)); @@ -221,7 +221,7 @@ public: const auto origVolVars = curVolVars; // element solution container to be deflected - auto elemSol = elementSolution(element, curSol, fvGridGeometry); + auto elemSol = elementSolution(element, curSol, gridGeometry); // derivatives in the neighbors with repect to the current elements // in index 0 we save the derivative of the element residual with respect to it's own dofs @@ -349,11 +349,11 @@ public: // get some aliases for convenience const auto& element = this->element(); const auto& fvGeometry = this->fvGeometry(); - const auto& fvGridGeometry = this->assembler().gridGeometry(); + const auto& gridGeometry = this->assembler().gridGeometry(); auto&& curElemVolVars = this->curElemVolVars(); // reference to the element's scv (needed later) and corresponding vol vars - const auto globalI = fvGridGeometry.elementMapper().index(element); + const auto globalI = gridGeometry.elementMapper().index(element); const auto& scv = fvGeometry.scv(globalI); auto& curVolVars = ParentType::getVolVarAccess(gridVariables.curGridVolVars(), curElemVolVars, scv); @@ -364,7 +364,7 @@ public: const auto origVolVars = curVolVars; // element solution container to be deflected - auto elemSol = elementSolution(element, curSol, fvGridGeometry); + auto elemSol = elementSolution(element, curSol, gridGeometry); NumEqVector partialDeriv; diff --git a/dumux/assembly/fvlocalresidual.hh b/dumux/assembly/fvlocalresidual.hh index b933a7d7d07002b407391ab7b09eaeefc7595f49..22ed0e4e98e35b2c2095d5bf296489e5befdcf0a 100644 --- a/dumux/assembly/fvlocalresidual.hh +++ b/dumux/assembly/fvlocalresidual.hh @@ -50,7 +50,7 @@ class FVLocalResidual using Element = typename GridView::template Codim<0>::Entity; using FVElementGeometry = typename GetPropType::LocalView; using GridVariables = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using NumEqVector = GetPropType; @@ -88,18 +88,18 @@ public: * \param problem The problem to solve * \param element The DUNE Codim<0> entity for which the storage * term ought to be calculated - * \param fvGridGeometry The finite-volume grid geometry + * \param gridGeometry The finite-volume grid geometry * \param gridVariables The grid variables (volume and flux variables) * \param sol The solution vector */ ElementResidualVector evalStorage(const Problem& problem, const Element &element, - const FVGridGeometry& fvGridGeometry, + const GridGeometry& gridGeometry, const GridVariables& gridVariables, const SolutionVector& sol) const { // make sure FVElementGeometry and volume variables are bound to the element - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bind(element); auto elemVolVars = localView(gridVariables.curGridVolVars()); diff --git a/dumux/assembly/partialreassembler.hh b/dumux/assembly/partialreassembler.hh index 9e986758b827e6f166c42ba33add94be371c1797..f164191967a0a49f7abccda5ded0a9f959483315 100644 --- a/dumux/assembly/partialreassembler.hh +++ b/dumux/assembly/partialreassembler.hh @@ -99,10 +99,10 @@ template class PartialReassemblerEngine { using Scalar = typename Assembler::Scalar; - using FVGridGeometry = typename Assembler::GridGeometry; + using GridGeometry = typename Assembler::GridGeometry; using JacobianMatrix = typename Assembler::JacobianMatrix; - using VertexMapper = typename FVGridGeometry::VertexMapper; - static constexpr int dim = FVGridGeometry::GridView::dimension; + using VertexMapper = typename GridGeometry::VertexMapper; + static constexpr int dim = GridGeometry::GridView::dimension; public: PartialReassemblerEngine(const Assembler& assembler) @@ -115,10 +115,10 @@ public: const std::vector& distanceFromLastLinearization, Scalar threshold) { - const auto& fvGridGeometry = assembler.gridGeometry(); - const auto& gridView = fvGridGeometry.gridView(); - const auto& elementMapper = fvGridGeometry.elementMapper(); - const auto& vertexMapper = fvGridGeometry.vertexMapper(); + const auto& gridGeometry = assembler.gridGeometry(); + const auto& gridView = gridGeometry.gridView(); + const auto& elementMapper = gridGeometry.elementMapper(); + const auto& vertexMapper = gridGeometry.vertexMapper(); // set all vertices to green vertexColor_.assign(vertexColor_.size(), EntityColor::green); @@ -305,7 +305,7 @@ template class PartialReassemblerEngine { using Scalar = typename Assembler::Scalar; - using FVGridGeometry = typename Assembler::GridGeometry; + using GridGeometry = typename Assembler::GridGeometry; using JacobianMatrix = typename Assembler::JacobianMatrix; public: @@ -318,9 +318,9 @@ public: const std::vector& distanceFromLastLinearization, Scalar threshold) { - const auto& fvGridGeometry = assembler.gridGeometry(); - const auto& gridView = fvGridGeometry.gridView(); - const auto& elementMapper = fvGridGeometry.elementMapper(); + const auto& gridGeometry = assembler.gridGeometry(); + const auto& gridView = gridGeometry.gridView(); + const auto& elementMapper = gridGeometry.elementMapper(); // mark the red elements for (const auto& element : elements(gridView)) @@ -340,7 +340,7 @@ public: } // mark the neighbors also red - const auto& connectivityMap = fvGridGeometry.connectivityMap(); + const auto& connectivityMap = gridGeometry.connectivityMap(); for (unsigned eIdx = 0; eIdx < elementColor_.size(); ++eIdx) { if (elementColor_[eIdx] == EntityColor::red) @@ -423,11 +423,11 @@ template class PartialReassembler { using Scalar = typename Assembler::Scalar; - using FVGridGeometry = typename Assembler::GridGeometry; + using GridGeometry = typename Assembler::GridGeometry; using JacobianMatrix = typename Assembler::JacobianMatrix; - using VertexMapper = typename FVGridGeometry::VertexMapper; + using VertexMapper = typename GridGeometry::VertexMapper; - static constexpr DiscretizationMethod discMethod = FVGridGeometry::discMethod; + static constexpr DiscretizationMethod discMethod = GridGeometry::discMethod; using Engine = PartialReassemblerEngine; public: @@ -440,9 +440,9 @@ public: : engine_(assembler) , greenElems_(0) { - const auto& fvGridGeometry = assembler.gridGeometry(); - totalElems_ = fvGridGeometry.elementMapper().size(); - totalElems_ = fvGridGeometry.gridView().comm().sum(totalElems_); + const auto& gridGeometry = assembler.gridGeometry(); + totalElems_ = gridGeometry.elementMapper().size(); + totalElems_ = gridGeometry.gridView().comm().sum(totalElems_); } /*! diff --git a/dumux/assembly/staggeredfvassembler.hh b/dumux/assembly/staggeredfvassembler.hh index bcd7f3d7a75e4d905f688167ecc63b54f1ae7633..786b99a533fed2679c420768e77e9093d2c19147 100644 --- a/dumux/assembly/staggeredfvassembler.hh +++ b/dumux/assembly/staggeredfvassembler.hh @@ -101,12 +101,12 @@ public: //! The constructor for instationary problems StaggeredFVAssembler(std::shared_ptr problem, - std::shared_ptr fvGridGeometry, + std::shared_ptr gridGeometry, std::shared_ptr gridVariables, std::shared_ptr timeLoop, const SolutionVector& prevSol) : ParentType(std::make_tuple(problem, problem), - std::make_tuple(fvGridGeometry->cellCenterFVGridGeometryPtr(), fvGridGeometry->faceFVGridGeometryPtr()), + std::make_tuple(gridGeometry->cellCenterFVGridGeometryPtr(), gridGeometry->faceFVGridGeometryPtr()), std::make_tuple(gridVariables->cellCenterGridVariablesPtr(), gridVariables->faceGridVariablesPtr()), std::make_shared(), timeLoop, @@ -129,7 +129,7 @@ public: { return gridGeometry(); } const GridGeometry& gridGeometry() const - { return ParentType::gridGeometry(Dune::index_constant<0>()).actualfvGridGeometry(); } + { return ParentType::gridGeometry(Dune::index_constant<0>()).actualGridGeometry(); } }; diff --git a/dumux/common/fvproblem.hh b/dumux/common/fvproblem.hh index b40f3337b15e32898c07ad25ec54832260967087..ad06c7aebfe33b792eb9d62af0a049b6b9bfdc64 100644 --- a/dumux/common/fvproblem.hh +++ b/dumux/common/fvproblem.hh @@ -50,9 +50,9 @@ class FVProblem { using Implementation = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using Element = typename GridView::template Codim<0>::Entity; @@ -72,8 +72,8 @@ class FVProblem using SolutionVector = GetPropType; - static constexpr bool isBox = FVGridGeometry::discMethod == DiscretizationMethod::box; - static constexpr bool isStaggered = FVGridGeometry::discMethod == DiscretizationMethod::staggered; + static constexpr bool isBox = GridGeometry::discMethod == DiscretizationMethod::box; + static constexpr bool isStaggered = GridGeometry::discMethod == DiscretizationMethod::staggered; using Scalar = GetPropType; using PrimaryVariables = GetPropType; @@ -92,11 +92,11 @@ public: /*! * \brief Constructor - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param paramGroup The parameter group in which to look for runtime parameters first (default is "") */ - FVProblem(std::shared_ptr fvGridGeometry, const std::string& paramGroup = "") - : fvGridGeometry_(fvGridGeometry) + FVProblem(std::shared_ptr gridGeometry, const std::string& paramGroup = "") + : gridGeometry_(gridGeometry) , paramGroup_(paramGroup) { // set a default name for the problem @@ -439,7 +439,7 @@ public: { NumEqVector source(0); auto scvIdx = scv.indexInElement(); - auto key = std::make_pair(fvGridGeometry_->elementMapper().index(element), scvIdx); + auto key = std::make_pair(gridGeometry_->elementMapper().index(element), scvIdx); if (pointSourceMap_.count(key)) { // call the solDependent function. Herein the user might fill/add values to the point sources @@ -493,7 +493,7 @@ public: if (!sources.empty()) { // calculate point source locations and save them in a map - PointSourceHelper::computePointSourceMap(*fvGridGeometry_, + PointSourceHelper::computePointSourceMap(*gridGeometry_, sources, pointSourceMap_); } @@ -581,12 +581,12 @@ public: //! The finite volume grid geometry [[deprecated("Use gridGeometry() instead. fvGridGeometry() will be removed after 3.1!")]] - const FVGridGeometry& fvGridGeometry() const + const GridGeometry& fvGridGeometry() const { return gridGeometry(); } //! The finite volume grid geometry - const FVGridGeometry& gridGeometry() const - { return *fvGridGeometry_; } + const GridGeometry& gridGeometry() const + { return *gridGeometry_; } //! The parameter group in which to retrieve runtime parameters const std::string& paramGroup() const @@ -607,8 +607,8 @@ private: */ void applyInitialSolutionImpl_(SolutionVector& sol, /*isBox=*/std::true_type) const { - const auto numDofs = fvGridGeometry_->vertexMapper().size(); - const auto numVert = fvGridGeometry_->gridView().size(dim); + const auto numDofs = gridGeometry_->vertexMapper().size(); + const auto numVert = gridGeometry_->gridView().size(dim); sol.resize(numDofs); // if there are more dofs than vertices (enriched nodal dofs), we have to @@ -616,11 +616,11 @@ private: if (numDofs != numVert) { std::vector dofVisited(numDofs, false); - for (const auto& element : elements(fvGridGeometry_->gridView())) + for (const auto& element : elements(gridGeometry_->gridView())) { for (int i = 0; i < element.subEntities(dim); ++i) { - const auto dofIdxGlobal = fvGridGeometry_->vertexMapper().subIndex(element, i, dim); + const auto dofIdxGlobal = gridGeometry_->vertexMapper().subIndex(element, i, dim); // forward to implementation if value at dof is not set yet if (!dofVisited[dofIdxGlobal]) @@ -635,9 +635,9 @@ private: // otherwise we directly loop over the vertices else { - for (const auto& vertex : vertices(fvGridGeometry_->gridView())) + for (const auto& vertex : vertices(gridGeometry_->gridView())) { - const auto dofIdxGlobal = fvGridGeometry_->vertexMapper().index(vertex); + const auto dofIdxGlobal = gridGeometry_->vertexMapper().index(vertex); sol[dofIdxGlobal] = asImp_().initial(vertex); } } @@ -648,16 +648,16 @@ private: */ void applyInitialSolutionImpl_(SolutionVector& sol, /*isBox=*/std::false_type) const { - sol.resize(fvGridGeometry_->numDofs()); - for (const auto& element : elements(fvGridGeometry_->gridView())) + sol.resize(gridGeometry_->numDofs()); + for (const auto& element : elements(gridGeometry_->gridView())) { - const auto dofIdxGlobal = fvGridGeometry_->elementMapper().index(element); + const auto dofIdxGlobal = gridGeometry_->elementMapper().index(element); sol[dofIdxGlobal] = asImp_().initial(element); } } //! The finite volume grid geometry - std::shared_ptr fvGridGeometry_; + std::shared_ptr gridGeometry_; //! The parameter group in which to retrieve runtime parameters std::string paramGroup_; diff --git a/dumux/common/pointsource.hh b/dumux/common/pointsource.hh index 7123186fc48fb4071770cc3ad50e5930c2159b91..e7c7a9f093b1b28dfbdda811cb68ec6f6c3fdeba 100644 --- a/dumux/common/pointsource.hh +++ b/dumux/common/pointsource.hh @@ -276,14 +276,14 @@ class BoundingBoxTreePointSourceHelper { public: //! calculate a DOF index to point source map from given vector of point sources - template - static void computePointSourceMap(const FVGridGeometry& fvGridGeometry, + template + static void computePointSourceMap(const GridGeometry& gridGeometry, std::vector& sources, PointSourceMap& pointSourceMap) { - constexpr bool isBox = FVGridGeometry::discMethod == DiscretizationMethod::box; + constexpr bool isBox = GridGeometry::discMethod == DiscretizationMethod::box; - const auto& boundingBoxTree = fvGridGeometry.boundingBoxTree(); + const auto& boundingBoxTree = gridGeometry.boundingBoxTree(); for (auto&& source : sources) { @@ -298,7 +298,7 @@ public: { // check in which subcontrolvolume(s) we are const auto element = boundingBoxTree.entitySet().entity(eIdx); - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bindElement(element); const auto globalPos = source.position(); diff --git a/dumux/common/staggeredfvproblem.hh b/dumux/common/staggeredfvproblem.hh index 8ce229b555776715d50124238ce71f76274dd5ca..49eb564b6fc644dc3d15359f7f5d21d94707495b 100644 --- a/dumux/common/staggeredfvproblem.hh +++ b/dumux/common/staggeredfvproblem.hh @@ -55,8 +55,8 @@ class StaggeredFVProblem : public FVProblem using ElementFaceVariables = typename GridFaceVariables::LocalView; using PrimaryVariables = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using NumEqVector = GetPropType; @@ -64,8 +64,8 @@ class StaggeredFVProblem : public FVProblem using CoordScalar = typename GridView::ctype; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; - static constexpr auto cellCenterIdx = FVGridGeometry::cellCenterIdx(); - static constexpr auto faceIdx = FVGridGeometry::faceIdx(); + static constexpr auto cellCenterIdx = GridGeometry::cellCenterIdx(); + static constexpr auto faceIdx = GridGeometry::faceIdx(); static constexpr auto numEqCellCenter = getPropValue(); static constexpr auto numEqFace = getPropValue(); @@ -73,11 +73,11 @@ class StaggeredFVProblem : public FVProblem public: /*! * \brief Constructor - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param paramGroup The parameter group in which to look for runtime parameters first (default is "") */ - StaggeredFVProblem(std::shared_ptr fvGridGeometry, const std::string& paramGroup = "") - : ParentType(fvGridGeometry, paramGroup) + StaggeredFVProblem(std::shared_ptr gridGeometry, const std::string& paramGroup = "") + : ParentType(gridGeometry, paramGroup) { } /*! diff --git a/dumux/discretization/box/elementboundarytypes.hh b/dumux/discretization/box/elementboundarytypes.hh index aff498420f1717bada74c75393d27f1925232fd0..ac9422771db7126316859f1ec704e91a5d807ddb 100644 --- a/dumux/discretization/box/elementboundarytypes.hh +++ b/dumux/discretization/box/elementboundarytypes.hh @@ -52,8 +52,8 @@ public: const Element &element, const FVElementGeometry &fvGeometry) { - using FVGridGeometry = typename FVElementGeometry::GridGeometry; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = typename FVElementGeometry::GridGeometry; + using GridView = typename GridGeometry::GridView; vertexBCTypes_.resize( element.subEntities(GridView::dimension) ); diff --git a/dumux/discretization/box/elementsolution.hh b/dumux/discretization/box/elementsolution.hh index 68e3bc362832e64d0d1f9353032137469ed9c1ce..bc7b80051486bd0846167c166c3c75d2b0cbdb3e 100644 --- a/dumux/discretization/box/elementsolution.hh +++ b/dumux/discretization/box/elementsolution.hh @@ -37,8 +37,8 @@ namespace Dumux { template class BoxElementSolution { - using FVGridGeometry = typename FVElementGeometry::GridGeometry; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = typename FVElementGeometry::GridGeometry; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; public: @@ -51,9 +51,9 @@ public: //! Constructor with element and solution and grid geometry template BoxElementSolution(const Element& element, const SolutionVector& sol, - const FVGridGeometry& fvGridGeometry) + const GridGeometry& gridGeometry) { - update(element, sol, fvGridGeometry); + update(element, sol, gridGeometry); } //! Constructor with element and elemVolVars and fvGeometry @@ -70,12 +70,12 @@ public: //! extract the element solution from the solution vector using a mapper template void update(const Element& element, const SolutionVector& sol, - const FVGridGeometry& fvGridGeometry) + const GridGeometry& gridGeometry) { const auto numVert = element.subEntities(GridView::dimension); priVars_.resize(numVert); for (int vIdx = 0; vIdx < numVert; ++vIdx) - priVars_[vIdx] = sol[fvGridGeometry.vertexMapper().subIndex(element, vIdx, GridView::dimension)]; + priVars_[vIdx] = sol[gridGeometry.vertexMapper().subIndex(element, vIdx, GridView::dimension)]; } //! extract the element solution from the solution vector using a local fv geometry @@ -111,15 +111,15 @@ private: * \ingroup BoxDiscretization * \brief Make an element solution for box schemes */ -template -auto elementSolution(const Element& element, const SolutionVector& sol, const FVGridGeometry& gg) --> std::enable_if_t +auto elementSolution(const Element& element, const SolutionVector& sol, const GridGeometry& gg) +-> std::enable_if_t()[0])>> > { using PrimaryVariables = std::decay_t()[0])>; - return BoxElementSolution(element, sol, gg); + return BoxElementSolution(element, sol, gg); } /*! diff --git a/dumux/discretization/box/fluxvariablescache.hh b/dumux/discretization/box/fluxvariablescache.hh index 96ca21a14ca5c009901712b8c3f69e9684fbb86e..c4013217148729c664796f4b31161402c5477a3a 100644 --- a/dumux/discretization/box/fluxvariablescache.hh +++ b/dumux/discretization/box/fluxvariablescache.hh @@ -35,15 +35,15 @@ namespace Dumux { * For the box scheme, this class does not contain any physics-/process-dependent * data. It solely stores disretization-/grid-related data. */ -template< class Scalar, class FVGridGeometry > +template< class Scalar, class GridGeometry > class BoxFluxVariablesCache { - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; static const int dim = GridView::dimension; static const int dimWorld = GridView::dimensionworld; diff --git a/dumux/discretization/box/fvelementgeometry.hh b/dumux/discretization/box/fvelementgeometry.hh index eaae427ae9efcc13d8953df2608eae24a37bb411..fcdd9233f3467d189d6ba2b41ef92501c9e55ce0 100644 --- a/dumux/discretization/box/fvelementgeometry.hh +++ b/dumux/discretization/box/fvelementgeometry.hh @@ -150,7 +150,7 @@ public: //! The global finite volume geometry we are a restriction of [[deprecated ("Use gridGeometry() instead. fvGridGeometry() will be removed after 3.1!")]] - const FVGridGeometry& fvGridGeometry() const + const GridGeometry& fvGridGeometry() const { return gridGeometry(); } const GridGeometry& gridGeometry() const { return *gridGeometryPtr_; } @@ -271,7 +271,7 @@ public: //! The global finite volume geometry we are a restriction of [[deprecated ("Use gridGeometry() instead. fvGridGeometry() will be removed after 3.1!")]] - const FVGridGeometry& fvGridGeometry() const + const GridGeometry& fvGridGeometry() const { return gridGeometry(); } const GridGeometry& gridGeometry() const { return *gridGeometryPtr_; } diff --git a/dumux/discretization/box/fvgridgeometry.hh b/dumux/discretization/box/fvgridgeometry.hh index 2e6cb065bf2857699e3f64e069376f5a5716775f..6c320b26060442ca80730ba9301a1e0c6ba08f4d 100644 --- a/dumux/discretization/box/fvgridgeometry.hh +++ b/dumux/discretization/box/fvgridgeometry.hh @@ -56,8 +56,8 @@ struct BoxDefaultGridGeometryTraits using SubControlVolume = BoxSubControlVolume; using SubControlVolumeFace = BoxSubControlVolumeFace; - template - using LocalView = BoxFVElementGeometry; + template + using LocalView = BoxFVElementGeometry; }; /*! diff --git a/dumux/discretization/box/gridfluxvariablescache.hh b/dumux/discretization/box/gridfluxvariablescache.hh index e28010b95f368402161036b27a8c44f8b8336847..90d6079e80d3872e85af027c327196c87801b6c0 100644 --- a/dumux/discretization/box/gridfluxvariablescache.hh +++ b/dumux/discretization/box/gridfluxvariablescache.hh @@ -78,8 +78,8 @@ public: BoxGridFluxVariablesCache(const Problem& problem) : problemPtr_(&problem) {} - template - void update(const FVGridGeometry& fvGridGeometry, + template + void update(const GridGeometry& gridGeometry, const GridVolumeVariables& gridVolVars, const SolutionVector& sol, bool forceUpdate = false) @@ -87,12 +87,12 @@ public: // Here, we do not do anything unless it is a forced update if (forceUpdate) { - fluxVarsCache_.resize(fvGridGeometry.gridView().size(0)); - for (const auto& element : elements(fvGridGeometry.gridView())) + fluxVarsCache_.resize(gridGeometry.gridView().size(0)); + for (const auto& element : elements(gridGeometry.gridView())) { - auto eIdx = fvGridGeometry.elementMapper().index(element); + auto eIdx = gridGeometry.elementMapper().index(element); // bind the geometries and volume variables to the element (all the elements in stencil) - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bind(element); auto elemVolVars = localView(gridVolVars); @@ -144,8 +144,8 @@ public: BoxGridFluxVariablesCache(const Problem& problem) : problemPtr_(&problem) {} - template - void update(const FVGridGeometry& fvGridGeometry, + template + void update(const GridGeometry& gridGeometry, const GridVolumeVariables& gridVolVars, const SolutionVector& sol, bool forceUpdate = false) {} diff --git a/dumux/discretization/box/gridvolumevariables.hh b/dumux/discretization/box/gridvolumevariables.hh index 74bc2117ecf0ea188029b7ab13ec86e431c3cff1..9a54ece6e444b0860ea0e8c34f15d52f82d45225 100644 --- a/dumux/discretization/box/gridvolumevariables.hh +++ b/dumux/discretization/box/gridvolumevariables.hh @@ -74,19 +74,19 @@ public: BoxGridVolumeVariables(const Problem& problem) : problemPtr_(&problem) {} - template - void update(const FVGridGeometry& fvGridGeometry, const SolutionVector& sol) + template + void update(const GridGeometry& gridGeometry, const SolutionVector& sol) { - volumeVariables_.resize(fvGridGeometry.gridView().size(0)); - for (const auto& element : elements(fvGridGeometry.gridView())) + volumeVariables_.resize(gridGeometry.gridView().size(0)); + for (const auto& element : elements(gridGeometry.gridView())) { - auto eIdx = fvGridGeometry.elementMapper().index(element); + auto eIdx = gridGeometry.elementMapper().index(element); - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bindElement(element); // get the element solution - auto elemSol = elementSolution(element, sol, fvGridGeometry); + auto elemSol = elementSolution(element, sol, gridGeometry); // update the volvars of the element volumeVariables_[eIdx].resize(fvGeometry.numScv()); @@ -139,8 +139,8 @@ public: BoxGridVolumeVariables(const Problem& problem) : problemPtr_(&problem) {} - template - void update(const FVGridGeometry& fvGridGeometry, const SolutionVector& sol) {} + template + void update(const GridGeometry& gridGeometry, const SolutionVector& sol) {} const Problem& problem() const { return *problemPtr_;} diff --git a/dumux/discretization/box/scvftoscvboundarytypes.hh b/dumux/discretization/box/scvftoscvboundarytypes.hh index b7f511c1cfb373bcf1523d65ee9df282aa13f019..569fb6c4f9e5e4f82b9f9ac031c99395cce3a2eb 100644 --- a/dumux/discretization/box/scvftoscvboundarytypes.hh +++ b/dumux/discretization/box/scvftoscvboundarytypes.hh @@ -46,16 +46,16 @@ public: // only do something for box if (discMethod == DiscretizationMethod::box) { - const auto& fvGridGeometry = problem.gridGeometry(); - scvBoundaryTypes.resize(fvGridGeometry.vertexMapper().size()); + const auto& gridGeometry = problem.gridGeometry(); + scvBoundaryTypes.resize(gridGeometry.vertexMapper().size()); // set all equations to Neumann by default for (std::size_t vIdx = 0; vIdx < scvBoundaryTypes.size(); vIdx++) scvBoundaryTypes[vIdx].setAllNeumann(); - for (const auto& element : elements(fvGridGeometry.gridView())) + for (const auto& element : elements(gridGeometry.gridView())) { // iterate over the scvfs - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bindElement(element); for (const auto& scvf : scvfs(fvGeometry)) diff --git a/dumux/discretization/cellcentered/connectivitymap.hh b/dumux/discretization/cellcentered/connectivitymap.hh index 2e775c698ba817c3a1aa0d003d000ca5b9ffb3cd..707ba3f09e3939430fa1d73e4dc6664d6636fb0a 100644 --- a/dumux/discretization/cellcentered/connectivitymap.hh +++ b/dumux/discretization/cellcentered/connectivitymap.hh @@ -48,14 +48,14 @@ namespace Dumux { * to compute these fluxes. The same holds for scvfs in the cells J, i.e. we need only those * scvfs in the cells J in which the cell I is in the stencil. */ -template +template class CCSimpleConnectivityMap { - using FVElementGeometry = typename FVGridGeometry::LocalView; - using GridView = typename FVGridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; using GridIndexType = typename IndexTraits::GridIndex; using FluxStencil = Dumux::FluxStencil; - static constexpr int maxElemStencilSize = FVGridGeometry::maxElementStencilSize; + static constexpr int maxElemStencilSize = GridGeometry::maxElementStencilSize; struct DataJ { @@ -73,22 +73,22 @@ public: /*! * \brief Initialize the ConnectivityMap object. * - * \param fvGridGeometry The grid's finite volume geometry. + * \param gridGeometry The grid's finite volume geometry. */ - void update(const FVGridGeometry& fvGridGeometry) + void update(const GridGeometry& gridGeometry) { map_.clear(); - map_.resize(fvGridGeometry.gridView().size(0)); + map_.resize(gridGeometry.gridView().size(0)); // container to store for each element J the elements I which have J in their flux stencil Dune::ReservedVector, maxElemStencilSize> dataJForI; - for (const auto& element : elements(fvGridGeometry.gridView())) + for (const auto& element : elements(gridGeometry.gridView())) { // We are looking for the elements I, for which this element J is in the flux stencil - const auto globalJ = fvGridGeometry.elementMapper().index(element); + const auto globalJ = gridGeometry.elementMapper().index(element); - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bindElement(element); // obtain the data of J in elements I @@ -115,7 +115,7 @@ public: if (dataJForI.size() > maxElemStencilSize - 1) DUNE_THROW(Dune::InvalidStateException, "Maximum admissible stencil size (" << maxElemStencilSize-1 << ") is surpassed (" << dataJForI.size() << "). " - << "Please adjust the FVGridGeometry traits accordingly!"); + << "Please adjust the GridGeometry traits accordingly!"); dataJForI.push_back(std::make_pair(globalI, DataJ({globalJ, {scvf.index()}, {}}))); } diff --git a/dumux/discretization/cellcentered/elementsolution.hh b/dumux/discretization/cellcentered/elementsolution.hh index abf1a0bad7e484dbc64ba8e0bee005bee6f5efb5..5aabd0934e329694e58a65ba5ab512c42e05089d 100644 --- a/dumux/discretization/cellcentered/elementsolution.hh +++ b/dumux/discretization/cellcentered/elementsolution.hh @@ -38,8 +38,8 @@ namespace Dumux { template class CCElementSolution { - using FVGridGeometry = typename FVElementGeometry::GridGeometry; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = typename FVElementGeometry::GridGeometry; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; public: @@ -52,8 +52,8 @@ public: //! Constructor with element, solution vector and grid geometry template CCElementSolution(const Element& element, const SolutionVector& sol, - const FVGridGeometry& fvGridGeometry) - : CCElementSolution(sol[fvGridGeometry.elementMapper().index(element)]) + const GridGeometry& gridGeometry) + : CCElementSolution(sol[gridGeometry.elementMapper().index(element)]) {} //! Constructor with element, element volume variables and fv element geometry @@ -76,9 +76,9 @@ public: //! extract the element solution from the solution vector using a mapper template void update(const Element& element, const SolutionVector& sol, - const FVGridGeometry& fvGridGeometry) + const GridGeometry& gridGeometry) { - priVars_ = sol[fvGridGeometry.elementMapper().index(element)]; + priVars_ = sol[gridGeometry.elementMapper().index(element)]; } //! return the size of the element solution @@ -109,16 +109,16 @@ private: * \ingroup CCDiscretization * \brief Make an element solution for cell-centered schemes */ -template -auto elementSolution(const Element& element, const SolutionVector& sol, const FVGridGeometry& gg) --> std::enable_if_t +auto elementSolution(const Element& element, const SolutionVector& sol, const GridGeometry& gg) +-> std::enable_if_t()[0])>> > { using PrimaryVariables = std::decay_t()[0])>; - return CCElementSolution(element, sol, gg); + return CCElementSolution(element, sol, gg); } /*! diff --git a/dumux/discretization/cellcentered/gridvolumevariables.hh b/dumux/discretization/cellcentered/gridvolumevariables.hh index e1f69e70866f6b0d609089267e60789469dc6484..62897f109bf41e51ff3fb1d099ad3d47e6ea3906 100644 --- a/dumux/discretization/cellcentered/gridvolumevariables.hh +++ b/dumux/discretization/cellcentered/gridvolumevariables.hh @@ -64,20 +64,20 @@ public: CCGridVolumeVariables(const Problem& problem) : problemPtr_(&problem) {} - template - void update(const FVGridGeometry& fvGridGeometry, const SolutionVector& sol) + template + void update(const GridGeometry& gridGeometry, const SolutionVector& sol) { - const auto numScv = fvGridGeometry.numScv(); + const auto numScv = gridGeometry.numScv(); volumeVariables_.resize(numScv); - for (const auto& element : elements(fvGridGeometry.gridView())) + for (const auto& element : elements(gridGeometry.gridView())) { - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bindElement(element); for (auto&& scv : scvs(fvGeometry)) { - const auto elemSol = elementSolution(element, sol, fvGridGeometry); + const auto elemSol = elementSolution(element, sol, gridGeometry); volumeVariables_[scv.dofIndex()].update(elemSol, problem(), element, scv); } } @@ -136,8 +136,8 @@ public: CCGridVolumeVariables(const Problem& problem) : problemPtr_(&problem) {} - template - void update(const FVGridGeometry& fvGridGeometry, const SolutionVector& sol) {} + template + void update(const GridGeometry& gridGeometry, const SolutionVector& sol) {} //! The problem we are solving const Problem& problem() const diff --git a/dumux/discretization/cellcentered/mpfa/connectivitymap.hh b/dumux/discretization/cellcentered/mpfa/connectivitymap.hh index 8365acb2e63eb3ed856ef2885b8c9935ef7a8888..8fcab2ddb45dc4824b2d0d5f123fa01ef35878dd 100644 --- a/dumux/discretization/cellcentered/mpfa/connectivitymap.hh +++ b/dumux/discretization/cellcentered/mpfa/connectivitymap.hh @@ -33,12 +33,12 @@ namespace Dumux { //! Forward declaration of method specific implementation of the assembly map -template +template class CCMpfaConnectivityMap; //! The o-method can use the simple (symmetric) assembly map -template -class CCMpfaConnectivityMap : public CCSimpleConnectivityMap {}; +template +class CCMpfaConnectivityMap : public CCSimpleConnectivityMap {}; } // end namespace Dumux #endif diff --git a/dumux/discretization/cellcentered/mpfa/elementfluxvariablescache.hh b/dumux/discretization/cellcentered/mpfa/elementfluxvariablescache.hh index 3c6940f60e3cf0775e3f154ac5d764dae1c87532..3c3485c53cb1d357f091f802b512d213d0d9f3d7 100644 --- a/dumux/discretization/cellcentered/mpfa/elementfluxvariablescache.hh +++ b/dumux/discretization/cellcentered/mpfa/elementfluxvariablescache.hh @@ -162,8 +162,8 @@ public: std::size_t numSecondaryIv; numSecondaryIv = 0; std::size_t numCaches; numCaches = 0; - const auto& fvGridGeometry = fvGeometry.gridGeometry(); - const auto& gridIvIndexSets = fvGridGeometry.gridInteractionVolumeIndexSets(); + const auto& gridGeometry = fvGeometry.gridGeometry(); + const auto& gridIvIndexSets = gridGeometry.gridInteractionVolumeIndexSets(); // lambda to check if a scvf was handled already auto scvfHandled = [&] (auto idx) @@ -191,21 +191,21 @@ public: // search for ivs at boundary vertices for (const auto& scvf : scvfs(fvGeometry)) - fvGridGeometry.vertexUsesSecondaryInteractionVolume(scvf.vertexIndex()) ? + gridGeometry.vertexUsesSecondaryInteractionVolume(scvf.vertexIndex()) ? handleScvf(scvf, gridIvIndexSets.secondaryIndexSet(scvf), true) : handleScvf(scvf, gridIvIndexSets.primaryIndexSet(scvf), false) ; // skip the rest if there are no boundary caches to be created if (numCaches > 0) { - const auto& assemblyMapI = fvGridGeometry.connectivityMap()[fvGridGeometry.elementMapper().index(element)]; + const auto& assemblyMapI = gridGeometry.connectivityMap()[gridGeometry.elementMapper().index(element)]; for (const auto& dataJ : assemblyMapI) { for (const auto& scvfJIdx : dataJ.scvfsJ) { const auto& scvfJ = fvGeometry.scvf(scvfJIdx); - if (fvGridGeometry.vertexUsesSecondaryInteractionVolume(scvfJ.vertexIndex())) + if (gridGeometry.vertexUsesSecondaryInteractionVolume(scvfJ.vertexIndex())) handleScvf(scvfJ, gridIvIndexSets.secondaryIndexSet(scvfJ), true); else handleScvf(scvfJ, gridIvIndexSets.primaryIndexSet(scvfJ), false); @@ -320,9 +320,9 @@ private: template bool isEmbeddedInBoundaryIV_(const SubControlVolumeFace& scvf) const { - const auto& fvGridGeometry = gridFluxVarsCachePtr_->problem().gridGeometry(); - const auto& gridIvIndexSets = fvGridGeometry.gridInteractionVolumeIndexSets(); - if (fvGridGeometry.vertexUsesSecondaryInteractionVolume(scvf.vertexIndex())) + const auto& gridGeometry = gridFluxVarsCachePtr_->problem().gridGeometry(); + const auto& gridIvIndexSets = gridGeometry.gridInteractionVolumeIndexSets(); + if (gridGeometry.vertexUsesSecondaryInteractionVolume(scvf.vertexIndex())) return gridIvIndexSets.secondaryIndexSet(scvf).nodalIndexSet().numBoundaryScvfs() > 0; else return gridIvIndexSets.primaryIndexSet(scvf).nodalIndexSet().numBoundaryScvfs() > 0; @@ -397,10 +397,10 @@ public: // some references for convenience const auto& problem = gridFluxVarsCache().problem(); - const auto& fvGridGeometry = fvGeometry.gridGeometry(); + const auto& gridGeometry = fvGeometry.gridGeometry(); // the assembly map of the given element - const auto& assemblyMapI = fvGridGeometry.connectivityMap()[fvGridGeometry.elementMapper().index(element)]; + const auto& assemblyMapI = gridGeometry.connectivityMap()[gridGeometry.elementMapper().index(element)]; // reserve memory for scvf index container unsigned int numNeighborScvfs = 0; @@ -445,7 +445,7 @@ public: for (const auto& dataJ : assemblyMapI) { - const auto elementJ = fvGridGeometry.element(dataJ.globalJ); + const auto elementJ = gridGeometry.element(dataJ.globalJ); for (const auto scvfIdx : dataJ.scvfsJ) { auto& scvfCache = fluxVarsCache_[i++]; @@ -485,8 +485,8 @@ public: if (FluxVariablesCacheFiller::isSolDependent) { const auto& problem = gridFluxVarsCache().problem(); - const auto& fvGridGeometry = fvGeometry.gridGeometry(); - const auto& assemblyMapI = fvGridGeometry.connectivityMap()[fvGridGeometry.elementMapper().index(element)]; + const auto& gridGeometry = fvGeometry.gridGeometry(); + const auto& assemblyMapI = gridGeometry.connectivityMap()[gridGeometry.elementMapper().index(element)]; // helper class to fill flux variables caches FluxVariablesCacheFiller filler(problem); @@ -506,7 +506,7 @@ public: for (const auto& dataJ : assemblyMapI) { - const auto elementJ = fvGridGeometry.element(dataJ.globalJ); + const auto elementJ = gridGeometry.element(dataJ.globalJ); for (const auto scvfIdx : dataJ.scvfsJ) { auto& scvfCache = fluxVarsCache_[i++]; diff --git a/dumux/discretization/cellcentered/mpfa/elementvolumevariables.hh b/dumux/discretization/cellcentered/mpfa/elementvolumevariables.hh index 8d3ba2f1968f7f32a81c06882774b35e8cf1c631..83b6b3a93acab074b3d263b98156c0c843a34969 100644 --- a/dumux/discretization/cellcentered/mpfa/elementvolumevariables.hh +++ b/dumux/discretization/cellcentered/mpfa/elementvolumevariables.hh @@ -48,13 +48,13 @@ namespace CCMpfa { template std::size_t maxNumBoundaryVolVars(const FVElementGeometry& fvGeometry) { - const auto& fvGridGeometry = fvGeometry.gridGeometry(); - const auto& gridIvIndexSets = fvGridGeometry.gridInteractionVolumeIndexSets(); + const auto& gridGeometry = fvGeometry.gridGeometry(); + const auto& gridIvIndexSets = gridGeometry.gridInteractionVolumeIndexSets(); std::size_t numBoundaryVolVars = 0; for (const auto& scvf : scvfs(fvGeometry)) { - if (!fvGridGeometry.vertexUsesSecondaryInteractionVolume(scvf.vertexIndex())) + if (!gridGeometry.vertexUsesSecondaryInteractionVolume(scvf.vertexIndex())) numBoundaryVolVars += gridIvIndexSets.primaryIndexSet(scvf).nodalIndexSet().numBoundaryScvfs(); else numBoundaryVolVars += gridIvIndexSets.secondaryIndexSet(scvf).nodalIndexSet().numBoundaryScvfs(); @@ -138,12 +138,12 @@ namespace CCMpfa { const typename FVElemGeom::GridGeometry::GridView::template Codim<0>::Entity& element, const FVElemGeom& fvGeometry) { - const auto& fvGridGeometry = fvGeometry.gridGeometry(); + const auto& gridGeometry = fvGeometry.gridGeometry(); // treat the BCs inside the element if (fvGeometry.hasBoundaryScvf()) { - const auto boundElemIdx = fvGridGeometry.elementMapper().index(element); + const auto boundElemIdx = gridGeometry.elementMapper().index(element); const auto& scvI = fvGeometry.scv(boundElemIdx); for (const auto& scvf : scvfs(fvGeometry)) @@ -168,10 +168,10 @@ namespace CCMpfa { } // Update boundary volume variables in the neighbors - const auto& gridIvIndexSets = fvGridGeometry.gridInteractionVolumeIndexSets(); + const auto& gridIvIndexSets = gridGeometry.gridInteractionVolumeIndexSets(); for (const auto& scvf : scvfs(fvGeometry)) { - if (!fvGridGeometry.vertexUsesSecondaryInteractionVolume(scvf.vertexIndex())) + if (!gridGeometry.vertexUsesSecondaryInteractionVolume(scvf.vertexIndex())) addBoundaryVolVarsAtNode( volVars, volVarIndices, problem, element, fvGeometry, gridIvIndexSets.primaryIndexSet(scvf).nodalIndexSet() ); else @@ -307,11 +307,11 @@ public: clear(); const auto& problem = gridVolVars().problem(); - const auto& fvGridGeometry = fvGeometry.gridGeometry(); + const auto& gridGeometry = fvGeometry.gridGeometry(); // stencil information - const auto globalI = fvGridGeometry.elementMapper().index(element); - const auto& assemblyMapI = fvGridGeometry.connectivityMap()[globalI]; + const auto globalI = gridGeometry.elementMapper().index(element); + const auto& assemblyMapI = gridGeometry.connectivityMap()[globalI]; const auto numVolVars = assemblyMapI.size() + 1; // resize local containers to the required size (for internal elements) @@ -321,7 +321,7 @@ public: VolumeVariables volVars; const auto& scvI = fvGeometry.scv(globalI); - volVars.update(elementSolution(element, sol, fvGridGeometry), + volVars.update(elementSolution(element, sol, gridGeometry), problem, element, scvI); @@ -332,10 +332,10 @@ public: // Update the volume variables of the neighboring elements for (auto&& dataJ : assemblyMapI) { - const auto& elementJ = fvGridGeometry.element(dataJ.globalJ); + const auto& elementJ = gridGeometry.element(dataJ.globalJ); const auto& scvJ = fvGeometry.scv(dataJ.globalJ); VolumeVariables volVarsJ; - volVarsJ.update(elementSolution(elementJ, sol, fvGridGeometry), + volVarsJ.update(elementSolution(elementJ, sol, gridGeometry), problem, elementJ, scvJ); @@ -357,11 +357,11 @@ public: // volVarIndices_.reserve(volVarIndices_.size() + additionalDofDependencies.size()); // for (auto globalJ : additionalDofDependencies) // { - // const auto& elementJ = fvGridGeometry.element(globalJ); + // const auto& elementJ = gridGeometry.element(globalJ); // const auto& scvJ = fvGeometry.scv(globalJ); // VolumeVariables additionalVolVars; - // additionalVolVars.update(elementSolution(elementJ, sol, fvGridGeometry), + // additionalVolVars.update(elementSolution(elementJ, sol, gridGeometry), // problem, // elementJ, // scvJ); @@ -380,14 +380,14 @@ public: { clear(); - const auto& fvGridGeometry = fvGeometry.gridGeometry(); - auto eIdx = fvGridGeometry.elementMapper().index(element); + const auto& gridGeometry = fvGeometry.gridGeometry(); + auto eIdx = gridGeometry.elementMapper().index(element); volumeVariables_.resize(1); volVarIndices_.resize(1); // update the volume variables of the element const auto& scv = fvGeometry.scv(eIdx); - volumeVariables_[0].update(elementSolution(element, sol, fvGridGeometry), + volumeVariables_[0].update(elementSolution(element, sol, gridGeometry), gridVolVars().problem(), element, scv); diff --git a/dumux/discretization/cellcentered/mpfa/fvelementgeometry.hh b/dumux/discretization/cellcentered/mpfa/fvelementgeometry.hh index 426d8a3ae23b1c09e00d50112024665284fe036c..7beedaa45f7095575e0bc2e81b4bfa2a7d061f08 100644 --- a/dumux/discretization/cellcentered/mpfa/fvelementgeometry.hh +++ b/dumux/discretization/cellcentered/mpfa/fvelementgeometry.hh @@ -154,7 +154,7 @@ public: //! The global finite volume geometry we are a restriction of [[deprecated("Use gridGeometry() instead. fvGridGeometry() will be removed after 3.1!")]] - const FVGridGeometry& fvGridGeometry() const + const GridGeometry& fvGridGeometry() const { return gridGeometry(); } const GridGeometry& gridGeometry() const { return *gridGeometryPtr_; } @@ -316,7 +316,7 @@ public: //! The global finite volume geometry we are a restriction of [[deprecated("Use gridGeometry() instead. fvGridGeometry() will be removed after 3.1!")]] - const FVGridGeometry& fvGridGeometry() const + const GridGeometry& fvGridGeometry() const { return gridGeometry(); } const GridGeometry& gridGeometry() const { return *gridGeometryPtr_; } diff --git a/dumux/discretization/cellcentered/mpfa/fvgridgeometrytraits.hh b/dumux/discretization/cellcentered/mpfa/fvgridgeometrytraits.hh index 6e9b2aa53a5d609c22fd3ddbf5a453de30e6b747..ad4620916a12c16935239d831d9931e9eca0b07a 100644 --- a/dumux/discretization/cellcentered/mpfa/fvgridgeometrytraits.hh +++ b/dumux/discretization/cellcentered/mpfa/fvgridgeometrytraits.hh @@ -56,7 +56,7 @@ struct CCMpfaFVGridGeometryTraits : public DefaultMapperTraits //! We assume simplex grids where stencils can get quite large but the size is unknown static constexpr int maxElementStencilSize = int(GV::dimension) == 3 ? 150 : (int(GV::dimension) using MpfaHelper = CCMpfaHelper< FVGridGeom >; template< class FVGridGeom > diff --git a/dumux/discretization/cellcentered/mpfa/gridfluxvariablescache.hh b/dumux/discretization/cellcentered/mpfa/gridfluxvariablescache.hh index a0c3cbb396ee40741e3aa97dee73990645c55f69..0b1a77744d09b6834dc448e8c312801022f691a3 100644 --- a/dumux/discretization/cellcentered/mpfa/gridfluxvariablescache.hh +++ b/dumux/discretization/cellcentered/mpfa/gridfluxvariablescache.hh @@ -124,8 +124,8 @@ public: {} //! When global caching is enabled, precompute transmissibilities for all scv faces - template - void update(const FVGridGeometry& fvGridGeometry, + template + void update(const GridGeometry& gridGeometry, const GridVolumeVariables& gridVolVars, const SolutionVector& sol, bool forceUpdate = false) @@ -139,7 +139,7 @@ public: { clear_(); - const auto& gridIvIndexSets = fvGridGeometry.gridInteractionVolumeIndexSets(); + const auto& gridIvIndexSets = gridGeometry.gridInteractionVolumeIndexSets(); const auto numPrimaryIvs = gridIvIndexSets.numPrimaryInteractionVolumes(); const auto numSecondaryIVs = gridIvIndexSets.numSecondaryInteractionVolumes(); ivDataStorage_.primaryInteractionVolumes.reserve(numPrimaryIvs); @@ -148,7 +148,7 @@ public: ivDataStorage_.secondaryDataHandles.reserve(numSecondaryIVs); // reserve memory estimate for caches, interaction volumes and corresponding data - fluxVarsCache_.resize(fvGridGeometry.numScvf()); + fluxVarsCache_.resize(gridGeometry.numScvf()); } // instantiate helper class to fill the caches @@ -158,9 +158,9 @@ public: for (auto& cache : fluxVarsCache_) cache.setUpdateStatus(false); - for (const auto& element : elements(fvGridGeometry.gridView())) + for (const auto& element : elements(gridGeometry.gridView())) { - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bind(element); auto elemVolVars = localView(gridVolVars); @@ -169,7 +169,7 @@ public: // Prepare all caches of the scvfs inside the corresponding interaction volume. Skip // those ivs that are touching a boundary, we only store the data on interior ivs here. for (const auto& scvf : scvfs(fvGeometry)) - if (!isEmbeddedInBoundaryIV_(scvf, fvGridGeometry) && !fluxVarsCache_[scvf.index()].isUpdated()) + if (!isEmbeddedInBoundaryIV_(scvf, gridGeometry) && !fluxVarsCache_[scvf.index()].isUpdated()) filler.fill(*this, fluxVarsCache_[scvf.index()], ivDataStorage_, element, fvGeometry, elemVolVars, scvf, forceUpdate); } } @@ -184,8 +184,8 @@ public: // solution-dependent stuff into the caches if (FluxVariablesCacheFiller::isSolDependent) { - const auto& fvGridGeometry = fvGeometry.gridGeometry(); - const auto& assemblyMapI = fvGridGeometry.connectivityMap()[fvGridGeometry.elementMapper().index(element)]; + const auto& gridGeometry = fvGeometry.gridGeometry(); + const auto& assemblyMapI = gridGeometry.connectivityMap()[gridGeometry.elementMapper().index(element)]; // helper class to fill flux variables caches FluxVariablesCacheFiller filler(problem()); @@ -201,18 +201,18 @@ public: for (const auto& scvf : scvfs(fvGeometry)) { auto& scvfCache = fluxVarsCache_[scvf.index()]; - if (!isEmbeddedInBoundaryIV_(scvf, fvGridGeometry) && !scvfCache.isUpdated()) + if (!isEmbeddedInBoundaryIV_(scvf, gridGeometry) && !scvfCache.isUpdated()) filler.fill(*this, scvfCache, ivDataStorage_, element, fvGeometry, elemVolVars, scvf); } for (const auto& dataJ : assemblyMapI) { - const auto elementJ = fvGridGeometry.element(dataJ.globalJ); + const auto elementJ = gridGeometry.element(dataJ.globalJ); for (const auto scvfIdx : dataJ.scvfsJ) { auto& scvfCache = fluxVarsCache_[scvfIdx]; const auto& scvf = fvGeometry.scvf(scvfIdx); - if (!isEmbeddedInBoundaryIV_(scvf, fvGridGeometry) && !scvfCache.isUpdated()) + if (!isEmbeddedInBoundaryIV_(scvf, gridGeometry) && !scvfCache.isUpdated()) filler.fill(*this, scvfCache, ivDataStorage_, elementJ, fvGeometry, elemVolVars, scvf); } } @@ -254,11 +254,11 @@ public: private: //! returns true if an scvf is contained in an interaction volume that touches the boundary - template - bool isEmbeddedInBoundaryIV_(const SubControlVolumeFace& scvf, const FVGridGeometry& fvGridGeometry) const + template + bool isEmbeddedInBoundaryIV_(const SubControlVolumeFace& scvf, const GridGeometry& gridGeometry) const { - const auto& gridIvIndexSets = fvGridGeometry.gridInteractionVolumeIndexSets(); - if (fvGridGeometry.vertexUsesSecondaryInteractionVolume(scvf.vertexIndex())) + const auto& gridIvIndexSets = gridGeometry.gridInteractionVolumeIndexSets(); + if (gridGeometry.vertexUsesSecondaryInteractionVolume(scvf.vertexIndex())) return gridIvIndexSets.secondaryIndexSet(scvf).nodalIndexSet().numBoundaryScvfs() > 0; else return gridIvIndexSets.primaryIndexSet(scvf).nodalIndexSet().numBoundaryScvfs() > 0; @@ -322,8 +322,8 @@ public: CCMpfaGridFluxVariablesCache(const Problem& problem) : problemPtr_(&problem) {} //! When global flux variables caching is disabled, we don't need to update the cache - template - void update(const FVGridGeometry& fvGridGeometry, + template + void update(const GridGeometry& gridGeometry, const GridVolumeVariables& gridVolVars, const SolutionVector& sol, bool forceUpdate = false) {} diff --git a/dumux/discretization/cellcentered/mpfa/gridinteractionvolumeindexsets.hh b/dumux/discretization/cellcentered/mpfa/gridinteractionvolumeindexsets.hh index 5a90d9e4e5b439bedd4504363c6a41e275c3b314..81c5e4e96d9c0570f332c33bdc8750969f181d5d 100644 --- a/dumux/discretization/cellcentered/mpfa/gridinteractionvolumeindexsets.hh +++ b/dumux/discretization/cellcentered/mpfa/gridinteractionvolumeindexsets.hh @@ -47,7 +47,7 @@ class CCMpfaGridInteractionVolumeIndexSets using SecondaryIVIndexSet = typename SI::Traits::IndexSet; public: - using FVGridGeometry = FVG; + using GridGeometry = FVG; using PrimaryInteractionVolume = PI; using SecondaryInteractionVolume = SI; @@ -57,10 +57,10 @@ public: /*! * \brief Construct all interaction volume index sets on the grid view * - * \param fvGridGeometry The finite volume geometry on the grid view + * \param gridGeometry The finite volume geometry on the grid view * \param dualGridIdSet The index sets of the dual grid on the grid view */ - void update(FVGridGeometry& fvGridGeometry, DualGridIndexSet&& dualGridIdSet) + void update(GridGeometry& gridGeometry, DualGridIndexSet&& dualGridIdSet) { dualGridIndexSet_ = std::make_unique(std::move(dualGridIdSet)); @@ -72,10 +72,10 @@ public: // find out how many primary & secondary interaction volumes are needed numPrimaryIV_ = 0; numSecondaryIV_ = 0; - for (const auto& vertex : vertices(fvGridGeometry.gridView())) + for (const auto& vertex : vertices(gridGeometry.gridView())) { - const auto vIdxGlobal = fvGridGeometry.vertexMapper().index(vertex); - if (!fvGridGeometry.vertexUsesSecondaryInteractionVolume(vIdxGlobal)) + const auto vIdxGlobal = gridGeometry.vertexMapper().index(vertex); + if (!gridGeometry.vertexUsesSecondaryInteractionVolume(vIdxGlobal)) numPrimaryIV_ += PrimaryInteractionVolume::numIVAtVertex((*dualGridIndexSet_)[vIdxGlobal]); else numSecondaryIV_ += SecondaryInteractionVolume::numIVAtVertex((*dualGridIndexSet_)[vIdxGlobal]); @@ -84,22 +84,22 @@ public: // reserve memory primaryIVIndexSets_.reserve(numPrimaryIV_); secondaryIVIndexSets_.reserve(numSecondaryIV_); - scvfIndexMap_.resize(fvGridGeometry.numScvf()); + scvfIndexMap_.resize(gridGeometry.numScvf()); // create interaction volume index sets around each vertex - for (const auto& vertex : vertices(fvGridGeometry.gridView())) + for (const auto& vertex : vertices(gridGeometry.gridView())) { - const auto vIdxGlobal = fvGridGeometry.vertexMapper().index(vertex); - if (!fvGridGeometry.vertexUsesSecondaryInteractionVolume(vIdxGlobal)) + const auto vIdxGlobal = gridGeometry.vertexMapper().index(vertex); + if (!gridGeometry.vertexUsesSecondaryInteractionVolume(vIdxGlobal)) PrimaryInteractionVolume::addIVIndexSets(primaryIVIndexSets_, scvfIndexMap_, (*dualGridIndexSet_)[vIdxGlobal], - fvGridGeometry.flipScvfIndexSet()); + gridGeometry.flipScvfIndexSet()); else SecondaryInteractionVolume::addIVIndexSets(secondaryIVIndexSets_, scvfIndexMap_, (*dualGridIndexSet_)[vIdxGlobal], - fvGridGeometry.flipScvfIndexSet()); + gridGeometry.flipScvfIndexSet()); } } diff --git a/dumux/discretization/cellcentered/mpfa/helper.hh b/dumux/discretization/cellcentered/mpfa/helper.hh index 8181a30ab78af9b24fd7044904638b0aa23dd61a..4acc361fcb17b3a55dc4bb4369816ea9db1ea61d 100644 --- a/dumux/discretization/cellcentered/mpfa/helper.hh +++ b/dumux/discretization/cellcentered/mpfa/helper.hh @@ -39,23 +39,23 @@ namespace Dumux { * \ingroup CCMpfaDiscretization * \brief Dimension-specific helper class to get data required for mpfa scheme. */ -template +template class MpfaDimensionHelper; /*! * \ingroup CCMpfaDiscretization * \brief Dimension-specific mpfa helper class for dim == 2 & dimWorld == 2 */ -template -class MpfaDimensionHelper +template +class MpfaDimensionHelper { - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using CoordScalar = typename GridView::ctype; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; using ScvfCornerVector = typename SubControlVolumeFace::Traits::CornerStorage; // Container to store the positions of intersections required for scvf @@ -199,11 +199,11 @@ public: * \brief Dimension-specific mpfa helper class for dim == 2 & dimWorld == 2. * Reuses some functionality of the specialization for dim = dimWorld = 2 */ -template -class MpfaDimensionHelper -: public MpfaDimensionHelper +template +class MpfaDimensionHelper +: public MpfaDimensionHelper { - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using CoordScalar = typename GridView::ctype; public: @@ -260,14 +260,14 @@ public: * \brief Dimension-specific mpfa helper class for dim == 3 & dimWorld == 3. * */ -template -class MpfaDimensionHelper +template +class MpfaDimensionHelper { - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; using ScvfCornerVector = typename SubControlVolumeFace::Traits::CornerStorage; // Be picky about the dimensions - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using CoordScalar = typename GridView::ctype; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -498,22 +498,22 @@ public: * \ingroup CCMpfaDiscretization * \brief Helper class to get the required information on an interaction volume. * - * \tparam FVGridGeometry The finite volume grid geometry + * \tparam GridGeometry The finite volume grid geometry */ -template -class CCMpfaHelper : public MpfaDimensionHelper +template +class CCMpfaHelper : public MpfaDimensionHelper { - using PrimaryInteractionVolume = typename FVGridGeometry::GridIVIndexSets::PrimaryInteractionVolume; - using SecondaryInteractionVolume = typename FVGridGeometry::GridIVIndexSets::SecondaryInteractionVolume; + using PrimaryInteractionVolume = typename GridGeometry::GridIVIndexSets::PrimaryInteractionVolume; + using SecondaryInteractionVolume = typename GridGeometry::GridIVIndexSets::SecondaryInteractionVolume; - using VertexMapper = typename FVGridGeometry::VertexMapper; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using VertexMapper = typename GridGeometry::VertexMapper; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using ScvfCornerVector = typename SubControlVolumeFace::Traits::CornerStorage; - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; static constexpr int dim = GridView::dimension; using Element = typename GridView::template Codim<0>::Entity; diff --git a/dumux/discretization/cellcentered/mpfa/scvgradients.hh b/dumux/discretization/cellcentered/mpfa/scvgradients.hh index dca568965edc6f3653a4f7158d14c79a5f1aa6f1..bb4f4c9ddcbae8c2408361d0f472a082d8bd2629 100644 --- a/dumux/discretization/cellcentered/mpfa/scvgradients.hh +++ b/dumux/discretization/cellcentered/mpfa/scvgradients.hh @@ -44,23 +44,23 @@ namespace Dumux { class CCMpfaScvGradients { //! Return type of the gradient computation function (pair of scv centers and corresponding gradients) - template - using ResultPair = std::pair< std::vector, - std::vector> >; + template + using ResultPair = std::pair< std::vector, + std::vector> >; public: /*! * \brief Computes the phase velocities in the scvs of the grid. * - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param gridVariables The variables living on the grid * \param x The vector containing the solution * \param phaseIdx The index of the fluid phase to be considered */ - template - static ResultPair - computeVelocities(const FVGridGeometry& fvGridGeometry, + template + static ResultPair + computeVelocities(const GridGeometry& gridGeometry, const GridVariables& gridVariables, const SolutionVector& x, unsigned int phaseIdx) @@ -72,32 +72,32 @@ public: return vel; }; - return computePressureGradients(fvGridGeometry, gridVariables, x, phaseIdx, gradToVelocity); + return computePressureGradients(gridGeometry, gridVariables, x, phaseIdx, gradToVelocity); } /*! * \brief Computes the pressure gradients in the scvs of the grid. * - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param gridVariables The variables living on the grid * \param x The vector containing the solution * \param phaseIdx The index of the fluid phase to be considered */ - template - static ResultPair - computePressureGradients(const FVGridGeometry& fvGridGeometry, + template + static ResultPair + computePressureGradients(const GridGeometry& gridGeometry, const GridVariables& gridVariables, const SolutionVector& x, unsigned int phaseIdx) { auto f = [] (const auto& grad, const auto& volVars) { return grad; }; - return computePressureGradients(fvGridGeometry, gridVariables, x, phaseIdx, f); + return computePressureGradients(gridGeometry, gridVariables, x, phaseIdx, f); } /*! * \brief Computes the pressure gradients in the scvs of the grid. * - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param gridVariables The variables living on the grid * \param x The vector containing the solution * \param phaseIdx The index of the fluid phase to be considered @@ -110,16 +110,16 @@ public: * variables and returns the modified gradient. This can be * used e.g. to turn the pressure gradients into velocities. */ - template - static ResultPair - computePressureGradients(const FVGridGeometry& fvGridGeometry, + template + static ResultPair + computePressureGradients(const GridGeometry& gridGeometry, const GridVariables& gridVariables, const SolutionVector& x, unsigned int phaseIdx, F& f) { using ElemVolVars = typename GridVariables::GridVolumeVariables::LocalView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; auto handleFunction = [&] (auto& result, const auto& handle, @@ -138,7 +138,7 @@ public: } }; - return computeGradients_(fvGridGeometry, gridVariables, x, handleFunction); + return computeGradients_(gridGeometry, gridVariables, x, handleFunction); } private: @@ -146,23 +146,23 @@ private: * \brief Computes the gradients executing the provided function * on an interaction volume / data handle pair. */ - template - static ResultPair - computeGradients_(const FVGridGeometry& fvGridGeometry, + template + static ResultPair + computeGradients_(const GridGeometry& gridGeometry, const GridVariables& gridVariables, const SolutionVector& x, const HandleFunction& handleFunction) { - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; static constexpr int dim = GridView::dimension; // first, find out how many scvs live on this grid std::size_t numScvs = 0; - const auto& gridView = fvGridGeometry.gridView(); + const auto& gridView = gridGeometry.gridView(); for (const auto& element : elements(gridView)) numScvs += element.subEntities(dim); - ResultPair result; + ResultPair result; result.first.reserve(numScvs); result.second.reserve(numScvs); std::vector vertexHandled(gridView.size(dim), false); @@ -171,7 +171,7 @@ private: { bool allFinished = true; for (int i = 0; i < element.subEntities(dim); ++i) - if (!vertexHandled[fvGridGeometry.vertexMapper().subIndex(element, i, dim)]) + if (!vertexHandled[gridGeometry.vertexMapper().subIndex(element, i, dim)]) allFinished = false; // bind views only if there is unfinished buisness @@ -179,7 +179,7 @@ private: continue; // compute gradients in all scvs of all interaction volumes in this element - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); auto elemVolVars = localView(gridVariables.curGridVolVars()); auto elemFluxVarsCache = localView(gridVariables.gridFluxVarsCache()); fvGeometry.bind(element); @@ -191,7 +191,7 @@ private: if (vertexHandled[scvf.vertexIndex()]) continue; - if (fvGridGeometry.vertexUsesSecondaryInteractionVolume(scvf.vertexIndex())) + if (gridGeometry.vertexUsesSecondaryInteractionVolume(scvf.vertexIndex())) { const auto& iv = elemFluxVarsCache.secondaryInteractionVolume(scvf); const auto& handle = elemFluxVarsCache.secondaryDataHandle(scvf); diff --git a/dumux/discretization/cellcentered/tpfa/elementfluxvariablescache.hh b/dumux/discretization/cellcentered/tpfa/elementfluxvariablescache.hh index b6686a5dd5825ad33980d6195f07777bd5857914..44afab9f1e837a71440c8a3b37b1b77798af6448 100644 --- a/dumux/discretization/cellcentered/tpfa/elementfluxvariablescache.hh +++ b/dumux/discretization/cellcentered/tpfa/elementfluxvariablescache.hh @@ -159,9 +159,9 @@ public: const ElementVolumeVariables& elemVolVars) { const auto& problem = gridFluxVarsCache().problem(); - const auto& fvGridGeometry = fvGeometry.gridGeometry(); - const auto globalI = fvGridGeometry.elementMapper().index(element); - const auto& connectivityMapI = fvGridGeometry.connectivityMap()[globalI]; + const auto& gridGeometry = fvGeometry.gridGeometry(); + const auto globalI = gridGeometry.elementMapper().index(element); + const auto& connectivityMapI = gridGeometry.connectivityMap()[globalI]; const auto numNeighbors = connectivityMapI.size(); // instantiate helper class to fill the caches @@ -186,7 +186,7 @@ public: // add required data on the scv faces in the neighboring elements for (unsigned int localIdxJ = 0; localIdxJ < numNeighbors; ++localIdxJ) { - const auto elementJ = fvGridGeometry.element(connectivityMapI[localIdxJ].globalJ); + const auto elementJ = gridGeometry.element(connectivityMapI[localIdxJ].globalJ); for (auto scvfIdx : connectivityMapI[localIdxJ].scvfsJ) { auto&& scvfJ = fvGeometry.scvf(scvfIdx); diff --git a/dumux/discretization/cellcentered/tpfa/elementvolumevariables.hh b/dumux/discretization/cellcentered/tpfa/elementvolumevariables.hh index 4344892d3f950554de3d9136876f2b97b70376ac..e10d37ac5cbae1cc063cf1378144a11a855f0be6 100644 --- a/dumux/discretization/cellcentered/tpfa/elementvolumevariables.hh +++ b/dumux/discretization/cellcentered/tpfa/elementvolumevariables.hh @@ -182,9 +182,9 @@ public: clear_(); const auto& problem = gridVolVars().problem(); - const auto& fvGridGeometry = fvGeometry.gridGeometry(); - const auto globalI = fvGridGeometry.elementMapper().index(element); - const auto& connectivityMapI = fvGridGeometry.connectivityMap()[globalI]; + const auto& gridGeometry = fvGeometry.gridGeometry(); + const auto globalI = gridGeometry.elementMapper().index(element); + const auto& connectivityMapI = gridGeometry.connectivityMap()[globalI]; const auto numDofs = connectivityMapI.size() + 1; // resize local containers to the required size (for internal elements) @@ -194,7 +194,7 @@ public: // update the volume variables of the element at hand auto&& scvI = fvGeometry.scv(globalI); - volumeVariables_[localIdx].update(elementSolution(element, sol, fvGridGeometry), + volumeVariables_[localIdx].update(elementSolution(element, sol, gridGeometry), problem, element, scvI); @@ -204,9 +204,9 @@ public: // Update the volume variables of the neighboring elements for (const auto& dataJ : connectivityMapI) { - const auto& elementJ = fvGridGeometry.element(dataJ.globalJ); + const auto& elementJ = gridGeometry.element(dataJ.globalJ); auto&& scvJ = fvGeometry.scv(dataJ.globalJ); - volumeVariables_[localIdx].update(elementSolution(elementJ, sol, fvGridGeometry), + volumeVariables_[localIdx].update(elementSolution(elementJ, sol, gridGeometry), problem, elementJ, scvJ); @@ -250,10 +250,10 @@ public: // volVarIndices_.resize(volVarIndices_.size() + additionalDofDependencies.size()); // for (auto globalJ : additionalDofDependencies) // { - // const auto& elementJ = fvGridGeometry.element(globalJ); + // const auto& elementJ = gridGeometry.element(globalJ); // auto&& scvJ = fvGeometry.scv(globalJ); - // volumeVariables_[localIdx].update(elementSolution(elementJ, sol, fvGridGeometry), + // volumeVariables_[localIdx].update(elementSolution(elementJ, sol, gridGeometry), // problem, // elementJ, // scvJ); diff --git a/dumux/discretization/cellcentered/tpfa/fvelementgeometry.hh b/dumux/discretization/cellcentered/tpfa/fvelementgeometry.hh index 07798af3303373d043507069dff4ab5202ac99b0..155d9fe58005e7bdd76df23a2b89964d0f6b7ef8 100644 --- a/dumux/discretization/cellcentered/tpfa/fvelementgeometry.hh +++ b/dumux/discretization/cellcentered/tpfa/fvelementgeometry.hh @@ -159,7 +159,7 @@ public: const GridGeometry& gridGeometry() const { return *gridGeometryPtr_; } [[deprecated("Use gridGeometry() instead. fvGridGeometry() will be removed after 3.1!")]] - const FVGridGeometry& fvGridGeometry() const + const GridGeometry& fvGridGeometry() const { return gridGeometry(); } //! Returns whether one of the geometry's scvfs lies on a boundary @@ -363,7 +363,7 @@ public: const GridGeometry& gridGeometry() const { return *gridGeometryPtr_; } [[deprecated("Use gridGeometry() instead. fvGridGeometry() will be removed after 3.1!")]] - const FVGridGeometry& fvGridGeometry() const + const GridGeometry& fvGridGeometry() const { return gridGeometry(); } //! Returns whether one of the geometry's scvfs lies on a boundary diff --git a/dumux/discretization/cellcentered/tpfa/fvgridgeometry.hh b/dumux/discretization/cellcentered/tpfa/fvgridgeometry.hh index 6e91c8b4f13c1aea2401d082df4506cec2c737d5..5ec25e498cf323a50836b90b28d226df01b30957 100644 --- a/dumux/discretization/cellcentered/tpfa/fvgridgeometry.hh +++ b/dumux/discretization/cellcentered/tpfa/fvgridgeometry.hh @@ -54,11 +54,11 @@ struct CCTpfaDefaultGridGeometryTraits using SubControlVolume = CCSubControlVolume; using SubControlVolumeFace = CCTpfaSubControlVolumeFace; - template - using ConnectivityMap = CCSimpleConnectivityMap; + template + using ConnectivityMap = CCSimpleConnectivityMap; - template - using LocalView = CCTpfaFVElementGeometry; + template + using LocalView = CCTpfaFVElementGeometry; //! State the maximum admissible number of neighbors per scvf //! Per default, we allow for 8 branches on network/surface grids, where diff --git a/dumux/discretization/cellcentered/tpfa/gridfluxvariablescache.hh b/dumux/discretization/cellcentered/tpfa/gridfluxvariablescache.hh index fce7d81ec35140812fe57027829d5cf7bfc16ea6..f368da20db8e14d537a5cb731c8addeb2e4b9a81 100644 --- a/dumux/discretization/cellcentered/tpfa/gridfluxvariablescache.hh +++ b/dumux/discretization/cellcentered/tpfa/gridfluxvariablescache.hh @@ -87,8 +87,8 @@ public: CCTpfaGridFluxVariablesCache(const Problem& problem) : problemPtr_(&problem) {} // When global caching is enabled, precompute transmissibilities and stencils for all the scv faces - template - void update(const FVGridGeometry& fvGridGeometry, + template + void update(const GridGeometry& gridGeometry, const GridVolumeVariables& gridVolVars, const SolutionVector& sol, bool forceUpdate = false) @@ -99,11 +99,11 @@ public: // instantiate helper class to fill the caches FluxVariablesCacheFiller filler(problem()); - fluxVarsCache_.resize(fvGridGeometry.numScvf()); - for (const auto& element : elements(fvGridGeometry.gridView())) + fluxVarsCache_.resize(gridGeometry.numScvf()); + for (const auto& element : elements(gridGeometry.gridView())) { // Prepare the geometries within the elements of the stencil - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bind(element); auto elemVolVars = localView(gridVolVars); @@ -194,8 +194,8 @@ public: CCTpfaGridFluxVariablesCache(const Problem& problem) : problemPtr_(&problem) {} //! When global flux variables caching is disabled, we don't need to update the cache - template - void update(const FVGridGeometry& fvGridGeometry, + template + void update(const GridGeometry& gridGeometry, const GridVolumeVariables& gridVolVars, const SolutionVector& sol, bool forceUpdate = false) {} diff --git a/dumux/discretization/evalgradients.hh b/dumux/discretization/evalgradients.hh index 555dc8a350564f5bfff9afe8f2ef3266985221ad..e891f659574eea5f8ef3f156d986db97cb713449 100644 --- a/dumux/discretization/evalgradients.hh +++ b/dumux/discretization/evalgradients.hh @@ -42,7 +42,7 @@ namespace Dumux { * * \param element The element * \param geometry The element geometry - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param elemSol The primary variables at the dofs of the element * \param globalPos The global position * \param ignoreState If true, the state of primary variables is ignored @@ -54,7 +54,7 @@ namespace Dumux { template auto evalGradients(const Element& element, const typename Element::Geometry& geometry, - const typename FVElementGeometry::GridGeometry& fvGridGeometry, + const typename FVElementGeometry::GridGeometry& gridGeometry, const BoxElementSolution& elemSol, const typename Element::Geometry::GlobalCoordinate& globalPos, bool ignoreState = false) @@ -68,7 +68,7 @@ auto evalGradients(const Element& element, using GlobalPosition = typename Element::Geometry::GlobalCoordinate; // evaluate gradients using the local finite element basis - const auto& localBasis = fvGridGeometry.feCache().get(geometry.type()).localBasis(); + const auto& localBasis = gridGeometry.feCache().get(geometry.type()).localBasis(); // evaluate the shape function gradients at the scv center using ShapeJacobian = typename std::decay_t< decltype(localBasis) >::Traits::JacobianType; @@ -114,7 +114,7 @@ auto evalGradients(const Element& element, * * \param element The element * \param geometry The element geometry - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param elemSol The primary variables at the dofs of the element * \param globalPos The global position * \throws Dune::NotImplemented @@ -127,7 +127,7 @@ template Dune::FieldVector evalGradients(const Element& element, const typename Element::Geometry& geometry, - const typename FVElementGeometry::GridGeometry& fvGridGeometry, + const typename FVElementGeometry::GridGeometry& gridGeometry, const CCElementSolution& elemSol, const typename Element::Geometry::GlobalCoordinate& globalPos) { DUNE_THROW(Dune::NotImplemented, "General gradient evaluation for cell-centered methods"); } diff --git a/dumux/discretization/evalsolution.hh b/dumux/discretization/evalsolution.hh index 56cc98e815035decca21a3e788659627ade55472..bfe27da98bc825968def22521e986c82d39cc7a3 100644 --- a/dumux/discretization/evalsolution.hh +++ b/dumux/discretization/evalsolution.hh @@ -86,7 +86,7 @@ auto minDistVertexSol(const Geometry& geometry, const typename Geometry::GlobalC * \return the interpolated primary variables * \param element The element * \param geometry The element geometry - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param elemSol The primary variables at the dofs of the element * \param globalPos The global position * \param ignoreState If true, the state of primary variables is ignored @@ -94,7 +94,7 @@ auto minDistVertexSol(const Geometry& geometry, const typename Geometry::GlobalC template PrimaryVariables evalSolution(const Element& element, const typename Element::Geometry& geometry, - const typename FVElementGeometry::GridGeometry& fvGridGeometry, + const typename FVElementGeometry::GridGeometry& gridGeometry, const BoxElementSolution& elemSol, const typename Element::Geometry::GlobalCoordinate& globalPos, bool ignoreState = false) @@ -108,7 +108,7 @@ PrimaryVariables evalSolution(const Element& element, using Scalar = typename PrimaryVariables::value_type; // interpolate the solution - const auto& localBasis = fvGridGeometry.feCache().get(geometry.type()).localBasis(); + const auto& localBasis = gridGeometry.feCache().get(geometry.type()).localBasis(); // evaluate the shape functions at the scv center const auto localPos = geometry.local(globalPos); @@ -150,7 +150,7 @@ PrimaryVariables evalSolution(const Element& element, * \ingroup Discretization * \brief Interpolates a given box element solution at a given global position. * - * Overload of the above evalSolution() function without a given fvGridGeometry. + * Overload of the above evalSolution() function without a given gridGeometry. * The local basis is computed on the fly. * * \return the interpolated primary variables @@ -228,7 +228,7 @@ PrimaryVariables evalSolution(const Element& element, * \return the primary variables (constant over the element) * \param element The element * \param geometry The element geometry - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param elemSol The primary variables at the dofs of the element * \param globalPos The global position * \param ignoreState If true, the state of primary variables is ignored @@ -236,7 +236,7 @@ PrimaryVariables evalSolution(const Element& element, template PrimaryVariables evalSolution(const Element& element, const typename Element::Geometry& geometry, - const typename FVElementGeometry::GridGeometry& fvGridGeometry, + const typename FVElementGeometry::GridGeometry& gridGeometry, const CCElementSolution& elemSol, const typename Element::Geometry::GlobalCoordinate& globalPos, bool ignoreState = false) @@ -246,7 +246,7 @@ PrimaryVariables evalSolution(const Element& element, /*! * \brief Interpolates a given cell-centered element solution at a given global position. - * Overload of the above evalSolution() function without a given fvGridGeometry. + * Overload of the above evalSolution() function without a given gridGeometry. * For compatibility reasons with the box scheme. * \ingroup Discretization * diff --git a/dumux/discretization/fluxstencil.hh b/dumux/discretization/fluxstencil.hh index c892fef6da22a18847e5c06504db8b2bbf30777e..f671e143b3621aefc4d5eaa476a3afe8931b60fd 100644 --- a/dumux/discretization/fluxstencil.hh +++ b/dumux/discretization/fluxstencil.hh @@ -52,9 +52,9 @@ class FluxStencil; template class FluxStencil { - using FVGridGeometry = typename FVElementGeometry::GridGeometry; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = typename FVElementGeometry::GridGeometry; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GridIndexType = typename IndexTraits::GridIndex; @@ -92,14 +92,14 @@ public: template class FluxStencil { - using FVGridGeometry = typename FVElementGeometry::GridGeometry; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = typename FVElementGeometry::GridGeometry; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GridIndexType = typename IndexTraits::GridIndex; // Use the stencil type of the primary interaction volume - using NodalIndexSet = typename FVGridGeometry::GridIVIndexSets::DualGridIndexSet::NodalIndexSet; + using NodalIndexSet = typename GridGeometry::GridIVIndexSets::DualGridIndexSet::NodalIndexSet; public: //! We don't know yet how many faces couple to a neighboring element @@ -113,13 +113,13 @@ public: const FVElementGeometry& fvGeometry, const SubControlVolumeFace& scvf) { - const auto& fvGridGeometry = fvGeometry.gridGeometry(); + const auto& gridGeometry = fvGeometry.gridGeometry(); // return the scv (element) indices in the interaction region - if (fvGridGeometry.vertexUsesSecondaryInteractionVolume(scvf.vertexIndex())) - return fvGridGeometry.gridInteractionVolumeIndexSets().secondaryIndexSet(scvf).gridScvIndices(); + if (gridGeometry.vertexUsesSecondaryInteractionVolume(scvf.vertexIndex())) + return gridGeometry.gridInteractionVolumeIndexSets().secondaryIndexSet(scvf).gridScvIndices(); else - return fvGridGeometry.gridInteractionVolumeIndexSets().primaryIndexSet(scvf).gridScvIndices(); + return gridGeometry.gridInteractionVolumeIndexSets().primaryIndexSet(scvf).gridScvIndices(); } }; diff --git a/dumux/discretization/fvgridvariables.hh b/dumux/discretization/fvgridvariables.hh index 751bfff5a06e72109cf940486c0939070566bff4..3df3811fd115f33f8f00918b0e59189a9dea0207 100644 --- a/dumux/discretization/fvgridvariables.hh +++ b/dumux/discretization/fvgridvariables.hh @@ -61,8 +61,8 @@ public: template FVGridVariables(std::shared_ptr problem, - std::shared_ptr fvGridGeometry) - : fvGridGeometry_(fvGridGeometry) + std::shared_ptr gridGeometry) + : gridGeometry_(gridGeometry) , curGridVolVars_(*problem) , prevGridVolVars_(*problem) , gridFluxVarsCache_(*problem) @@ -73,10 +73,10 @@ public: void init(const SolutionVector& curSol) { // resize and update the volVars with the initial solution - curGridVolVars_.update(*fvGridGeometry_, curSol); + curGridVolVars_.update(*gridGeometry_, curSol); // update the flux variables caches (always force flux cache update on initialization) - gridFluxVarsCache_.update(*fvGridGeometry_, curGridVolVars_, curSol, true); + gridFluxVarsCache_.update(*gridGeometry_, curGridVolVars_, curSol, true); // set the volvars of the previous time step in case we have an instationary problem // note that this means some memory overhead in the case of enabled caching, however @@ -99,10 +99,10 @@ public: void update(const SolutionVector& curSol, bool forceFluxCacheUpdate = false) { // resize and update the volVars with the initial solution - curGridVolVars_.update(*fvGridGeometry_, curSol); + curGridVolVars_.update(*gridGeometry_, curSol); // update the flux variables caches - gridFluxVarsCache_.update(*fvGridGeometry_, curGridVolVars_, curSol, forceFluxCacheUpdate); + gridFluxVarsCache_.update(*gridGeometry_, curGridVolVars_, curSol, forceFluxCacheUpdate); } //! update all variables after grid adaption @@ -134,7 +134,7 @@ public: curGridVolVars_ = prevGridVolVars_; // update the flux variables caches - gridFluxVarsCache_.update(*fvGridGeometry_, curGridVolVars_, solution); + gridFluxVarsCache_.update(*gridGeometry_, curGridVolVars_, solution); } //! return the flux variables cache @@ -168,11 +168,11 @@ public: //! return the finite volume grid geometry const GridGeometry& gridGeometry() const - { return *fvGridGeometry_; } + { return *gridGeometry_; } protected: - std::shared_ptr fvGridGeometry_; //!< pointer to the constant grid geometry + std::shared_ptr gridGeometry_; //!< pointer to the constant grid geometry private: GridVolumeVariables curGridVolVars_; //!< the current volume variables (primary and secondary variables) diff --git a/dumux/discretization/localview.hh b/dumux/discretization/localview.hh index d05420ee8d43f9e9aa3b36326c1cd76cbaebfd31..fc230e8b5d34c4ba876144e482f50e64c751b862 100644 --- a/dumux/discretization/localview.hh +++ b/dumux/discretization/localview.hh @@ -31,7 +31,7 @@ namespace Dumux { * \ingroup Discretization * \brief Free function to get the local view of a grid cache object * \note A local object is only functional after calling its bind/bindElement method. - * \tparam GridCache the grid caching type (such as FVGridGeometry) + * \tparam GridCache the grid caching type (such as GridGeometry) * \param gridCache the grid caching object we want to localView from */ template diff --git a/dumux/discretization/staggered/facesolution.hh b/dumux/discretization/staggered/facesolution.hh index 29d3bad86ca5629f76b8d810f9378597d0447fa3..58aa36181e7dfb20a5441c4f7bc019ea5bd87cd9 100644 --- a/dumux/discretization/staggered/facesolution.hh +++ b/dumux/discretization/staggered/facesolution.hh @@ -42,13 +42,13 @@ class StaggeredFaceSolution public: - template + template StaggeredFaceSolution(const SubControlVolumeFace& scvf, const FaceSolutionVector& sol, - const FVGridGeometry& fvGridGeometry) + const GridGeometry& gridGeometry) { - const auto& connectivityMap = fvGridGeometry.connectivityMap(); - const auto& stencil = connectivityMap(FVGridGeometry::faceIdx(), FVGridGeometry::faceIdx(), scvf.index()); + const auto& connectivityMap = gridGeometry.connectivityMap(); + const auto& stencil = connectivityMap(GridGeometry::faceIdx(), GridGeometry::faceIdx(), scvf.index()); facePriVars_.reserve(stencil.size()+1); map_.reserve(stencil.size()+1); diff --git a/dumux/discretization/staggered/freeflow/connectivitymap.hh b/dumux/discretization/staggered/freeflow/connectivitymap.hh index 23981f35b36cb6562bf0438324ce082072da158f..c9a06874f9698f2768596a176af684b53f20b062 100644 --- a/dumux/discretization/staggered/freeflow/connectivitymap.hh +++ b/dumux/discretization/staggered/freeflow/connectivitymap.hh @@ -34,51 +34,51 @@ namespace Dumux { * \brief Stores the dof indices corresponding to the neighboring cell centers and faces * that contribute to the derivative calculation. Specialization for the staggered free flow model. */ -template +template class StaggeredFreeFlowConnectivityMap { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; using Element = typename GridView::template Codim<0>::Entity; using GridIndexType = typename IndexTraits::GridIndex; - using CellCenterIdxType = typename FVGridGeometry::DofTypeIndices::CellCenterIdx; - using FaceIdxType = typename FVGridGeometry::DofTypeIndices::FaceIdx; + using CellCenterIdxType = typename GridGeometry::DofTypeIndices::CellCenterIdx; + using FaceIdxType = typename GridGeometry::DofTypeIndices::FaceIdx; using SmallLocalIndex = typename IndexTraits::SmallLocalIndex; using Stencil = std::vector; using Map = std::vector; - static constexpr SmallLocalIndex upwindSchemeOrder = FVGridGeometry::upwindSchemeOrder; + static constexpr SmallLocalIndex upwindSchemeOrder = GridGeometry::upwindSchemeOrder; static constexpr bool useHigherOrder = upwindSchemeOrder > 1; public: //! Update the map and prepare the stencils - void update(const FVGridGeometry& fvGridGeometry) + void update(const GridGeometry& gridGeometry) { - const auto numDofsCC = fvGridGeometry.gridView().size(0); - const auto numDofsFace = fvGridGeometry.gridView().size(1); - const auto numBoundaryFacets = fvGridGeometry.numBoundaryScvf(); + const auto numDofsCC = gridGeometry.gridView().size(0); + const auto numDofsFace = gridGeometry.gridView().size(1); + const auto numBoundaryFacets = gridGeometry.numBoundaryScvf(); cellCenterToCellCenterMap_.resize(numDofsCC); cellCenterToFaceMap_.resize(numDofsCC); faceToCellCenterMap_.resize(2*numDofsFace - numBoundaryFacets); faceToFaceMap_.resize(2*numDofsFace - numBoundaryFacets); - for(auto&& element: elements(fvGridGeometry.gridView())) + for(auto&& element: elements(gridGeometry.gridView())) { // restrict the FvGeometry locally and bind to the element - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bindElement(element); // loop over sub control faces for (auto&& scvf : scvfs(fvGeometry)) { // handle the cell center dof stencils first - const auto dofIdxCellCenter = fvGridGeometry.elementMapper().index(element); + const auto dofIdxCellCenter = gridGeometry.elementMapper().index(element); // the stencil for cell center dofs w.r.t. to other cell center dofs, // includes all neighboring element indices diff --git a/dumux/discretization/staggered/freeflow/elementvolumevariables.hh b/dumux/discretization/staggered/freeflow/elementvolumevariables.hh index 7c57103a7ca525f983c17d294640e5696323ba05..67b0acd3fc82465cf77f51e1f6f106e2d18fba22 100644 --- a/dumux/discretization/staggered/freeflow/elementvolumevariables.hh +++ b/dumux/discretization/staggered/freeflow/elementvolumevariables.hh @@ -209,9 +209,9 @@ public: clear_(); const auto& problem = gridVolVars().problem(); - const auto& fvGridGeometry = fvGeometry.gridGeometry(); - const auto globalI = fvGridGeometry.elementMapper().index(element); - const auto& map = fvGridGeometry.connectivityMap(); + const auto& gridGeometry = fvGeometry.gridGeometry(); + const auto globalI = gridGeometry.elementMapper().index(element); + const auto& map = gridGeometry.connectivityMap(); constexpr auto cellCenterIdx = FVElementGeometry::GridGeometry::cellCenterIdx(); const auto& connectivityMapI = map(cellCenterIdx, cellCenterIdx, globalI); const auto numDofs = connectivityMapI.size(); @@ -226,7 +226,7 @@ public: // Lambda to update the volume variables of the given index auto doVolVarUpdate = [&](int globalJ) { - const auto& elementJ = fvGridGeometry.element(globalJ); + const auto& elementJ = gridGeometry.element(globalJ); auto&& scvJ = fvGeometry.scv(globalJ); const auto elemSol = makeElementSolutionFromCellCenterPrivars(sol[globalJ]); volumeVariables_[localIdx].update(elemSol, diff --git a/dumux/discretization/staggered/freeflow/fvgridgeometrytraits.hh b/dumux/discretization/staggered/freeflow/fvgridgeometrytraits.hh index c9e88535066c1de09024b420d6427001c08d74ea..f321e56e2cdf2d90062b24ba68d5d80461525c2d 100644 --- a/dumux/discretization/staggered/freeflow/fvgridgeometrytraits.hh +++ b/dumux/discretization/staggered/freeflow/fvgridgeometrytraits.hh @@ -55,11 +55,11 @@ struct StaggeredFreeFlowDefaultFVGridGeometryTraits using FaceIdx = Dune::index_constant<1>; }; - template - using ConnectivityMap = StaggeredFreeFlowConnectivityMap; + template + using ConnectivityMap = StaggeredFreeFlowConnectivityMap; - template - using LocalView = StaggeredFVElementGeometry; + template + using LocalView = StaggeredFVElementGeometry; }; } //end namespace Dumux diff --git a/dumux/discretization/staggered/freeflow/gridvolumevariables.hh b/dumux/discretization/staggered/freeflow/gridvolumevariables.hh index 580dbae39d1c757f4b679cc423f808eb072e6a29..7170c40cd65878be68dcc7583b57c5a8a0f6c18b 100644 --- a/dumux/discretization/staggered/freeflow/gridvolumevariables.hh +++ b/dumux/discretization/staggered/freeflow/gridvolumevariables.hh @@ -159,15 +159,15 @@ public: StaggeredGridVolumeVariables(const Problem& problem) : problemPtr_(&problem) {} //! Update all volume variables - template - void update(const FVGridGeometry& fvGridGeometry, const SolutionVector& sol) + template + void update(const GridGeometry& gridGeometry, const SolutionVector& sol) { - auto numScv = fvGridGeometry.numScv(); + auto numScv = gridGeometry.numScv(); volumeVariables_.resize(numScv); - for (const auto& element : elements(fvGridGeometry.gridView())) + for (const auto& element : elements(gridGeometry.gridView())) { - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bindElement(element); for (auto&& scv : scvs(fvGeometry)) @@ -176,7 +176,7 @@ public: const auto& cellCenterPriVars = sol[scv.dofIndex()]; PrimaryVariables priVars = makePriVarsFromCellCenterPriVars(cellCenterPriVars); - auto elemSol = elementSolution(std::move(priVars)); + auto elemSol = elementSolution(std::move(priVars)); volumeVariables_[scv.dofIndex()].update(elemSol, problem(), element, scv); } } @@ -239,8 +239,8 @@ public: StaggeredGridVolumeVariables(const Problem& problem) : problemPtr_(&problem) {} - template - void update(const FVGridGeometry& fvGridGeometry, const SolutionVector& sol) {} + template + void update(const GridGeometry& gridGeometry, const SolutionVector& sol) {} const Problem& problem() const { return *problemPtr_;} diff --git a/dumux/discretization/staggered/freeflow/velocityoutput.hh b/dumux/discretization/staggered/freeflow/velocityoutput.hh index 1d4354093c70a595abbce99373c158cdd602f194..cb9b0e9a5c8c91350b59b0c9523d72b076a9236a 100644 --- a/dumux/discretization/staggered/freeflow/velocityoutput.hh +++ b/dumux/discretization/staggered/freeflow/velocityoutput.hh @@ -37,16 +37,16 @@ template class StaggeredFreeFlowVelocityOutput : public VelocityOutput { using ParentType = VelocityOutput; - using FVGridGeometry = typename GridVariables::GridGeometry; + using GridGeometry = typename GridVariables::GridGeometry; using Scalar = typename GridVariables::Scalar; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; using GridVolumeVariables = typename GridVariables::GridVolumeVariables; using ElementVolumeVariables = typename GridVolumeVariables::LocalView; using ElementFluxVarsCache = typename GridVariables::GridFluxVariablesCache::LocalView; using VolumeVariables = typename GridVariables::VolumeVariables; using FluidSystem = typename VolumeVariables::FluidSystem; - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; // TODO: should be possible to get this somehow using Problem = typename std::decay_t().problem())>; using Element = typename GridView::template Codim<0>::Entity; diff --git a/dumux/discretization/staggered/fvelementgeometry.hh b/dumux/discretization/staggered/fvelementgeometry.hh index f1e91e583002abf28648633f453005a890d82c98..b29bb9d435884293e8cd9e27b7f39716e3237d16 100644 --- a/dumux/discretization/staggered/fvelementgeometry.hh +++ b/dumux/discretization/staggered/fvelementgeometry.hh @@ -66,7 +66,7 @@ public: //! Needed for the multi-domain framework. template StaggeredFVElementGeometry(const CellCenterOrFaceFVGridGeometry& gridGeometry) - : ParentType(gridGeometry.actualfvGridGeometry()) {} + : ParentType(gridGeometry.actualGridGeometry()) {} //! Get a sub control volume face with an element index and a local scvf index using ParentType::scvf; @@ -105,7 +105,7 @@ public: //! Needed for the multi-domain framework. template StaggeredFVElementGeometry(const CellCenterOrFaceFVGridGeometry& gridGeometry) - : gridGeometryPtr_(&gridGeometry.actualfvGridGeometry()) {} + : gridGeometryPtr_(&gridGeometry.actualGridGeometry()) {} //! Constructor StaggeredFVElementGeometry(const GridGeometry& gridGeometry) diff --git a/dumux/discretization/staggered/fvgridgeometry.hh b/dumux/discretization/staggered/fvgridgeometry.hh index ac8bc79ccbce2e4454a1105359df712adbab49ea..466b48f1ce122209028643a797e7414b342055ad 100644 --- a/dumux/discretization/staggered/fvgridgeometry.hh +++ b/dumux/discretization/staggered/fvgridgeometry.hh @@ -34,20 +34,20 @@ namespace Dumux { /*! * \ingroup StaggeredDiscretization * \brief Base class for cell center of face specific auxiliary FvGridGeometry classes. - * Provides a common interface and a pointer to the actual fvGridGeometry. + * Provides a common interface and a pointer to the actual gridGeometry. */ -template +template class GridGeometryView { public: - explicit GridGeometryView(const ActualFVGridGeometry* actualFVGridGeometry) - : fvGridGeometry_(actualFVGridGeometry) {} + explicit GridGeometryView(const ActualGridGeometry* actualGridGeometry) + : gridGeometry_(actualGridGeometry) {} //! export the GridView type and the discretization method - using GridView = typename ActualFVGridGeometry::GridView; + using GridView = typename ActualGridGeometry::GridView; static constexpr DiscretizationMethod discMethod = DiscretizationMethod::staggered; - using LocalView = typename ActualFVGridGeometry::LocalView; + using LocalView = typename ActualGridGeometry::LocalView; /*! * \brief Returns true if this view if related to cell centered dofs @@ -63,47 +63,54 @@ public: * \brief Return an integral constant index for cell centered dofs */ static constexpr auto cellCenterIdx() - { return typename ActualFVGridGeometry::DofTypeIndices::CellCenterIdx{}; } + { return typename ActualGridGeometry::DofTypeIndices::CellCenterIdx{}; } /*! * \brief Return an integral constant index for face dofs */ static constexpr auto faceIdx() - { return typename ActualFVGridGeometry::DofTypeIndices::FaceIdx{}; } + { return typename ActualGridGeometry::DofTypeIndices::FaceIdx{}; } /*! * \brief Return the gridView this grid geometry object lives on */ const auto& gridView() const - { return fvGridGeometry_->gridView(); } + { return gridGeometry_->gridView(); } /*! * \brief Returns the connectivity map of which dofs have derivatives with respect * to a given dof. */ const auto& connectivityMap() const // TODO return correct map - { return fvGridGeometry_->connectivityMap(); } + { return gridGeometry_->connectivityMap(); } /*! * \brief Returns the mapper for vertices to indices for possibly adaptive grids. */ const auto& vertexMapper() const - { return fvGridGeometry_->vertexMapper(); } + { return gridGeometry_->vertexMapper(); } /*! * \brief Returns the mapper for elements to indices for constant grids. */ const auto& elementMapper() const - { return fvGridGeometry_->elementMapper(); } + { return gridGeometry_->elementMapper(); } /*! - * \brief Returns the actual fvGridGeometry we are a restriction of + * \brief Returns the actual gridGeometry we are a restriction of */ - const ActualFVGridGeometry& actualfvGridGeometry() const - { return *fvGridGeometry_; } + [[deprecated("Use actualGridGeometry instead")]] + const ActualGridGeometry& actualfvGridGeometry() const + { return actualGridGeometry(); } + + /*! + * \brief Returns the actual gridGeometry we are a restriction of + */ + const ActualGridGeometry& actualGridGeometry() const + { return *gridGeometry_; } protected: - const ActualFVGridGeometry* fvGridGeometry_; + const ActualGridGeometry* gridGeometry_; }; @@ -112,10 +119,10 @@ protected: * \brief Cell center specific auxiliary FvGridGeometry classes. * Required for the Dumux multi-domain framework. */ -template -class CellCenterFVGridGeometry : public GridGeometryView +template +class CellCenterFVGridGeometry : public GridGeometryView { - using ParentType = GridGeometryView; + using ParentType = GridGeometryView; public: using ParentType::ParentType; @@ -129,7 +136,7 @@ public: * \brief The total number of cell centered dofs */ std::size_t numDofs() const - { return this->fvGridGeometry_->numCellCenterDofs(); } + { return this->gridGeometry_->numCellCenterDofs(); } }; /*! @@ -137,10 +144,10 @@ public: * \brief Face specific auxiliary FvGridGeometry classes. * Required for the Dumux multi-domain framework. */ -template -class FaceFVGridGeometry : public GridGeometryView +template +class FaceFVGridGeometry : public GridGeometryView { - using ParentType = GridGeometryView; + using ParentType = GridGeometryView; public: using ParentType::ParentType; @@ -154,7 +161,7 @@ public: * \brief The total number of cell centered dofs */ std::size_t numDofs() const - { return this->fvGridGeometry_->numFaceDofs(); } + { return this->gridGeometry_->numFaceDofs(); } }; /*! diff --git a/dumux/discretization/staggered/gridfacevariables.hh b/dumux/discretization/staggered/gridfacevariables.hh index 109f742f91b813f3a6f470e840ce1bd58b69315e..f6c5eb63155dd862f2bdd9ff8e8390011917f4b8 100644 --- a/dumux/discretization/staggered/gridfacevariables.hh +++ b/dumux/discretization/staggered/gridfacevariables.hh @@ -81,15 +81,15 @@ public: StaggeredGridFaceVariables(const Problem& problem) : problemPtr_(&problem) {} //! Update all face variables - template - void update(const FVGridGeometry& fvGridGeometry, const SolutionVector& faceSol) + template + void update(const GridGeometry& gridGeometry, const SolutionVector& faceSol) { - faceVariables_.resize(fvGridGeometry.numScvf()); + faceVariables_.resize(gridGeometry.numScvf()); - for(auto&& element : elements(fvGridGeometry.gridView())) + for(auto&& element : elements(gridGeometry.gridView())) { - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bindElement(element); for(auto&& scvf : scvfs(fvGeometry)) @@ -137,8 +137,8 @@ public: StaggeredGridFaceVariables(const Problem& problem) : problemPtr_(&problem) {} //! Do nothing here. - template - void update(const FVGridGeometry& fvGridGeometry, const SolutionVector& sol) {} + template + void update(const GridGeometry& gridGeometry, const SolutionVector& sol) {} const Problem& problem() const { return *problemPtr_; } diff --git a/dumux/discretization/staggered/gridfluxvariablescache.hh b/dumux/discretization/staggered/gridfluxvariablescache.hh index 980da348d57aab568ebca228e5a626d230617a1a..ff6d9273bc49518076e6d7be1e3cf76b1e55d459 100644 --- a/dumux/discretization/staggered/gridfluxvariablescache.hh +++ b/dumux/discretization/staggered/gridfluxvariablescache.hh @@ -97,8 +97,8 @@ public: {} // When global caching is enabled, precompute transmissibilities and stencils for all the scv faces - template - void update(const FVGridGeometry& fvGridGeometry, + template + void update(const GridGeometry& gridGeometry, const GridVolumeVariables& gridVolVars, const SolutionVector& sol, bool forceUpdate = false) @@ -110,11 +110,11 @@ public: // FluxVariablesCacheFiller filler(problem()); TODO: use proper ctor FluxVariablesCacheFiller filler(problem()); - fluxVarsCache_.resize(fvGridGeometry.numScvf()); - for (const auto& element : elements(fvGridGeometry.gridView())) + fluxVarsCache_.resize(gridGeometry.numScvf()); + for (const auto& element : elements(gridGeometry.gridView())) { // Prepare the geometries within the elements of the stencil - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bind(element); auto elemVolVars = localView(gridVolVars); @@ -187,8 +187,8 @@ public: {} // When global caching is enabled, precompute transmissibilities and stencils for all the scv faces - template - void update(const FVGridGeometry& fvGridGeometry, + template + void update(const GridGeometry& gridGeometry, const GridVolumeVariables& gridVolVars, const SolutionVector& sol, bool forceUpdate = false) {} diff --git a/dumux/discretization/staggered/gridvariables.hh b/dumux/discretization/staggered/gridvariables.hh index 95d8578a926db9f69bbe7cc6d16ff3d92879308f..4475e690cd3427b6cfa06ad099c349500aea8363 100644 --- a/dumux/discretization/staggered/gridvariables.hh +++ b/dumux/discretization/staggered/gridvariables.hh @@ -94,11 +94,11 @@ public: //! return the fv grid geometry [[deprecated("Use gridGeometry() instead. fvGridGeometry() will be removed after 3.1!")]] - const FVGridGeometry& fvGridGeometry() const - { return (*gridVariables_->fvGridGeometry_); } + const GridGeometry& fvGridGeometry() const + { return (*gridVariables_->gridGeometry_); } //! return the fv grid geometry - const FVGridGeometry& gridGeometry() const - { return (*gridVariables_->fvGridGeometry_); } + const GridGeometry& gridGeometry() const + { return (*gridVariables_->gridGeometry_); } // return the actual grid variables const ActualGridVariables& gridVariables() const @@ -215,12 +215,11 @@ template class StaggeredGridVariables : public FVGridVariables { using ParentType = FVGridVariables; - using FVGridGeometry = GG; using ThisType = StaggeredGridVariables; friend class StaggeredGridVariablesView; - static constexpr auto cellCenterIdx = FVGridGeometry::cellCenterIdx(); - static constexpr auto faceIdx = FVGridGeometry::faceIdx(); + static constexpr auto cellCenterIdx = GG::cellCenterIdx(); + static constexpr auto faceIdx = GG::faceIdx(); public: using CellCenterGridVariablesType = CellCenterGridVariablesView; @@ -238,8 +237,8 @@ public: //! Constructor template StaggeredGridVariables(std::shared_ptr problem, - std::shared_ptr fvGridGeometry) - : ParentType(problem, fvGridGeometry) + std::shared_ptr gridGeometry) + : ParentType(problem, gridGeometry) , curGridFaceVariables_(*problem) , prevGridFaceVariables_(*problem) {} @@ -249,7 +248,7 @@ public: void update(const SolutionVector& curSol) { ParentType::update(curSol[cellCenterIdx]); - curGridFaceVariables_.update(*this->fvGridGeometry_, curSol[faceIdx]); + curGridFaceVariables_.update(*this->gridGeometry_, curSol[faceIdx]); } //! initialize all variables (stationary case) @@ -257,8 +256,8 @@ public: void init(const SolutionVector& curSol) { ParentType::init(curSol[cellCenterIdx]); - curGridFaceVariables_.update(*this->fvGridGeometry_, curSol[faceIdx]); - prevGridFaceVariables_.update(*this->fvGridGeometry_, curSol[faceIdx]); + curGridFaceVariables_.update(*this->gridGeometry_, curSol[faceIdx]); + prevGridFaceVariables_.update(*this->gridGeometry_, curSol[faceIdx]); } //! initialize all variables (instationary case) diff --git a/dumux/flux/box/darcyslaw.hh b/dumux/flux/box/darcyslaw.hh index d97dc02378812ccc204eaddf7476cbbd4e59e13c..fdf0f2ccff2ca705d52c3e487319bb75ec9d0a81 100644 --- a/dumux/flux/box/darcyslaw.hh +++ b/dumux/flux/box/darcyslaw.hh @@ -40,7 +40,7 @@ template class DarcysLawImplementation; // forward declaration -template +template class BoxDarcysLaw; /*! @@ -56,15 +56,15 @@ class DarcysLawImplementation * \ingroup BoxFlux * \brief Darcy's law for box schemes * \tparam Scalar the scalar type for scalar physical quantities - * \tparam FVGridGeometry the grid geometry + * \tparam GridGeometry the grid geometry */ -template +template class BoxDarcysLaw { - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using CoordScalar = typename GridView::ctype; diff --git a/dumux/flux/box/effectivestresslaw.hh b/dumux/flux/box/effectivestresslaw.hh index c51c2dad792134847199259d14202cf00171561c..524d5cf294df71139f3f96b6c5edc3f37fd5628c 100644 --- a/dumux/flux/box/effectivestresslaw.hh +++ b/dumux/flux/box/effectivestresslaw.hh @@ -35,16 +35,16 @@ namespace Dumux { * \brief Effective stress law for box scheme * \tparam StressType type used for the computation of * purely mechanical stresses (i.e. material law) - * \tparam FVGridGeometry the finite volume grid geometry + * \tparam GridGeometry the finite volume grid geometry */ -template -class EffectiveStressLaw +template +class EffectiveStressLaw { - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; static constexpr int dim = GridView::dimension; diff --git a/dumux/flux/box/hookeslaw.hh b/dumux/flux/box/hookeslaw.hh index 3a8a404c631a0c80686f852cefc762fc74bb6926..3a15e59d3eaf1fde437eec34a30cbd529fa4befa 100644 --- a/dumux/flux/box/hookeslaw.hh +++ b/dumux/flux/box/hookeslaw.hh @@ -37,16 +37,16 @@ namespace Dumux { * \ingroup BoxFlux * \brief Hooke's law for box scheme * \tparam ScalarType the scalar type for scalar physical quantities - * \tparam FVGridGeometry the grid geometry + * \tparam GridGeometry the grid geometry */ -template -class HookesLaw +template +class HookesLaw { - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; static constexpr int dim = GridView::dimension; diff --git a/dumux/flux/ccmpfa/darcyslaw.hh b/dumux/flux/ccmpfa/darcyslaw.hh index d2558effe8ecbf9796399e99f61f1772b3e2a062..61fb874476b8802325d27536827d87a2a38e29de 100644 --- a/dumux/flux/ccmpfa/darcyslaw.hh +++ b/dumux/flux/ccmpfa/darcyslaw.hh @@ -54,8 +54,8 @@ class DarcysLawImplementation static constexpr int dim = GridView::dimension; static constexpr int dimWorld = GridView::dimensionworld; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using ElementVolumeVariables = typename GetPropType::LocalView; @@ -94,7 +94,7 @@ class DarcysLawImplementation using Stencil = typename DualGridNodalIndexSet::NodalGridStencilType; - static constexpr bool considerSecondaryIVs = FVGridGeometry::MpfaHelper::considerSecondaryIVs(); + static constexpr bool considerSecondaryIVs = GridGeometry::MpfaHelper::considerSecondaryIVs(); using PrimaryDataHandle = typename ElementFluxVariablesCache::PrimaryIvDataHandle::AdvectionHandle; using SecondaryDataHandle = typename ElementFluxVariablesCache::SecondaryIvDataHandle::AdvectionHandle; diff --git a/dumux/flux/ccmpfa/fickslaw.hh b/dumux/flux/ccmpfa/fickslaw.hh index c17384152c94ec0e4e30d0c3bc2a5bcc9fd8570b..ba45b0ab13ca37450284c588255476ea70b6a1cc 100644 --- a/dumux/flux/ccmpfa/fickslaw.hh +++ b/dumux/flux/ccmpfa/fickslaw.hh @@ -51,8 +51,8 @@ class FicksLawImplementation; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; using FluidSystem = GetPropType; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using ElementVolumeVariables = typename GetPropType::LocalView; @@ -100,7 +100,7 @@ class FicksLawImplementation::numFluidPhases(); - static constexpr bool considerSecondaryIVs = FVGridGeometry::MpfaHelper::considerSecondaryIVs(); + static constexpr bool considerSecondaryIVs = GridGeometry::MpfaHelper::considerSecondaryIVs(); using PrimaryDataHandle = typename ElementFluxVariablesCache::PrimaryIvDataHandle::DiffusionHandle; using SecondaryDataHandle = typename ElementFluxVariablesCache::SecondaryIvDataHandle::DiffusionHandle; diff --git a/dumux/flux/ccmpfa/fourierslaw.hh b/dumux/flux/ccmpfa/fourierslaw.hh index fcb8ec28a57a90e8089a88af1c15695b5c07af36..b0ba06012f75d784301324a6c0b243dfee1025fc 100644 --- a/dumux/flux/ccmpfa/fourierslaw.hh +++ b/dumux/flux/ccmpfa/fourierslaw.hh @@ -51,8 +51,8 @@ class FouriersLawImplementation static constexpr int dim = GridView::dimension; static constexpr int dimWorld = GridView::dimensionworld; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using ElementVolumeVariables = typename GetPropType::LocalView; using ElementFluxVarsCache = typename GetPropType::LocalView; @@ -92,7 +92,7 @@ class FouriersLawImplementation using DualGridNodalIndexSet = GetPropType; using Stencil = typename DualGridNodalIndexSet::NodalGridStencilType; - static constexpr bool considerSecondaryIVs = FVGridGeometry::MpfaHelper::considerSecondaryIVs(); + static constexpr bool considerSecondaryIVs = GridGeometry::MpfaHelper::considerSecondaryIVs(); using PrimaryDataHandle = typename ElementFluxVarsCache::PrimaryIvDataHandle::HeatConductionHandle; using SecondaryDataHandle = typename ElementFluxVarsCache::SecondaryIvDataHandle::HeatConductionHandle; diff --git a/dumux/flux/cctpfa/darcyslaw.hh b/dumux/flux/cctpfa/darcyslaw.hh index 80d949f5ca4079aec8c84fdd90f0d7df56298b9d..61eb7b6f839b8b1bf34b6179add535cca9a5c596 100644 --- a/dumux/flux/cctpfa/darcyslaw.hh +++ b/dumux/flux/cctpfa/darcyslaw.hh @@ -42,10 +42,10 @@ class DarcysLawImplementation; * \brief Darcy's law for cell-centered finite volume schemes with two-point flux approximation * \note Darcy's law is specialized for network and surface grids (i.e. if grid dim < dimWorld) * \tparam Scalar the scalar type for scalar physical quantities - * \tparam FVGridGeometry the grid geometry + * \tparam GridGeometry the grid geometry * \tparam isNetwork whether we are computing on a network grid embedded in a higher world dimension */ -template +template class CCTpfaDarcysLaw; /*! @@ -64,12 +64,12 @@ class DarcysLawImplementation * \ingroup CCTpfaFlux * \brief Class that fills the cache corresponding to tpfa Darcy's Law */ -template +template class TpfaDarcysLawCacheFiller { - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; public: //! Function to fill a TpfaDarcysLawCache of a given scvf @@ -92,16 +92,16 @@ public: * \ingroup CCTpfaFlux * \brief The cache corresponding to tpfa Darcy's Law */ -template +template class TpfaDarcysLawCache { using Scalar = typename AdvectionType::Scalar; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; public: - using Filler = TpfaDarcysLawCacheFiller; + using Filler = TpfaDarcysLawCacheFiller; template void updateAdvection(const Problem& problem, @@ -124,14 +124,14 @@ private: * \ingroup CCTpfaFlux * \brief Specialization of the CCTpfaDarcysLaw grids where dim=dimWorld */ -template -class CCTpfaDarcysLaw +template +class CCTpfaDarcysLaw { - using ThisType = CCTpfaDarcysLaw; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using ThisType = CCTpfaDarcysLaw; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; static constexpr int dim = GridView::dimension; @@ -147,7 +147,7 @@ class CCTpfaDarcysLaw static const DiscretizationMethod discMethod = DiscretizationMethod::cctpfa; //! state the type for the corresponding cache - using Cache = TpfaDarcysLawCache; + using Cache = TpfaDarcysLawCache; //! Compute the advective flux template @@ -278,14 +278,14 @@ private: * \ingroup CCTpfaFlux * \brief Specialization of the CCTpfaDarcysLaw grids where dim < dimWorld (network/surface grids) */ -template -class CCTpfaDarcysLaw +template +class CCTpfaDarcysLaw { - using ThisType = CCTpfaDarcysLaw; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using ThisType = CCTpfaDarcysLaw; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; static constexpr int dim = GridView::dimension; @@ -301,7 +301,7 @@ public: static const DiscretizationMethod discMethod = DiscretizationMethod::cctpfa; //! state the type for the corresponding cache - using Cache = TpfaDarcysLawCache; + using Cache = TpfaDarcysLawCache; //! Compute the advective flux template diff --git a/dumux/flux/cctpfa/forchheimerslaw.hh b/dumux/flux/cctpfa/forchheimerslaw.hh index b721a1c12dbea62ca15528cbfe775435613fa863..75203037c4e41ddfa4944ca87b11743f50466b0d 100644 --- a/dumux/flux/cctpfa/forchheimerslaw.hh +++ b/dumux/flux/cctpfa/forchheimerslaw.hh @@ -46,10 +46,10 @@ class ForchheimersLawImplementation; * \brief Forchheimer's law for cell-centered finite volume schemes with two-point flux approximation * \note Forchheimer's law is specialized for network and surface grids (i.e. if grid dim < dimWorld) * \tparam Scalar the scalar type for scalar physical quantities - * \tparam FVGridGeometry the grid geometry + * \tparam GridGeometry the grid geometry * \tparam isNetwork whether we are computing on a network grid embedded in a higher world dimension */ -template +template class CCTpfaForchheimersLaw; /*! @@ -68,12 +68,12 @@ class ForchheimersLawImplementation * \ingroup CCTpfaFlux * \brief Class that fills the cache corresponding to tpfa Forchheimer's Law */ -template +template class TpfaForchheimersLawCacheFiller { - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; public: //! Function to fill a TpfaForchheimersLawCache of a given scvf @@ -96,18 +96,18 @@ public: * \ingroup CCTpfaFlux * \brief The cache corresponding to tpfa Forchheimer's Law */ -template +template class TpfaForchheimersLawCache { using Scalar = typename AdvectionType::Scalar; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; - static constexpr int dimWorld = FVGridGeometry::GridView::dimensionworld; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; + static constexpr int dimWorld = GridGeometry::GridView::dimensionworld; using DimWorldMatrix = Dune::FieldMatrix; public: - using Filler = TpfaForchheimersLawCacheFiller; + using Filler = TpfaForchheimersLawCacheFiller; template void updateAdvection(const Problem& problem, @@ -135,14 +135,14 @@ private: * \ingroup CCTpfaFlux * \brief Specialization of the CCTpfaForchheimersLaw grids where dim=dimWorld */ -template -class CCTpfaForchheimersLaw +template +class CCTpfaForchheimersLaw { - using ThisType = CCTpfaForchheimersLaw; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using ThisType = CCTpfaForchheimersLaw; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; static constexpr int dim = GridView::dimension; @@ -152,7 +152,7 @@ class CCTpfaForchheimersLaw using DimWorldVector = Dune::FieldVector; using DimWorldMatrix = Dune::FieldMatrix; - using DarcysLaw = CCTpfaDarcysLaw; + using DarcysLaw = CCTpfaDarcysLaw; public: //! state the scalar type of the law @@ -162,7 +162,7 @@ class CCTpfaForchheimersLaw static const DiscretizationMethod discMethod = DiscretizationMethod::cctpfa; //! state the type for the corresponding cache - using Cache = TpfaForchheimersLawCache; + using Cache = TpfaForchheimersLawCache; /*! \brief Compute the advective flux using the Forchheimer equation * @@ -547,8 +547,8 @@ private: * \ingroup CCTpfaFlux * \brief Specialization of the CCTpfaForchheimersLaw grids where dim -class CCTpfaForchheimersLaw +template +class CCTpfaForchheimersLaw { static_assert(AlwaysFalse::value, "Forchheimer not implemented for network grids"); }; diff --git a/dumux/flux/effectivestresslaw.hh b/dumux/flux/effectivestresslaw.hh index 4779166566b2d2db050da617d1f30329cb1bd9b7..4ec9a0b6fbcfe7422f827b967502cf058ffba066 100644 --- a/dumux/flux/effectivestresslaw.hh +++ b/dumux/flux/effectivestresslaw.hh @@ -35,7 +35,7 @@ namespace Dumux { * \note Specializations are provided for the different discretization methods. * These specializations are found in the headers included below. */ -template +template class EffectiveStressLaw; } // end namespace Dumux diff --git a/dumux/flux/hookeslaw.hh b/dumux/flux/hookeslaw.hh index a7a7e35e5caad12c665cf1240115afc6be4b17fb..a194ea95c0618fef0ff266422fc377a5bc4426e3 100644 --- a/dumux/flux/hookeslaw.hh +++ b/dumux/flux/hookeslaw.hh @@ -35,7 +35,7 @@ namespace Dumux { * \note Specializations are provided for the different discretization methods. * These specializations are found in the headers included below. */ -template +template class HookesLaw; } // end namespace Dumux diff --git a/dumux/flux/staggered/freeflow/fickslaw.hh b/dumux/flux/staggered/freeflow/fickslaw.hh index 2f47965913c8706525b4c036580ea617269ac0a6..68c00c76da1172489919aded18179686c5c861c9 100644 --- a/dumux/flux/staggered/freeflow/fickslaw.hh +++ b/dumux/flux/staggered/freeflow/fickslaw.hh @@ -50,10 +50,10 @@ template class FicksLawImplementation { using Scalar = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using ElementVolumeVariables = typename GetPropType::LocalView; using ModelTraits = GetPropType; diff --git a/dumux/flux/staggered/freeflow/fourierslaw.hh b/dumux/flux/staggered/freeflow/fourierslaw.hh index d810450d0107ced9f24c9e33fcd1201d6e68e732..436b411095b1c721c272bf1d84e885fbea773a20 100644 --- a/dumux/flux/staggered/freeflow/fourierslaw.hh +++ b/dumux/flux/staggered/freeflow/fourierslaw.hh @@ -44,11 +44,11 @@ template class FouriersLawImplementation { using Scalar = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using ElementVolumeVariables = typename GetPropType::LocalView; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using Indices = typename GetPropType::Indices; public: diff --git a/dumux/flux/staggered/freeflow/maxwellstefanslaw.hh b/dumux/flux/staggered/freeflow/maxwellstefanslaw.hh index 175c5f534505644955b1bdc2953b93b16cfaa3cb..965039346f6d81883a0863f281fd9b9d7d224b8e 100644 --- a/dumux/flux/staggered/freeflow/maxwellstefanslaw.hh +++ b/dumux/flux/staggered/freeflow/maxwellstefanslaw.hh @@ -48,10 +48,10 @@ class MaxwellStefansLawImplementation; using Problem = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using ElementVolumeVariables = typename GetPropType::LocalView; using VolumeVariables = GetPropType; diff --git a/dumux/flux/upwindscheme.hh b/dumux/flux/upwindscheme.hh index a292d5bc4ec733d9da28d5ea5795b3353e6abad9..fae491c22217e2927c6d9f62ee044e67d199e398 100644 --- a/dumux/flux/upwindscheme.hh +++ b/dumux/flux/upwindscheme.hh @@ -30,7 +30,7 @@ namespace Dumux { //! Forward declaration of the upwind scheme implementation -template +template class UpwindSchemeImpl; /*! @@ -38,12 +38,12 @@ class UpwindSchemeImpl; * \brief The upwind scheme used for the advective fluxes. * This depends on the chosen discretization method. */ -template -using UpwindScheme = UpwindSchemeImpl; +template +using UpwindScheme = UpwindSchemeImpl; //! Upwind scheme for the box method -template -class UpwindSchemeImpl +template +class UpwindSchemeImpl { public: // applies a simple upwind scheme to the precalculated advective flux @@ -72,10 +72,10 @@ public: }; //! Upwind scheme for the cell-centered tpfa scheme -template -class UpwindSchemeImpl +template +class UpwindSchemeImpl { - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; static constexpr int dim = GridView::dimension; static constexpr int dimWorld = GridView::dimensionworld; @@ -183,9 +183,9 @@ public: }; //! Upwind scheme for cell-centered mpfa schemes -template -class UpwindSchemeImpl -: public UpwindSchemeImpl {}; +template +class UpwindSchemeImpl +: public UpwindSchemeImpl {}; } // end namespace Dumux diff --git a/dumux/freeflow/compositional/staggered/fluxvariables.hh b/dumux/freeflow/compositional/staggered/fluxvariables.hh index d122c7eca75a35936fa776ae3f1abd93e1b61567..f1b5212a82840f7008f14716ccad3c006699d0f1 100644 --- a/dumux/freeflow/compositional/staggered/fluxvariables.hh +++ b/dumux/freeflow/compositional/staggered/fluxvariables.hh @@ -47,9 +47,9 @@ class FreeflowNCFluxVariablesImpl { using ParentType = NavierStokesFluxVariables; using Problem = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using CellCenterPrimaryVariables = GetPropType; using FluidSystem = GetPropType; diff --git a/dumux/freeflow/compositional/staggered/localresidual.hh b/dumux/freeflow/compositional/staggered/localresidual.hh index 4821df6825e4833e496dce68b27aedd0697a97cc..d7883e8b3fbf47b62d66293fac3f755ec7889c54 100644 --- a/dumux/freeflow/compositional/staggered/localresidual.hh +++ b/dumux/freeflow/compositional/staggered/localresidual.hh @@ -46,8 +46,8 @@ class FreeflowNCResidualImpl using Scalar = GetPropType; using Problem = GetPropType; - using FVGridGeometry = GetPropType; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = GetPropType; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using FVElementGeometry = typename GetPropType::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; diff --git a/dumux/freeflow/navierstokes/problem.hh b/dumux/freeflow/navierstokes/problem.hh index 16da4bc53047a05988a167c91f4d22f5e889ec03..6887765131e22a004046a15ec402edfec1f08dd6 100644 --- a/dumux/freeflow/navierstokes/problem.hh +++ b/dumux/freeflow/navierstokes/problem.hh @@ -64,8 +64,8 @@ class NavierStokesProblem : public NavierStokesParentProblem using ParentType = NavierStokesParentProblem; using Implementation = GetPropType; - using FVGridGeometry = GetPropType; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = GetPropType; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GridVariables = GetPropType; @@ -76,7 +76,7 @@ class NavierStokesProblem : public NavierStokesParentProblem using ElementVolumeVariables = typename GridVolumeVariables::LocalView; using Scalar = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using PrimaryVariables = GetPropType; @@ -93,11 +93,11 @@ class NavierStokesProblem : public NavierStokesParentProblem public: /*! * \brief The constructor - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param paramGroup The parameter group in which to look for runtime parameters first (default is "") */ - NavierStokesProblem(std::shared_ptr fvGridGeometry, const std::string& paramGroup = "") - : ParentType(fvGridGeometry, paramGroup) + NavierStokesProblem(std::shared_ptr gridGeometry, const std::string& paramGroup = "") + : ParentType(gridGeometry, paramGroup) , gravity_(0.0) { if (getParamFromGroup(paramGroup, "Problem.EnableGravity")) @@ -141,13 +141,13 @@ public: { return enableInertiaTerms_; } //! Applys the initial face solution (velocities on the faces). Specialization for staggered grid discretization. - template + template typename std::enable_if::type applyInitialFaceSolution(SolutionVector& sol, const SubControlVolumeFace& scvf, const PrimaryVariables& initSol) const { - sol[FVGridGeometry::faceIdx()][scvf.dofIndex()][0] = initSol[Indices::velocity(scvf.directionIndex())]; + sol[GridGeometry::faceIdx()][scvf.dofIndex()][0] = initSol[Indices::velocity(scvf.directionIndex())]; } @@ -174,7 +174,7 @@ public: } //! Convenience function for staggered grid implementation. - template + template typename std::enable_if::type pseudo3DWallFriction(const SubControlVolumeFace& scvf, const ElementVolumeVariables& elemVolVars, diff --git a/dumux/freeflow/navierstokes/staggered/fluxoversurface.hh b/dumux/freeflow/navierstokes/staggered/fluxoversurface.hh index 5e3bdcad246f8f86b7ad4f48ae8d43ae0119fa36..30d3e638ec32377a0aeca19b8c48e9b532e8d347 100644 --- a/dumux/freeflow/navierstokes/staggered/fluxoversurface.hh +++ b/dumux/freeflow/navierstokes/staggered/fluxoversurface.hh @@ -49,14 +49,14 @@ template::Entity; - using CellCenterPrimaryVariables = std::decay_t()[FVGridGeometry::cellCenterIdx()][0])>; + using CellCenterPrimaryVariables = std::decay_t()[GridGeometry::cellCenterIdx()][0])>; enum { // Grid and world dimension diff --git a/dumux/freeflow/navierstokes/staggered/fluxvariables.hh b/dumux/freeflow/navierstokes/staggered/fluxvariables.hh index 7a1431ad5b876c40957052f15ecaa7ad3a790cc8..180170856fcffeb49c8e3ffcca55ff7f9052c9f1 100644 --- a/dumux/freeflow/navierstokes/staggered/fluxvariables.hh +++ b/dumux/freeflow/navierstokes/staggered/fluxvariables.hh @@ -70,9 +70,9 @@ class NavierStokesFluxVariablesImpl using FaceVariables = typename GridFaceVariables::FaceVariables; using Problem = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using Scalar = GetPropType; using ModelTraits = GetPropType; @@ -81,14 +81,14 @@ class NavierStokesFluxVariablesImpl using CellCenterPrimaryVariables = GetPropType; using FacePrimaryVariables = GetPropType; using BoundaryTypes = GetPropType; - using VelocityGradients = StaggeredVelocityGradients; + using VelocityGradients = StaggeredVelocityGradients; static constexpr bool normalizePressure = getPropValue(); using GlobalPosition = typename Element::Geometry::GlobalCoordinate; - static constexpr auto cellCenterIdx = FVGridGeometry::cellCenterIdx(); - static constexpr auto faceIdx = FVGridGeometry::faceIdx(); + static constexpr auto cellCenterIdx = GridGeometry::cellCenterIdx(); + static constexpr auto faceIdx = GridGeometry::faceIdx(); static constexpr int upwindSchemeOrder = getPropValue(); static constexpr bool useHigherOrder = upwindSchemeOrder > 1; diff --git a/dumux/freeflow/navierstokes/staggered/localresidual.hh b/dumux/freeflow/navierstokes/staggered/localresidual.hh index b80121ce260c8c9e4ce386430edd8a7d85e9cdc1..7a57d81386995844a95586eacb39114f75cab9a3 100644 --- a/dumux/freeflow/navierstokes/staggered/localresidual.hh +++ b/dumux/freeflow/navierstokes/staggered/localresidual.hh @@ -62,9 +62,9 @@ class NavierStokesResidualImpl using Scalar = GetPropType; using Implementation = GetPropType; using Problem = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; @@ -80,7 +80,7 @@ class NavierStokesResidualImpl using ModelTraits = GetPropType; public: - using EnergyLocalResidual = FreeFlowEnergyLocalResidual 1)>; + using EnergyLocalResidual = FreeFlowEnergyLocalResidual 1)>; // account for the offset of the cell center privars within the PrimaryVariables container static constexpr auto cellCenterOffset = ModelTraits::numEq() - CellCenterPrimaryVariables::dimension; diff --git a/dumux/freeflow/navierstokes/staggered/staggeredupwindfluxvariables.hh b/dumux/freeflow/navierstokes/staggered/staggeredupwindfluxvariables.hh index 06580bedeb4a1f6a34475fdaf9754ccecaff98fc..4e31009d9fb4228e55438ab16b8b74f35a7a63ac 100644 --- a/dumux/freeflow/navierstokes/staggered/staggeredupwindfluxvariables.hh +++ b/dumux/freeflow/navierstokes/staggered/staggeredupwindfluxvariables.hh @@ -58,9 +58,9 @@ class StaggeredUpwindFluxVariables using FaceVariables = typename GridFaceVariables::FaceVariables; using Problem = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using Scalar = GetPropType; using ModelTraits = GetPropType; @@ -70,7 +70,7 @@ class StaggeredUpwindFluxVariables using CellCenterPrimaryVariables = GetPropType; using FacePrimaryVariables = GetPropType; using BoundaryTypes = GetPropType; - using VelocityGradients = StaggeredVelocityGradients; + using VelocityGradients = StaggeredVelocityGradients; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; static constexpr bool useHigherOrder = upwindSchemeOrder > 1; diff --git a/dumux/freeflow/navierstokes/staggered/velocitygradients.hh b/dumux/freeflow/navierstokes/staggered/velocitygradients.hh index 6b81f1e4f5b08379df7e5f4650cbc1a8ab769acf..f9d7a58edce996cda5d763c232cb17706a30c0ad 100644 --- a/dumux/freeflow/navierstokes/staggered/velocitygradients.hh +++ b/dumux/freeflow/navierstokes/staggered/velocitygradients.hh @@ -34,11 +34,11 @@ namespace Dumux { * \ingroup NavierStokesModel * \brief Helper class for calculating the velocity gradients for the Navier-Stokes model using the staggered grid discretization. */ -template +template class StaggeredVelocityGradients { - using FVElementGeometry = typename FVGridGeometry::LocalView; - using GridView = typename FVGridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; diff --git a/dumux/freeflow/nonisothermal/localresidual.hh b/dumux/freeflow/nonisothermal/localresidual.hh index abb3676f68294f2d0ed605f5558157065cc08f8c..1a681c5ddd4f61c2b22ae4cd06e2ed8aa45682c5 100644 --- a/dumux/freeflow/nonisothermal/localresidual.hh +++ b/dumux/freeflow/nonisothermal/localresidual.hh @@ -30,7 +30,7 @@ namespace Dumux { // forward declaration -template +template class FreeFlowEnergyLocalResidualImplementation; /*! @@ -38,19 +38,19 @@ class FreeFlowEnergyLocalResidualImplementation; * \brief Element-wise calculation of the local residual for non-isothermal * free-flow models */ -template +template using FreeFlowEnergyLocalResidual = - FreeFlowEnergyLocalResidualImplementation; /*! * \ingroup FreeflowNIModel * \brief Specialization for isothermal models, does nothing */ -template -class FreeFlowEnergyLocalResidualImplementation +template +class FreeFlowEnergyLocalResidualImplementation { public: @@ -69,14 +69,14 @@ public: * \ingroup FreeflowNIModel * \brief Specialization for staggered one-phase, non-isothermal models */ -template -class FreeFlowEnergyLocalResidualImplementation +class FreeFlowEnergyLocalResidualImplementation { - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; public: @@ -121,22 +121,22 @@ public: * \ingroup FreeflowNIModel * \brief Specialization for staggered compositional, non-isothermal models */ -template -class FreeFlowEnergyLocalResidualImplementation +class FreeFlowEnergyLocalResidualImplementation - : public FreeFlowEnergyLocalResidualImplementation { - using ParentType = FreeFlowEnergyLocalResidualImplementation; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; public: diff --git a/dumux/freeflow/rans/oneeq/problem.hh b/dumux/freeflow/rans/oneeq/problem.hh index fb549c7d9be1e0d97187ffa0bba7a77dde3cc313..3b7d889cc81683215aa83ba064f5e7061af799bf 100644 --- a/dumux/freeflow/rans/oneeq/problem.hh +++ b/dumux/freeflow/rans/oneeq/problem.hh @@ -54,7 +54,7 @@ class RANSProblemImpl : public RANSProblemBase< using Scalar = GetPropType; using DimVector = Dune::FieldVector; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using FVElementGeometry = typename GetPropType::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; @@ -66,8 +66,8 @@ class RANSProblemImpl : public RANSProblemBase< public: //! The constructor sets the gravity, if desired by the user. - RANSProblemImpl(std::shared_ptr fvGridGeometry, const std::string& paramGroup = "") - : ParentType(fvGridGeometry, paramGroup) + RANSProblemImpl(std::shared_ptr gridGeometry, const std::string& paramGroup = "") + : ParentType(gridGeometry, paramGroup) { useStoredEddyViscosity_ = getParamFromGroup(this->paramGroup(), "RANS.UseStoredEddyViscosity", false); @@ -104,9 +104,9 @@ public: for (auto&& scv : scvs(fvGeometry)) { const int dofIdx = scv.dofIndex(); - const auto& cellCenterPriVars = curSol[FVGridGeometry::cellCenterIdx()][dofIdx]; + const auto& cellCenterPriVars = curSol[GridGeometry::cellCenterIdx()][dofIdx]; PrimaryVariables priVars = makePriVarsFromCellCenterPriVars(cellCenterPriVars); - auto elemSol = elementSolution(std::move(priVars)); + auto elemSol = elementSolution(std::move(priVars)); // NOTE: first update the turbulence quantities storedViscosityTilde_[elementIdx] = elemSol[0][Indices::viscosityTildeIdx]; // NOTE: then update the volVars diff --git a/dumux/freeflow/rans/problem.hh b/dumux/freeflow/rans/problem.hh index 1eec0b80239993c55da8bb56e83653b6bdc5d715..1ba65564b5120a320762df9318dbe988e7ee821d 100644 --- a/dumux/freeflow/rans/problem.hh +++ b/dumux/freeflow/rans/problem.hh @@ -60,9 +60,9 @@ class RANSProblemBase : public NavierStokesProblem using Scalar = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; @@ -82,11 +82,11 @@ class RANSProblemBase : public NavierStokesProblem public: /*! * \brief The constructor - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param paramGroup The parameter group in which to look for runtime parameters first (default is "") */ - RANSProblemBase(std::shared_ptr fvGridGeometry, const std::string& paramGroup = "") - : ParentType(fvGridGeometry, paramGroup) + RANSProblemBase(std::shared_ptr gridGeometry, const std::string& paramGroup = "") + : ParentType(gridGeometry, paramGroup) { } /*! @@ -251,7 +251,7 @@ public: for (auto&& scvf : scvfs(fvGeometry)) { const int dofIdxFace = scvf.dofIndex(); - const auto numericalSolutionFace = curSol[FVGridGeometry::faceIdx()][dofIdxFace][Indices::velocity(scvf.directionIndex())]; + const auto numericalSolutionFace = curSol[GridGeometry::faceIdx()][dofIdxFace][Indices::velocity(scvf.directionIndex())]; velocityTemp[scvf.directionIndex()] += numericalSolutionFace; } for (unsigned int dimIdx = 0; dimIdx < dim; ++dimIdx) @@ -416,9 +416,9 @@ public: const int dofIdx = scv.dofIndex(); // construct a privars object from the cell center solution vector - const auto& cellCenterPriVars = curSol[FVGridGeometry::cellCenterIdx()][dofIdx]; + const auto& cellCenterPriVars = curSol[GridGeometry::cellCenterIdx()][dofIdx]; PrimaryVariables priVars = makePriVarsFromCellCenterPriVars(cellCenterPriVars); - auto elemSol = elementSolution(std::move(priVars)); + auto elemSol = elementSolution(std::move(priVars)); VolumeVariables volVars; volVars.update(elemSol, asImp_(), element, scv); diff --git a/dumux/freeflow/rans/twoeq/kepsilon/problem.hh b/dumux/freeflow/rans/twoeq/kepsilon/problem.hh index e56c56fb2a356372305e0c1a7bbe8e3c7193307c..40fccef2c342e9cb86dcafcc7a52988e224a0dcd 100644 --- a/dumux/freeflow/rans/twoeq/kepsilon/problem.hh +++ b/dumux/freeflow/rans/twoeq/kepsilon/problem.hh @@ -51,8 +51,8 @@ class RANSProblemImpl : public RANSProblemBa using Implementation = GetPropType; using Scalar = GetPropType; - using FVGridGeometry = GetPropType; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = GetPropType; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GridVariables = GetPropType; @@ -83,8 +83,8 @@ class RANSProblemImpl : public RANSProblemBa public: //! The constructor sets the gravity, if desired by the user. - RANSProblemImpl(std::shared_ptr fvGridGeometry, const std::string& paramGroup = "") - : ParentType(fvGridGeometry, paramGroup) + RANSProblemImpl(std::shared_ptr gridGeometry, const std::string& paramGroup = "") + : ParentType(gridGeometry, paramGroup) { yPlusThreshold_ = getParamFromGroup(this->paramGroup(), "KEpsilon.YPlusThreshold", 30); useStoredEddyViscosity_ = getParamFromGroup(this->paramGroup(), "RANS.UseStoredEddyViscosity", false); @@ -125,9 +125,9 @@ public: for (auto&& scv : scvs(fvGeometry)) { const int dofIdx = scv.dofIndex(); - const auto& cellCenterPriVars = curSol[FVGridGeometry::cellCenterIdx()][dofIdx]; + const auto& cellCenterPriVars = curSol[GridGeometry::cellCenterIdx()][dofIdx]; PrimaryVariables priVars = makePriVarsFromCellCenterPriVars(cellCenterPriVars); - auto elemSol = elementSolution(std::move(priVars)); + auto elemSol = elementSolution(std::move(priVars)); // NOTE: first update the turbulence quantities storedDissipation_[elementIdx] = elemSol[0][Indices::dissipationEqIdx]; storedTurbulentKineticEnergy_[elementIdx] = elemSol[0][Indices::turbulentKineticEnergyEqIdx]; diff --git a/dumux/freeflow/rans/twoeq/komega/problem.hh b/dumux/freeflow/rans/twoeq/komega/problem.hh index 98b08b3b6fd896a50d5d7ff9202900bbcd9570d4..808d86be2992ca295fcbfd56421661cb2977a9ea 100644 --- a/dumux/freeflow/rans/twoeq/komega/problem.hh +++ b/dumux/freeflow/rans/twoeq/komega/problem.hh @@ -49,7 +49,7 @@ class RANSProblemImpl : public RANSProblemBase using Implementation = GetPropType; using Scalar = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using FVElementGeometry = typename GetPropType::LocalView; using VolumeVariables = GetPropType; @@ -58,12 +58,12 @@ class RANSProblemImpl : public RANSProblemBase using CellCenterPrimaryVariables = GetPropType; using Indices = typename GetPropType::Indices; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using DimVector = typename Element::Geometry::GlobalCoordinate; public: - RANSProblemImpl(std::shared_ptr fvGridGeometry, const std::string& paramGroup = "") - : ParentType(fvGridGeometry, paramGroup) + RANSProblemImpl(std::shared_ptr gridGeometry, const std::string& paramGroup = "") + : ParentType(gridGeometry, paramGroup) { useStoredEddyViscosity_ = getParamFromGroup(this->paramGroup(), "RANS.UseStoredEddyViscosity", false); } @@ -101,9 +101,9 @@ public: for (auto&& scv : scvs(fvGeometry)) { const int dofIdx = scv.dofIndex(); - const auto& cellCenterPriVars = curSol[FVGridGeometry::cellCenterIdx()][dofIdx]; + const auto& cellCenterPriVars = curSol[GridGeometry::cellCenterIdx()][dofIdx]; PrimaryVariables priVars = makePriVarsFromCellCenterPriVars(cellCenterPriVars); - auto elemSol = elementSolution(std::move(priVars)); + auto elemSol = elementSolution(std::move(priVars)); // NOTE: first update the turbulence quantities storedDissipation_[elementIdx] = elemSol[0][Indices::dissipationEqIdx]; storedTurbulentKineticEnergy_[elementIdx] = elemSol[0][Indices::turbulentKineticEnergyEqIdx]; diff --git a/dumux/freeflow/rans/twoeq/lowrekepsilon/problem.hh b/dumux/freeflow/rans/twoeq/lowrekepsilon/problem.hh index ac72248784e3e1cfa2eb7a1a1fbd96d99529a0c6..0119d0792aad9038bc5eed0018699f05b959d3a0 100644 --- a/dumux/freeflow/rans/twoeq/lowrekepsilon/problem.hh +++ b/dumux/freeflow/rans/twoeq/lowrekepsilon/problem.hh @@ -49,7 +49,7 @@ class RANSProblemImpl : public RANSProb using Implementation = GetPropType; using Scalar = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using FVElementGeometry = typename GetPropType::LocalView; using VolumeVariables = GetPropType; @@ -60,8 +60,8 @@ class RANSProblemImpl : public RANSProb public: //! The constructor sets the gravity, if desired by the user. - RANSProblemImpl(std::shared_ptr fvGridGeometry, const std::string& paramGroup = "") - : ParentType(fvGridGeometry, paramGroup) + RANSProblemImpl(std::shared_ptr gridGeometry, const std::string& paramGroup = "") + : ParentType(gridGeometry, paramGroup) { useStoredEddyViscosity_ = getParamFromGroup(this->paramGroup(), "RANS.UseStoredEddyViscosity", true); } @@ -97,9 +97,9 @@ public: for (auto&& scv : scvs(fvGeometry)) { const int dofIdx = scv.dofIndex(); - const auto& cellCenterPriVars = curSol[FVGridGeometry::cellCenterIdx()][dofIdx]; + const auto& cellCenterPriVars = curSol[GridGeometry::cellCenterIdx()][dofIdx]; PrimaryVariables priVars = makePriVarsFromCellCenterPriVars(cellCenterPriVars); - auto elemSol = elementSolution(std::move(priVars)); + auto elemSol = elementSolution(std::move(priVars)); // NOTE: first update the turbulence quantities storedDissipationTilde_[elementIdx] = elemSol[0][Indices::dissipationEqIdx]; storedTurbulentKineticEnergy_[elementIdx] = elemSol[0][Indices::turbulentKineticEnergyEqIdx]; diff --git a/dumux/freeflow/rans/zeroeq/problem.hh b/dumux/freeflow/rans/zeroeq/problem.hh index dc2a5d0b55dfa3a5b085e3a16ea267396f672acb..0a439a5828245f7ed99cafb36d85a1f90cd0d325 100644 --- a/dumux/freeflow/rans/zeroeq/problem.hh +++ b/dumux/freeflow/rans/zeroeq/problem.hh @@ -54,7 +54,7 @@ class RANSProblemImpl : public RANSProblemBase using Grid = typename GridView::Grid; using Scalar = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using FVElementGeometry = typename GetPropType::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using VolumeVariables = GetPropType; @@ -72,11 +72,11 @@ class RANSProblemImpl : public RANSProblemBase public: /*! * \brief The constructor - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param paramGroup The parameter group in which to look for runtime parameters first (default is "") */ - RANSProblemImpl(std::shared_ptr fvGridGeometry, const std::string& paramGroup = "") - : ParentType(fvGridGeometry, paramGroup) + RANSProblemImpl(std::shared_ptr gridGeometry, const std::string& paramGroup = "") + : ParentType(gridGeometry, paramGroup) { eddyViscosityModel_ = getParamFromGroup(paramGroup, "RANS.EddyViscosityModel", "vanDriest"); } @@ -120,9 +120,9 @@ public: const int dofIdx = scv.dofIndex(); // construct a privars object from the cell center solution vector - const auto& cellCenterPriVars = curSol[FVGridGeometry::cellCenterIdx()][dofIdx]; + const auto& cellCenterPriVars = curSol[GridGeometry::cellCenterIdx()][dofIdx]; PrimaryVariables priVars = makePriVarsFromCellCenterPriVars(cellCenterPriVars); - auto elemSol = elementSolution(std::move(priVars)); + auto elemSol = elementSolution(std::move(priVars)); VolumeVariables volVars; volVars.update(elemSol, asImp_(), element, scv); diff --git a/dumux/freeflow/shallowwater/fluxvariables.hh b/dumux/freeflow/shallowwater/fluxvariables.hh index d37861c6f02fa33cdfcc5d02c84ef12030bdf6cc..57daf7e066ace07e733ed4a1838519d24ca66842 100644 --- a/dumux/freeflow/shallowwater/fluxvariables.hh +++ b/dumux/freeflow/shallowwater/fluxvariables.hh @@ -49,9 +49,9 @@ class ShallowWaterFluxVariables using GridVariables = GetPropType; using GridVolumeVariables = typename GridVariables::GridVolumeVariables; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using ElementVolumeVariables = typename GridVolumeVariables::LocalView; diff --git a/dumux/freeflow/shallowwater/problem.hh b/dumux/freeflow/shallowwater/problem.hh index d05e4bf4f04e7931f16d1c09fd7af71f379a3e05..f10bb09849e2e5b3647cda822531f1f2d03958d8 100644 --- a/dumux/freeflow/shallowwater/problem.hh +++ b/dumux/freeflow/shallowwater/problem.hh @@ -38,7 +38,7 @@ template class ShallowWaterProblem : public FVProblem { using ParentType = FVProblem; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; public: using SpatialParams = GetPropType; @@ -46,27 +46,27 @@ public: /*! * \brief Constructor, passing the spatial parameters * - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param spatialParams The spatial parameter class * \param paramGroup The parameter group in which to look for runtime parameters first (default is "") */ - ShallowWaterProblem(std::shared_ptr fvGridGeometry, + ShallowWaterProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams, const std::string& paramGroup = "") - : ParentType(fvGridGeometry, paramGroup) + : ParentType(gridGeometry, paramGroup) , spatialParams_(spatialParams) {} /*! * \brief Constructor, constructing the spatial parameters * - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param paramGroup The parameter group in which to look for runtime parameters first (default is "") */ - ShallowWaterProblem(std::shared_ptr fvGridGeometry, + ShallowWaterProblem(std::shared_ptr gridGeometry, const std::string& paramGroup = "") - : ShallowWaterProblem(fvGridGeometry, - std::make_shared(fvGridGeometry), + : ShallowWaterProblem(gridGeometry, + std::make_shared(gridGeometry), paramGroup) {} diff --git a/dumux/geomechanics/fvproblem.hh b/dumux/geomechanics/fvproblem.hh index daa8b2292367aea064a123f99aceed7e0b1b3b31..6329fa7db982b79c9f6bc1a95f6d6328d07ff571 100644 --- a/dumux/geomechanics/fvproblem.hh +++ b/dumux/geomechanics/fvproblem.hh @@ -69,9 +69,9 @@ class GeomechanicsFVProblem : public PorousMediumFlowProblem using ParentType = PorousMediumFlowProblem; using Scalar = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; using GridView = GetPropType; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; diff --git a/dumux/geomechanics/poroelastic/couplingmanager.hh b/dumux/geomechanics/poroelastic/couplingmanager.hh index 7f981653e09a58382a84409752110194f33c5599..a25a897edfda07d3e6a7a968a64c9e61fe9ce8b7 100644 --- a/dumux/geomechanics/poroelastic/couplingmanager.hh +++ b/dumux/geomechanics/poroelastic/couplingmanager.hh @@ -67,9 +67,9 @@ class PoroMechanicsCouplingManager : public virtual CouplingManager< MDTraits > template using GridVolumeVariables = typename GridVariables::GridVolumeVariables; template using ElementVolumeVariables = typename GridVolumeVariables::LocalView; template using VolumeVariables = typename GridVolumeVariables::VolumeVariables; - template using FVGridGeometry = typename GridVariables::GridGeometry; - template using FVElementGeometry = typename FVGridGeometry::LocalView; - template using GridView = typename FVGridGeometry::GridView; + template using GridGeometry = typename GridVariables::GridGeometry; + template using FVElementGeometry = typename GridGeometry::LocalView; + template using GridView = typename GridGeometry::GridView; template using GridIndexType = typename GridView::IndexSet::IndexType; template using Element = typename GridView::template Codim<0>::Entity; template using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -79,11 +79,11 @@ class PoroMechanicsCouplingManager : public virtual CouplingManager< MDTraits > "The grid types of the two sub-problems have to be equal!"); //! this coupling manager is for cc - box only - static_assert(FVGridGeometry::discMethod == DiscretizationMethod::box, + static_assert(GridGeometry::discMethod == DiscretizationMethod::box, "Poro-mechanical problem must be discretized with the box scheme for this coupling manager!"); - static_assert(FVGridGeometry::discMethod == DiscretizationMethod::cctpfa || - FVGridGeometry::discMethod == DiscretizationMethod::ccmpfa, + static_assert(GridGeometry::discMethod == DiscretizationMethod::cctpfa || + GridGeometry::discMethod == DiscretizationMethod::ccmpfa, "Porous medium flow problem must be discretized with a cell-centered scheme for this coupling manager!"); //! this does not work for enabled grid volume variables caching (update of local view in context has no effect) diff --git a/dumux/geomechanics/poroelastic/model.hh b/dumux/geomechanics/poroelastic/model.hh index ef4c337e511d2f6ddd7d380e77756b71e064e978..5bd888dacb56582a73b863af1710abca037ed8bc 100644 --- a/dumux/geomechanics/poroelastic/model.hh +++ b/dumux/geomechanics/poroelastic/model.hh @@ -115,10 +115,10 @@ struct StressType { private: using Scalar = GetPropType; - using FVGridGeometry = GetPropType; - using ElasticStressType = HookesLaw< Scalar, FVGridGeometry >; + using GridGeometry = GetPropType; + using ElasticStressType = HookesLaw< Scalar, GridGeometry >; public: - using type = EffectiveStressLaw< ElasticStressType, FVGridGeometry >; + using type = EffectiveStressLaw< ElasticStressType, GridGeometry >; }; } // namespace Properties diff --git a/dumux/geomechanics/stressvariablescache.hh b/dumux/geomechanics/stressvariablescache.hh index e1c79f34cbbc18260d38ad82b0288e6d11652714..f32d48abe6617133228938194e5a24cc1bd52a58 100644 --- a/dumux/geomechanics/stressvariablescache.hh +++ b/dumux/geomechanics/stressvariablescache.hh @@ -37,18 +37,18 @@ namespace Dumux { * \brief The stress variables cache classes for models involving geomechanics. * Store data required for stress calculation. */ -template< class Scalar, class FVGridGeometry, DiscretizationMethod dm = FVGridGeometry::discMethod > +template< class Scalar, class GridGeometry, DiscretizationMethod dm = GridGeometry::discMethod > class StressVariablesCache; //! We only store discretization-related quantities for the box method. -template< class Scalar, class FVGridGeometry > -class StressVariablesCache -: public BoxFluxVariablesCache< Scalar, FVGridGeometry > +template< class Scalar, class GridGeometry > +class StressVariablesCache +: public BoxFluxVariablesCache< Scalar, GridGeometry > {}; // specialization for the cell centered tpfa method -template< class Scalar, class FVGridGeometry > -class StressVariablesCache +template< class Scalar, class GridGeometry > +class StressVariablesCache : public FluxVariablesCaching::_EmptyCache { public: @@ -75,9 +75,9 @@ public: }; // specialization for the cell centered mpfa method -template< class Scalar, class FVGridGeometry > -class StressVariablesCache -: public StressVariablesCache +template< class Scalar, class GridGeometry > +class StressVariablesCache +: public StressVariablesCache {}; } // end namespace Dumux diff --git a/dumux/io/loadsolution.hh b/dumux/io/loadsolution.hh index 26533678336073cdb3300d2528e229243688ab13..224254c1cb6731b203779140913080b9a76bfc79 100644 --- a/dumux/io/loadsolution.hh +++ b/dumux/io/loadsolution.hh @@ -98,18 +98,18 @@ private: * \ingroup InputOutput * \brief read from a vtk file into a solution vector with primary variables without state */ -template +template auto loadSolutionFromVtkFile(SolutionVector& sol, const std::string fileName, PvNameFunc&& pvNameFunc, - const FVGridGeometry& fvGridGeometry, + const GridGeometry& gridGeometry, const VTKReader::DataType& dataType) -> typename std::enable_if_t { VTKReader vtu(fileName); using PrimaryVariables = typename SolutionVector::block_type; using Scalar = typename PrimaryVariables::field_type; - constexpr auto dim = FVGridGeometry::GridView::dimension; + constexpr auto dim = GridGeometry::GridView::dimension; for (size_t pvIdx = 0; pvIdx < PrimaryVariables::dimension; ++pvIdx) { @@ -119,14 +119,14 @@ auto loadSolutionFromVtkFile(SolutionVector& sol, if (dataType == VTKReader::DataType::cellData) { std::size_t i = 0; - for (const auto& element : elements(fvGridGeometry.gridView(), Dune::Partitions::interior)) + for (const auto& element : elements(gridGeometry.gridView(), Dune::Partitions::interior)) { - const auto eIdx = fvGridGeometry.elementMapper().index(element); + const auto eIdx = gridGeometry.elementMapper().index(element); sol[eIdx][pvIdx] = vec[i++]; } } // for staggered face data (which is written out as VTK point data) we just read in the vector - else if (dataType == VTKReader::DataType::pointData && FVGridGeometry::discMethod == DiscretizationMethod::staggered) + else if (dataType == VTKReader::DataType::pointData && GridGeometry::discMethod == DiscretizationMethod::staggered) { if (sol.size() != vec.size()) DUNE_THROW(Dune::InvalidStateException, "Solution size (" << sol.size() << ") does not match input size (" << vec.size() << ")!"); @@ -137,12 +137,12 @@ auto loadSolutionFromVtkFile(SolutionVector& sol, else { std::size_t i = 0; - std::vector visited(fvGridGeometry.gridView().size(dim), false); - for (const auto& element : elements(fvGridGeometry.gridView(), Dune::Partitions::interior)) + std::vector visited(gridGeometry.gridView().size(dim), false); + for (const auto& element : elements(gridGeometry.gridView(), Dune::Partitions::interior)) { for (int vIdxLocal = 0; vIdxLocal < element.subEntities(dim); ++vIdxLocal) { - const auto vIdxGlobal = fvGridGeometry.vertexMapper().subIndex(element, vIdxLocal, dim); + const auto vIdxGlobal = gridGeometry.vertexMapper().subIndex(element, vIdxLocal, dim); if (!visited[vIdxGlobal]) { sol[vIdxGlobal][pvIdx] = vec[i++]; @@ -158,11 +158,11 @@ auto loadSolutionFromVtkFile(SolutionVector& sol, * \ingroup InputOutput * \brief read from a sequential file into a solution vector with primary variables with state */ -template +template auto loadSolutionFromVtkFile(SolutionVector& sol, const std::string fileName, PvNameFunc&& pvNameFunc, - const FVGridGeometry& fvGridGeometry, + const GridGeometry& gridGeometry, const VTKReader::DataType& dataType) -> typename std::enable_if_t { @@ -187,9 +187,9 @@ auto loadSolutionFromVtkFile(SolutionVector& sol, if (dataType == VTKReader::DataType::cellData) { std::size_t i = 0; - for (const auto& element : elements(fvGridGeometry.gridView(), Dune::Partitions::interior)) + for (const auto& element : elements(gridGeometry.gridView(), Dune::Partitions::interior)) { - const auto eIdx = fvGridGeometry.elementMapper().index(element); + const auto eIdx = gridGeometry.elementMapper().index(element); const auto state = stateAtDof[i]; sol[eIdx][pvIdx] = data[state][i++]; sol[eIdx].setState(state); @@ -198,13 +198,13 @@ auto loadSolutionFromVtkFile(SolutionVector& sol, else { std::size_t i = 0; - constexpr int dim = FVGridGeometry::GridView::dimension; - std::vector visited(fvGridGeometry.gridView().size(dim), false); - for (const auto& element : elements(fvGridGeometry.gridView(), Dune::Partitions::interior)) + constexpr int dim = GridGeometry::GridView::dimension; + std::vector visited(gridGeometry.gridView().size(dim), false); + for (const auto& element : elements(gridGeometry.gridView(), Dune::Partitions::interior)) { for (int vIdxLocal = 0; vIdxLocal < element.subEntities(dim); ++vIdxLocal) { - const auto vIdxGlobal = fvGridGeometry.vertexMapper().subIndex(element, vIdxLocal, dim); + const auto vIdxGlobal = gridGeometry.vertexMapper().subIndex(element, vIdxLocal, dim); if (!visited[vIdxGlobal]) { const auto state = stateAtDof[i]; @@ -272,52 +272,52 @@ auto createPVNameFunction(const std::string& paramGroup = "") * \param fileName the file name of the file to read from * \param pvNameFunc a function with the signature std::string(int pvIdx) * in case the primary variables have a state the signature is std::string(int pvIdx, int state) - * \param fvGridGeometry the grid geometry of the discretization method used + * \param gridGeometry the grid geometry of the discretization method used */ -template +template void loadSolution(SolutionVector& sol, const std::string& fileName, PvNameFunc&& pvNameFunc, - const FVGridGeometry& fvGridGeometry) + const GridGeometry& gridGeometry) { const auto extension = fileName.substr(fileName.find_last_of(".") + 1); - auto dataType = FVGridGeometry::discMethod == DiscretizationMethod::box ? + auto dataType = GridGeometry::discMethod == DiscretizationMethod::box ? VTKReader::DataType::pointData : VTKReader::DataType::cellData; if (extension == "vtu" || extension == "vtp") { - if (FVGridGeometry::discMethod == DiscretizationMethod::staggered && extension == "vtp") + if (GridGeometry::discMethod == DiscretizationMethod::staggered && extension == "vtp") dataType = VTKReader::DataType::pointData; - loadSolutionFromVtkFile(sol, fileName, pvNameFunc, fvGridGeometry, dataType); + loadSolutionFromVtkFile(sol, fileName, pvNameFunc, gridGeometry, dataType); } else if (extension == "pvtu" || extension == "pvtp") { - if (FVGridGeometry::discMethod == DiscretizationMethod::staggered) + if (GridGeometry::discMethod == DiscretizationMethod::staggered) DUNE_THROW(Dune::NotImplemented, "reading staggered solution from a parallel vtk file"); - loadSolutionFromVtkFile(sol, fileName, pvNameFunc, fvGridGeometry, dataType); + loadSolutionFromVtkFile(sol, fileName, pvNameFunc, gridGeometry, dataType); } else DUNE_THROW(Dune::NotImplemented, "loadSolution for file with extension " << extension); // communicate solution on ghost and overlap dofs - if (fvGridGeometry.gridView().comm().size() > 1) + if (gridGeometry.gridView().comm().size() > 1) { - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; if (dataType == VTKReader::DataType::cellData) { - LoadSolutionDataHandle - dataHandle(sol, fvGridGeometry.elementMapper()); - fvGridGeometry.gridView().communicate(dataHandle, + LoadSolutionDataHandle + dataHandle(sol, gridGeometry.elementMapper()); + gridGeometry.gridView().communicate(dataHandle, Dune::InteriorBorder_All_Interface, Dune::ForwardCommunication); } else { - LoadSolutionDataHandle - dataHandle(sol, fvGridGeometry.vertexMapper()); - fvGridGeometry.gridView().communicate(dataHandle, + LoadSolutionDataHandle + dataHandle(sol, gridGeometry.vertexMapper()); + gridGeometry.gridView().communicate(dataHandle, Dune::InteriorBorder_All_Interface, Dune::ForwardCommunication); } diff --git a/dumux/io/staggeredvtkoutputmodule.hh b/dumux/io/staggeredvtkoutputmodule.hh index 020dcfaf4c3585abbe07e147891549428bf72190..54a3d54be0766c6f843465f1c5940030243c22f1 100644 --- a/dumux/io/staggeredvtkoutputmodule.hh +++ b/dumux/io/staggeredvtkoutputmodule.hh @@ -49,11 +49,11 @@ class StaggeredVtkOutputModule : public VtkOutputModule { using ParentType = VtkOutputModule; - using FVGridGeometry = typename GridVariables::GridGeometry; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = typename GridVariables::GridGeometry; + using GridView = typename GridGeometry::GridView; using Scalar = typename GridVariables::Scalar; using FaceVariables = typename GridVariables::GridFaceVariables::FaceVariables; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using Element = typename GridView::template Codim<0>::Entity; @@ -111,7 +111,7 @@ public: //! \param name The name of the vtk field void addFaceField(const std::vector& v, const std::string& name) { - if (v.size() == this->fvGridGeometry().gridView().size(1)) + if (v.size() == this->gridGeometry().gridView().size(1)) faceFieldScalarDataInfo_.emplace_back(v, name); else DUNE_THROW(Dune::RangeError, "Size mismatch of added field!"); @@ -122,7 +122,7 @@ public: //! \param name The name of the vtk field void addFaceField(const std::vector& v, const std::string& name) { - if (v.size() == this->fvGridGeometry().gridView().size(1)) + if (v.size() == this->gridGeometry().gridView().size(1)) faceFieldVectorDataInfo_.emplace_back(v, name); else DUNE_THROW(Dune::RangeError, "Size mismatch of added field!"); @@ -160,10 +160,10 @@ private: //! Update the coordinates (the face centers) void updateCoordinates_() { - coordinates_.resize(this->fvGridGeometry().numFaceDofs()); - for(auto&& facet : facets(this->fvGridGeometry().gridView())) + coordinates_.resize(this->gridGeometry().numFaceDofs()); + for(auto&& facet : facets(this->gridGeometry().gridView())) { - const int dofIdxGlobal = this->fvGridGeometry().gridView().indexSet().index(facet); + const int dofIdxGlobal = this->gridGeometry().gridView().indexSet().index(facet); coordinates_[dofIdxGlobal] = facet.geometry().center(); } coordinatesInitialized_ = true; @@ -173,7 +173,7 @@ private: //! \param time The current time void getFaceDataAndWrite_(const Scalar time) { - const auto numPoints = this->fvGridGeometry().numFaceDofs(); + const auto numPoints = this->gridGeometry().numFaceDofs(); // make sure not to iterate over the same dofs twice std::vector dofVisited(numPoints, false); @@ -192,9 +192,9 @@ private: if(!faceVarVectorDataInfo_.empty()) faceVarVectorData.resize(faceVarVectorDataInfo_.size(), std::vector(numPoints)); - for (const auto& element : elements(this->fvGridGeometry().gridView(), Dune::Partitions::interior)) + for (const auto& element : elements(this->gridGeometry().gridView(), Dune::Partitions::interior)) { - auto fvGeometry = localView(this->fvGridGeometry()); + auto fvGeometry = localView(this->gridGeometry()); auto elemFaceVars = localView(this->gridVariables().curGridFaceVars()); if (!faceVarScalarDataInfo_.empty() || !faceVarVectorDataInfo_.empty()) diff --git a/dumux/io/vtkoutputmodule.hh b/dumux/io/vtkoutputmodule.hh index 2c4cb087b3b3e1697ce0c70efcd3d98c72f75d11..3584f0c9c6ed6b091380924d55cf258fdd8e8864 100644 --- a/dumux/io/vtkoutputmodule.hh +++ b/dumux/io/vtkoutputmodule.hh @@ -64,12 +64,12 @@ namespace Dumux { template class VtkOutputModule { - using FVGridGeometry = typename GridVariables::GridGeometry; + using GridGeometry = typename GridVariables::GridGeometry; using VV = typename GridVariables::VolumeVariables; using Scalar = typename GridVariables::Scalar; - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; enum { dim = GridView::dimension, @@ -79,7 +79,7 @@ class VtkOutputModule using Element = typename GridView::template Codim<0>::Entity; using VolVarsVector = Dune::FieldVector; - static constexpr bool isBox = FVGridGeometry::discMethod == DiscretizationMethod::box; + static constexpr bool isBox = GridGeometry::discMethod == DiscretizationMethod::box; static constexpr int dofCodim = isBox ? dim : 0; struct VolVarScalarDataInfo { std::function get; std::string name; }; @@ -163,8 +163,8 @@ public: // Deduce the number of components from the given vector type const auto nComp = getNumberOfComponents_(v); - const auto numElemDofs = fvGridGeometry().elementMapper().size(); - const auto numVertexDofs = fvGridGeometry().vertexMapper().size(); + const auto numElemDofs = gridGeometry().elementMapper().size(); + const auto numVertexDofs = gridGeometry().vertexMapper().size(); // Automatically deduce the field type ... if(fieldType == FieldType::automatic) @@ -193,9 +193,9 @@ public: // add the appropriate field if (fieldType == FieldType::element) - fields_.emplace_back(fvGridGeometry().gridView(), fvGridGeometry().elementMapper(), v, name, nComp, 0); + fields_.emplace_back(gridGeometry().gridView(), gridGeometry().elementMapper(), v, name, nComp, 0); else - fields_.emplace_back(fvGridGeometry().gridView(), fvGridGeometry().vertexMapper(), v, name, nComp, dim); + fields_.emplace_back(gridGeometry().gridView(), gridGeometry().vertexMapper(), v, name, nComp, dim); } ////////////////////////////////////////////////////////////////////////////////////////////// @@ -230,7 +230,7 @@ public: protected: // some return functions for differing implementations to use const auto& problem() const { return gridVariables_.curGridVolVars().problem(); } - const FVGridGeometry& fvGridGeometry() const { return gridVariables_.gridGeometry(); } + const GridGeometry& gridGeometry() const { return gridVariables_.gridGeometry(); } const GridVariables& gridVariables() const { return gridVariables_; } const SolutionVector& sol() const { return sol_; } @@ -276,7 +276,7 @@ private: || velocityOutput_->enableOutput() || addProcessRank) { - const auto numCells = fvGridGeometry().gridView().size(0); + const auto numCells = gridGeometry().gridView().size(0); const auto numDofs = numDofs_(); // get fields for all volume variables @@ -299,11 +299,11 @@ private: // maybe allocate space for the process rank if (addProcessRank) rank.resize(numCells); - for (const auto& element : elements(fvGridGeometry().gridView(), Dune::Partitions::interior)) + for (const auto& element : elements(gridGeometry().gridView(), Dune::Partitions::interior)) { - const auto eIdxGlobal = fvGridGeometry().elementMapper().index(element); + const auto eIdxGlobal = gridGeometry().elementMapper().index(element); - auto fvGeometry = localView(fvGridGeometry()); + auto fvGeometry = localView(gridGeometry()); auto elemVolVars = localView(gridVariables_.curGridVolVars()); // If velocity output is enabled we need to bind to the whole stencil @@ -349,7 +349,7 @@ private: //! the rank if (addProcessRank) - rank[eIdxGlobal] = static_cast(fvGridGeometry().gridView().comm().rank()); + rank[eIdxGlobal] = static_cast(gridGeometry().gridView().comm().rank()); } ////////////////////////////////////////////////////////////// @@ -360,19 +360,19 @@ private: if (isBox) { for (std::size_t i = 0; i < volVarScalarDataInfo_.size(); ++i) - sequenceWriter_.addVertexData( Field(fvGridGeometry().gridView(), fvGridGeometry().vertexMapper(), volVarScalarData[i], + sequenceWriter_.addVertexData( Field(gridGeometry().gridView(), gridGeometry().vertexMapper(), volVarScalarData[i], volVarScalarDataInfo_[i].name, /*numComp*/1, /*codim*/dim).get() ); for (std::size_t i = 0; i < volVarVectorDataInfo_.size(); ++i) - sequenceWriter_.addVertexData( Field(fvGridGeometry().gridView(), fvGridGeometry().vertexMapper(), volVarVectorData[i], + sequenceWriter_.addVertexData( Field(gridGeometry().gridView(), gridGeometry().vertexMapper(), volVarVectorData[i], volVarVectorDataInfo_[i].name, /*numComp*/dimWorld, /*codim*/dim).get() ); } else { for (std::size_t i = 0; i < volVarScalarDataInfo_.size(); ++i) - sequenceWriter_.addCellData( Field(fvGridGeometry().gridView(), fvGridGeometry().elementMapper(), volVarScalarData[i], + sequenceWriter_.addCellData( Field(gridGeometry().gridView(), gridGeometry().elementMapper(), volVarScalarData[i], volVarScalarDataInfo_[i].name, /*numComp*/1, /*codim*/0).get() ); for (std::size_t i = 0; i < volVarVectorDataInfo_.size(); ++i) - sequenceWriter_.addCellData( Field(fvGridGeometry().gridView(), fvGridGeometry().elementMapper(), volVarVectorData[i], + sequenceWriter_.addCellData( Field(gridGeometry().gridView(), gridGeometry().elementMapper(), volVarVectorData[i], volVarVectorDataInfo_[i].name, /*numComp*/dimWorld, /*codim*/0).get() ); } @@ -382,7 +382,7 @@ private: if (isBox && dim > 1) { for (int phaseIdx = 0; phaseIdx < velocityOutput_->numFluidPhases(); ++phaseIdx) - sequenceWriter_.addVertexData( Field(fvGridGeometry().gridView(), fvGridGeometry().vertexMapper(), velocity[phaseIdx], + sequenceWriter_.addVertexData( Field(gridGeometry().gridView(), gridGeometry().vertexMapper(), velocity[phaseIdx], "velocity_" + velocityOutput_->phaseName(phaseIdx) + " (m/s)", /*numComp*/dimWorld, /*codim*/dim).get() ); } @@ -390,7 +390,7 @@ private: else { for (int phaseIdx = 0; phaseIdx < velocityOutput_->numFluidPhases(); ++phaseIdx) - sequenceWriter_.addCellData( Field(fvGridGeometry().gridView(), fvGridGeometry().elementMapper(), velocity[phaseIdx], + sequenceWriter_.addCellData( Field(gridGeometry().gridView(), gridGeometry().elementMapper(), velocity[phaseIdx], "velocity_" + velocityOutput_->phaseName(phaseIdx) + " (m/s)", /*numComp*/dimWorld, /*codim*/0).get() ); } @@ -398,7 +398,7 @@ private: // the process rank if (addProcessRank) - sequenceWriter_.addCellData(Field(fvGridGeometry().gridView(), fvGridGeometry().elementMapper(), rank, "process rank", 1, 0).get()); + sequenceWriter_.addCellData(Field(gridGeometry().gridView(), gridGeometry().elementMapper(), rank, "process rank", 1, 0).get()); // also register additional (non-standardized) user fields if any for (auto&& field : fields_) @@ -460,7 +460,7 @@ private: || velocityOutput_->enableOutput() || addProcessRank) { - const auto numCells = fvGridGeometry().gridView().size(0); + const auto numCells = gridGeometry().gridView().size(0); const auto numDofs = numDofs_(); // get fields for all volume variables @@ -483,12 +483,12 @@ private: // maybe allocate space for the process rank if (addProcessRank) rank.resize(numCells); - for (const auto& element : elements(fvGridGeometry().gridView(), Dune::Partitions::interior)) + for (const auto& element : elements(gridGeometry().gridView(), Dune::Partitions::interior)) { - const auto eIdxGlobal = fvGridGeometry().elementMapper().index(element); + const auto eIdxGlobal = gridGeometry().elementMapper().index(element); const auto numCorners = element.subEntities(dim); - auto fvGeometry = localView(fvGridGeometry()); + auto fvGeometry = localView(gridGeometry()); auto elemVolVars = localView(gridVariables_.curGridVolVars()); // resize element-local data containers @@ -539,7 +539,7 @@ private: //! the rank if (addProcessRank) - rank[eIdxGlobal] = static_cast(fvGridGeometry().gridView().comm().rank()); + rank[eIdxGlobal] = static_cast(gridGeometry().gridView().comm().rank()); } ////////////////////////////////////////////////////////////// @@ -548,11 +548,11 @@ private: // volume variables if any for (std::size_t i = 0; i < volVarScalarDataInfo_.size(); ++i) - sequenceWriter_.addVertexData( Field(fvGridGeometry().gridView(), fvGridGeometry().elementMapper(), volVarScalarData[i], + sequenceWriter_.addVertexData( Field(gridGeometry().gridView(), gridGeometry().elementMapper(), volVarScalarData[i], volVarScalarDataInfo_[i].name, /*numComp*/1, /*codim*/dim, /*nonconforming*/dm_).get() ); for (std::size_t i = 0; i < volVarVectorDataInfo_.size(); ++i) - sequenceWriter_.addVertexData( Field(fvGridGeometry().gridView(), fvGridGeometry().elementMapper(), volVarVectorData[i], + sequenceWriter_.addVertexData( Field(gridGeometry().gridView(), gridGeometry().elementMapper(), volVarVectorData[i], volVarVectorDataInfo_[i].name, /*numComp*/dimWorld, /*codim*/dim, /*nonconforming*/dm_).get() ); // the velocity field @@ -561,21 +561,21 @@ private: // node-wise velocities if (dim > 1) for (int phaseIdx = 0; phaseIdx < velocityOutput_->numFluidPhases(); ++phaseIdx) - sequenceWriter_.addVertexData( Field(fvGridGeometry().gridView(), fvGridGeometry().vertexMapper(), velocity[phaseIdx], + sequenceWriter_.addVertexData( Field(gridGeometry().gridView(), gridGeometry().vertexMapper(), velocity[phaseIdx], "velocity_" + velocityOutput_->phaseName(phaseIdx) + " (m/s)", /*numComp*/dimWorld, /*codim*/dim).get() ); // cell-wise velocities else for (int phaseIdx = 0; phaseIdx < velocityOutput_->numFluidPhases(); ++phaseIdx) - sequenceWriter_.addCellData( Field(fvGridGeometry().gridView(), fvGridGeometry().elementMapper(), velocity[phaseIdx], + sequenceWriter_.addCellData( Field(gridGeometry().gridView(), gridGeometry().elementMapper(), velocity[phaseIdx], "velocity_" + velocityOutput_->phaseName(phaseIdx) + " (m/s)", /*numComp*/dimWorld, /*codim*/0).get() ); } // the process rank if (addProcessRank) - sequenceWriter_.addCellData( Field(fvGridGeometry().gridView(), fvGridGeometry().elementMapper(), rank, "process rank", 1, 0).get() ); + sequenceWriter_.addCellData( Field(gridGeometry().gridView(), gridGeometry().elementMapper(), rank, "process rank", 1, 0).get() ); // also register additional (non-standardized) user fields if any for (auto&& field : fields_) @@ -609,7 +609,7 @@ private: std::size_t getNumberOfComponents_(const Vector& v) { return 1; } //! return the number of dofs, we only support vertex and cell data - std::size_t numDofs_() const { return dofCodim == dim ? fvGridGeometry().vertexMapper().size() : fvGridGeometry().elementMapper().size(); } + std::size_t numDofs_() const { return dofCodim == dim ? gridGeometry().vertexMapper().size() : gridGeometry().elementMapper().size(); } const GridVariables& gridVariables_; const SolutionVector& sol_; diff --git a/dumux/linear/amgtraits.hh b/dumux/linear/amgtraits.hh index a1c66c527ffbcb578bf8709a4758529f0fed3769..942f68ee65e22a98ebe840a8acb7287c356be93e 100644 --- a/dumux/linear/amgtraits.hh +++ b/dumux/linear/amgtraits.hh @@ -68,11 +68,11 @@ struct canCommunicate, codim> namespace Dumux { //! The implementation is specialized for the different discretizations -template struct AmgTraitsImpl; +template struct AmgTraitsImpl; //! The type traits required for using the AMG backend -template -using AmgTraits = AmgTraitsImpl; +template +using AmgTraits = AmgTraitsImpl; //! NonoverlappingSolverTraits used by discretization with non-overlapping parallel model template @@ -98,10 +98,10 @@ public: #endif //! Box: use the non-overlapping AMG -template -struct AmgTraitsImpl +template +struct AmgTraitsImpl { - using Grid = typename FVGridGeometry::GridView::Traits::Grid; + using Grid = typename GridGeometry::GridView::Traits::Grid; enum { dofCodim = Grid::dimension, isNonOverlapping = true, @@ -117,7 +117,7 @@ struct AmgTraitsImpl using ScalarProduct = typename SolverTraits::ScalarProduct; using Smoother = typename SolverTraits::Smoother; - using DofMapper = typename FVGridGeometry::VertexMapper; + using DofMapper = typename GridGeometry::VertexMapper; }; //! OverlappingSolverTraits used by discretization with overlapping parallel model @@ -144,10 +144,10 @@ public: #endif //! Cell-centered tpfa: use the overlapping AMG -template -struct AmgTraitsImpl +template +struct AmgTraitsImpl { - using Grid = typename FVGridGeometry::GridView::Traits::Grid; + using Grid = typename GridGeometry::GridView::Traits::Grid; enum { dofCodim = 0, isNonOverlapping = false, @@ -163,12 +163,12 @@ struct AmgTraitsImpl -struct AmgTraitsImpl -: public AmgTraitsImpl {}; +template +struct AmgTraitsImpl +: public AmgTraitsImpl {}; } // end namespace Dumux diff --git a/dumux/material/chemistry/electrochemistry/electrochemistry.hh b/dumux/material/chemistry/electrochemistry/electrochemistry.hh index 081acfd9413e75d42b3e96c7e012ae5f4da1c934..9fe071ef33330c67a8e7a3ada4f52a24a321b957 100644 --- a/dumux/material/chemistry/electrochemistry/electrochemistry.hh +++ b/dumux/material/chemistry/electrochemistry/electrochemistry.hh @@ -48,7 +48,7 @@ enum ElectroChemistryModel { Ochs, Acosta }; * \todo TODO: Scalar type should be extracted from VolumeVariables! * \todo TODO: This shouldn't depend on grid and discretization!! */ -template +template class ElectroChemistry { @@ -74,8 +74,8 @@ class ElectroChemistry gasPhaseIdx = FluidSystem::gasPhaseIdx }; - using GridView = typename FVGridGeometry::GridView; - static constexpr bool isBox = FVGridGeometry::discMethod == DiscretizationMethod::box; + using GridView = typename GridGeometry::GridView; + static constexpr bool isBox = GridGeometry::discMethod == DiscretizationMethod::box; using GlobalPosition = typename Dune::FieldVector; public: diff --git a/dumux/material/chemistry/electrochemistry/electrochemistryni.hh b/dumux/material/chemistry/electrochemistry/electrochemistryni.hh index f2a4b8f6d801912cdd05c3171daac5e54cf90f7c..d4d31de82eb6e089e27a442cccfac2320c67480d 100644 --- a/dumux/material/chemistry/electrochemistry/electrochemistryni.hh +++ b/dumux/material/chemistry/electrochemistry/electrochemistryni.hh @@ -37,10 +37,10 @@ namespace Dumux { * \todo TODO: Scalar type should be extracted from VolumeVariables! * \todo TODO: This shouldn't depend on discretization and grid!! */ -template -class ElectroChemistryNI : public ElectroChemistry +template +class ElectroChemistryNI : public ElectroChemistry { - using ParentType = ElectroChemistry; + using ParentType = ElectroChemistry; using Constant = Constants; enum { @@ -50,8 +50,8 @@ class ElectroChemistryNI : public ElectroChemistry; using CellVector = typename Dune::FieldVector; diff --git a/dumux/material/fluidmatrixinteractions/porositydeformation.hh b/dumux/material/fluidmatrixinteractions/porositydeformation.hh index e1304dda7a19f49a716ccdc150115967cea3d519..2389db780a9661a4da7c0fdf826b452ab1e71fc3 100644 --- a/dumux/material/fluidmatrixinteractions/porositydeformation.hh +++ b/dumux/material/fluidmatrixinteractions/porositydeformation.hh @@ -44,7 +44,7 @@ public: * the displacements in the different grid directions are stored * in the first entries of the primary variable vector. * - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param element The finite element * \param elemSol The element solution * \param globalPos The global position (in the element) @@ -62,7 +62,7 @@ public: * \f$\phi = \frac{\phi_0 + \text{div} \mathbf{u}}{1 + \text{div} \mathbf{u}}\f$. */ template< class FVGridGeom, class ElemSol > - static Scalar evaluatePorosity(const FVGridGeom& fvGridGeometry, + static Scalar evaluatePorosity(const FVGridGeom& gridGeometry, const typename FVGridGeom::GridView::template Codim<0>::Entity& element, const typename FVGridGeom::GridView::template Codim<0>::Entity::Geometry::GlobalCoordinate& globalPos, const ElemSol& elemSol, @@ -72,7 +72,7 @@ public: { // compute divergence of displacement at the given position Scalar divU = 0.0; - const auto gradU = evalGradients(element, element.geometry(), fvGridGeometry, elemSol, globalPos); + const auto gradU = evalGradients(element, element.geometry(), gridGeometry, elemSol, globalPos); for (int dir = 0; dir < FVGridGeom::GridView::dimension; ++dir) divU += gradU[dir][dir]; @@ -88,7 +88,7 @@ public: * in the first entries of the primary variable vector. * * - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param element The finite element * \param elemSol The element solution * \param scv The sub-control volume @@ -96,7 +96,7 @@ public: * \param minPoro A minimum porosity value */ template< class FVGridGeom, class ElemSol > - static Scalar evaluatePorosity(const FVGridGeom& fvGridGeometry, + static Scalar evaluatePorosity(const FVGridGeom& gridGeometry, const typename FVGridGeom::GridView::template Codim<0>::Entity& element, const typename FVGridGeom::SubControlVolume& scv, const ElemSol& elemSol, @@ -104,7 +104,7 @@ public: Scalar minPoro = 0.0) { // evaluate the porosity at the scv center - return evaluatePorosity(fvGridGeometry, element, scv.center(), elemSol, refPoro, minPoro); + return evaluatePorosity(gridGeometry, element, scv.center(), elemSol, refPoro, minPoro); } }; diff --git a/dumux/material/spatialparams/fv.hh b/dumux/material/spatialparams/fv.hh index 3ff1cf17d44625e6cf27688851955b053b3d4c2f..4fb8c097b5c9340fd975218cf9086151f4044dc3 100644 --- a/dumux/material/spatialparams/fv.hh +++ b/dumux/material/spatialparams/fv.hh @@ -52,20 +52,20 @@ struct hasMaterialLawParamsAtPos * \brief The base class for spatial parameters of multi-phase problems * using a fully implicit discretization method. */ -template -class FVSpatialParams : public FVSpatialParamsOneP +template +class FVSpatialParams : public FVSpatialParamsOneP { - using ParentType = FVSpatialParamsOneP; - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; + using ParentType = FVSpatialParamsOneP; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: - FVSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + FVSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) {} /*! diff --git a/dumux/material/spatialparams/fv1p.hh b/dumux/material/spatialparams/fv1p.hh index 7bd4bd020cfb3f8560a96dd3267ef24445c4074f..fecc19e4e1008fc3271fec19b81f0e7c92ad4311 100644 --- a/dumux/material/spatialparams/fv1p.hh +++ b/dumux/material/spatialparams/fv1p.hh @@ -72,13 +72,13 @@ struct hasPorosityAtPos * \brief The base class for spatial parameters of one-phase problems * using a fully implicit discretization method. */ -template +template class FVSpatialParamsOneP { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; using Element = typename GridView::template Codim<0>::Entity; enum { dim = GridView::dimension }; @@ -88,8 +88,8 @@ class FVSpatialParamsOneP using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: - FVSpatialParamsOneP(std::shared_ptr fvGridGeometry) - : fvGridGeometry_(fvGridGeometry) + FVSpatialParamsOneP(std::shared_ptr gridGeometry) + : gridGeometry_(gridGeometry) , gravity_(0.0) { const bool enableGravity = getParam("Problem.EnableGravity"); @@ -326,13 +326,13 @@ public: } //! The finite volume grid geometry - [[deprecated("Use more general GridGeometry instead. FVGridGeometry will be removed after 3.1!")]] - const FVGridGeometry& fvGridGeometry() const - { return *fvGridGeometry_; } + [[deprecated("Use gridGeometry() instead. fvGridGeometry() will be removed after 3.1!")]] + const GridGeometry& fvGridGeometry() const + { return *gridGeometry_; } //! The finite volume grid geometry - const FVGridGeometry& gridGeometry() const - { return *fvGridGeometry_; } + const GridGeometry& gridGeometry() const + { return *gridGeometry_; } protected: @@ -343,7 +343,7 @@ protected: { return *static_cast(this); } private: - std::shared_ptr fvGridGeometry_; + std::shared_ptr gridGeometry_; GlobalPosition gravity_; //!< The gravity vector Scalar forchCoeffDefault_; }; diff --git a/dumux/material/spatialparams/fvelastic.hh b/dumux/material/spatialparams/fvelastic.hh index e864051cfb2bb27fabc8e53d39c7eecac5d7852e..84f67a33638a51ec5762154ec8bb9bb92128edce 100644 --- a/dumux/material/spatialparams/fvelastic.hh +++ b/dumux/material/spatialparams/fvelastic.hh @@ -53,12 +53,12 @@ struct hasLameParamsAtPos * \ingroup SpatialParameters * \brief The base class for spatial parameters of linear elastic geomechanical problems */ -template +template class FVSpatialParamsElastic { - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using GridView = typename FVGridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -66,8 +66,8 @@ class FVSpatialParamsElastic public: //! The constructor - FVSpatialParamsElastic(std::shared_ptr fvGridGeometry) - : fvGridGeometry_(fvGridGeometry) + FVSpatialParamsElastic(std::shared_ptr gridGeometry) + : gridGeometry_(gridGeometry) , gravity_(0.0) { const bool enableGravity = getParam("Problem.EnableGravity"); @@ -159,13 +159,13 @@ public: } //! The finite volume grid geometry - [[deprecated("Use more general GridGeometry instead. FVGridGeometry will be removed after 3.1!")]] - const FVGridGeometry& fvGridGeometry() const - { return *fvGridGeometry_; } + [[deprecated("Use gridGeometry() instead. fvGridGeometry() will be removed after 3.1!")]] + const GridGeometry& fvGridGeometry() const + { return *gridGeometry_; } //! The finite volume grid geometry - const FVGridGeometry& gridGeometry() const - { return *fvGridGeometry_; } + const GridGeometry& gridGeometry() const + { return *gridGeometry_; } protected: Implementation &asImp_() @@ -175,7 +175,7 @@ protected: { return *static_cast(this); } private: - std::shared_ptr fvGridGeometry_; + std::shared_ptr gridGeometry_; GlobalPosition gravity_; //!< The gravity vector }; } // end namespace Dumuxs diff --git a/dumux/material/spatialparams/fvnonequilibrium.hh b/dumux/material/spatialparams/fvnonequilibrium.hh index 576fb89182779a7d87bd3da8f05fd285e9d0344e..492d18d2485ba197018d05b2e4676346e91c9c4b 100644 --- a/dumux/material/spatialparams/fvnonequilibrium.hh +++ b/dumux/material/spatialparams/fvnonequilibrium.hh @@ -33,14 +33,14 @@ namespace Dumux { * \ingroup SpatialParameters * \brief Definition of the spatial parameters for non-equilibrium */ -template +template class FVNonEquilibriumSpatialParams -: public FVSpatialParams +: public FVSpatialParams { - using ParentType = FVSpatialParams; - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; + using ParentType = FVSpatialParams; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -50,8 +50,8 @@ public: using AwsSurfaceParams = Scalar; using AnsSurfaceParams = Scalar; - FVNonEquilibriumSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + FVNonEquilibriumSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { } /*! diff --git a/dumux/material/spatialparams/fvporoelastic.hh b/dumux/material/spatialparams/fvporoelastic.hh index df29df7836d035f15898a7f8810c66a7ffad5e0a..602893c0c27b0396774645ea3206c8991ed3ea69 100644 --- a/dumux/material/spatialparams/fvporoelastic.hh +++ b/dumux/material/spatialparams/fvporoelastic.hh @@ -74,12 +74,12 @@ struct hasBiotCoeffAtPos * \ingroup SpatialParameters * \brief The base class for spatial parameters of poro-elastic geomechanical problems */ -template +template class FVSpatialParamsPoroElastic { - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using GridView = typename FVGridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -87,8 +87,8 @@ class FVSpatialParamsPoroElastic public: //! The constructor - FVSpatialParamsPoroElastic(std::shared_ptr fvGridGeometry) - : fvGridGeometry_(fvGridGeometry) + FVSpatialParamsPoroElastic(std::shared_ptr gridGeometry) + : gridGeometry_(gridGeometry) , gravity_(0.0) { const bool enableGravity = getParam("Problem.EnableGravity"); @@ -314,13 +314,13 @@ public: } //! The finite volume grid geometry - [[deprecated("Use more general GridGeometry instead. FVGridGeometry will be removed after 3.1!")]] - const FVGridGeometry& fvGridGeometry() const - { return *fvGridGeometry_; } + [[deprecated("Use gridGeometry() instead. fvGridGeometry() will be removed after 3.1!")]] + const GridGeometry& fvGridGeometry() const + { return *gridGeometry_; } //! The finite volume grid geometry - const FVGridGeometry& gridGeometry() const - { return *fvGridGeometry_; } + const GridGeometry& gridGeometry() const + { return *gridGeometry_; } protected: Implementation &asImp_() @@ -330,7 +330,7 @@ protected: { return *static_cast(this); } private: - std::shared_ptr fvGridGeometry_; + std::shared_ptr gridGeometry_; GlobalPosition gravity_; //!< The gravity vector }; } // end namespace Dumux diff --git a/dumux/multidomain/boundary/darcydarcy/couplingmanager.hh b/dumux/multidomain/boundary/darcydarcy/couplingmanager.hh index 56064912fa83addf7e5dab5324f2ef5237a5ac02..206299bec2552b2805b075746525db6f681411a5 100644 --- a/dumux/multidomain/boundary/darcydarcy/couplingmanager.hh +++ b/dumux/multidomain/boundary/darcydarcy/couplingmanager.hh @@ -60,11 +60,11 @@ class DarcyDarcyBoundaryCouplingManager template using NumEqVector = GetPropType, Properties::NumEqVector>; template using ElementVolumeVariables = typename GetPropType, Properties::GridVolumeVariables>::LocalView; template using VolumeVariables = typename GetPropType, Properties::GridVolumeVariables>::VolumeVariables; - template using FVGridGeometry = typename MDTraits::template SubDomain::GridGeometry; - template using FVElementGeometry = typename FVGridGeometry::LocalView; - template using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - template using SubControlVolume = typename FVGridGeometry::SubControlVolume; - template using GridView = typename FVGridGeometry::GridView; + template using GridGeometry = typename MDTraits::template SubDomain::GridGeometry; + template using FVElementGeometry = typename GridGeometry::LocalView; + template using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + template using SubControlVolume = typename GridGeometry::SubControlVolume; + template using GridView = typename GridGeometry::GridView; template using Element = typename GridView::template Codim<0>::Entity; template @@ -73,7 +73,7 @@ class DarcyDarcyBoundaryCouplingManager template static constexpr bool isCCTpfa() - { return FVGridGeometry::discMethod == DiscretizationMethod::cctpfa; } + { return GridGeometry::discMethod == DiscretizationMethod::cctpfa; } using CouplingStencil = std::vector; public: diff --git a/dumux/multidomain/boundary/darcydarcy/couplingmapper.hh b/dumux/multidomain/boundary/darcydarcy/couplingmapper.hh index fe7604809141c03cfe71a1e930ee26aa73d3e9a7..f13d1cc8488e0af12bc86ef39f6bb13b5a82ae15 100644 --- a/dumux/multidomain/boundary/darcydarcy/couplingmapper.hh +++ b/dumux/multidomain/boundary/darcydarcy/couplingmapper.hh @@ -49,9 +49,9 @@ class DarcyDarcyBoundaryCouplingMapper { using Scalar = typename MDTraits::Scalar; - template using FVGridGeometry = typename MDTraits::template SubDomain::GridGeometry; - template using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - template using GridView = typename FVGridGeometry::GridView; + template using GridGeometry = typename MDTraits::template SubDomain::GridGeometry; + template using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + template using GridView = typename GridGeometry::GridView; template using Element = typename GridView::template Codim<0>::Entity; template @@ -60,7 +60,7 @@ class DarcyDarcyBoundaryCouplingMapper template static constexpr bool isCCTpfa() - { return FVGridGeometry::discMethod == DiscretizationMethod::cctpfa; } + { return GridGeometry::discMethod == DiscretizationMethod::cctpfa; } struct ScvfInfo { diff --git a/dumux/multidomain/boundary/stokesdarcy/couplingdata.hh b/dumux/multidomain/boundary/stokesdarcy/couplingdata.hh index fd03a4eb5f8d28d619d6d7a3a1d6627ca56a6358..c54991c45adcfa4d376d1ee8d8e74624ae383029 100644 --- a/dumux/multidomain/boundary/stokesdarcy/couplingdata.hh +++ b/dumux/multidomain/boundary/stokesdarcy/couplingdata.hh @@ -225,11 +225,11 @@ class StokesDarcyCouplingDataImplementationBase using Scalar = typename MDTraits::Scalar; template using SubDomainTypeTag = typename MDTraits::template SubDomain::TypeTag; - template using FVGridGeometry = GetPropType, Properties::GridGeometry>; - template using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; - template using FVElementGeometry = typename FVGridGeometry::LocalView; - template using SubControlVolumeFace = typename FVGridGeometry::LocalView::SubControlVolumeFace; - template using SubControlVolume = typename FVGridGeometry::LocalView::SubControlVolume; + template using GridGeometry = GetPropType, Properties::GridGeometry>; + template using Element = typename GridGeometry::GridView::template Codim<0>::Entity; + template using FVElementGeometry = typename GridGeometry::LocalView; + template using SubControlVolumeFace = typename GridGeometry::LocalView::SubControlVolumeFace; + template using SubControlVolume = typename GridGeometry::LocalView::SubControlVolume; template using Indices = typename GetPropType, Properties::ModelTraits>::Indices; template using ElementVolumeVariables = typename GetPropType, Properties::GridVolumeVariables>::LocalView; template using VolumeVariables = typename GetPropType, Properties::GridVolumeVariables>::VolumeVariables; @@ -241,8 +241,8 @@ class StokesDarcyCouplingDataImplementationBase static constexpr auto darcyIdx = CouplingManager::darcyIdx; using AdvectionType = GetPropType, Properties::AdvectionType>; - using DarcysLaw = DarcysLawImplementation, FVGridGeometry::discMethod>; - using ForchheimersLaw = ForchheimersLawImplementation, FVGridGeometry::discMethod>; + using DarcysLaw = DarcysLawImplementation, GridGeometry::discMethod>; + using ForchheimersLaw = ForchheimersLawImplementation, GridGeometry::discMethod>; static constexpr bool adapterUsed = ModelTraits::numFluidPhases() > 1; using IndexHelper = Dumux::IndexHelper, adapterUsed>; @@ -525,11 +525,11 @@ class StokesDarcyCouplingDataImplementation using SubDomainTypeTag = typename MDTraits::template SubDomain::TypeTag; - template using FVGridGeometry = GetPropType, Properties::GridGeometry>; - template using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; - template using FVElementGeometry = typename FVGridGeometry::LocalView; - template using SubControlVolumeFace = typename FVGridGeometry::LocalView::SubControlVolumeFace; - template using SubControlVolume = typename FVGridGeometry::LocalView::SubControlVolume; + template using GridGeometry = GetPropType, Properties::GridGeometry>; + template using Element = typename GridGeometry::GridView::template Codim<0>::Entity; + template using FVElementGeometry = typename GridGeometry::LocalView; + template using SubControlVolumeFace = typename GridGeometry::LocalView::SubControlVolumeFace; + template using SubControlVolume = typename GridGeometry::LocalView::SubControlVolume; template using Indices = typename GetPropType, Properties::ModelTraits>::Indices; template using ElementVolumeVariables = typename GetPropType, Properties::GridVolumeVariables>::LocalView; template using ElementFaceVariables = typename GetPropType, Properties::GridFaceVariables>::LocalView; @@ -687,11 +687,11 @@ class StokesDarcyCouplingDataImplementation using SubDomainTypeTag = typename MDTraits::template SubDomain::TypeTag; - template using FVGridGeometry = GetPropType, Properties::GridGeometry>; - template using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; - template using FVElementGeometry = typename FVGridGeometry::LocalView; + template using GridGeometry = GetPropType, Properties::GridGeometry>; + template using Element = typename GridGeometry::GridView::template Codim<0>::Entity; + template using FVElementGeometry = typename GridGeometry::LocalView; template using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; - template using SubControlVolume = typename FVGridGeometry::LocalView::SubControlVolume; + template using SubControlVolume = typename GridGeometry::LocalView::SubControlVolume; template using Indices = typename GetPropType, Properties::ModelTraits>::Indices; template using ElementVolumeVariables = typename GetPropType, Properties::GridVolumeVariables>::LocalView; template using ElementFaceVariables = typename GetPropType, Properties::GridFaceVariables>::LocalView; diff --git a/dumux/multidomain/boundary/stokesdarcy/couplingmanager.hh b/dumux/multidomain/boundary/stokesdarcy/couplingmanager.hh index 7636ae7d212c7e901fd92e425ffc6be0551490d1..e453df942df8014e93f396c057d8d47b9c948bda 100644 --- a/dumux/multidomain/boundary/stokesdarcy/couplingmanager.hh +++ b/dumux/multidomain/boundary/stokesdarcy/couplingmanager.hh @@ -81,8 +81,8 @@ private: template using ElementVolumeVariables = typename GetPropType, Properties::GridVolumeVariables>::LocalView; template using GridVolumeVariables = GetPropType, Properties::GridVolumeVariables>; template using VolumeVariables = typename GetPropType, Properties::GridVolumeVariables>::VolumeVariables; - template using FVGridGeometry = GetPropType, Properties::GridGeometry>; - template using FVElementGeometry = typename FVGridGeometry::LocalView; + template using GridGeometry = GetPropType, Properties::GridGeometry>; + template using FVElementGeometry = typename GridGeometry::LocalView; template using ElementBoundaryTypes = GetPropType, Properties::ElementBoundaryTypes>; template using ElementFluxVariablesCache = typename GetPropType, Properties::GridFluxVariablesCache>::LocalView; template using GridVariables = GetPropType, Properties::GridVariables>; @@ -121,8 +121,8 @@ public: using CouplingData = StokesDarcyCouplingData>; //! Constructor - StokesDarcyCouplingManager(std::shared_ptr> stokesFvGridGeometry, - std::shared_ptr> darcyFvGridGeometry) : couplingMapper_(*this) + StokesDarcyCouplingManager(std::shared_ptr> stokesFvGridGeometry, + std::shared_ptr> darcyFvGridGeometry) : couplingMapper_(*this) { } /*! diff --git a/dumux/multidomain/embedded/couplingmanager1d3d.hh b/dumux/multidomain/embedded/couplingmanager1d3d.hh index 0c16d200ed23482b83e97e4dcf047ed55b62f6c8..d40c1485a635ae6acb625b73b8763ac25277d4f4 100644 --- a/dumux/multidomain/embedded/couplingmanager1d3d.hh +++ b/dumux/multidomain/embedded/couplingmanager1d3d.hh @@ -53,12 +53,12 @@ struct CircleAveragePointSourceTraits { private: template using SubDomainTypeTag = typename MDTraits::template SubDomain::TypeTag; - template using FVGridGeometry = GetPropType, Properties::GridGeometry>; + template using GridGeometry = GetPropType, Properties::GridGeometry>; template using NumEqVector = GetPropType, Properties::NumEqVector>; public: //! export the point source type for domain i template - using PointSource = IntegrationPointSource::GlobalCoordinate, NumEqVector>; + using PointSource = IntegrationPointSource::GlobalCoordinate, NumEqVector>; //! export the point source helper type for domain i template @@ -100,8 +100,8 @@ class EmbeddedCouplingManager1d3d // the sub domain type aliases template using SubDomainTypeTag = typename MDTraits::template SubDomain::TypeTag; template using Problem = GetPropType, Properties::Problem>; - template using FVGridGeometry = GetPropType, Properties::GridGeometry>; - template using GridView = typename FVGridGeometry::GridView; + template using GridGeometry = GetPropType, Properties::GridGeometry>; + template using GridView = typename GridGeometry::GridView; template using Element = typename GridView::template Codim<0>::Entity; public: @@ -200,15 +200,15 @@ class EmbeddedCouplingManager1d3d // the sub domain type aliases template using SubDomainTypeTag = typename MDTraits::template SubDomain::TypeTag; template using Problem = GetPropType, Properties::Problem>; - template using FVGridGeometry = GetPropType, Properties::GridGeometry>; - template using GridView = typename FVGridGeometry::GridView; + template using GridGeometry = GetPropType, Properties::GridGeometry>; + template using GridView = typename GridGeometry::GridView; template using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; template static constexpr bool isBox() - { return FVGridGeometry::discMethod == DiscretizationMethod::box; } + { return GridGeometry::discMethod == DiscretizationMethod::box; } public: @@ -577,15 +577,15 @@ class EmbeddedCouplingManager1d3d using SubDomainTypeTag = typename MDTraits::template SubDomain::TypeTag; template using Problem = GetPropType, Properties::Problem>; - template using FVGridGeometry = GetPropType, Properties::GridGeometry>; - template using GridView = typename FVGridGeometry::GridView; + template using GridGeometry = GetPropType, Properties::GridGeometry>; + template using GridView = typename GridGeometry::GridView; template using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; template static constexpr bool isBox() - { return FVGridGeometry::discMethod == DiscretizationMethod::box; } + { return GridGeometry::discMethod == DiscretizationMethod::box; } enum { bulkDim = GridView::dimension, @@ -853,15 +853,15 @@ class EmbeddedCouplingManager1d3d // the sub domain type aliases template using SubDomainTypeTag = typename MDTraits::template SubDomain::TypeTag; template using Problem = GetPropType, Properties::Problem>; - template using FVGridGeometry = GetPropType, Properties::GridGeometry>; - template using GridView = typename FVGridGeometry::GridView; + template using GridGeometry = GetPropType, Properties::GridGeometry>; + template using GridView = typename GridGeometry::GridView; template using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; template static constexpr bool isBox() - { return FVGridGeometry::discMethod == DiscretizationMethod::box; } + { return GridGeometry::discMethod == DiscretizationMethod::box; } enum { bulkDim = GridView::dimension, diff --git a/dumux/multidomain/embedded/couplingmanagerbase.hh b/dumux/multidomain/embedded/couplingmanagerbase.hh index b50a5e53711e50fe6302cb15d2278443b8dbe397..f64b47db970ded62e2d280f56840758750886c00 100644 --- a/dumux/multidomain/embedded/couplingmanagerbase.hh +++ b/dumux/multidomain/embedded/couplingmanagerbase.hh @@ -51,12 +51,12 @@ struct DefaultPointSourceTraits { private: template using SubDomainTypeTag = typename MDTraits::template SubDomain::TypeTag; - template using FVGridGeometry = GetPropType, Properties::GridGeometry>; + template using GridGeometry = GetPropType, Properties::GridGeometry>; template using NumEqVector = GetPropType, Properties::NumEqVector>; public: //! export the point source type for domain i template - using PointSource = IntegrationPointSource::GlobalCoordinate, NumEqVector>; + using PointSource = IntegrationPointSource::GlobalCoordinate, NumEqVector>; //! export the point source helper type for domain i template @@ -87,9 +87,9 @@ class EmbeddedCouplingManagerBase template using SubDomainTypeTag = typename MDTraits::template SubDomain::TypeTag; template using Problem = GetPropType, Properties::Problem>; template using PrimaryVariables = GetPropType, Properties::PrimaryVariables>; - template using FVGridGeometry = GetPropType, Properties::GridGeometry>; - template using GridView = typename FVGridGeometry::GridView; - template using ElementMapper = typename FVGridGeometry::ElementMapper; + template using GridGeometry = GetPropType, Properties::GridGeometry>; + template using GridView = typename GridGeometry::GridView; + template using ElementMapper = typename GridGeometry::ElementMapper; template using Element = typename GridView::template Codim<0>::Entity; enum { @@ -100,7 +100,7 @@ class EmbeddedCouplingManagerBase template static constexpr bool isBox() - { return FVGridGeometry::discMethod == DiscretizationMethod::box; } + { return GridGeometry::discMethod == DiscretizationMethod::box; } using CouplingStencil = std::vector; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -117,8 +117,8 @@ public: /*! * \brief call this after grid adaption */ - void updateAfterGridAdaption(std::shared_ptr> bulkFvGridGeometry, - std::shared_ptr> lowDimFvGridGeometry) + void updateAfterGridAdaption(std::shared_ptr> bulkFvGridGeometry, + std::shared_ptr> lowDimFvGridGeometry) { glue_ = std::make_shared(); } @@ -126,8 +126,8 @@ public: /*! * \brief Constructor */ - EmbeddedCouplingManagerBase(std::shared_ptr> bulkFvGridGeometry, - std::shared_ptr> lowDimFvGridGeometry) + EmbeddedCouplingManagerBase(std::shared_ptr> bulkFvGridGeometry, + std::shared_ptr> lowDimFvGridGeometry) { updateAfterGridAdaption(bulkFvGridGeometry, lowDimFvGridGeometry); } @@ -446,7 +446,7 @@ protected: //! compute the shape function for a given point and geometry template = 0> - void getShapeValues(Dune::index_constant domainI, const FVGG& fvGridGeometry, const Geometry& geo, const GlobalPosition& globalPos, ShapeValues& shapeValues) + void getShapeValues(Dune::index_constant domainI, const FVGG& gridGeometry, const Geometry& geo, const GlobalPosition& globalPos, ShapeValues& shapeValues) { const auto ipLocal = geo.local(globalPos); const auto& localBasis = this->problem(domainI).gridGeometry().feCache().get(geo.type()).localBasis(); @@ -455,7 +455,7 @@ protected: //! compute the shape function for a given point and geometry template = 0> - void getShapeValues(Dune::index_constant domainI, const FVGG& fvGridGeometry, const Geometry& geo, const GlobalPosition& globalPos, ShapeValues& shapeValues) + void getShapeValues(Dune::index_constant domainI, const FVGG& gridGeometry, const Geometry& geo, const GlobalPosition& globalPos, ShapeValues& shapeValues) { DUNE_THROW(Dune::InvalidStateException, "Shape values requested for other discretization than box!"); } diff --git a/dumux/multidomain/embedded/extendedsourcestencil.hh b/dumux/multidomain/embedded/extendedsourcestencil.hh index 7e90408154abb0de3e25e738f7b0521571a8d7d6..9d1baae3e6ae44e23a343dfa0f0de1f28ec924db 100644 --- a/dumux/multidomain/embedded/extendedsourcestencil.hh +++ b/dumux/multidomain/embedded/extendedsourcestencil.hh @@ -49,8 +49,8 @@ class ExtendedSourceStencil using Scalar = typename MDTraits::Scalar; template using SubDomainTypeTag = typename MDTraits::template SubDomain::TypeTag; - template using FVGridGeometry = GetPropType, Properties::GridGeometry>; - template using GridView = typename FVGridGeometry::GridView; + template using GridGeometry = GetPropType, Properties::GridGeometry>; + template using GridView = typename GridGeometry::GridView; template using Element = typename GridView::template Codim<0>::Entity; static constexpr auto bulkIdx = typename MDTraits::template SubDomain<0>::Index(); @@ -58,7 +58,7 @@ class ExtendedSourceStencil template static constexpr bool isBox() - { return FVGridGeometry::discMethod == DiscretizationMethod::box; } + { return GridGeometry::discMethod == DiscretizationMethod::box; } public: /*! * \brief extend the jacobian pattern of the diagonal block of domain i diff --git a/dumux/multidomain/embedded/integrationpointsource.hh b/dumux/multidomain/embedded/integrationpointsource.hh index 4569845609ed030463cd8e9785ccb8dbecd66d1c..74ac494c9f378c6394ee78000e1155c8c14c6c60 100644 --- a/dumux/multidomain/embedded/integrationpointsource.hh +++ b/dumux/multidomain/embedded/integrationpointsource.hh @@ -108,8 +108,8 @@ class IntegrationPointSourceHelper public: //! calculate a DOF index to point source map from given vector of point sources - template - static void computePointSourceMap(const FVGridGeometry& fvGridGeometry, + template + static void computePointSourceMap(const GridGeometry& gridGeometry, std::vector& sources, PointSourceMap& pointSourceMap) { @@ -122,15 +122,15 @@ public: // loop over all intersected elements for (unsigned int eIdx : entities) { - if (FVGridGeometry::discMethod == DiscretizationMethod::box) + if (GridGeometry::discMethod == DiscretizationMethod::box) { // check in which subcontrolvolume(s) we are - const auto element = fvGridGeometry.boundingBoxTree().entitySet().entity(eIdx); - auto fvGeometry = localView(fvGridGeometry); + const auto element = gridGeometry.boundingBoxTree().entitySet().entity(eIdx); + auto fvGeometry = localView(gridGeometry); fvGeometry.bindElement(element); const auto globalPos = source.position(); // loop over all sub control volumes and check if the point source is inside - constexpr int dim = FVGridGeometry::GridView::dimension; + constexpr int dim = GridGeometry::GridView::dimension; Dune::ReservedVector scvIndices; for (auto&& scv : scvs(fvGeometry)) if (intersectsPointGeometry(globalPos, scv.geometry())) diff --git a/dumux/multidomain/facet/box/couplingmanager.hh b/dumux/multidomain/facet/box/couplingmanager.hh index 8022db17930359557fae355c6babfd8887f61561..601212f606c995c8f35cc1c7f7bbc116f35c7c12 100644 --- a/dumux/multidomain/facet/box/couplingmanager.hh +++ b/dumux/multidomain/facet/box/couplingmanager.hh @@ -68,11 +68,11 @@ class FacetCouplingManager using ElementBoundaryTypes = GetPropType, Properties::ElementBoundaryTypes>; template using LocalResidual = GetPropType, Properties::LocalResidual>; - template using FVGridGeometry = GetPropType, Properties::GridGeometry>; - template using FVElementGeometry = typename FVGridGeometry::LocalView; - template using SubControlVolume = typename FVGridGeometry::SubControlVolume; - template using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - template using GridView = typename FVGridGeometry::GridView; + template using GridGeometry = GetPropType, Properties::GridGeometry>; + template using FVElementGeometry = typename GridGeometry::LocalView; + template using SubControlVolume = typename GridGeometry::SubControlVolume; + template using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + template using GridView = typename GridGeometry::GridView; template using Element = typename GridView::template Codim<0>::Entity; template using GridIndexType = typename GridView::IndexSet::IndexType; @@ -89,7 +89,7 @@ class FacetCouplingManager(); static constexpr auto lowDimGridId = CouplingMapper::template gridId(); - static constexpr bool lowDimUsesBox = FVGridGeometry::discMethod == DiscretizationMethod::box; + static constexpr bool lowDimUsesBox = GridGeometry::discMethod == DiscretizationMethod::box; /*! * \brief The coupling context of the bulk domain. Contains all data of the lower- diff --git a/dumux/multidomain/facet/box/darcyslaw.hh b/dumux/multidomain/facet/box/darcyslaw.hh index 85e1d70340c65cb72c40906898d97946368d9e89..a7f06d4f279b57ab72c52c4252734ded3991bf11 100644 --- a/dumux/multidomain/facet/box/darcyslaw.hh +++ b/dumux/multidomain/facet/box/darcyslaw.hh @@ -46,15 +46,15 @@ namespace Dumux { * where coupling occurs across the facets of the bulk domain elements * with a lower-dimensional domain living on these facets. */ -template +template class BoxFacetCouplingDarcysLaw { - using DefaultBoxDarcysLaw = BoxDarcysLaw; + using DefaultBoxDarcysLaw = BoxDarcysLaw; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using CoordScalar = typename GridView::ctype; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; diff --git a/dumux/multidomain/facet/box/elementboundarytypes.hh b/dumux/multidomain/facet/box/elementboundarytypes.hh index 5093d4290a9f9698ef9e8c7bca3903d5e648e233..e4384855d80b9c94f7f8062c25962bc94c705af1 100644 --- a/dumux/multidomain/facet/box/elementboundarytypes.hh +++ b/dumux/multidomain/facet/box/elementboundarytypes.hh @@ -59,8 +59,8 @@ public: const Element &element, const FVElementGeometry &fvGeometry) { - using FVGridGeometry = typename FVElementGeometry::GridGeometry; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = typename FVElementGeometry::GridGeometry; + using GridView = typename GridGeometry::GridView; this->vertexBCTypes_.resize( element.subEntities(GridView::dimension) ); diff --git a/dumux/multidomain/facet/box/fvelementgeometry.hh b/dumux/multidomain/facet/box/fvelementgeometry.hh index 2ef80eb54eee499f6896945a4dc06d267179afc8..fcd7b4c9e1be0dbc0a442e42b018d8b1a70745d5 100644 --- a/dumux/multidomain/facet/box/fvelementgeometry.hh +++ b/dumux/multidomain/facet/box/fvelementgeometry.hh @@ -73,8 +73,8 @@ public: static constexpr std::size_t maxNumElementScvs = (1< scvs_; diff --git a/dumux/multidomain/facet/box/fvgridgeometry.hh b/dumux/multidomain/facet/box/fvgridgeometry.hh index c8385ecabdf709a4a4ee5f763c36abfccf0a79ec..3569aac8d05ff2f0e7a49b4385a78916851488eb 100644 --- a/dumux/multidomain/facet/box/fvgridgeometry.hh +++ b/dumux/multidomain/facet/box/fvgridgeometry.hh @@ -59,8 +59,8 @@ struct BoxFacetCouplingDefaultGridGeometryTraits using SubControlVolume = BoxSubControlVolume; using SubControlVolumeFace = BoxFacetCouplingSubControlVolumeFace; - template - using LocalView = BoxFacetCouplingFVElementGeometry; + template + using LocalView = BoxFacetCouplingFVElementGeometry; // per default we use an mcmg mapper for the elements using ElementMapper = Dune::MultipleCodimMultipleGeomTypeMapper; diff --git a/dumux/multidomain/facet/box/upwindscheme.hh b/dumux/multidomain/facet/box/upwindscheme.hh index 8ce7d7f19d3feb12ab2a4c9e43593f1f7da320e3..f03dbb2744823d6f5c3a781f8c837842039c89b6 100644 --- a/dumux/multidomain/facet/box/upwindscheme.hh +++ b/dumux/multidomain/facet/box/upwindscheme.hh @@ -36,7 +36,7 @@ namespace Dumux { * This is a modified scheme for models involving coupling * with a lower-dimensional domain across the element facets. */ -template +template class BoxFacetCouplingUpwindScheme { public: diff --git a/dumux/multidomain/facet/cellcentered/localresidual.hh b/dumux/multidomain/facet/cellcentered/localresidual.hh index 46da82281d6d6774d45f7d3828be31feb873cb7e..77819a5918fbe23c97643c724bed83c2a65e52d1 100644 --- a/dumux/multidomain/facet/cellcentered/localresidual.hh +++ b/dumux/multidomain/facet/cellcentered/localresidual.hh @@ -48,10 +48,10 @@ class CCFacetCouplingLocalResidual : public CCLocalResidual using ElementVolumeVariables = typename GridVariables::GridVolumeVariables::LocalView; using ElementFluxVariablesCache = typename GridVariables::GridFluxVariablesCache::LocalView; - using FVGridGeometry = typename GridVariables::GridGeometry; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using GridGeometry = typename GridVariables::GridGeometry; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using NumEqVector = GetPropType; diff --git a/dumux/multidomain/facet/cellcentered/mpfa/couplingmanager.hh b/dumux/multidomain/facet/cellcentered/mpfa/couplingmanager.hh index 1b667da08f5bc0fe76183db2c2fb9a2dca05224a..73c1707a4d6af0a73a191b30e91520392956e466 100644 --- a/dumux/multidomain/facet/cellcentered/mpfa/couplingmanager.hh +++ b/dumux/multidomain/facet/cellcentered/mpfa/couplingmanager.hh @@ -69,11 +69,11 @@ class FacetCouplingManager using Scalar = GetPropType, Properties::Scalar>; template using Problem = GetPropType, Properties::Problem>; template using NumEqVector = GetPropType, Properties::NumEqVector>; - template using FVGridGeometry = GetPropType, Properties::GridGeometry>; - template using FVElementGeometry = typename FVGridGeometry::LocalView; - template using SubControlVolume = typename FVGridGeometry::SubControlVolume; - template using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - template using GridView = typename FVGridGeometry::GridView; + template using GridGeometry = GetPropType, Properties::GridGeometry>; + template using FVElementGeometry = typename GridGeometry::LocalView; + template using SubControlVolume = typename GridGeometry::SubControlVolume; + template using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + template using GridView = typename GridGeometry::GridView; template using GridIndexType = typename IndexTraits< GridView >::GridIndex; template using Element = typename GridView::template Codim<0>::Entity; template using LocalResidual = GetPropType, Properties::LocalResidual>; @@ -88,7 +88,7 @@ class FacetCouplingManager(); static constexpr auto lowDimGridId = CouplingMapper::template gridId(); - static constexpr bool lowDimUsesBox = FVGridGeometry::discMethod == DiscretizationMethod::box; + static constexpr bool lowDimUsesBox = GridGeometry::discMethod == DiscretizationMethod::box; public: diff --git a/dumux/multidomain/facet/cellcentered/tpfa/couplingmanager.hh b/dumux/multidomain/facet/cellcentered/tpfa/couplingmanager.hh index 24b29a478b5a2091c7ebb599db7c7b2192b84482..19fca678a62f42656425f09dd2e7f29f1b994be1 100644 --- a/dumux/multidomain/facet/cellcentered/tpfa/couplingmanager.hh +++ b/dumux/multidomain/facet/cellcentered/tpfa/couplingmanager.hh @@ -68,11 +68,11 @@ class FacetCouplingManager using NumEqVector = GetPropType, Properties::NumEqVector>; template using LocalResidual = GetPropType, Properties::LocalResidual>; - template using FVGridGeometry = GetPropType, Properties::GridGeometry>; - template using FVElementGeometry = typename FVGridGeometry::LocalView; - template using SubControlVolume = typename FVGridGeometry::SubControlVolume; - template using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - template using GridView = typename FVGridGeometry::GridView; + template using GridGeometry = GetPropType, Properties::GridGeometry>; + template using FVElementGeometry = typename GridGeometry::LocalView; + template using SubControlVolume = typename GridGeometry::SubControlVolume; + template using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + template using GridView = typename GridGeometry::GridView; template using Element = typename GridView::template Codim<0>::Entity; template using GridIndexType = typename IndexTraits< GridView >::GridIndex; @@ -97,7 +97,7 @@ class FacetCouplingManager(); static constexpr auto lowDimGridId = CouplingMapper::template gridId(); - static constexpr bool lowDimUsesBox = FVGridGeometry::discMethod == DiscretizationMethod::box; + static constexpr bool lowDimUsesBox = GridGeometry::discMethod == DiscretizationMethod::box; /*! * \brief The coupling context of the bulk domain. Contains all data of the lower- diff --git a/dumux/multidomain/facet/cellcentered/tpfa/darcyslaw.hh b/dumux/multidomain/facet/cellcentered/tpfa/darcyslaw.hh index fe782aba49f00d91c4bdd810a520826b936f3560..27d5265961636f8af9b36c12502430e21bae1c99 100644 --- a/dumux/multidomain/facet/cellcentered/tpfa/darcyslaw.hh +++ b/dumux/multidomain/facet/cellcentered/tpfa/darcyslaw.hh @@ -42,7 +42,7 @@ namespace Dumux { //! Forward declaration of the implementation -template +template class CCTpfaFacetCouplingDarcysLawImpl; /*! @@ -51,7 +51,7 @@ class CCTpfaFacetCouplingDarcysLawImpl; * \note We distinguish between network and non-network grids here. Specializations * for the two cases can be found below. */ -template +template class CCTpfaFacetCouplingDarcysLawCache; /*! @@ -60,26 +60,26 @@ class CCTpfaFacetCouplingDarcysLawCache; * in the context of coupled models where the coupling occurs across the facets of the bulk * domain elements with a lower-dimensional domain living on these facets. */ -template +template using CCTpfaFacetCouplingDarcysLaw = - CCTpfaFacetCouplingDarcysLawImpl< ScalarType, FVGridGeometry, ( int(FVGridGeometry::GridView::dimension) < - int(FVGridGeometry::GridView::dimensionworld) ) >; + CCTpfaFacetCouplingDarcysLawImpl< ScalarType, GridGeometry, ( int(GridGeometry::GridView::dimension) < + int(GridGeometry::GridView::dimensionworld) ) >; /*! * \ingroup FacetCoupling * \brief Specialization of the FacetCouplingTpfaDarcysLawCache for non-network grids. */ -template -class CCTpfaFacetCouplingDarcysLawCache +template +class CCTpfaFacetCouplingDarcysLawCache { using Scalar = typename AdvectionType::Scalar; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; public: //! export the corresponding filler class - using Filler = TpfaDarcysLawCacheFiller; + using Filler = TpfaDarcysLawCacheFiller; //! we store the transmissibilities associated with the interior //! cell, outside cell, and the fracture facet in an array. Access @@ -137,17 +137,17 @@ private: * \ingroup FacetCoupling * \brief Specialization of the CCTpfaDarcysLaw grids where dim=dimWorld */ -template -class CCTpfaFacetCouplingDarcysLawImpl +template +class CCTpfaFacetCouplingDarcysLawImpl { - using ThisType = CCTpfaFacetCouplingDarcysLawImpl; - using TpfaDarcysLaw = CCTpfaDarcysLaw; + using ThisType = CCTpfaFacetCouplingDarcysLawImpl; + using TpfaDarcysLaw = CCTpfaDarcysLaw; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -168,7 +168,7 @@ class CCTpfaFacetCouplingDarcysLawImpl; + using Cache = CCTpfaFacetCouplingDarcysLawCache; //! export the type used to store transmissibilities using TijContainer = typename Cache::AdvectionTransmissibilityContainer; @@ -355,17 +355,17 @@ class CCTpfaFacetCouplingDarcysLawImpl -class CCTpfaFacetCouplingDarcysLawCache +template +class CCTpfaFacetCouplingDarcysLawCache { using Scalar = typename AdvectionType::Scalar; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; public: //! export the corresponding filler class - using Filler = TpfaDarcysLawCacheFiller; + using Filler = TpfaDarcysLawCacheFiller; //! we store the transmissibilities associated with the interior //! cell and the fracture facet in an array. Access to this array @@ -410,17 +410,17 @@ private: * \ingroup FacetCoupling * \brief Specialization of the CCTpfaDarcysLaw grids where dim -class CCTpfaFacetCouplingDarcysLawImpl +template +class CCTpfaFacetCouplingDarcysLawImpl { - using ThisType = CCTpfaFacetCouplingDarcysLawImpl; - using TpfaDarcysLaw = CCTpfaDarcysLaw; + using ThisType = CCTpfaFacetCouplingDarcysLawImpl; + using TpfaDarcysLaw = CCTpfaDarcysLaw; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -430,7 +430,7 @@ class CCTpfaFacetCouplingDarcysLawImpl; + using Cache = CCTpfaFacetCouplingDarcysLawCache; //! export the type used to store transmissibilities using TijContainer = typename Cache::AdvectionTransmissibilityContainer; diff --git a/dumux/multidomain/facet/cellcentered/upwindscheme.hh b/dumux/multidomain/facet/cellcentered/upwindscheme.hh index cfe8f1d87572c1833462c3504088d12f356c8ea8..c19bfb17c225730d4128a2bee7759cf304224580 100644 --- a/dumux/multidomain/facet/cellcentered/upwindscheme.hh +++ b/dumux/multidomain/facet/cellcentered/upwindscheme.hh @@ -37,10 +37,10 @@ namespace Dumux { * This is a modified scheme for models involving coupling * with a lower-dimensional domain across the element facets. */ -template +template class CCFacetCouplingUpwindScheme { - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; static constexpr int dim = GridView::dimension; static constexpr int dimWorld = GridView::dimensionworld; diff --git a/dumux/multidomain/facet/couplingmanager.hh b/dumux/multidomain/facet/couplingmanager.hh index 77860003fcfa9bbae892b119c41a12472b3edf7f..03b2ea07b3bff7690f09fc33a4aef932f7d9ade2 100644 --- a/dumux/multidomain/facet/couplingmanager.hh +++ b/dumux/multidomain/facet/couplingmanager.hh @@ -134,10 +134,10 @@ class FacetCouplingThreeDomainManager template using PrimaryVariables = GetPropType, Properties::PrimaryVariables>; template using Problem = GetPropType, Properties::Problem>; - template using FVGridGeometry = GetPropType, Properties::GridGeometry>; - template using FVElementGeometry = typename FVGridGeometry::LocalView; - template using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - template using GridView = typename FVGridGeometry::GridView; + template using GridGeometry = GetPropType, Properties::GridGeometry>; + template using FVElementGeometry = typename GridGeometry::LocalView; + template using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + template using GridView = typename GridGeometry::GridView; template using GridIndexType = typename IndexTraits>::GridIndex; template using Element = typename GridView::template Codim<0>::Entity; @@ -148,7 +148,7 @@ class FacetCouplingThreeDomainManager // helper function to check if a domain uses mpfa template static constexpr bool usesMpfa(Dune::index_constant domainId) - { return FVGridGeometry::discMethod == DiscretizationMethod::ccmpfa; } + { return GridGeometry::discMethod == DiscretizationMethod::ccmpfa; } public: //! types used for coupling stencils diff --git a/dumux/multidomain/facet/couplingmapperbase.hh b/dumux/multidomain/facet/couplingmapperbase.hh index 42aab8a65835ef867996400348e34dba62d41d79..df6bac359a754475e67a5026f2c37b14bb5a1b41 100644 --- a/dumux/multidomain/facet/couplingmapperbase.hh +++ b/dumux/multidomain/facet/couplingmapperbase.hh @@ -205,18 +205,18 @@ protected: } //! Creates a container with the nodal dofs within an element - template< class FVGridGeometry> - std::vector< typename IndexTraits::GridIndex > - extractNodalDofs_(const typename FVGridGeometry::GridView::template Codim<0>::Entity& element, - const FVGridGeometry& fvGridGeometry) + template< class GridGeometry> + std::vector< typename IndexTraits::GridIndex > + extractNodalDofs_(const typename GridGeometry::GridView::template Codim<0>::Entity& element, + const GridGeometry& gridGeometry) { - static constexpr int dim = FVGridGeometry::GridView::dimension; - using GridIndexType = typename IndexTraits::GridIndex; + static constexpr int dim = GridGeometry::GridView::dimension; + using GridIndexType = typename IndexTraits::GridIndex; const auto numCorners = element.subEntities(dim); std::vector< GridIndexType > nodalDofs(numCorners); for (unsigned int i = 0; i < numCorners; ++i) - nodalDofs[i] = fvGridGeometry.vertexMapper().subIndex(element, i, dim); + nodalDofs[i] = gridGeometry.vertexMapper().subIndex(element, i, dim); return nodalDofs; } @@ -232,15 +232,15 @@ protected: private: //! Creates the map from element insertion index to grid element index - template< class Embeddings, class FVGridGeometry> - std::unordered_map< typename IndexTraits::GridIndex, typename IndexTraits::GridIndex > - makeInsertionToGridIndexMap_(std::shared_ptr embeddings, const FVGridGeometry& fvGridGeometry) const + template< class Embeddings, class GridGeometry> + std::unordered_map< typename IndexTraits::GridIndex, typename IndexTraits::GridIndex > + makeInsertionToGridIndexMap_(std::shared_ptr embeddings, const GridGeometry& gridGeometry) const { - using GridIndexType = typename IndexTraits::GridIndex; + using GridIndexType = typename IndexTraits::GridIndex; std::unordered_map< GridIndexType, GridIndexType > map; - for (const auto& e : elements(fvGridGeometry.gridView())) - map.insert( std::make_pair( embeddings->template insertionIndex(e), fvGridGeometry.elementMapper().index(e) ) ); + for (const auto& e : elements(gridGeometry.gridView())) + map.insert( std::make_pair( embeddings->template insertionIndex(e), gridGeometry.elementMapper().index(e) ) ); return map; } diff --git a/dumux/multidomain/fvassembler.hh b/dumux/multidomain/fvassembler.hh index 35952200565c2c81408da7d3f4ddbb83faf26470..13cf56370a65105b1aa3a72b46f543b1ac29d6be 100644 --- a/dumux/multidomain/fvassembler.hh +++ b/dumux/multidomain/fvassembler.hh @@ -96,7 +96,7 @@ public: private: using ProblemTuple = typename MDTraits::template TupleOfSharedPtrConst; - using FVGridGeometryTuple = typename MDTraits::template TupleOfSharedPtrConst; + using GridGeometryTuple = typename MDTraits::template TupleOfSharedPtrConst; using GridVariablesTuple = typename MDTraits::template TupleOfSharedPtr; using TimeLoop = TimeLoopBase; @@ -130,7 +130,7 @@ private: }; template - using SubDomainAssembler = typename SubDomainAssemblerType::discMethod, id>::type; + using SubDomainAssembler = typename SubDomainAssemblerType::discMethod, id>::type; public: @@ -141,12 +141,12 @@ public: * it is however guaranteed that the state after assembly will be the same as before */ MultiDomainFVAssembler(ProblemTuple&& problem, - FVGridGeometryTuple&& fvGridGeometry, + GridGeometryTuple&& gridGeometry, GridVariablesTuple&& gridVariables, std::shared_ptr couplingManager) : couplingManager_(couplingManager) , problemTuple_(problem) - , fvGridGeometryTuple_(fvGridGeometry) + , gridGeometryTuple_(gridGeometry) , gridVariablesTuple_(gridVariables) , timeLoop_() , isStationaryProblem_(true) @@ -161,13 +161,13 @@ public: */ [[deprecated("Please use constructor taking the previous solution instead. Will be removed after release 3.2!")]] MultiDomainFVAssembler(ProblemTuple&& problem, - FVGridGeometryTuple&& fvGridGeometry, + GridGeometryTuple&& gridGeometry, GridVariablesTuple&& gridVariables, std::shared_ptr couplingManager, std::shared_ptr timeLoop) : couplingManager_(couplingManager) , problemTuple_(problem) - , fvGridGeometryTuple_(fvGridGeometry) + , gridGeometryTuple_(gridGeometry) , gridVariablesTuple_(gridVariables) , timeLoop_(timeLoop) , isStationaryProblem_(false) @@ -181,14 +181,14 @@ public: * it is however guaranteed that the state after assembly will be the same as before */ MultiDomainFVAssembler(ProblemTuple&& problem, - FVGridGeometryTuple&& fvGridGeometry, + GridGeometryTuple&& gridGeometry, GridVariablesTuple&& gridVariables, std::shared_ptr couplingManager, std::shared_ptr timeLoop, const SolutionVector& prevSol) : couplingManager_(couplingManager) , problemTuple_(problem) - , fvGridGeometryTuple_(fvGridGeometry) + , gridGeometryTuple_(gridGeometry) , gridVariablesTuple_(gridVariables) , timeLoop_(timeLoop) , prevSol_(&prevSol) @@ -351,7 +351,7 @@ public: //! the number of dof locations of domain i template std::size_t numDofs(Dune::index_constant domainId) const - { return std::get(fvGridGeometryTuple_)->numDofs(); } + { return std::get(gridGeometryTuple_)->numDofs(); } //! the problem of domain i template @@ -367,7 +367,7 @@ public: //! the finite volume grid geometry of domain i template const auto& gridGeometry(Dune::index_constant domainId) const - { return *std::get(fvGridGeometryTuple_); } + { return *std::get(gridGeometryTuple_); } //! the grid view of domain i template @@ -529,7 +529,7 @@ private: ProblemTuple problemTuple_; //! the finite volume geometry of the grid - FVGridGeometryTuple fvGridGeometryTuple_; + GridGeometryTuple gridGeometryTuple_; //! the variables container for the grid GridVariablesTuple gridVariablesTuple_; diff --git a/dumux/multidomain/newtonsolver.hh b/dumux/multidomain/newtonsolver.hh index c9daad5580fdb720774ab119502175f49b482e1f..5d555124041799c3fcadaad06b72f36dba872df1 100644 --- a/dumux/multidomain/newtonsolver.hh +++ b/dumux/multidomain/newtonsolver.hh @@ -165,9 +165,9 @@ private: priVarsSwitchedInLastIteration_[i] = false; const auto& problem = this->assembler().problem(id); - const auto& fvGridGeometry = this->assembler().gridGeometry(id); + const auto& gridGeometry = this->assembler().gridGeometry(id); auto& gridVariables = this->assembler().gridVariables(id); - priVarSwitch.updateBoundary(problem, fvGridGeometry, gridVariables, sol[id]); + priVarSwitch.updateBoundary(problem, gridGeometry, gridVariables, sol[id]); } /*! @@ -184,7 +184,7 @@ private: { // update the variable switch (returns true if the pri vars at at least one dof were switched) // for disabled grid variable caching - const auto& fvGridGeometry = this->assembler().gridGeometry(id); + const auto& gridGeometry = this->assembler().gridGeometry(id); const auto& problem = this->assembler().problem(id); auto& gridVariables = this->assembler().gridVariables(id); @@ -193,17 +193,17 @@ private: // invoke the primary variable switch priVarsSwitchedInLastIteration_[i] = priVarSwitch.update(uCurrentIter, gridVariables, - problem, fvGridGeometry); + problem, gridGeometry); if (priVarsSwitchedInLastIteration_[i]) { - for (const auto& element : elements(fvGridGeometry.gridView())) + for (const auto& element : elements(gridGeometry.gridView())) { // if the volume variables are cached globally, we need to update those where the primary variables have been switched - priVarSwitch.updateSwitchedVolVars(problem, element, fvGridGeometry, gridVariables, uCurrentIter); + priVarSwitch.updateSwitchedVolVars(problem, element, gridGeometry, gridVariables, uCurrentIter); // if the flux variables are cached globally, we need to update those where the primary variables have been switched - priVarSwitch.updateSwitchedFluxVarsCache(problem, element, fvGridGeometry, gridVariables, uCurrentIter); + priVarSwitch.updateSwitchedFluxVarsCache(problem, element, gridGeometry, gridVariables, uCurrentIter); } } } diff --git a/dumux/multidomain/staggeredcouplingmanager.hh b/dumux/multidomain/staggeredcouplingmanager.hh index e154281c79984717349e1121449321c3676bdf62..fe75d64c4fd47cedc178f2ef007669da58587563 100644 --- a/dumux/multidomain/staggeredcouplingmanager.hh +++ b/dumux/multidomain/staggeredcouplingmanager.hh @@ -42,10 +42,10 @@ class StaggeredCouplingManager: virtual public CouplingManager { using ParentType = CouplingManager; - template using FVGridGeometry = typename MDTraits::template SubDomain::GridGeometry; - template using GridView = typename FVGridGeometry::GridView; + template using GridGeometry = typename MDTraits::template SubDomain::GridGeometry; + template using GridView = typename GridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry<0>::LocalView; + using FVElementGeometry = typename GridGeometry<0>::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using Element = typename GridView<0>::template Codim<0>::Entity; @@ -58,8 +58,8 @@ public: using Traits = MDTraits; - static constexpr auto cellCenterIdx = FVGridGeometry<0>::cellCenterIdx(); - static constexpr auto faceIdx = FVGridGeometry<0>::faceIdx(); + static constexpr auto cellCenterIdx = GridGeometry<0>::cellCenterIdx(); + static constexpr auto faceIdx = GridGeometry<0>::faceIdx(); /*! * \copydoc Dumux::CouplingManager::updateCouplingContext() @@ -186,7 +186,7 @@ public: * \brief return the numeric epsilon used for deflecting primary variables of coupled domain i. * \note specialization for non-staggered schemes */ - template::discMethod != DiscretizationMethod::staggered), int> = 0> + template::discMethod != DiscretizationMethod::staggered), int> = 0> decltype(auto) numericEpsilon(Dune::index_constant id, const std::string& paramGroup) const { @@ -197,13 +197,13 @@ public: * \brief return the numeric epsilon used for deflecting primary variables of coupled domain i. * \note specialization for non-staggered schemes */ - template::discMethod == DiscretizationMethod::staggered), int> = 0> + template::discMethod == DiscretizationMethod::staggered), int> = 0> decltype(auto) numericEpsilon(Dune::index_constant, const std::string& paramGroup) const { constexpr std::size_t numEqCellCenter = Traits::template SubDomain::PrimaryVariables::dimension; constexpr std::size_t numEqFace = Traits::template SubDomain::PrimaryVariables::dimension; - constexpr bool isCellCenter = FVGridGeometry::isCellCenter(); + constexpr bool isCellCenter = GridGeometry::isCellCenter(); constexpr std::size_t numEq = isCellCenter ? numEqCellCenter : numEqFace; constexpr auto prefix = isCellCenter ? "CellCenter" : "Face"; diff --git a/dumux/multidomain/subdomainboxlocalassembler.hh b/dumux/multidomain/subdomainboxlocalassembler.hh index f267475a6ff8c6fb1f82d95d8b76e73b5983c2d5..f8e068c60d7a475a2d3941f21d31bd6f2427458c 100644 --- a/dumux/multidomain/subdomainboxlocalassembler.hh +++ b/dumux/multidomain/subdomainboxlocalassembler.hh @@ -72,10 +72,10 @@ class SubDomainBoxLocalAssemblerBase : public FVLocalAssemblerBase; using Element = typename GridView::template Codim<0>::Entity; @@ -347,9 +347,9 @@ class SubDomainBoxLocalAssembler::LocalView; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; enum { numEq = GetPropType::numEq() }; @@ -582,9 +582,9 @@ class SubDomainBoxLocalAssembler; using ElementResidualVector = typename ParentType::LocalResidual::ElementResidualVector; using ElementVolumeVariables = typename GetPropType::LocalView; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; enum { numEq = GetPropType::numEq() }; diff --git a/dumux/multidomain/subdomaincclocalassembler.hh b/dumux/multidomain/subdomaincclocalassembler.hh index e07c42fbf6e92b1cd87994ec5ca4de2f6860ee96..5d1dd8784d78d807b6dc73d5322c2ddfed4bfb0b 100644 --- a/dumux/multidomain/subdomaincclocalassembler.hh +++ b/dumux/multidomain/subdomaincclocalassembler.hh @@ -72,10 +72,10 @@ class SubDomainCCLocalAssemblerBase : public FVLocalAssemblerBase; using Element = typename GridView::template Codim<0>::Entity; @@ -284,9 +284,9 @@ class SubDomainCCLocalAssembler; using LocalResidualValues = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; enum { numEq = GetPropType::numEq() }; @@ -294,7 +294,7 @@ class SubDomainCCLocalAssembler(); static constexpr bool enableGridVolVarsCache = getPropValue(); - static constexpr int maxElementStencilSize = FVGridGeometry::maxElementStencilSize; + static constexpr int maxElementStencilSize = GridGeometry::maxElementStencilSize; static constexpr auto domainI = Dune::index_constant(); public: @@ -318,13 +318,13 @@ public: // get some aliases for convenience const auto& element = this->element(); const auto& fvGeometry = this->fvGeometry(); - const auto& fvGridGeometry = fvGeometry.gridGeometry(); + const auto& gridGeometry = fvGeometry.gridGeometry(); auto&& curElemVolVars = this->curElemVolVars(); auto&& elemFluxVarsCache = this->elemFluxVarsCache(); // get stencil informations - const auto globalI = fvGridGeometry.elementMapper().index(element); - const auto& connectivityMap = fvGridGeometry.connectivityMap(); + const auto globalI = gridGeometry.elementMapper().index(element); + const auto& connectivityMap = gridGeometry.connectivityMap(); const auto numNeighbors = connectivityMap[globalI].size(); // container to store the neighboring elements @@ -341,7 +341,7 @@ public: unsigned int j = 1; for (const auto& dataJ : connectivityMap[globalI]) { - neighborElements[j-1] = fvGridGeometry.element(dataJ.globalJ); + neighborElements[j-1] = gridGeometry.element(dataJ.globalJ); for (const auto scvfIdx : dataJ.scvfsJ) origResiduals[j] += this->evalFluxResidual(neighborElements[j-1], fvGeometry.scvf(scvfIdx)); @@ -457,12 +457,12 @@ public: // get some aliases for convenience const auto& element = this->element(); const auto& fvGeometry = this->fvGeometry(); - const auto& fvGridGeometry = fvGeometry.gridGeometry(); + const auto& gridGeometry = fvGeometry.gridGeometry(); auto&& curElemVolVars = this->curElemVolVars(); auto&& elemFluxVarsCache = this->elemFluxVarsCache(); // get stencil informations - const auto globalI = fvGridGeometry.elementMapper().index(element); + const auto globalI = gridGeometry.elementMapper().index(element); const auto& stencil = this->couplingManager().couplingStencil(domainI, element, domainJ); const auto& curSolJ = this->curSol()[domainJ]; @@ -594,11 +594,11 @@ public: // get some aliases for convenience const auto& element = this->element(); const auto& fvGeometry = this->fvGeometry(); - const auto& fvGridGeometry = fvGeometry.gridGeometry(); + const auto& gridGeometry = fvGeometry.gridGeometry(); auto&& curElemVolVars = this->curElemVolVars(); // reference to the element's scv (needed later) and corresponding vol vars - const auto globalI = fvGridGeometry.elementMapper().index(element); + const auto globalI = gridGeometry.elementMapper().index(element); const auto& scv = fvGeometry.scv(globalI); auto& curVolVars = ParentType::getVolVarAccess(gridVariables.curGridVolVars(), curElemVolVars, scv); @@ -609,7 +609,7 @@ public: const auto origVolVars = curVolVars; // element solution container to be deflected - auto elemSol = elementSolution(element, curSol, fvGridGeometry); + auto elemSol = elementSolution(element, curSol, gridGeometry); // derivatives in the neighbors with repect to the current elements LocalResidualValues partialDeriv; @@ -768,12 +768,12 @@ public: // get some aliases for convenience const auto& element = this->element(); const auto& fvGeometry = this->fvGeometry(); - const auto& fvGridGeometry = fvGeometry.gridGeometry(); + const auto& gridGeometry = fvGeometry.gridGeometry(); auto&& curElemVolVars = this->curElemVolVars(); // auto&& elemFluxVarsCache = this->elemFluxVarsCache(); // get stencil informations - const auto globalI = fvGridGeometry.elementMapper().index(element); + const auto globalI = gridGeometry.elementMapper().index(element); const auto& stencil = this->couplingManager().couplingStencil(domainI, element, domainJ); for (const auto globalJ : stencil) diff --git a/dumux/multidomain/subdomainstaggeredlocalassembler.hh b/dumux/multidomain/subdomainstaggeredlocalassembler.hh index faab9bebe8ac4f8dbd88f13b55e36fa7bc4e16c6..c14390b471022b42e6bec91a1159d02151c4cf1a 100644 --- a/dumux/multidomain/subdomainstaggeredlocalassembler.hh +++ b/dumux/multidomain/subdomainstaggeredlocalassembler.hh @@ -71,9 +71,9 @@ class SubDomainStaggeredLocalAssemblerBase : public FVLocalAssemblerBase; using Element = typename GridView::template Codim<0>::Entity; @@ -497,9 +497,9 @@ class SubDomainStaggeredLocalAssembler; using ElementFaceVariables = typename GetPropType::LocalView; using FaceVariables = typename ElementFaceVariables::FaceVariables; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; using VolumeVariables = GetPropType; using CellCenterPrimaryVariables = GetPropType; using FacePrimaryVariables = GetPropType; @@ -543,10 +543,10 @@ public: const auto& element = this->element(); const auto& fvGeometry = this->fvGeometry(); auto&& curElemVolVars = this->curElemVolVars(); - const auto& fvGridGeometry = this->problem().gridGeometry(); + const auto& gridGeometry = this->problem().gridGeometry(); const auto& curSol = this->curSol()[domainI]; - const auto cellCenterGlobalI = fvGridGeometry.elementMapper().index(element); + const auto cellCenterGlobalI = gridGeometry.elementMapper().index(element); const auto origResidual = this->evalLocalResidualForCellCenter(); ///////////////////////////////////////////////////////////////////////////////////////////////////////// @@ -607,7 +607,7 @@ public: }; // get the list of cell center dofs that have an influence on the cell center resdiual of the current element - const auto& connectivityMap = fvGridGeometry.connectivityMap(); + const auto& connectivityMap = gridGeometry.connectivityMap(); // evaluate derivatives w.r.t. own dof evaluateCellCenterDerivatives(cellCenterGlobalI); @@ -634,7 +634,7 @@ public: const auto& problem = this->problem(); const auto& element = this->element(); const auto& fvGeometry = this->fvGeometry(); - const auto& fvGridGeometry = this->problem().gridGeometry(); + const auto& gridGeometry = this->problem().gridGeometry(); const auto& curSol = this->curSol()[domainI]; using FaceSolutionVector = GetPropType; // TODO: use reserved vector @@ -659,7 +659,7 @@ public: const auto faceGlobalI = scvf.dofIndex(); using FaceSolution = GetPropType; - const auto origFaceSolution = FaceSolution(scvf, curSol, fvGridGeometry); + const auto origFaceSolution = FaceSolution(scvf, curSol, gridGeometry); // Lambda to evaluate the derivatives for faces auto evaluateFaceDerivatives = [&](const std::size_t globalJ) @@ -708,7 +708,7 @@ public: evaluateFaceDerivatives(scvf.dofIndex()); // get the list of face dofs that have an influence on the resdiual of the current face - const auto& connectivityMap = fvGridGeometry.connectivityMap(); + const auto& connectivityMap = gridGeometry.connectivityMap(); // evaluate derivatives w.r.t. all other related face dofs for (const auto& globalJ : connectivityMap(faceId, faceId, scvf.index())) @@ -735,10 +735,10 @@ public: // get some aliases for convenience const auto& element = this->element(); const auto& fvGeometry = this->fvGeometry(); - const auto& fvGridGeometry = this->problem().gridGeometry(); + const auto& gridGeometry = this->problem().gridGeometry(); const auto& curSol = this->curSol()[domainJ]; // build derivatives with for cell center dofs w.r.t. cell center dofs - const auto cellCenterGlobalI = fvGridGeometry.elementMapper().index(element); + const auto cellCenterGlobalI = gridGeometry.elementMapper().index(element); for (const auto& scvfJ : scvfs(fvGeometry)) { @@ -857,8 +857,8 @@ public: // get some aliases for convenience const auto& problem = this->problem(); const auto& fvGeometry = this->fvGeometry(); - const auto& fvGridGeometry = this->problem().gridGeometry(); - const auto& connectivityMap = fvGridGeometry.connectivityMap(); + const auto& gridGeometry = this->problem().gridGeometry(); + const auto& connectivityMap = gridGeometry.connectivityMap(); const auto& curSol = this->curSol()[domainJ]; // build derivatives with for cell center dofs w.r.t. cell center dofs diff --git a/dumux/nonlinear/newtonconvergencewriter.hh b/dumux/nonlinear/newtonconvergencewriter.hh index ac5c7cd78337281afb0253a4ea1758e2bf112aab..cadf82de45baa1cb862b1d1768bf5ccb8c54bcd3 100644 --- a/dumux/nonlinear/newtonconvergencewriter.hh +++ b/dumux/nonlinear/newtonconvergencewriter.hh @@ -50,29 +50,29 @@ struct ConvergenceWriterInterface * to write out multiple Newton solves with a unique id, if you don't call use all * Newton iterations just come after each other in the pvd file. */ -template +template class NewtonConvergenceWriter : public ConvergenceWriterInterface { - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; static constexpr auto numEq = SolutionVector::block_type::dimension; using Scalar = typename SolutionVector::block_type::value_type; - static_assert(FVGridGeometry::discMethod != DiscretizationMethod::staggered, + static_assert(GridGeometry::discMethod != DiscretizationMethod::staggered, "This convergence writer does not work for the staggered method, use the StaggeredNewtonConvergenceWriter instead"); public: /*! * \brief Constructor - * \param fvGridGeometry The finite-volume grid geometry + * \param gridGeometry The finite-volume grid geometry * \param name Base name of the vtk output */ - NewtonConvergenceWriter(const FVGridGeometry& fvGridGeometry, + NewtonConvergenceWriter(const GridGeometry& gridGeometry, const std::string& name = "newton_convergence") - : fvGridGeometry_(fvGridGeometry) - , writer_(fvGridGeometry.gridView(), name, "", "") + : gridGeometry_(gridGeometry) + , writer_(gridGeometry.gridView(), name, "", "") { resize(); - if (FVGridGeometry::discMethod == DiscretizationMethod::box) + if (GridGeometry::discMethod == DiscretizationMethod::box) { for (int eqIdx = 0; eqIdx < numEq; ++eqIdx) { @@ -95,7 +95,7 @@ public: //! Resizes the output fields. This has to be called whenever the grid changes void resize() { - const auto numDofs = fvGridGeometry_.numDofs(); + const auto numDofs = gridGeometry_.numDofs(); // resize the output fields for (int eqIdx = 0; eqIdx < numEq; ++eqIdx) @@ -135,7 +135,7 @@ private: std::size_t id_ = 0UL; std::size_t iteration_ = 0UL; - const FVGridGeometry& fvGridGeometry_; + const GridGeometry& gridGeometry_; Dune::VTKSequenceWriter writer_; diff --git a/dumux/nonlinear/newtonsolver.hh b/dumux/nonlinear/newtonsolver.hh index 30660b5023079d8a2683049c073b0db3b62a6d95..823ede7e52180f9c4d859ee9afe24e1ce4274866 100644 --- a/dumux/nonlinear/newtonsolver.hh +++ b/dumux/nonlinear/newtonsolver.hh @@ -747,9 +747,9 @@ protected: priVarsSwitchedInLastIteration_ = false; const auto& problem = this->assembler().problem(); - const auto& fvGridGeometry = this->assembler().gridGeometry(); + const auto& gridGeometry = this->assembler().gridGeometry(); auto& gridVariables = this->assembler().gridVariables(); - priVarSwitch_->updateBoundary(problem, fvGridGeometry, gridVariables, sol); + priVarSwitch_->updateBoundary(problem, gridGeometry, gridVariables, sol); } /*! @@ -764,23 +764,23 @@ protected: { // update the variable switch (returns true if the pri vars at at least one dof were switched) // for disabled grid variable caching - const auto& fvGridGeometry = this->assembler().gridGeometry(); + const auto& gridGeometry = this->assembler().gridGeometry(); const auto& problem = this->assembler().problem(); auto& gridVariables = this->assembler().gridVariables(); // invoke the primary variable switch priVarsSwitchedInLastIteration_ = priVarSwitch_->update(uCurrentIter, gridVariables, - problem, fvGridGeometry); + problem, gridGeometry); if (priVarsSwitchedInLastIteration_) { - for (const auto& element : elements(fvGridGeometry.gridView())) + for (const auto& element : elements(gridGeometry.gridView())) { // if the volume variables are cached globally, we need to update those where the primary variables have been switched - priVarSwitch_->updateSwitchedVolVars(problem, element, fvGridGeometry, gridVariables, uCurrentIter); + priVarSwitch_->updateSwitchedVolVars(problem, element, gridGeometry, gridVariables, uCurrentIter); // if the flux variables are cached globally, we need to update those where the primary variables have been switched - priVarSwitch_->updateSwitchedFluxVarsCache(problem, element, fvGridGeometry, gridVariables, uCurrentIter); + priVarSwitch_->updateSwitchedFluxVarsCache(problem, element, gridGeometry, gridVariables, uCurrentIter); } } } diff --git a/dumux/nonlinear/staggerednewtonconvergencewriter.hh b/dumux/nonlinear/staggerednewtonconvergencewriter.hh index 1cb85da200eb9be4485731a8dbe9d380b29e785c..251a6d53799180b522c930d120b0ad87b2cdff52 100644 --- a/dumux/nonlinear/staggerednewtonconvergencewriter.hh +++ b/dumux/nonlinear/staggerednewtonconvergencewriter.hh @@ -43,13 +43,13 @@ namespace Dumux { * to write out multiple Newton solves with a unique id, if you don't call use all * Newton iterations just come after each other in the pvd file. */ -template +template class StaggeredNewtonConvergenceWriter : public ConvergenceWriterInterface { - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; - using CellCenterSolutionVector = typename std::decay_t()[FVGridGeometry::cellCenterIdx()])>; - using FaceSolutionVector = typename std::decay_t()[FVGridGeometry::faceIdx()])>; + using CellCenterSolutionVector = typename std::decay_t()[GridGeometry::cellCenterIdx()])>; + using FaceSolutionVector = typename std::decay_t()[GridGeometry::faceIdx()])>; using Scalar = typename CellCenterSolutionVector::block_type::value_type; @@ -59,22 +59,22 @@ class StaggeredNewtonConvergenceWriter : public ConvergenceWriterInterface::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; - static_assert(FVGridGeometry::discMethod == DiscretizationMethod::staggered, + static_assert(GridGeometry::discMethod == DiscretizationMethod::staggered, "This convergence writer does only work for the staggered method, use the NewtonConvergenceWriter instead"); public: /*! * \brief Constructor - * \param fvGridGeometry The finite volume geometry on the grid view + * \param gridGeometry The finite volume geometry on the grid view * \param name Base name of the vtk output */ - StaggeredNewtonConvergenceWriter(const FVGridGeometry& fvGridGeometry, + StaggeredNewtonConvergenceWriter(const GridGeometry& gridGeometry, const std::string& name = "newton_convergence") - : fvGridGeometry_(fvGridGeometry) - , ccWriter_(fvGridGeometry.gridView(), name, "", "") + : gridGeometry_(gridGeometry) + , ccWriter_(gridGeometry.gridView(), name, "", "") , faceWriter_(std::make_shared>(coordinates_)) , faceSequenceWriter_(faceWriter_, name + "-face", "","", - fvGridGeometry.gridView().comm().rank(), - fvGridGeometry.gridView().comm().size()) + gridGeometry.gridView().comm().rank(), + gridGeometry.gridView().comm().size()) { resize(); @@ -89,8 +89,8 @@ public: //! Resizes the output fields. This has to be called whenever the grid changes void resize() { - const auto numCellCenterDofs = fvGridGeometry_.numCellCenterDofs(); - const auto numFaceDofs = fvGridGeometry_.numFaceDofs(); + const auto numCellCenterDofs = gridGeometry_.numCellCenterDofs(); + const auto numFaceDofs = gridGeometry_.numFaceDofs(); // resize the cell center output fields for (int eqIdx = 0; eqIdx < numEqCellCenter; ++eqIdx) @@ -109,9 +109,9 @@ public: } coordinates_.resize(numFaceDofs); - for (auto&& facet : facets(fvGridGeometry_.gridView())) + for (auto&& facet : facets(gridGeometry_.gridView())) { - const auto dofIdxGlobal = fvGridGeometry_.gridView().indexSet().index(facet); + const auto dofIdxGlobal = gridGeometry_.gridView().indexSet().index(facet); coordinates_[dofIdxGlobal] = facet.geometry().center(); } } @@ -127,13 +127,13 @@ public: { assert(uLastIter.size() == deltaU.size() && uLastIter.size() == residual.size()); - for (std::size_t dofIdxGlobal = 0; dofIdxGlobal < deltaU[FVGridGeometry::cellCenterIdx()].size(); ++dofIdxGlobal) + for (std::size_t dofIdxGlobal = 0; dofIdxGlobal < deltaU[GridGeometry::cellCenterIdx()].size(); ++dofIdxGlobal) { for (int eqIdx = 0; eqIdx < numEqCellCenter; ++eqIdx) { - xCellCenter_[eqIdx][dofIdxGlobal] = uLastIter[FVGridGeometry::cellCenterIdx()][dofIdxGlobal][eqIdx]; - deltaCellCenter_[eqIdx][dofIdxGlobal] = - deltaU[FVGridGeometry::cellCenterIdx()][dofIdxGlobal][eqIdx]; - defCellCenter_[eqIdx][dofIdxGlobal] = residual[FVGridGeometry::cellCenterIdx()][dofIdxGlobal][eqIdx]; + xCellCenter_[eqIdx][dofIdxGlobal] = uLastIter[GridGeometry::cellCenterIdx()][dofIdxGlobal][eqIdx]; + deltaCellCenter_[eqIdx][dofIdxGlobal] = - deltaU[GridGeometry::cellCenterIdx()][dofIdxGlobal][eqIdx]; + defCellCenter_[eqIdx][dofIdxGlobal] = residual[GridGeometry::cellCenterIdx()][dofIdxGlobal][eqIdx]; } } @@ -144,13 +144,13 @@ public: faceWriter_->addPointData(defFace_[eqIdx], "defect_" + std::to_string(eqIdx)); } - for (std::size_t dofIdxGlobal = 0; dofIdxGlobal < deltaU[FVGridGeometry::faceIdx()].size(); ++dofIdxGlobal) + for (std::size_t dofIdxGlobal = 0; dofIdxGlobal < deltaU[GridGeometry::faceIdx()].size(); ++dofIdxGlobal) { for (int eqIdx = 0; eqIdx < numEqFace; ++eqIdx) { - xFace_[eqIdx][dofIdxGlobal] = uLastIter[FVGridGeometry::faceIdx()][dofIdxGlobal][eqIdx]; - deltaFace_[eqIdx][dofIdxGlobal] = - deltaU[FVGridGeometry::faceIdx()][dofIdxGlobal][eqIdx]; - defFace_[eqIdx][dofIdxGlobal] = residual[FVGridGeometry::faceIdx()][dofIdxGlobal][eqIdx]; + xFace_[eqIdx][dofIdxGlobal] = uLastIter[GridGeometry::faceIdx()][dofIdxGlobal][eqIdx]; + deltaFace_[eqIdx][dofIdxGlobal] = - deltaU[GridGeometry::faceIdx()][dofIdxGlobal][eqIdx]; + defFace_[eqIdx][dofIdxGlobal] = residual[GridGeometry::faceIdx()][dofIdxGlobal][eqIdx]; } } @@ -163,7 +163,7 @@ private: std::size_t id_ = 0UL; std::size_t iteration_ = 0UL; - const FVGridGeometry& fvGridGeometry_; + const GridGeometry& gridGeometry_; Dune::VTKSequenceWriter ccWriter_; diff --git a/dumux/porousmediumflow/2p/boxmaterialinterfaceparams.hh b/dumux/porousmediumflow/2p/boxmaterialinterfaceparams.hh index 4a825532d54b48bae749c7536e386691baa4b4e2..63dad808af722e7200269410866d62b692b5b2a0 100644 --- a/dumux/porousmediumflow/2p/boxmaterialinterfaceparams.hh +++ b/dumux/porousmediumflow/2p/boxmaterialinterfaceparams.hh @@ -51,39 +51,39 @@ public: /*! * \brief Updates the scv -> dofparameter map * - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param spatialParams Class encapsulating the spatial parameters * \param x The current state of the solution vector */ - template - void update(const FVGridGeometry& fvGridGeometry, + template + void update(const GridGeometry& gridGeometry, const SpatialParams& spatialParams, const SolutionVector& x) { using MaterialLaw = typename SpatialParams::MaterialLaw; // Make sure the spatial params return a const ref and no copy! - using Elem = typename FVGridGeometry::GridView::template Codim<0>::Entity; - using ElemSol = decltype( elementSolution(Elem(), x, fvGridGeometry) ); - using Scv = typename FVGridGeometry::SubControlVolume; + using Elem = typename GridGeometry::GridView::template Codim<0>::Entity; + using ElemSol = decltype( elementSolution(Elem(), x, gridGeometry) ); + using Scv = typename GridGeometry::SubControlVolume; using ReturnType = decltype(spatialParams.materialLawParams(Elem(), Scv(), ElemSol())); static_assert(std::is_lvalue_reference::value, "In order to use the box-interface solver please provide access " "to the material law parameters via returning (const) references"); // make sure this is only called for geometries of the box method! - if (FVGridGeometry::discMethod != DiscretizationMethod::box) + if (GridGeometry::discMethod != DiscretizationMethod::box) DUNE_THROW(Dune::InvalidStateException, "Determination of the interface material parameters with " "this class only makes sense when using the box method!"); isUpdated_ = true; - isOnMaterialInterface_.resize(fvGridGeometry.numDofs(), false); - dofParams_.resize(fvGridGeometry.numDofs(), nullptr); - for (const auto& element : elements(fvGridGeometry.gridView())) + isOnMaterialInterface_.resize(gridGeometry.numDofs(), false); + dofParams_.resize(gridGeometry.numDofs(), nullptr); + for (const auto& element : elements(gridGeometry.gridView())) { - const auto elemSol = elementSolution(element, x, fvGridGeometry); + const auto elemSol = elementSolution(element, x, gridGeometry); - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bind(element); for (const auto& scv : scvs(fvGeometry)) { diff --git a/dumux/porousmediumflow/2p/gridadaptindicator.hh b/dumux/porousmediumflow/2p/gridadaptindicator.hh index 28d174ebf104e2361aaf0600812e74d1c511c3b7..fbf5205699e5c7ea93d085736169a52a0c1ec7b9 100644 --- a/dumux/porousmediumflow/2p/gridadaptindicator.hh +++ b/dumux/porousmediumflow/2p/gridadaptindicator.hh @@ -43,7 +43,7 @@ namespace Dumux { template class TwoPGridAdaptIndicator { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using GridView = GetPropType; using Element = typename GridView::template Codim<0>::Entity; using Scalar = GetPropType; @@ -56,18 +56,18 @@ public: /*! * \brief The Constructor * - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param paramGroup The parameter group in which to look for runtime parameters first (default is "") * * Note: refineBound_, coarsenBound_ & maxSaturationDelta_ are chosen * in a way such that the indicator returns false for all elements * before having been calculated. */ - TwoPGridAdaptIndicator(std::shared_ptr fvGridGeometry, const std::string& paramGroup = "") - : fvGridGeometry_(fvGridGeometry) + TwoPGridAdaptIndicator(std::shared_ptr gridGeometry, const std::string& paramGroup = "") + : gridGeometry_(gridGeometry) , refineBound_(std::numeric_limits::max()) , coarsenBound_(std::numeric_limits::lowest()) - , maxSaturationDelta_(fvGridGeometry_->gridView().size(0), 0.0) + , maxSaturationDelta_(gridGeometry_->gridView().size(0), 0.0) , minLevel_(getParamFromGroup(paramGroup, "Adaptive.MinLevel", 0)) , maxLevel_(getParamFromGroup(paramGroup, "Adaptive.MaxLevel", 0)) {} @@ -120,7 +120,7 @@ public: //! Reset the indicator to a state that returns false for all elements refineBound_ = std::numeric_limits::max(); coarsenBound_ = std::numeric_limits::lowest(); - maxSaturationDelta_.assign(fvGridGeometry_->gridView().size(0), 0.0); + maxSaturationDelta_.assign(gridGeometry_->gridView().size(0), 0.0); //! maxLevel_ must be higher than minLevel_ to allow for refinement if (minLevel_ >= maxLevel_) @@ -135,15 +135,15 @@ public: Scalar globalMin = std::numeric_limits::max(); //! Calculate minimum and maximum saturation - for (const auto& element : elements(fvGridGeometry_->gridView())) + for (const auto& element : elements(gridGeometry_->gridView())) { //! Index of the current leaf-element - const auto globalIdxI = fvGridGeometry_->elementMapper().index(element); + const auto globalIdxI = gridGeometry_->elementMapper().index(element); //! Obtain the saturation at the center of the element const auto geometry = element.geometry(); - const auto elemSol = elementSolution(element, sol, *fvGridGeometry_); - const Scalar satI = evalSolution(element, geometry, *fvGridGeometry_, elemSol, geometry.center())[saturationIdx]; + const auto elemSol = elementSolution(element, sol, *gridGeometry_); + const Scalar satI = evalSolution(element, geometry, *gridGeometry_, elemSol, geometry.center())[saturationIdx]; //! Maybe update the global minimum/maximum using std::min; @@ -152,22 +152,22 @@ public: globalMax = max(satI, globalMax); //! Calculate maximum delta in saturation for this cell - for (const auto& intersection : intersections(fvGridGeometry_->gridView(), element)) + for (const auto& intersection : intersections(gridGeometry_->gridView(), element)) { //! Only consider internal intersections if (intersection.neighbor()) { //! Access neighbor const auto outside = intersection.outside(); - const auto globalIdxJ = fvGridGeometry_->elementMapper().index(outside); + const auto globalIdxJ = gridGeometry_->elementMapper().index(outside); //! Visit intersection only once if (element.level() > outside.level() || (element.level() == outside.level() && globalIdxI < globalIdxJ)) { //! Obtain saturation in the neighbor const auto outsideGeometry = outside.geometry(); - const auto elemSolJ = elementSolution(outside, sol, *fvGridGeometry_); - const Scalar satJ = evalSolution(outside, outsideGeometry, *fvGridGeometry_, elemSolJ, outsideGeometry.center())[saturationIdx]; + const auto elemSolJ = elementSolution(outside, sol, *gridGeometry_); + const Scalar satJ = evalSolution(outside, outsideGeometry, *gridGeometry_, elemSolJ, outsideGeometry.center())[saturationIdx]; using std::abs; Scalar localdelta = abs(satI - satJ); @@ -201,7 +201,7 @@ public: //#endif //! check if neighbors have to be refined too - for (const auto& element : elements(fvGridGeometry_->gridView(), Dune::Partitions::interior)) + for (const auto& element : elements(gridGeometry_->gridView(), Dune::Partitions::interior)) if (this->operator()(element) > 0) checkNeighborsRefine_(element); } @@ -218,12 +218,12 @@ public: int operator() (const Element& element) const { if (element.hasFather() - && maxSaturationDelta_[fvGridGeometry_->elementMapper().index(element)] < coarsenBound_) + && maxSaturationDelta_[gridGeometry_->elementMapper().index(element)] < coarsenBound_) { return -1; } else if (element.level() < maxLevel_ - && maxSaturationDelta_[fvGridGeometry_->elementMapper().index(element)] > refineBound_) + && maxSaturationDelta_[gridGeometry_->elementMapper().index(element)] > refineBound_) { return 1; } @@ -245,7 +245,7 @@ private: */ bool checkNeighborsRefine_(const Element &element, std::size_t level = 1) { - for(const auto& intersection : intersections(fvGridGeometry_->gridView(), element)) + for(const auto& intersection : intersections(gridGeometry_->gridView(), element)) { if(!intersection.neighbor()) continue; @@ -260,7 +260,7 @@ private: if (outside.level() < maxLevel_ && outside.level() < element.level()) { // ensure refinement for outside element - maxSaturationDelta_[fvGridGeometry_->elementMapper().index(outside)] = std::numeric_limits::max(); + maxSaturationDelta_[gridGeometry_->elementMapper().index(outside)] = std::numeric_limits::max(); if(level < maxLevel_) checkNeighborsRefine_(outside, ++level); } @@ -269,7 +269,7 @@ private: return true; } - std::shared_ptr fvGridGeometry_; + std::shared_ptr gridGeometry_; Scalar refineBound_; Scalar coarsenBound_; diff --git a/dumux/porousmediumflow/2p/griddatatransfer.hh b/dumux/porousmediumflow/2p/griddatatransfer.hh index b89fd3fc6a76f37a0543b2a45af9fbf69a81daeb..8027dd913e504e8dfe97688851369ffc926d9b49 100644 --- a/dumux/porousmediumflow/2p/griddatatransfer.hh +++ b/dumux/porousmediumflow/2p/griddatatransfer.hh @@ -49,8 +49,8 @@ class TwoPGridDataTransfer : public GridDataTransfer using Grid = GetPropType; using Scalar = GetPropType; using Problem = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using GridVariables = GetPropType; using VolumeVariables = GetPropType; @@ -59,7 +59,7 @@ class TwoPGridDataTransfer : public GridDataTransfer using Element = typename Grid::template Codim<0>::Entity; using ElementSolution = std::decay_t(), std::declval(), - std::declval()))>; + std::declval()))>; using FluidSystem = GetPropType; using ModelTraits = GetPropType; using Indices = typename ModelTraits::Indices; @@ -109,20 +109,20 @@ public: * \brief Constructor * * \param problem The DuMuX problem to be solved - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param gridVariables The secondary variables on the grid * \param sol The solution (primary variables) on the grid */ TwoPGridDataTransfer(std::shared_ptr problem, - std::shared_ptr fvGridGeometry, + std::shared_ptr gridGeometry, std::shared_ptr gridVariables, SolutionVector& sol) : GridDataTransfer() , problem_(problem) - , fvGridGeometry_(fvGridGeometry) + , gridGeometry_(gridGeometry) , gridVariables_(gridVariables) , sol_(sol) - , adaptionMap_(fvGridGeometry->gridView().grid(), 0) + , adaptionMap_(gridGeometry->gridView().grid(), 0) {} /*! @@ -137,7 +137,7 @@ public: { adaptionMap_.resize(); - const auto& grid = fvGridGeometry_->gridView().grid(); + const auto& grid = gridGeometry_->gridView().grid(); for (auto level = grid.maxLevel(); level >= 0; level--) { for (const auto& element : elements(grid.levelGridView(level))) @@ -148,11 +148,11 @@ public: // put values in the map for leaf elements if (element.isLeaf()) { - auto fvGeometry = localView(*fvGridGeometry_); + auto fvGeometry = localView(*gridGeometry_); fvGeometry.bindElement(element); // store current element solution - adaptedValues.u = ElementSolution(element, sol_, *fvGridGeometry_); + adaptedValues.u = ElementSolution(element, sol_, *gridGeometry_); // compute mass in the scvs for (const auto& scv : scvs(fvGeometry)) @@ -183,7 +183,7 @@ public: // This element solution constructor uses the vertex mapper to obtain // the privars at the vertices, thus, this works for non-leaf elements! if(isBox && !element.isLeaf()) - adaptedValues.u = ElementSolution(element, sol_, *fvGridGeometry_); + adaptedValues.u = ElementSolution(element, sol_, *gridGeometry_); } } } @@ -203,8 +203,8 @@ public: { // resize stuff (grid might have changed) adaptionMap_.resize(); - fvGridGeometry_->update(); - sol_.resize(fvGridGeometry_->numDofs()); + gridGeometry_->update(); + sol_.resize(gridGeometry_->numDofs()); // vectors storing the mass associated with each vertex, when using the box method std::vector massCoeff; @@ -212,18 +212,18 @@ public: if(isBox) { - massCoeff.resize(fvGridGeometry_->numDofs(), 0.0); - associatedMass.resize(fvGridGeometry_->numDofs(), 0.0); + massCoeff.resize(gridGeometry_->numDofs(), 0.0); + associatedMass.resize(gridGeometry_->numDofs(), 0.0); } // iterate over leaf and reconstruct the solution - for (const auto& element : elements(fvGridGeometry_->gridView().grid().leafGridView(), Dune::Partitions::interior)) + for (const auto& element : elements(gridGeometry_->gridView().grid().leafGridView(), Dune::Partitions::interior)) { if (!element.isNew()) { const auto& adaptedValues = adaptionMap_[element]; - auto fvGeometry = localView(*fvGridGeometry_); + auto fvGeometry = localView(*gridGeometry_); fvGeometry.bindElement(element); // obtain element solution from map (divide by count!) @@ -302,7 +302,7 @@ public: auto elemSolSon = adaptedValuesFather.u; elemSolSon[0] /= adaptedValuesFather.count; - auto fvGeometry = localView(*fvGridGeometry_); + auto fvGeometry = localView(*gridGeometry_); fvGeometry.bindElement(element); for (const auto& scv : scvs(fvGeometry)) @@ -326,11 +326,11 @@ public: { auto& adaptedValuesFather = adaptionMap_[fatherElement]; - auto fvGeometry = localView(*fvGridGeometry_); + auto fvGeometry = localView(*gridGeometry_); fvGeometry.bindElement(element); // interpolate solution in the father to the vertices of the new son - ElementSolution elemSolSon(element, sol_, *fvGridGeometry_); + ElementSolution elemSolSon(element, sol_, *gridGeometry_); const auto fatherGeometry = fatherElement.geometry(); for (const auto& scv : scvs(fvGeometry)) elemSolSon[scv.localDofIndex()] = evalSolution(fatherElement, @@ -367,7 +367,7 @@ public: if(isBox) { - for(std::size_t dofIdxGlobal = 0; dofIdxGlobal < fvGridGeometry_->numDofs(); dofIdxGlobal++) + for(std::size_t dofIdxGlobal = 0; dofIdxGlobal < gridGeometry_->numDofs(); dofIdxGlobal++) sol_[dofIdxGlobal][saturationIdx] = associatedMass[dofIdxGlobal] / massCoeff[dofIdxGlobal]; } @@ -434,7 +434,7 @@ public: } std::shared_ptr problem_; - std::shared_ptr fvGridGeometry_; + std::shared_ptr gridGeometry_; std::shared_ptr gridVariables_; SolutionVector& sol_; PersistentContainer adaptionMap_; diff --git a/dumux/porousmediumflow/2p/incompressiblelocalresidual.hh b/dumux/porousmediumflow/2p/incompressiblelocalresidual.hh index 54396316e48f83a90b925ea9e1939e5a437b522c..05f2a24c02a866646d0b49ba1e9b9c5bc1690427 100644 --- a/dumux/porousmediumflow/2p/incompressiblelocalresidual.hh +++ b/dumux/porousmediumflow/2p/incompressiblelocalresidual.hh @@ -56,8 +56,8 @@ class TwoPIncompressibleLocalResidual : public ImmiscibleLocalResidual using FluxVariables = GetPropType; using ElementFluxVariablesCache = typename GetPropType::LocalView; using SolutionVector = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using GridView = GetPropType; diff --git a/dumux/porousmediumflow/boxdfm/fvelementgeometry.hh b/dumux/porousmediumflow/boxdfm/fvelementgeometry.hh index a79f362bff9fe16d1f00d1c4ed684d90c7321b00..bfa34112a07e8803451aba513e32286e0663e437 100644 --- a/dumux/porousmediumflow/boxdfm/fvelementgeometry.hh +++ b/dumux/porousmediumflow/boxdfm/fvelementgeometry.hh @@ -78,8 +78,8 @@ public: static constexpr std::size_t maxNumElementScvs = (1<; using SubControlVolumeFace = BoxDfmSubControlVolumeFace; - template - using LocalView = BoxDfmFVElementGeometry; + template + using LocalView = BoxDfmFVElementGeometry; // Mapper type for mapping edges using FacetMapper = Dune::MultipleCodimMultipleGeomTypeMapper; @@ -106,7 +106,7 @@ class BoxDfmFVGridGeometry using CoordScalar = typename GV::ctype; static const int dim = GV::dimension; static const int dimWorld = GV::dimensionworld; - static_assert(dim == 2 || dim == 3, "The box-dfm FVGridGeometry is only implemented in 2 or 3 dimensions."); + static_assert(dim == 2 || dim == 3, "The box-dfm GridGeometry is only implemented in 2 or 3 dimensions."); using ReferenceElements = typename Dune::ReferenceElements; using FaceReferenceElements = typename Dune::ReferenceElements; diff --git a/dumux/porousmediumflow/boxdfm/vtkoutputmodule.hh b/dumux/porousmediumflow/boxdfm/vtkoutputmodule.hh index 3933dd65a03b317660e06a6f202ef16cef8d263c..1b90c61a5caf3d7e3443e3e5a8b9bd8160544066 100644 --- a/dumux/porousmediumflow/boxdfm/vtkoutputmodule.hh +++ b/dumux/porousmediumflow/boxdfm/vtkoutputmodule.hh @@ -56,12 +56,12 @@ template class BoxDfmVtkOutputModule : public VtkOutputModule { using ParentType = VtkOutputModule; - using FVGridGeometry = typename GridVariables::GridGeometry; + using GridGeometry = typename GridVariables::GridGeometry; using VV = typename GridVariables::VolumeVariables; using FluidSystem = typename VV::FluidSystem; using Scalar = typename GridVariables::Scalar; - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using FractureGridView = typename FractureGrid::LeafGridView; using FractureMapper = Dune::MultipleCodimMultipleGeomTypeMapper; @@ -82,7 +82,7 @@ class BoxDfmVtkOutputModule : public VtkOutputModule 1, "Box-Dfm output only works for dim > 1"); static_assert(FractureGrid::dimension == int(dim-1), "Fracture grid must be of codimension one!"); static_assert(FractureGrid::dimensionworld == int(dimWorld), "Fracture grid has to has the same coordinate dimension!"); - static_assert(FVGridGeometry::discMethod == DiscretizationMethod::box, "Box-Dfm output module can only be used with the box scheme!"); + static_assert(GridGeometry::discMethod == DiscretizationMethod::box, "Box-Dfm output module can only be used with the box scheme!"); public: //! The constructor @@ -150,7 +150,7 @@ private: std::vector> volVarVectorDataFracture; // some references for convenience - const auto& gridView = this->fvGridGeometry().gridView(); + const auto& gridView = this->gridGeometry().gridView(); const auto& fractureGridView = fractureGrid_->leafGridView(); const auto& volVarScalarDataInfo = this->volVarScalarDataInfo(); const auto& volVarVectorDataInfo = this->volVarVectorDataInfo(); @@ -187,9 +187,9 @@ private: for (const auto& element : elements(gridView, Dune::Partitions::interior)) { - const auto eIdxGlobal = this->fvGridGeometry().elementMapper().index(element); + const auto eIdxGlobal = this->gridGeometry().elementMapper().index(element); - auto fvGeometry = localView(this->fvGridGeometry()); + auto fvGeometry = localView(this->gridGeometry()); auto elemVolVars = localView(this->gridVariables().curGridVolVars()); // If velocity output is enabled we need to bind to the whole stencil @@ -257,7 +257,7 @@ private: for (std::size_t i = 0; i < volVarVectorDataInfo.size(); ++i) { - this->sequenceWriter().addVertexData( Field(gridView, this->fvGridGeometry().vertexMapper(), volVarVectorData[i], + this->sequenceWriter().addVertexData( Field(gridView, this->gridGeometry().vertexMapper(), volVarVectorData[i], volVarVectorDataInfo[i].name, /*numComp*/dimWorld, /*codim*/dim).get() ); fractureSequenceWriter_->addVertexData( FractureField(fractureGridView, *fractureVertexMapper_, volVarVectorDataFracture[i], volVarVectorDataInfo[i].name, /*numComp*/dimWorld, /*codim*/dim-1).get() ); @@ -267,14 +267,14 @@ private: if (this->velocityOutput().enableOutput()) { for (int phaseIdx = 0; phaseIdx < this->velocityOutput().numFluidPhases(); ++phaseIdx) - this->sequenceWriter().addVertexData( Field(gridView, this->fvGridGeometry().vertexMapper(), velocity[phaseIdx], + this->sequenceWriter().addVertexData( Field(gridView, this->gridGeometry().vertexMapper(), velocity[phaseIdx], "velocity_" + std::string(this->velocityOutput().phaseName(phaseIdx)) + " (m/s)", /*numComp*/dimWorld, /*codim*/dim).get() ); } // the process rank if (addProcessRank) - this->sequenceWriter().addCellData( Field(gridView, this->fvGridGeometry().elementMapper(), rank, + this->sequenceWriter().addCellData( Field(gridView, this->gridGeometry().elementMapper(), rank, "process rank", /*numComp*/1, /*codim*/0).get() ); // also register additional (non-standardized) user fields if any (only on matrix grid) @@ -325,7 +325,7 @@ private: std::vector< VectorDataContainer > volVarVectorDataFracture; // some references for convenience - const auto& gridView = this->fvGridGeometry().gridView(); + const auto& gridView = this->gridGeometry().gridView(); const auto& fractureGridView = fractureGrid_->leafGridView(); const auto& volVarScalarDataInfo = this->volVarScalarDataInfo(); const auto& volVarVectorDataInfo = this->volVarVectorDataInfo(); @@ -362,10 +362,10 @@ private: for (const auto& element : elements(gridView, Dune::Partitions::interior)) { - const auto eIdxGlobal = this->fvGridGeometry().elementMapper().index(element); + const auto eIdxGlobal = this->gridGeometry().elementMapper().index(element); const auto numCorners = element.subEntities(dim); - auto fvGeometry = localView(this->fvGridGeometry()); + auto fvGeometry = localView(this->gridGeometry()); auto elemVolVars = localView(this->gridVariables().curGridVolVars()); // resize element-local data containers (for bulk grid) @@ -435,7 +435,7 @@ private: // volume variables if any for (std::size_t i = 0; i < volVarScalarDataInfo.size(); ++i) { - this->sequenceWriter().addVertexData( Field(gridView, this->fvGridGeometry().elementMapper(), volVarScalarData[i], + this->sequenceWriter().addVertexData( Field(gridView, this->gridGeometry().elementMapper(), volVarScalarData[i], volVarScalarDataInfo[i].name, /*numComp*/1, /*codim*/dim, /*nonconforming*/this->dataMode()).get() ); fractureSequenceWriter_->addVertexData( FractureField(fractureGridView, *fractureElementMapper_, volVarScalarDataFracture[i], @@ -445,7 +445,7 @@ private: for (std::size_t i = 0; i < volVarVectorDataInfo.size(); ++i) { - this->sequenceWriter().addVertexData( Field(gridView, this->fvGridGeometry().elementMapper(), volVarVectorData[i], + this->sequenceWriter().addVertexData( Field(gridView, this->gridGeometry().elementMapper(), volVarVectorData[i], volVarVectorDataInfo[i].name, /*numComp*/dimWorld, /*codim*/dim, /*nonconforming*/this->dataMode()).get() ); fractureSequenceWriter_->addVertexData( FractureField(fractureGridView, *fractureElementMapper_, volVarVectorDataFracture[i], @@ -457,14 +457,14 @@ private: if (this->velocityOutput().enableOutput()) { for (int phaseIdx = 0; phaseIdx < this->velocityOutput().numFluidPhases(); ++phaseIdx) - this->sequenceWriter().addVertexData( Field(gridView, this->fvGridGeometry().vertexMapper(), velocity[phaseIdx], + this->sequenceWriter().addVertexData( Field(gridView, this->gridGeometry().vertexMapper(), velocity[phaseIdx], "velocity_" + std::string(this->velocityOutput().phaseName(phaseIdx)) + " (m/s)", /*numComp*/dimWorld, /*codim*/dim).get() ); } // the process rank if (addProcessRank) - this->sequenceWriter().addCellData( Field(gridView, this->fvGridGeometry().elementMapper(), rank, + this->sequenceWriter().addCellData( Field(gridView, this->gridGeometry().elementMapper(), rank, "process rank", /*numComp*/1, /*codim*/0).get() ); // also register additional (non-standardized) user fields if any (only on matrix grid) @@ -496,8 +496,8 @@ private: template< class FractureGridAdapter > void initializeFracture_(const FractureGridAdapter& fractureGridAdapter) { - const auto& fvGridGeometry = this->fvGridGeometry(); - const auto& gridView = fvGridGeometry.gridView(); + const auto& gridGeometry = this->gridGeometry(); + const auto& gridView = gridGeometry.gridView(); Dune::GridFactory gridFactory; // insert fracture vertices @@ -508,7 +508,7 @@ private: if (fractureGridAdapter.isOnFacetGrid(v)) { gridFactory.insertVertex(v.geometry().center()); - vertexToFractureVertexIdx_[fvGridGeometry.vertexMapper().index(v)] = fracVertexCount++; + vertexToFractureVertexIdx_[gridGeometry.vertexMapper().index(v)] = fracVertexCount++; } } @@ -518,7 +518,7 @@ private: std::set< std::pair > handledFacets; for (const auto& element : elements(gridView)) { - const auto eIdxGlobal = fvGridGeometry.elementMapper().index(element); + const auto eIdxGlobal = gridGeometry.elementMapper().index(element); const auto referenceElement = ReferenceElements::general(element.type()); for (const auto& is : intersections(gridView, element)) @@ -530,7 +530,7 @@ private: std::vector isVertexIndices(numCorners); for (unsigned int i = 0; i < numCorners; ++i) - isVertexIndices[i] = fvGridGeometry.vertexMapper().subIndex(element, + isVertexIndices[i] = gridGeometry.vertexMapper().subIndex(element, referenceElement.subEntity(indexInInside, 1, i, dim), dim); @@ -542,7 +542,7 @@ private: if (!is.boundary()) { // only proceed if facet has not been handled yet - const auto outsideEIdx = fvGridGeometry.elementMapper().index(is.outside()); + const auto outsideEIdx = gridGeometry.elementMapper().index(is.outside()); const auto idxInOutside = is.indexInOutside(); const auto pair = std::make_pair(outsideEIdx, idxInOutside); if (handledFacets.count( pair ) != 0) @@ -591,7 +591,7 @@ private: // update vertex index map for (GridIndexType dofIdx = 0; dofIdx < gridView.size(GridView::dimension); ++dofIdx) - if (fvGridGeometry.dofOnFracture(dofIdx)) + if (gridGeometry.dofOnFracture(dofIdx)) vertexToFractureVertexIdx_[dofIdx] = insToVertexIdx[ vertexToFractureVertexIdx_[dofIdx] ]; // update fracture element map diff --git a/dumux/porousmediumflow/compositional/primaryvariableswitch.hh b/dumux/porousmediumflow/compositional/primaryvariableswitch.hh index 9112ecd129a1e617bfa0bb98904166eaff28d38c..70318d4d68da681e47ff01469c0326d71a65fa0c 100644 --- a/dumux/porousmediumflow/compositional/primaryvariableswitch.hh +++ b/dumux/porousmediumflow/compositional/primaryvariableswitch.hh @@ -81,27 +81,27 @@ public: * \param curSol The current solution to be updated / modified * \param gridVariables The secondary variables on the grid * \param problem The problem - * \param fvGridGeometry The finite-volume grid geometry + * \param gridGeometry The finite-volume grid geometry */ template bool update(SolutionVector& curSol, GridVariables& gridVariables, const Problem& problem, - const typename GridVariables::GridGeometry& fvGridGeometry) + const typename GridVariables::GridGeometry& gridGeometry) { bool switched = false; visited_.assign(wasSwitched_.size(), false); std::size_t countSwitched = 0; - for (const auto& element : elements(fvGridGeometry.gridView())) + for (const auto& element : elements(gridGeometry.gridView())) { // make sure FVElementGeometry is bound to the element - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bindElement(element); auto elemVolVars = localView(gridVariables.curGridVolVars()); elemVolVars.bindElement(element, fvGeometry, curSol); - const auto curElemSol = elementSolution(element, curSol, fvGridGeometry); + const auto curElemSol = elementSolution(element, curSol, gridGeometry); for (auto&& scv : scvs(fvGeometry)) { auto dofIdxGlobal = scv.dofIndex(); @@ -126,12 +126,12 @@ public: if (verbosity_ > 0 && countSwitched > 0) std::cout << "Switched primary variables at " << countSwitched << " dof locations on processor " - << fvGridGeometry.gridView().comm().rank() << "." << std::endl; + << gridGeometry.gridView().comm().rank() << "." << std::endl; // make sure that if there was a variable switch in an // other partition we will also set the switch flag for our partition. - if (fvGridGeometry.gridView().comm().size() > 1) - switched = fvGridGeometry.gridView().comm().max(switched); + if (gridGeometry.gridView().comm().size() > 1) + switched = gridGeometry.gridView().comm().max(switched); return switched; } @@ -146,12 +146,12 @@ public: std::enable_if_t = 0> void updateSwitchedVolVars(const Problem& problem, const typename GridVariables::GridGeometry::GridView::template Codim<0>::Entity& element, - const typename GridVariables::GridGeometry& fvGridGeometry, + const typename GridVariables::GridGeometry& gridGeometry, GridVariables& gridVariables, const SolutionVector& sol) { // make sure FVElementGeometry is bound to the element - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bindElement(element); // update the secondary variables if global caching is enabled @@ -160,7 +160,7 @@ public: const auto dofIdxGlobal = scv.dofIndex(); if (asImp_().wasSwitched(dofIdxGlobal)) { - const auto elemSol = elementSolution(element, sol, fvGridGeometry); + const auto elemSol = elementSolution(element, sol, gridGeometry); auto& volVars = gridVariables.curGridVolVars().volVars(scv); volVars.update(elemSol, problem, element, scv); } @@ -178,17 +178,17 @@ public: GridVariables::GridGeometry::discMethod != DiscretizationMethod::box), int> = 0> void updateSwitchedFluxVarsCache(const Problem& problem, const typename GridVariables::GridGeometry::GridView::template Codim<0>::Entity& element, - const typename GridVariables::GridGeometry& fvGridGeometry, + const typename GridVariables::GridGeometry& gridGeometry, GridVariables& gridVariables, const SolutionVector& sol) { // update the flux variables if global caching is enabled - const auto dofIdxGlobal = fvGridGeometry.dofMapper().index(element); + const auto dofIdxGlobal = gridGeometry.dofMapper().index(element); if (asImp_().wasSwitched(dofIdxGlobal)) { // make sure FVElementGeometry and the volume variables are bound - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bind(element); auto curElemVolVars = localView(gridVariables.curGridVolVars()); curElemVolVars.bind(element, fvGeometry, sol); @@ -204,16 +204,16 @@ public: template = 0> void updateBoundary(const Problem& problem, - const typename GridVariables::GridGeometry& fvGridGeometry, + const typename GridVariables::GridGeometry& gridGeometry, GridVariables& gridVariables, SolutionVector& sol) { std::vector stateChanged(sol.size(), false); std::size_t countChanged = 0; - for (const auto& element : elements(fvGridGeometry.gridView())) + for (const auto& element : elements(gridGeometry.gridView())) { - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bindElement(element); // skip if the element is not at a boundary @@ -227,7 +227,7 @@ public: { // this implies that state is set equal for all scvs associated with the dof const auto dofIdx = scv.dofIndex(); - if (!fvGridGeometry.dofOnBoundary(dofIdx) || stateChanged[dofIdx]) + if (!gridGeometry.dofOnBoundary(dofIdx) || stateChanged[dofIdx]) continue; const auto bcTypes = problem.boundaryTypes(element, scv); @@ -264,7 +264,7 @@ public: // update the volVars if caching is enabled if (GridVariables::GridVolumeVariables::cachingEnabled && countChanged > 0) { - const auto curElemSol = elementSolution(element, sol, fvGridGeometry); + const auto curElemSol = elementSolution(element, sol, gridGeometry); for (const auto& scv : scvs(fvGeometry)) { if (stateChanged[scv.dofIndex()]) @@ -278,7 +278,7 @@ public: if (verbosity_ > 0 && countChanged > 0) std::cout << "Changed primary variable states and solution values at boundary to Dirichlet states and values at " << countChanged << " dof locations on processor " - << fvGridGeometry.gridView().comm().rank() << "." << std::endl; + << gridGeometry.gridView().comm().rank() << "." << std::endl; } //! Do nothing when volume variables are not cached globally. @@ -286,7 +286,7 @@ public: std::enable_if_t = 0> void updateSwitchedVolVars(const Problem& problem, const typename GridVariables::GridGeometry::GridView::template Codim<0>::Entity& element, - const typename GridVariables::GridGeometry& fvGridGeometry, + const typename GridVariables::GridGeometry& gridGeometry, GridVariables& gridVariables, const SolutionVector &uCurrentIter) const {} @@ -296,7 +296,7 @@ public: GridVariables::GridGeometry::discMethod == DiscretizationMethod::box), int> = 0> void updateSwitchedFluxVarsCache(const Problem& problem, const typename GridVariables::GridGeometry::GridView::template Codim<0>::Entity& element, - const typename GridVariables::GridGeometry& fvGridGeometry, + const typename GridVariables::GridGeometry& gridGeometry, GridVariables& gridVariables, const SolutionVector& sol) const {} @@ -304,7 +304,7 @@ public: template = 0> void updateBoundary(const Problem& problem, - const typename GridVariables::GridGeometry& fvGridGeometry, + const typename GridVariables::GridGeometry& gridGeometry, GridVariables& gridVariables, SolutionVector& sol) const {} diff --git a/dumux/porousmediumflow/fluxvariables.hh b/dumux/porousmediumflow/fluxvariables.hh index 1838524d4f23c98212b1db8b0feaf7d5fa23e2b5..60f7cd3c5ffa1424436277a5065a47caf79a9488 100644 --- a/dumux/porousmediumflow/fluxvariables.hh +++ b/dumux/porousmediumflow/fluxvariables.hh @@ -53,9 +53,9 @@ class PorousMediumFluxVariables { using Scalar = GetPropType; using ModelTraits = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; diff --git a/dumux/porousmediumflow/fluxvariablescachefiller.hh b/dumux/porousmediumflow/fluxvariablescachefiller.hh index 916ceff5b2aca2672209dea00c4a98206eebb2b5..8693779f716d6e81db5fab751c2b32306600ca62 100644 --- a/dumux/porousmediumflow/fluxvariablescachefiller.hh +++ b/dumux/porousmediumflow/fluxvariablescachefiller.hh @@ -218,9 +218,9 @@ class PorousMediumFluxVariablesCacheFillerImplementation; using Element = typename GridView::template Codim<0>::Entity; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using MpfaHelper = typename FVGridGeometry::MpfaHelper; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using MpfaHelper = typename GridGeometry::MpfaHelper; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using ElementVolumeVariables = typename GetPropType::LocalView; using ElementFluxVariablesCache = typename GetPropType::LocalView; @@ -281,8 +281,8 @@ public: elemVolVarsPtr_ = &elemVolVars; // prepare interaction volume and fill caches of all the scvfs connected to it - const auto& fvGridGeometry = fvGeometry.gridGeometry(); - if (fvGridGeometry.vertexUsesSecondaryInteractionVolume(scvf.vertexIndex())) + const auto& gridGeometry = fvGeometry.gridGeometry(); + if (gridGeometry.vertexUsesSecondaryInteractionVolume(scvf.vertexIndex())) { if (forceUpdateAll) { @@ -290,7 +290,7 @@ public: const auto ivIndexInContainer = ivDataStorage.secondaryInteractionVolumes.size(); // prepare the locally cached boundary interaction volume - const auto& indexSet = fvGridGeometry.gridInteractionVolumeIndexSets().secondaryIndexSet(scvf); + const auto& indexSet = gridGeometry.gridInteractionVolumeIndexSets().secondaryIndexSet(scvf); ivDataStorage.secondaryInteractionVolumes.emplace_back(); secondaryIv_ = &ivDataStorage.secondaryInteractionVolumes.back(); secondaryIv_->bind(indexSet, problem(), fvGeometry); @@ -320,7 +320,7 @@ public: const auto ivIndexInContainer = ivDataStorage.primaryInteractionVolumes.size(); // prepare the locally cached boundary interaction volume - const auto& indexSet = fvGridGeometry.gridInteractionVolumeIndexSets().primaryIndexSet(scvf); + const auto& indexSet = gridGeometry.gridInteractionVolumeIndexSets().primaryIndexSet(scvf); ivDataStorage.primaryInteractionVolumes.emplace_back(); primaryIv_ = &ivDataStorage.primaryInteractionVolumes.back(); primaryIv_->bind(indexSet, problem(), fvGeometry); diff --git a/dumux/porousmediumflow/nonequilibrium/gridvariables.hh b/dumux/porousmediumflow/nonequilibrium/gridvariables.hh index 7d2e2660a3fab0a25fc6acb1448642389eaff552..e27312975058a80f78c4fd025b044fcee6a19f9d 100644 --- a/dumux/porousmediumflow/nonequilibrium/gridvariables.hh +++ b/dumux/porousmediumflow/nonequilibrium/gridvariables.hh @@ -88,15 +88,15 @@ public: for (int phaseIdx = 0; phaseIdx < numPhases; ++phaseIdx) { if(isBox && dim == 1) - velocity[phaseIdx].resize(this->fvGridGeometry_->gridView().size(0)); + velocity[phaseIdx].resize(this->gridGeometry_->gridView().size(0)); else - velocity[phaseIdx].resize(this->fvGridGeometry_->numDofs()); + velocity[phaseIdx].resize(this->gridGeometry_->numDofs()); } - for (const auto& element : elements(this->fvGridGeometry_->gridView(), Dune::Partitions::interior)) + for (const auto& element : elements(this->gridGeometry_->gridView(), Dune::Partitions::interior)) { - const auto eIdxGlobal = this->fvGridGeometry_->elementMapper().index(element); + const auto eIdxGlobal = this->gridGeometry_->elementMapper().index(element); - auto fvGeometry = localView(*this->fvGridGeometry_); + auto fvGeometry = localView(*this->gridGeometry_); auto elemVolVars = localView(this->curGridVolVars()); auto elemFluxVarsCache = localView(this->gridFluxVarsCache()); diff --git a/dumux/porousmediumflow/problem.hh b/dumux/porousmediumflow/problem.hh index 384dd51794e8002459d22364616343cf414db08a..03c55997a9ce6440f5b16095b91ca1b5eec36f69 100644 --- a/dumux/porousmediumflow/problem.hh +++ b/dumux/porousmediumflow/problem.hh @@ -38,7 +38,7 @@ template class PorousMediumFlowProblem : public FVProblem { using ParentType = FVProblem; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using GridView = GetPropType; enum { @@ -60,14 +60,14 @@ public: /*! * \brief Constructor, passing the spatial parameters. * - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param spatialParams The spatial parameter class * \param paramGroup The parameter group in which to look for runtime parameters first (default is "") */ - PorousMediumFlowProblem(std::shared_ptr fvGridGeometry, + PorousMediumFlowProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams, const std::string& paramGroup = "") - : ParentType(fvGridGeometry, paramGroup) + : ParentType(gridGeometry, paramGroup) , gravity_(0.0) , spatialParams_(spatialParams) { @@ -79,13 +79,13 @@ public: /*! * \brief Constructor, constructing the spatial parameters. * - * \param fvGridGeometry The finite volume grid geometry + * \param gridGeometry The finite volume grid geometry * \param paramGroup The parameter group in which to look for runtime parameters first (default is "") */ - PorousMediumFlowProblem(std::shared_ptr fvGridGeometry, + PorousMediumFlowProblem(std::shared_ptr gridGeometry, const std::string& paramGroup = "") - : PorousMediumFlowProblem(fvGridGeometry, - std::make_shared(fvGridGeometry), + : PorousMediumFlowProblem(gridGeometry, + std::make_shared(gridGeometry), paramGroup) {} diff --git a/dumux/porousmediumflow/richards/newtonsolver.hh b/dumux/porousmediumflow/richards/newtonsolver.hh index ffb72218faef890313bc2a148e22503b93e27a20..bafc188d171595db8b09b5a411a1f5e1f59e518b 100644 --- a/dumux/porousmediumflow/richards/newtonsolver.hh +++ b/dumux/porousmediumflow/richards/newtonsolver.hh @@ -75,10 +75,10 @@ private: if (this->numSteps_ <= 4) { // clamp saturation change to at most 20% per iteration - const auto& fvGridGeometry = this->assembler().gridGeometry(); - for (const auto& element : elements(fvGridGeometry.gridView())) + const auto& gridGeometry = this->assembler().gridGeometry(); + for (const auto& element : elements(gridGeometry.gridView())) { - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bindElement(element); for (auto&& scv : scvs(fvGeometry)) @@ -87,7 +87,7 @@ private: // calculate the old wetting phase saturation const auto& spatialParams = this->assembler().problem().spatialParams(); - const auto elemSol = elementSolution(element, uCurrentIter, fvGridGeometry); + const auto elemSol = elementSolution(element, uCurrentIter, gridGeometry); const auto& materialLawParams = spatialParams.materialLawParams(element, scv, elemSol); const Scalar pcMin = MaterialLaw::pc(materialLawParams, 1.0); const Scalar pw = uLastIter[dofIdxGlobal][pressureIdx]; diff --git a/dumux/porousmediumflow/velocity.hh b/dumux/porousmediumflow/velocity.hh index 28e9d3affa38b1cf5ac3677ca6b308d8ae66c5e8..5531251ccb7729792447e80a7fcd7f816c546691 100644 --- a/dumux/porousmediumflow/velocity.hh +++ b/dumux/porousmediumflow/velocity.hh @@ -45,11 +45,11 @@ namespace Dumux { template class PorousMediumFlowVelocity { - using FVGridGeometry = typename GridVariables::GridGeometry; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = typename GridVariables::GridGeometry; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GridVolumeVariables = typename GridVariables::GridVolumeVariables; using ElementFluxVarsCache = typename GridVariables::GridFluxVariablesCache::LocalView; @@ -60,7 +60,7 @@ class PorousMediumFlowVelocity static constexpr int dim = GridView::dimension; static constexpr int dimWorld = GridView::dimensionworld; - static constexpr bool isBox = FVGridGeometry::discMethod == DiscretizationMethod::box; + static constexpr bool isBox = GridGeometry::discMethod == DiscretizationMethod::box; static constexpr int dofCodim = isBox ? dim : 0; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -80,18 +80,18 @@ public: */ PorousMediumFlowVelocity(const GridVariables& gridVariables) : problem_(gridVariables.curGridVolVars().problem()) - , fvGridGeometry_(gridVariables.gridGeometry()) + , gridGeometry_(gridVariables.gridGeometry()) , gridVariables_(gridVariables) { // set the number of scvs the vertices are connected to if (isBox && dim > 1) { // resize to the number of vertices of the grid - cellNum_.assign(fvGridGeometry_.gridView().size(dim), 0); + cellNum_.assign(gridGeometry_.gridView().size(dim), 0); - for (const auto& element : elements(fvGridGeometry_.gridView())) + for (const auto& element : elements(gridGeometry_.gridView())) for (unsigned int vIdx = 0; vIdx < element.subEntities(dim); ++vIdx) - ++cellNum_[fvGridGeometry_.vertexMapper().subIndex(element, vIdx, dim)]; + ++cellNum_[gridGeometry_.vertexMapper().subIndex(element, vIdx, dim)]; } } @@ -135,7 +135,7 @@ public: flux /= insideVolVars.extrusionFactor(); tmpVelocity *= flux; - const int eIdxGlobal = fvGridGeometry_.elementMapper().index(element); + const int eIdxGlobal = gridGeometry_.elementMapper().index(element); velocity[eIdxGlobal] = tmpVelocity; } return; @@ -205,7 +205,7 @@ public: // For the number of scvfs per facet (mpfa) we simply obtain the number of // corners of the first facet as prisms/pyramids are not supported here anyway // -> for prisms/pyramids the number of scvfs would differ from facet to facet - static constexpr bool isMpfa = FVGridGeometry::discMethod == DiscretizationMethod::ccmpfa; + static constexpr bool isMpfa = GridGeometry::discMethod == DiscretizationMethod::ccmpfa; const int numScvfsPerFace = isMpfa ? element.template subEntity<1>(0).geometry().corners() : 1; if (fvGeometry.numScvf() != element.subEntities(1)*numScvfsPerFace) @@ -225,7 +225,7 @@ public: // find the local face indices of the scvfs (for conforming meshes) std::vector scvfIndexInInside(fvGeometry.numScvf()); int localScvfIdx = 0; - for (const auto& intersection : intersections(fvGridGeometry_.gridView(), element)) + for (const auto& intersection : intersections(gridGeometry_.gridView(), element)) { if (dim < dimWorld) if (handledScvf[intersection.indexInInside()]) @@ -331,7 +331,7 @@ public: scvVelocity /= geometry.integrationElement(localPos); - int eIdxGlobal = fvGridGeometry_.elementMapper().index(element); + int eIdxGlobal = gridGeometry_.elementMapper().index(element); velocity[eIdxGlobal] = scvVelocity; @@ -420,7 +420,7 @@ private: { return BoundaryTypes(); } const Problem& problem_; - const FVGridGeometry& fvGridGeometry_; + const GridGeometry& gridGeometry_; const GridVariables& gridVariables_; std::vector cellNum_; diff --git a/dumux/porousmediumflow/velocityoutput.hh b/dumux/porousmediumflow/velocityoutput.hh index 0d04c5b57890d34f34a92432774437909750406d..d9aff469c487c83c8235f2091e109f20ffbc43f8 100644 --- a/dumux/porousmediumflow/velocityoutput.hh +++ b/dumux/porousmediumflow/velocityoutput.hh @@ -46,11 +46,11 @@ template class PorousMediumFlowVelocityOutput : public VelocityOutput { using ParentType = VelocityOutput; - using FVGridGeometry = typename GridVariables::GridGeometry; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = typename GridVariables::GridGeometry; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GridVolumeVariables = typename GridVariables::GridVolumeVariables; using ElementFluxVarsCache = typename GridVariables::GridFluxVariablesCache::LocalView; @@ -61,7 +61,7 @@ class PorousMediumFlowVelocityOutput : public VelocityOutput static constexpr int dim = GridView::dimension; static constexpr int dimWorld = GridView::dimensionworld; - static constexpr bool isBox = FVGridGeometry::discMethod == DiscretizationMethod::box; + static constexpr bool isBox = GridGeometry::discMethod == DiscretizationMethod::box; static constexpr int dofCodim = isBox ? dim : 0; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; diff --git a/examples/1ptracer/main.cc b/examples/1ptracer/main.cc index ba44ca3f761653d7e7cd5d534a5db055675180d1..0325eeac465862445fcd2a6b55c1278cd57cb03d 100644 --- a/examples/1ptracer/main.cc +++ b/examples/1ptracer/main.cc @@ -87,13 +87,13 @@ int main(int argc, char** argv) try // #### Set-up // We create and initialize the finite volume grid geometry, the problem, the linear system, including the jacobian matrix, the residual and the solution vector and the gridvariables. // We need the finite volume geometry to build up the subcontrolvolumes (scv) and subcontrolvolume faces (scvf) for each element of the grid partition. - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // In the problem, we define the boundary and initial conditions. using OnePProblem = GetPropType; - auto problemOneP = std::make_shared(fvGridGeometry); + auto problemOneP = std::make_shared(gridGeometry); // The jacobian matrix (`A`), the solution vector (`p`) and the residual (`r`) are parts of the linear system. using JacobianMatrix = GetPropType; @@ -105,13 +105,13 @@ int main(int argc, char** argv) try // The grid variables store variables on scv and scvf (volume and flux variables). using OnePGridVariables = GetPropType; - auto onePGridVariables = std::make_shared(problemOneP, fvGridGeometry); + auto onePGridVariables = std::make_shared(problemOneP, gridGeometry); onePGridVariables->init(p); // #### Assembling the linear system // We created and inizialize the assembler. using OnePAssembler = FVAssembler; - auto assemblerOneP = std::make_shared(problemOneP, fvGridGeometry, onePGridVariables); + auto assemblerOneP = std::make_shared(problemOneP, gridGeometry, onePGridVariables); assemblerOneP->setLinearSystem(A, r); // We assemble the local jacobian and the residual and stop the time needed, which is displayed in the terminal output, using the `assemblyTimer`. Further, we start the timer to evaluate the total time of the assembly, solving and updating. @@ -159,7 +159,7 @@ int main(int argc, char** argv) try // We use the results of the 1p problem to calculate the volume fluxes in the model domain. using Scalar = GetPropType; - std::vector volumeFlux(fvGridGeometry->numScvf(), 0.0); + std::vector volumeFlux(gridGeometry->numScvf(), 0.0); using FluxVariables = GetPropType; auto upwindTerm = [](const auto& volVars) { return volVars.mobility(0); }; @@ -167,7 +167,7 @@ int main(int argc, char** argv) try // We iterate over all elements. for (const auto& element : elements(leafGridView)) { - auto fvGeometry = localView(*fvGridGeometry); + auto fvGeometry = localView(*gridGeometry); fvGeometry.bind(element); auto elemVolVars = localView(onePGridVariables->curGridVolVars()); @@ -206,7 +206,7 @@ int main(int argc, char** argv) try // #### Set-up // Similar to the 1p problem, we first create and initialize the problem. using TracerProblem = GetPropType; - auto tracerProblem = std::make_shared(fvGridGeometry); + auto tracerProblem = std::make_shared(gridGeometry); // We use the volume fluxes calculated in the previous section as input for the tracer model. tracerProblem->spatialParams().setVolumeFlux(volumeFlux); @@ -218,7 +218,7 @@ int main(int argc, char** argv) try // We create and initialize the grid variables. using GridVariables = GetPropType; - auto gridVariables = std::make_shared(tracerProblem, fvGridGeometry); + auto gridVariables = std::make_shared(tracerProblem, gridGeometry); gridVariables->init(x); // We read in some time loop parameters from the input file. The parameter `tEnd` defines the duration of the simulation, dt the initial time step size and `maxDt` the maximal time step size. @@ -232,7 +232,7 @@ int main(int argc, char** argv) try // We create and inizialize the assembler with time loop for the instationary problem. using TracerAssembler = FVAssembler; - auto assembler = std::make_shared(tracerProblem, fvGridGeometry, gridVariables, timeLoop); + auto assembler = std::make_shared(tracerProblem, gridGeometry, gridVariables, timeLoop); assembler->setLinearSystem(A, r); // We initialize the vtk output module and add a velocity output. diff --git a/examples/1ptracer/problem_1p.hh b/examples/1ptracer/problem_1p.hh index 82dd98a0cba091efbdf5f402e8a0f4da8a366972..cd8caedb33d837adeecb818e87a056acae1ce424 100644 --- a/examples/1ptracer/problem_1p.hh +++ b/examples/1ptracer/problem_1p.hh @@ -72,10 +72,10 @@ template struct SpatialParams { // We define convenient shortcuts to the properties `GridGeometry` and `Scalar`: - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; // Finally, we set the spatial parameters: - using type = OnePTestSpatialParams; + using type = OnePTestSpatialParams; }; // The local residual contains analytic derivative methods for incompressible flow: @@ -120,15 +120,15 @@ class OnePTestProblem : public PorousMediumFlowProblem using PrimaryVariables = GetPropType; using FVElementGeometry = typename GetPropType::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using BoundaryTypes = GetPropType; static constexpr int dimWorld = GridView::dimensionworld; public: // This is the constructor of our problem class: - OnePTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) {} + OnePTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) {} // First, we define the type of boundary conditions depending on location. Two types of boundary conditions // can be specified: Dirichlet or Neumann boundary condition. On a Dirichlet boundary, the values of the diff --git a/examples/1ptracer/problem_tracer.hh b/examples/1ptracer/problem_tracer.hh index bebaa7abdeebcc3675026e8b3e9d8a409e0556af..07f00277c6685c783e5b505d80934aed67cc3fe9 100644 --- a/examples/1ptracer/problem_tracer.hh +++ b/examples/1ptracer/problem_tracer.hh @@ -73,9 +73,9 @@ struct Problem { using type = TracerTestProblem struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = TracerTestSpatialParams; + using type = TracerTestSpatialParams; }; // We define that mass fractions are used to define the concentrations @@ -151,20 +151,20 @@ class TracerTestProblem : public PorousMediumFlowProblem using Scalar = GetPropType; using Indices = typename GetPropType::Indices; using GridView = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using BoundaryTypes = GetPropType; using PrimaryVariables = GetPropType; using FluidSystem = GetPropType; using SpatialParams = GetPropType; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; //We create a bool saying whether mole or mass fractions are used static constexpr bool useMoles = getPropValue(); public: // This is the constructor of our problem class: - TracerTestProblem(std::shared_ptr fvGridGeom) - : ParentType(fvGridGeom) + TracerTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { // We print out whether mole or mass fractions are used if(useMoles) diff --git a/examples/1ptracer/spatialparams_1p.hh b/examples/1ptracer/spatialparams_1p.hh index 885f21d1ba56f8d3044404c433620382793b07b3..38d22f0fbad3e17824620e79c46121dad42b1eb0 100644 --- a/examples/1ptracer/spatialparams_1p.hh +++ b/examples/1ptracer/spatialparams_1p.hh @@ -34,26 +34,26 @@ namespace Dumux { // In the `OnePTestSpatialParams` class, we define all functions needed to describe the porous matrix, e.g. porosity and permeability for the 1p_problem. -template +template class OnePTestSpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { // We introduce `using` declarations that are derived from the property system, which we need in this class. - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParamsOneP>; + using ParentType = FVSpatialParamsOneP>; static constexpr int dimWorld = GridView::dimensionworld; using GlobalPosition = typename SubControlVolume::GlobalPosition; public: using PermeabilityType = Scalar; - OnePTestSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry), K_(fvGridGeometry->gridView().size(0), 0.0) + OnePTestSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry), K_(gridGeometry->gridView().size(0), 0.0) { // ### Generation of the random permeability field // We get the permeability of the domain and the lens from the `params.input` file. @@ -68,9 +68,9 @@ public: std::mt19937 rand(0); std::lognormal_distribution K(std::log(permeability_), std::log(permeability_)*0.1); std::lognormal_distribution KLens(std::log(permeabilityLens_), std::log(permeabilityLens_)*0.1); - for (const auto& element : elements(fvGridGeometry->gridView())) + for (const auto& element : elements(gridGeometry->gridView())) { - const auto eIdx = fvGridGeometry->elementMapper().index(element); + const auto eIdx = gridGeometry->elementMapper().index(element); const auto globalPos = element.geometry().center(); K_[eIdx] = isInLens_(globalPos) ? KLens(rand) : K(rand); } diff --git a/examples/1ptracer/spatialparams_tracer.hh b/examples/1ptracer/spatialparams_tracer.hh index 6a13799bded4ce59f9d1fc5948ab3e79b8765747..00bedcae4cce36f5af8ba92f90c339ef5d2752b5 100644 --- a/examples/1ptracer/spatialparams_tracer.hh +++ b/examples/1ptracer/spatialparams_tracer.hh @@ -33,26 +33,26 @@ namespace Dumux { // In the `TracerTestSpatialParams` class, we define all functions needed to describe spatially dependent parameters for the `tracer_problem`. -template +template class TracerTestSpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParamsOneP>; + using ParentType = FVSpatialParamsOneP>; static const int dimWorld = GridView::dimensionworld; using GlobalPosition = typename Dune::FieldVector; public: - TracerTestSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) {} + TracerTestSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) {} // ### Properties of the porous matrix // We define the same porosity for the whole domain as in the 1p spatialparams. diff --git a/examples/2pinfiltration/main.cc b/examples/2pinfiltration/main.cc index 46b31e111b878008f29eb023d3f4055089af05a9..8d5f1dc50f7f2899d405d62dab6e2808d8fa0843 100644 --- a/examples/2pinfiltration/main.cc +++ b/examples/2pinfiltration/main.cc @@ -102,25 +102,25 @@ int main(int argc, char** argv) try // We create and initialize the finite volume grid geometry, the problem, the linear system, including the jacobian matrix, the residual and the solution vector and the gridvariables. // // We need the finite volume geometry to build up the subcontrolvolumes (scv) and subcontrolvolume faces (scvf) for each element of the grid partition. - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // In the problem, we define the boundary and initial conditions. using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // We call the `computePointSourceMap` method to compute the point sources. The `computePointSourceMap` method is inherited from the fvproblem and therefore specified in the `dumux/common/fvproblem.hh`. It calls the `addPointSources` method specified in the `problem.hh` file. problem->computePointSourceMap(); // We initialize the solution vector, using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // and then use the solution vector to intialize the `gridVariables`. using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); //We instantiate the indicator for grid adaption & the data transfer, we read some parameters for indicator from the input file. @@ -128,12 +128,12 @@ int main(int argc, char** argv) try const Scalar refineTol = getParam("Adaptive.RefineTolerance"); const Scalar coarsenTol = getParam("Adaptive.CoarsenTolerance"); // We use an indicator for a two-phase flow problem that is saturation-dependent and defined in the file `dumux/porousmediumflow/2p/gridadaptindicator.hh.` It allows to set the minimum and maximum allowed refinement levels via the input parameters. - TwoPGridAdaptIndicator indicator(fvGridGeometry); + TwoPGridAdaptIndicator indicator(gridGeometry); // The data transfer performs the transfer of data on a grid from before to after adaptation and is defined in the file `dumux/porousmediumflow/2p/griddatatransfer.hh`. Its main functions are to store and reconstruct the primary variables. - TwoPGridDataTransfer dataTransfer(problem, fvGridGeometry, gridVariables, x); + TwoPGridDataTransfer dataTransfer(problem, gridGeometry, gridVariables, x); // We do an initial refinement around sources/BCs. We use the `GridAdaptInitializationIndicator` defined in `dumux/adaptive/initializationindicator.hh` for that. - GridAdaptInitializationIndicator initIndicator(problem, fvGridGeometry, gridVariables); + GridAdaptInitializationIndicator initIndicator(problem, gridGeometry, gridVariables); //We refine up to the maximum level. For every level, the indicator used for the refinement/coarsening is calculated. If any grid cells have to be adapted, the gridvariables and the pointsourcemap are updated. const auto maxLevel = getParam("Adaptive.MaxLevel", 0); @@ -198,11 +198,11 @@ int main(int argc, char** argv) try //we set the assembler with the time loop because we have an instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop); // we set the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // additionally we set the non-linear solver. using NewtonSolver = Dumux::NewtonSolver; diff --git a/examples/2pinfiltration/problem.hh b/examples/2pinfiltration/problem.hh index 913962b7f8ebe53a5da511ec7e110269984f0542..f7ddfceef02c00a5bf21bdba455b2db32289cf1d 100644 --- a/examples/2pinfiltration/problem.hh +++ b/examples/2pinfiltration/problem.hh @@ -106,11 +106,11 @@ namespace Dumux { { // We define convenient shortcuts to the properties GridGeometry and Scalar: private: - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; // Finally we set the spatial parameters: public: - using type = TwoPTestSpatialParams; + using type = TwoPTestSpatialParams; }; // We enable caching for the grid volume variables, the grid flux variables and the FV grid geometry. The cache @@ -139,7 +139,7 @@ class PointSourceProblem : public PorousMediumFlowProblem using Scalar = GetPropType; using FluidSystem = GetPropType; using PrimaryVariables = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using PointSource = GetPropType; using BoundaryTypes = GetPropType; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -157,8 +157,8 @@ class PointSourceProblem : public PorousMediumFlowProblem public: // This is the constructor of our problem class: - PointSourceProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + PointSourceProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { // We read in the values for the initial condition of our simulation: initialValues_ = readFileToContainer>("initialsolutioncc.txt"); diff --git a/examples/2pinfiltration/spatialparams.hh b/examples/2pinfiltration/spatialparams.hh index c261ac81e4fcd969f370d8438035fc8842b8b9fd..4bcb5292d01b0891a6587d4957baaf304c339d29 100644 --- a/examples/2pinfiltration/spatialparams.hh +++ b/examples/2pinfiltration/spatialparams.hh @@ -32,17 +32,17 @@ namespace Dumux { //In the TwoPTestSpatialParams class we define all functions needed to describe the porous matrix, e.g. porosity and permeability -template +template class TwoPTestSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { //we introduce using declarations that are derived from the property system which we need in this class - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; - using ThisType = TwoPTestSpatialParams; - using ParentType = FVSpatialParams; + using ThisType = TwoPTestSpatialParams; + using ParentType = FVSpatialParams; static constexpr int dimWorld = GridView::dimensionworld; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -54,8 +54,8 @@ public: using MaterialLawParams = typename MaterialLaw::Params; using PermeabilityType = Scalar; - TwoPTestSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + TwoPTestSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { //we get the position of the lens from the params.input file. The lens is defined by the position of the lower left and the upper right corner lensLowerLeft_ = getParam("SpatialParams.LensLowerLeft"); diff --git a/examples/shallowwaterfriction/problem.hh b/examples/shallowwaterfriction/problem.hh index 91f9b47cfaaded6630b9652b46fe919699b81b46..8d7c55f968085cf13f71f0da8716cea775cf6114 100644 --- a/examples/shallowwaterfriction/problem.hh +++ b/examples/shallowwaterfriction/problem.hh @@ -68,14 +68,14 @@ template struct SpatialParams { private: - // We define convenient shortcuts to the properties FVGridGeometry, Scalar, ElementVolumeVariables and VolumeVariables: - using FVGridGeometry = GetPropType; + // We define convenient shortcuts to the properties GridGeometry, Scalar, ElementVolumeVariables and VolumeVariables: + using GridGeometry = GetPropType; using Scalar = GetPropType; using ElementVolumeVariables = typename GetPropType::LocalView; using VolumeVariables = typename ElementVolumeVariables::VolumeVariables; // Finally we set the spatial parameters: public: - using type = RoughChannelSpatialParams; + using type = RoughChannelSpatialParams; }; // We enable caching for the FV grid geometry and the grid volume variables. The cache @@ -103,7 +103,7 @@ class RoughChannelProblem : public ShallowWaterProblem using BoundaryTypes = GetPropType; using Scalar = GetPropType; using Indices = typename GetPropType::Indices; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using NeumannFluxes = GetPropType; using ElementVolumeVariables = typename GetPropType::LocalView; using GridVariables = GetPropType; @@ -119,8 +119,8 @@ class RoughChannelProblem : public ShallowWaterProblem public: // This is the constructor of our problem class. - RoughChannelProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + RoughChannelProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { // We read the parameters from the params.input file. name_ = getParam("Problem.Name"); @@ -130,8 +130,8 @@ public: // We calculate the outflow boundary condition using the Gauckler-Manning-Strickler formula. hBoundary_ = this->gauklerManningStrickler(discharge_,constManningN_,bedSlope_); // We initialize the analytic solution to a verctor of the appropriate size filled with zeros. - exactWaterDepth_.resize(fvGridGeometry->numDofs(), 0.0); - exactVelocityX_.resize(fvGridGeometry->numDofs(), 0.0); + exactWaterDepth_.resize(gridGeometry->numDofs(), 0.0); + exactVelocityX_.resize(gridGeometry->numDofs(), 0.0); } // Get the analytical water depth diff --git a/examples/shallowwaterfriction/spatialparams.hh b/examples/shallowwaterfriction/spatialparams.hh index a6e6f315afe0435dfc7eebc5e1568115464960a1..17bca79fee127dfc08583c8a67a7fb787477acfe 100644 --- a/examples/shallowwaterfriction/spatialparams.hh +++ b/examples/shallowwaterfriction/spatialparams.hh @@ -34,24 +34,24 @@ namespace Dumux { //In the RoughChannelSpatialParams class we define all functions needed to describe the spatial distributed parameters. -template +template class RoughChannelSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { // We introduce using declarations that are derived from the property system which we need in this class - using ThisType = RoughChannelSpatialParams; - using ParentType = FVSpatialParams; - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using ThisType = RoughChannelSpatialParams; + using ParentType = FVSpatialParams; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: // In the constructor be read some values from the `params.input` and initialize the friciton law. - RoughChannelSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + RoughChannelSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { gravity_ = getParam("Problem.Gravity"); bedSlope_ = getParam("Problem.BedSlope"); diff --git a/test/discretization/box/test_boxfvgeometry.cc b/test/discretization/box/test_boxfvgeometry.cc index 17b719f0ae2ad754a35c05ddff38c302af6768bd..6e6688f9e4013e02d765581f8e6c2c447266c4c0 100644 --- a/test/discretization/box/test_boxfvgeometry.cc +++ b/test/discretization/box/test_boxfvgeometry.cc @@ -59,8 +59,8 @@ int main (int argc, char *argv[]) try constexpr int dim = Grid::dimension; - using FVGridGeometry = BoxFVGridGeometry; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = BoxFVGridGeometry; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using GlobalPosition = typename SubControlVolume::GlobalPosition; @@ -72,15 +72,15 @@ int main (int argc, char *argv[]) try std::shared_ptr grid = Dune::StructuredGridFactory::createCubeGrid(lower, upper, els); auto leafGridView = grid->leafGridView(); - FVGridGeometry fvGridGeometry(leafGridView); - fvGridGeometry.update(); + GridGeometry gridGeometry(leafGridView); + gridGeometry.update(); // iterate over elements. For every element get fv geometry and loop over scvs and scvfaces for (const auto& element : elements(leafGridView)) { - auto eIdx = fvGridGeometry.elementMapper().index(element); + auto eIdx = gridGeometry.elementMapper().index(element); std::cout << std::endl << "Checking fvGeometry of element " << eIdx << std::endl; - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bind(element); auto range = scvs(fvGeometry); diff --git a/test/discretization/cellcentered/tpfa/test_tpfafvgeometry.cc b/test/discretization/cellcentered/tpfa/test_tpfafvgeometry.cc index 5c95f2d5e6dd4e1f09e091898cfee446a9a4288a..856b3f6517cf3889d162c9e7fbf9274c53582947 100644 --- a/test/discretization/cellcentered/tpfa/test_tpfafvgeometry.cc +++ b/test/discretization/cellcentered/tpfa/test_tpfafvgeometry.cc @@ -59,8 +59,8 @@ int main (int argc, char *argv[]) try constexpr int dim = Grid::dimension; - using FVGridGeometry = CCTpfaFVGridGeometry; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = CCTpfaFVGridGeometry; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using GlobalPosition = typename SubControlVolume::GlobalPosition; @@ -71,17 +71,17 @@ int main (int argc, char *argv[]) try std::array els{{2, 2}}; std::shared_ptr grid = Dune::StructuredGridFactory::createCubeGrid(lower, upper, els); - // obtain leaf and make FVGridGeometry + // obtain leaf and make GridGeometry auto leafGridView = grid->leafGridView(); - FVGridGeometry fvGridGeometry(leafGridView); - fvGridGeometry.update(); + GridGeometry gridGeometry(leafGridView); + gridGeometry.update(); // iterate over elements. For every element get fv geometry and loop over scvs and scvfaces for (const auto& element : elements(leafGridView)) { - auto eIdx = fvGridGeometry.elementMapper().index(element); + auto eIdx = gridGeometry.elementMapper().index(element); std::cout << std::endl << "Checking fvGeometry of element " << eIdx << std::endl; - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bind(element); auto range = scvs(fvGeometry); diff --git a/test/discretization/cellcentered/tpfa/test_tpfafvgeometry_nonconforming.cc b/test/discretization/cellcentered/tpfa/test_tpfafvgeometry_nonconforming.cc index c5159902879adb1a7c8d77693a19263f13cdcfdc..ffbed2d4b53bf8f53fef3164a65c7ebce01e43de 100644 --- a/test/discretization/cellcentered/tpfa/test_tpfafvgeometry_nonconforming.cc +++ b/test/discretization/cellcentered/tpfa/test_tpfafvgeometry_nonconforming.cc @@ -120,8 +120,8 @@ int main (int argc, char *argv[]) try constexpr int dim = Grid::dimension; - using FVGridGeometry = CCTpfaFVGridGeometry; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using GridGeometry = CCTpfaFVGridGeometry; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; //! make a grid @@ -141,22 +141,22 @@ int main (int argc, char *argv[]) try if (leafGridView.size(0) != 12) DUNE_THROW(Dune::InvalidStateException, "Refined grid does not have exactly 12 elements!"); - //! instantiate and update fvGridGeometry - FVGridGeometry fvGridGeometry(leafGridView); - fvGridGeometry.update(); + //! instantiate and update gridGeometry + GridGeometry gridGeometry(leafGridView); + gridGeometry.update(); //! We should have constructed 12 scvfs - if (fvGridGeometry.numScv() != 12) + if (gridGeometry.numScv() != 12) DUNE_THROW(Dune::InvalidStateException, "FvGridGeometry does not have exactly 12 scvs!"); //! We should have constructed 52 scvfs - if (fvGridGeometry.numScvf() != 52) + if (gridGeometry.numScvf() != 52) DUNE_THROW(Dune::InvalidStateException, "FvGridGeometry does not have exactly 52 scvfs!"); //! iterate over elements and check for each element the number of scvfs for (const auto& element : elements(leafGridView)) { - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bind(element); //! For the tpfa scheme there is always one scv per element @@ -224,7 +224,7 @@ int main (int argc, char *argv[]) try //! check levels of neighbors if (!scvf.boundary()) { - const auto outsideElement = fvGridGeometry.element(scvf.outsideScvIdx()); + const auto outsideElement = gridGeometry.element(scvf.outsideScvIdx()); const auto outsideCenter = outsideElement.geometry().center(); if (isInCentralElement(outsideCenter)) diff --git a/test/discretization/staggered/test_staggered_free_flow_geometry.cc b/test/discretization/staggered/test_staggered_free_flow_geometry.cc index d0e703c8b612cc1919d914843a7d5baed112c181..b1cdde06fc1dd9fa6e4205affb14900dab5ae9b1 100644 --- a/test/discretization/staggered/test_staggered_free_flow_geometry.cc +++ b/test/discretization/staggered/test_staggered_free_flow_geometry.cc @@ -68,11 +68,11 @@ struct TestFVGGTraits : public DefaultMapperTraits using FaceIdx = Dune::index_constant<1>; }; - template - using ConnectivityMap = StaggeredFreeFlowConnectivityMap; + template + using ConnectivityMap = StaggeredFreeFlowConnectivityMap; - template - using LocalView = StaggeredFVElementGeometry; + template + using LocalView = StaggeredFVElementGeometry; }; } // end namespace Dumux @@ -95,9 +95,9 @@ int main (int argc, char *argv[]) try static constexpr int upwindSchemeOrder = 2; - using FVGridGeometry = StaggeredFVGridGeometry >; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using GlobalPosition = typename SubControlVolume::GlobalPosition; @@ -109,8 +109,8 @@ int main (int argc, char *argv[]) try std::shared_ptr grid = Dune::StructuredGridFactory::createCubeGrid(lower, upper, els); auto leafGridView = grid->leafGridView(); - FVGridGeometry fvGridGeometry(leafGridView); - fvGridGeometry.update(); + GridGeometry gridGeometry(leafGridView); + gridGeometry.update(); std::cout << "Abbreviatons:\n" << "pos - postition of face center\n" @@ -125,11 +125,11 @@ int main (int argc, char *argv[]) try // iterate over elements. For every element get fv geometry and loop over scvs and scvfaces for (const auto& element : elements(leafGridView)) { - auto eIdx = fvGridGeometry.elementMapper().index(element); + auto eIdx = gridGeometry.elementMapper().index(element); if(eIdx == 12 || eIdx == 0) { std::cout << std::endl << "Checking fvGeometry of element " << eIdx << std::endl; - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bind(element); auto range = scvs(fvGeometry); @@ -162,11 +162,11 @@ int main (int argc, char *argv[]) try std::cout << std::fixed << std::left << std::setprecision(2); std::cout << " On Axis Dof Index: \n"; - if(fvGridGeometry.upwindStencilOrder() > 1) + if(gridGeometry.upwindStencilOrder() > 1) {std::cout << " | Forward dofIdx : " << std::setw(3) << scvf.axisData().inAxisForwardDofs[0] << "\n";} std::cout << " | Self dofIdx : " << std::setw(3) << scvf.dofIndex() << "\n"; std::cout << " | Opposite dofIdx : " << std::setw(3) << scvf.dofIndexOpposingFace() << "\n"; - if(fvGridGeometry.upwindStencilOrder() > 1) + if(gridGeometry.upwindStencilOrder() > 1) {std::cout << " | Backward dofIdx : " << std::setw(3) << scvf.axisData().inAxisBackwardDofs[0] << "\n";} std::cout << " Normal Dof Index: \n"; @@ -179,22 +179,22 @@ int main (int argc, char *argv[]) try std::cout << " Parallel Dof Index: \n"; for(int i = 0; i < scvf.pairData().size(); i++) { - for(int j = 0; j < fvGridGeometry.upwindStencilOrder(); j++) + for(int j = 0; j < gridGeometry.upwindStencilOrder(); j++) { std::cout << " | Parallel Dof "<< j << " on axis " << i << ": "<< std::setw(3) << scvf.pairData(i).parallelDofs[j] << "\n"; } } std::cout << " Distances: \n"; - if(fvGridGeometry.upwindStencilOrder() > 1) + if(gridGeometry.upwindStencilOrder() > 1) {std::cout << " | Opposite To Backwards Face Dist : " << std::setw(3) << scvf.axisData().inAxisBackwardDistances[0] << "\n";} std::cout << " | self To Opposite Dist : " << std::setw(3) << scvf.selfToOppositeDistance() << "\n"; - if(fvGridGeometry.upwindStencilOrder() > 1) + if(gridGeometry.upwindStencilOrder() > 1) {std::cout << " | self To Forwards Face Dist : " << std::setw(3) << scvf.axisData().inAxisForwardDistances[0] << "\n";} for(int i = 0; i < scvf.pairData().size(); i++) { - for(int j = 0; j < fvGridGeometry.upwindStencilOrder(); j++) + for(int j = 0; j < gridGeometry.upwindStencilOrder(); j++) { std::cout << " | Parallel Cell Widths "<< j << " on axis " << i << ": "<< std::setw(3) << scvf.pairData(i).parallelCellWidths[j] << "\n"; } @@ -202,7 +202,7 @@ int main (int argc, char *argv[]) try for(int i = 0; i < scvf.pairData().size(); i++) { - for(int j = 0; j < fvGridGeometry.upwindStencilOrder(); j++) + for(int j = 0; j < gridGeometry.upwindStencilOrder(); j++) { std::cout << " | Cell Centered Parallel Distance "<< j << " on axis " << i << ": "<< std::setw(3) << scvf.parallelDofsDistance(i,j) << "\n"; } diff --git a/test/discretization/staggered/test_staggeredfvgeometry.cc b/test/discretization/staggered/test_staggeredfvgeometry.cc index 3296aca99c8253429632cb41f0454d8db37e3b45..e8a067704c7ce06bdd5e978fe90f6f7caff7ed97 100644 --- a/test/discretization/staggered/test_staggeredfvgeometry.cc +++ b/test/discretization/staggered/test_staggeredfvgeometry.cc @@ -65,19 +65,19 @@ struct TestFVGGTraits : public DefaultMapperTraits using FaceIdx = Dune::index_constant<1>; }; - //! Dummy connectivity map, required by FVGridGeometry - template + //! Dummy connectivity map, required by GridGeometry + template struct MockConnectivityMap { - void update(const FVGridGeometry& fvGridGeometry) {} + void update(const GridGeometry& gridGeometry) {} void setStencilOrder(const int order) {} }; - template - using ConnectivityMap = MockConnectivityMap; + template + using ConnectivityMap = MockConnectivityMap; - template - using LocalView = StaggeredFVElementGeometry; + template + using LocalView = StaggeredFVElementGeometry; }; } // end namespace Dumux @@ -101,9 +101,9 @@ int main (int argc, char *argv[]) try constexpr int dimworld = Grid::dimensionworld; using GlobalPosition = typename Dune::FieldVector; - using FVGridGeometry = StaggeredFVGridGeometry >; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; @@ -114,15 +114,15 @@ int main (int argc, char *argv[]) try std::shared_ptr grid = Dune::StructuredGridFactory::createCubeGrid(lower, upper, els); auto leafGridView = grid->leafGridView(); - FVGridGeometry fvGridGeometry(leafGridView); - fvGridGeometry.update(); + GridGeometry gridGeometry(leafGridView); + gridGeometry.update(); // iterate over elements. For every element get fv geometry and loop over scvs and scvfaces for (const auto& element : elements(leafGridView)) { - auto eIdx = fvGridGeometry.elementMapper().index(element); + auto eIdx = gridGeometry.elementMapper().index(element); std::cout << std::endl << "Checking fvGeometry of element " << eIdx << std::endl; - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bind(element); auto range = scvs(fvGeometry); diff --git a/test/freeflow/navierstokes/angeli/main.cc b/test/freeflow/navierstokes/angeli/main.cc index 4da3af1cca59d50f73594bcac961ac31ad607cea..cfce492f446b798a9a02006647ea183447a9df68 100644 --- a/test/freeflow/navierstokes/angeli/main.cc +++ b/test/freeflow/navierstokes/angeli/main.cc @@ -57,8 +57,8 @@ template auto createAnalyticalSolution(const Scalar time, const Problem& problem) { - const auto& fvGridGeometry = problem.gridGeometry(); - using GridView = typename std::decay_t::GridView; + const auto& gridGeometry = problem.gridGeometry(); + using GridView = typename std::decay_t::GridView; static constexpr auto dim = GridView::dimension; static constexpr auto dimWorld = GridView::dimensionworld; @@ -69,14 +69,14 @@ auto createAnalyticalSolution(const Scalar time, const Problem& problem) std::vector analyticalVelocity; std::vector analyticalVelocityOnFace; - analyticalPressure.resize(fvGridGeometry.numCellCenterDofs()); - analyticalVelocity.resize(fvGridGeometry.numCellCenterDofs()); - analyticalVelocityOnFace.resize(fvGridGeometry.numFaceDofs()); + analyticalPressure.resize(gridGeometry.numCellCenterDofs()); + analyticalVelocity.resize(gridGeometry.numCellCenterDofs()); + analyticalVelocityOnFace.resize(gridGeometry.numFaceDofs()); using Indices = typename Problem::Indices; - for (const auto& element : elements(fvGridGeometry.gridView())) + for (const auto& element : elements(gridGeometry.gridView())) { - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bindElement(element); for (auto&& scv : scvs(fvGeometry)) { @@ -133,9 +133,9 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // get some time loop parameters using Scalar = GetPropType; @@ -149,20 +149,20 @@ int main(int argc, char** argv) try // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); problem->updateTimeStepSize(timeLoop->timeStepSize()); // the solution vector using SolutionVector = GetPropType; SolutionVector x; - x[FVGridGeometry::cellCenterIdx()].resize(fvGridGeometry->numCellCenterDofs()); - x[FVGridGeometry::faceIdx()].resize(fvGridGeometry->numFaceDofs()); + x[GridGeometry::cellCenterIdx()].resize(gridGeometry->numCellCenterDofs()); + x[GridGeometry::faceIdx()].resize(gridGeometry->numFaceDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // initialize the vtk output module @@ -178,7 +178,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = StaggeredFVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::UMFPackBackend; @@ -207,8 +207,8 @@ int main(int argc, char** argv) try using L2Error = NavierStokesTestL2Error; const auto l2error = L2Error::calculateL2Error(*problem, x); - const int numCellCenterDofs = fvGridGeometry->numCellCenterDofs(); - const int numFaceDofs = fvGridGeometry->numFaceDofs(); + const int numCellCenterDofs = gridGeometry->numCellCenterDofs(); + const int numFaceDofs = gridGeometry->numFaceDofs(); std::cout << std::setprecision(8) << "** L2 error (abs/rel) for " << std::setw(6) << numCellCenterDofs << " cc dofs and " << numFaceDofs << " face dofs (total: " << numCellCenterDofs + numFaceDofs << "): " << std::scientific diff --git a/test/freeflow/navierstokes/angeli/problem.hh b/test/freeflow/navierstokes/angeli/problem.hh index 2e2f7bd82046dcfa472c50ef9c189f6b7d5a906f..18d1f9090b23ec2e50012fc986283a7624bd90e6 100644 --- a/test/freeflow/navierstokes/angeli/problem.hh +++ b/test/freeflow/navierstokes/angeli/problem.hh @@ -88,7 +88,7 @@ class AngeliTestProblem : public NavierStokesProblem using ParentType = NavierStokesProblem; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using ModelTraits = GetPropType; using NumEqVector = GetPropType; using PrimaryVariables = GetPropType; @@ -97,15 +97,15 @@ class AngeliTestProblem : public NavierStokesProblem using TimeLoopPtr = std::shared_ptr>; static constexpr auto dimWorld = GetPropType::dimensionworld; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; using VelocityVector = Dune::FieldVector; public: using Indices = typename GetPropType::Indices; - AngeliTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + AngeliTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { kinematicViscosity_ = getParam("Component.LiquidKinematicViscosity", 1.0); } @@ -150,8 +150,8 @@ public: * \param pvIdx The primary variable index in the solution vector */ bool isDirichletCell(const Element& element, - const typename FVGridGeometry::LocalView& fvGeometry, - const typename FVGridGeometry::SubControlVolume& scv, + const typename GridGeometry::LocalView& fvGeometry, + const typename GridGeometry::SubControlVolume& scv, int pvIdx) const { // set a fixed pressure in all cells at the boundary diff --git a/test/freeflow/navierstokes/channel/1d/main.cc b/test/freeflow/navierstokes/channel/1d/main.cc index 249474a69eae676648f498d95449a18b0fdcd912..2880b03269d978de714825fb2c91c10ad2c77cc1 100644 --- a/test/freeflow/navierstokes/channel/1d/main.cc +++ b/test/freeflow/navierstokes/channel/1d/main.cc @@ -75,23 +75,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; SolutionVector x; - x[FVGridGeometry::cellCenterIdx()].resize(fvGridGeometry->numCellCenterDofs()); - x[FVGridGeometry::faceIdx()].resize(fvGridGeometry->numFaceDofs()); + x[GridGeometry::cellCenterIdx()].resize(gridGeometry->numCellCenterDofs()); + x[GridGeometry::faceIdx()].resize(gridGeometry->numFaceDofs()); // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // intialize the vtk output module @@ -105,7 +105,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = StaggeredFVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables); // the linear solver using LinearSolver = Dumux::UMFPackBackend; diff --git a/test/freeflow/navierstokes/channel/1d/problem.hh b/test/freeflow/navierstokes/channel/1d/problem.hh index 4e171491d28a4faea60ec1181b4aa9b0d8a9556d..de84b08752cc736fa9148f6819306db829ae5f23 100644 --- a/test/freeflow/navierstokes/channel/1d/problem.hh +++ b/test/freeflow/navierstokes/channel/1d/problem.hh @@ -90,7 +90,7 @@ class NavierStokesAnalyticProblem : public NavierStokesProblem using ParentType = NavierStokesProblem; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Indices = typename GetPropType::Indices; using NumEqVector = GetPropType; using ModelTraits = GetPropType; @@ -99,14 +99,14 @@ class NavierStokesAnalyticProblem : public NavierStokesProblem using SolutionVector = GetPropType; static constexpr auto dimWorld = GetPropType::dimensionworld; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; using DimVector = GlobalPosition; using DimMatrix = Dune::FieldMatrix; public: - NavierStokesAnalyticProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry), eps_(1e-6) + NavierStokesAnalyticProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry), eps_(1e-6) { printL2Error_ = getParam("Problem.PrintL2Error"); density_ = getParam("Component.LiquidDensity"); @@ -224,8 +224,8 @@ public: * \param pvIdx The primary variable index in the solution vector */ bool isDirichletCell(const Element& element, - const typename FVGridGeometry::LocalView& fvGeometry, - const typename FVGridGeometry::SubControlVolume& scv, + const typename GridGeometry::LocalView& fvGeometry, + const typename GridGeometry::SubControlVolume& scv, int pvIdx) const { // set a fixed pressure in all cells at the boundary diff --git a/test/freeflow/navierstokes/channel/2d/main.cc b/test/freeflow/navierstokes/channel/2d/main.cc index 43da72d5e90b67d505b2d8fbefc810f9657dbdc1..cd95b48b046400e03bd9fcca443c38d85c70f4e4 100644 --- a/test/freeflow/navierstokes/channel/2d/main.cc +++ b/test/freeflow/navierstokes/channel/2d/main.cc @@ -76,13 +76,13 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // get some time loop parameters using Scalar = GetPropType; @@ -96,8 +96,8 @@ int main(int argc, char** argv) try // the solution vector using SolutionVector = GetPropType; SolutionVector x; - x[FVGridGeometry::cellCenterIdx()].resize(fvGridGeometry->numCellCenterDofs()); - x[FVGridGeometry::faceIdx()].resize(fvGridGeometry->numFaceDofs()); + x[GridGeometry::cellCenterIdx()].resize(gridGeometry->numCellCenterDofs()); + x[GridGeometry::faceIdx()].resize(gridGeometry->numFaceDofs()); problem->applyInitialSolution(x); auto xOld = x; @@ -108,7 +108,7 @@ int main(int argc, char** argv) try // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // initialize the vtk output module @@ -119,7 +119,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = StaggeredFVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::UMFPackBackend; @@ -139,10 +139,10 @@ int main(int argc, char** argv) try using GlobalPosition = typename Element::Geometry::GlobalCoordinate; - const Scalar xMin = fvGridGeometry->bBoxMin()[0]; - const Scalar xMax = fvGridGeometry->bBoxMax()[0]; - const Scalar yMin = fvGridGeometry->bBoxMin()[1]; - const Scalar yMax = fvGridGeometry->bBoxMax()[1]; + const Scalar xMin = gridGeometry->bBoxMin()[0]; + const Scalar xMax = gridGeometry->bBoxMax()[0]; + const Scalar yMin = gridGeometry->bBoxMin()[1]; + const Scalar yMax = gridGeometry->bBoxMax()[1]; // The first surface shall be placed at the middle of the channel. // If we have an odd number of cells in x-direction, there would not be any cell faces diff --git a/test/freeflow/navierstokes/channel/2d/problem.hh b/test/freeflow/navierstokes/channel/2d/problem.hh index d3b47821a7f3346b5d6187ff930d69e1ff1b1655..759ad3bb9732d0e83b172b055ac0f2560ea20851 100644 --- a/test/freeflow/navierstokes/channel/2d/problem.hh +++ b/test/freeflow/navierstokes/channel/2d/problem.hh @@ -95,15 +95,15 @@ class ChannelTestProblem : public NavierStokesProblem using ParentType = NavierStokesProblem; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; using Indices = typename GetPropType::Indices; using NumEqVector = GetPropType; using PrimaryVariables = GetPropType; using Scalar = GetPropType; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; using TimeLoopPtr = std::shared_ptr>; @@ -115,8 +115,8 @@ class ChannelTestProblem : public NavierStokesProblem }; public: - ChannelTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry), eps_(1e-6) + ChannelTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry), eps_(1e-6) { inletVelocity_ = getParam("Problem.InletVelocity"); const auto tmp = getParam("Problem.OutletCondition", "Outflow"); diff --git a/test/freeflow/navierstokes/channel/3d/main.cc b/test/freeflow/navierstokes/channel/3d/main.cc index be17fa9846387b54e80de351dc912fb61fae6596..30f792820efd639464df70700b3150de5fd2ff15 100644 --- a/test/freeflow/navierstokes/channel/3d/main.cc +++ b/test/freeflow/navierstokes/channel/3d/main.cc @@ -76,23 +76,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; SolutionVector x; - x[FVGridGeometry::cellCenterIdx()].resize(fvGridGeometry->numCellCenterDofs()); - x[FVGridGeometry::faceIdx()].resize(fvGridGeometry->numFaceDofs()); + x[GridGeometry::cellCenterIdx()].resize(gridGeometry->numCellCenterDofs()); + x[GridGeometry::faceIdx()].resize(gridGeometry->numFaceDofs()); // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // intialize the vtk output module @@ -103,7 +103,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = StaggeredFVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables); // the linear solver using LinearSolver = Dumux::UMFPackBackend; @@ -122,13 +122,13 @@ int main(int argc, char** argv) try using Scalar = GetPropType; using GlobalPosition = Dune::FieldVector; - const Scalar xMin = fvGridGeometry->bBoxMin()[0]; - const Scalar xMax = fvGridGeometry->bBoxMax()[0]; - const Scalar yMin = fvGridGeometry->bBoxMin()[1]; - const Scalar yMax = fvGridGeometry->bBoxMax()[1]; + const Scalar xMin = gridGeometry->bBoxMin()[0]; + const Scalar xMax = gridGeometry->bBoxMax()[0]; + const Scalar yMin = gridGeometry->bBoxMin()[1]; + const Scalar yMax = gridGeometry->bBoxMax()[1]; #if DIM_3D - const Scalar zMin = fvGridGeometry->bBoxMin()[2]; - const Scalar zMax = fvGridGeometry->bBoxMax()[2]; + const Scalar zMin = gridGeometry->bBoxMin()[2]; + const Scalar zMax = gridGeometry->bBoxMax()[2]; #endif // The first plane shall be placed at the middle of the channel. diff --git a/test/freeflow/navierstokes/channel/3d/problem.hh b/test/freeflow/navierstokes/channel/3d/problem.hh index c9d4f908eccde0233b388f76c9b882d3ae43cfb2..dd5d68fdacd9eaa8371df882b2f7092712e4e116 100644 --- a/test/freeflow/navierstokes/channel/3d/problem.hh +++ b/test/freeflow/navierstokes/channel/3d/problem.hh @@ -105,8 +105,8 @@ class ThreeDChannelTestProblem : public NavierStokesProblem using BoundaryTypes = GetPropType; using Element = typename GridView::template Codim<0>::Entity; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; @@ -123,8 +123,8 @@ class ThreeDChannelTestProblem : public NavierStokesProblem static constexpr bool enablePseudoThreeDWallFriction = !DIM_3D; public: - ThreeDChannelTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry), eps_(1e-6) + ThreeDChannelTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry), eps_(1e-6) { deltaP_ = getParam("Problem.DeltaP"); height_ = getParam("Problem.Height"); diff --git a/test/freeflow/navierstokes/closedsystem/main.cc b/test/freeflow/navierstokes/closedsystem/main.cc index 35e2f9ff8b53b3f8a892ac54aa7df278d1f0b4f6..5e1a20d7a917ce9f76271cbcafca9ecaf49ff7fe 100644 --- a/test/freeflow/navierstokes/closedsystem/main.cc +++ b/test/freeflow/navierstokes/closedsystem/main.cc @@ -75,25 +75,25 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; SolutionVector x; - x[FVGridGeometry::cellCenterIdx()].resize(fvGridGeometry->numCellCenterDofs()); - x[FVGridGeometry::faceIdx()].resize(fvGridGeometry->numFaceDofs()); + x[GridGeometry::cellCenterIdx()].resize(gridGeometry->numCellCenterDofs()); + x[GridGeometry::faceIdx()].resize(gridGeometry->numFaceDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -114,7 +114,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = StaggeredFVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::UMFPackBackend; diff --git a/test/freeflow/navierstokes/closedsystem/problem.hh b/test/freeflow/navierstokes/closedsystem/problem.hh index 3e2054b388b91e010781ae2de2442191528ce335..97153af6faa6f62ba22ea7f35b5f9c06089c79f6 100644 --- a/test/freeflow/navierstokes/closedsystem/problem.hh +++ b/test/freeflow/navierstokes/closedsystem/problem.hh @@ -84,21 +84,21 @@ class ClosedSystemTestProblem : public NavierStokesProblem using ParentType = NavierStokesProblem; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; using Indices = typename GetPropType::Indices; using NumEqVector = GetPropType; using PrimaryVariables = GetPropType; using Scalar = GetPropType; static constexpr auto dimWorld = GetPropType::dimensionworld; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: - ClosedSystemTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry), eps_(1e-6) + ClosedSystemTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry), eps_(1e-6) { lidVelocity_ = getParam("Problem.LidVelocity"); } diff --git a/test/freeflow/navierstokes/donea/main.cc b/test/freeflow/navierstokes/donea/main.cc index c4acd223c09545088cf44cacaa1ad8c4d362122e..1db594dacb9abd0cab367093b0b58af540ab31db 100644 --- a/test/freeflow/navierstokes/donea/main.cc +++ b/test/freeflow/navierstokes/donea/main.cc @@ -77,23 +77,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; SolutionVector x; - x[FVGridGeometry::cellCenterIdx()].resize(fvGridGeometry->numCellCenterDofs()); - x[FVGridGeometry::faceIdx()].resize(fvGridGeometry->numFaceDofs()); + x[GridGeometry::cellCenterIdx()].resize(gridGeometry->numCellCenterDofs()); + x[GridGeometry::faceIdx()].resize(gridGeometry->numFaceDofs()); // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // intialize the vtk output module @@ -107,7 +107,7 @@ int main(int argc, char** argv) try // use the staggered FV assembler using Assembler = StaggeredFVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables); // the linear solver using LinearSolver = Dumux::UMFPackBackend; @@ -117,8 +117,8 @@ int main(int argc, char** argv) try using NewtonSolver = Dumux::NewtonSolver; NewtonSolver nonLinearSolver(assembler, linearSolver); - using NewtonConvergenceWriter = StaggeredNewtonConvergenceWriter; - auto convergenceWriter = std::make_shared(*fvGridGeometry); + using NewtonConvergenceWriter = StaggeredNewtonConvergenceWriter; + auto convergenceWriter = std::make_shared(*gridGeometry); nonLinearSolver.attachConvergenceWriter(convergenceWriter); // linearize & solve diff --git a/test/freeflow/navierstokes/donea/problem.hh b/test/freeflow/navierstokes/donea/problem.hh index 9765de2584b9fa4d4b316898a0369614e16851ff..75026d4e9884ae4f6909fa3b88c32e21b613ac06 100644 --- a/test/freeflow/navierstokes/donea/problem.hh +++ b/test/freeflow/navierstokes/donea/problem.hh @@ -91,7 +91,7 @@ class DoneaTestProblem : public NavierStokesProblem using ParentType = NavierStokesProblem; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Indices = typename GetPropType::Indices; using NumEqVector = GetPropType; using ModelTraits = GetPropType; @@ -100,13 +100,13 @@ class DoneaTestProblem : public NavierStokesProblem using SolutionVector = GetPropType; static constexpr auto dimWorld = GetPropType::dimensionworld; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; using VelocityVector = Dune::FieldVector; public: - DoneaTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry), eps_(1e-6) + DoneaTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry), eps_(1e-6) { printL2Error_ = getParam("Problem.PrintL2Error"); createAnalyticalSolution_(); @@ -200,8 +200,8 @@ public: * \param pvIdx The primary variable index in the solution vector */ bool isDirichletCell(const Element& element, - const typename FVGridGeometry::LocalView& fvGeometry, - const typename FVGridGeometry::SubControlVolume& scv, + const typename GridGeometry::LocalView& fvGeometry, + const typename GridGeometry::SubControlVolume& scv, int pvIdx) const { bool onBoundary = false; diff --git a/test/freeflow/navierstokes/kovasznay/main.cc b/test/freeflow/navierstokes/kovasznay/main.cc index b60f0d98c051f1dd6554b8cce5e6f0310c9c7420..c21d9a0936fbfe11e162a5ee14395a4ca4a09df6 100644 --- a/test/freeflow/navierstokes/kovasznay/main.cc +++ b/test/freeflow/navierstokes/kovasznay/main.cc @@ -75,23 +75,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; SolutionVector x; - x[FVGridGeometry::cellCenterIdx()].resize(fvGridGeometry->numCellCenterDofs()); - x[FVGridGeometry::faceIdx()].resize(fvGridGeometry->numFaceDofs()); + x[GridGeometry::cellCenterIdx()].resize(gridGeometry->numCellCenterDofs()); + x[GridGeometry::faceIdx()].resize(gridGeometry->numFaceDofs()); // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // intialize the vtk output module @@ -105,7 +105,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = StaggeredFVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables); // the linear solver using LinearSolver = Dumux::UMFPackBackend; diff --git a/test/freeflow/navierstokes/kovasznay/problem.hh b/test/freeflow/navierstokes/kovasznay/problem.hh index 813b605210fb23c34a44fcc75475a339031eecbb..51441147917a4f936fb2d55f7d93a1dcbabd5b3a 100644 --- a/test/freeflow/navierstokes/kovasznay/problem.hh +++ b/test/freeflow/navierstokes/kovasznay/problem.hh @@ -91,9 +91,9 @@ class KovasznayTestProblem : public NavierStokesProblem using ParentType = NavierStokesProblem; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; using Indices = typename GetPropType::Indices; using ModelTraits = GetPropType; using NumEqVector = GetPropType; @@ -102,18 +102,18 @@ class KovasznayTestProblem : public NavierStokesProblem using SolutionVector = GetPropType; static constexpr auto dimWorld = GetPropType::dimensionworld; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; using VelocityVector = Dune::FieldVector; static constexpr auto upwindSchemeOrder = getPropValue(); public: - KovasznayTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry), eps_(1e-6) + KovasznayTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry), eps_(1e-6) { printL2Error_ = getParam("Problem.PrintL2Error"); - std::cout<< "upwindSchemeOrder is: " << FVGridGeometry::upwindStencilOrder() << "\n"; + std::cout<< "upwindSchemeOrder is: " << GridGeometry::upwindStencilOrder() << "\n"; kinematicViscosity_ = getParam("Component.LiquidKinematicViscosity", 1.0); Scalar reynoldsNumber = 1.0 / kinematicViscosity_; lambda_ = 0.5 * reynoldsNumber diff --git a/test/freeflow/navierstokes/l2error.hh b/test/freeflow/navierstokes/l2error.hh index 5d19b80104998867d508450f1d04ba80019ac48c..21b0006afe35a5710a4319525a86df669db2b293 100644 --- a/test/freeflow/navierstokes/l2error.hh +++ b/test/freeflow/navierstokes/l2error.hh @@ -49,7 +49,7 @@ public: template static auto calculateL2Error(const Problem& problem, const SolutionVector& curSol) { - using FVGridGeometry = std::decay_t; + using GridGeometry = std::decay_t; PrimaryVariables sumError(0.0), sumReference(0.0), l2NormAbs(0.0), l2NormRel(0.0); const int numFaceDofs = problem.gridGeometry().numFaceDofs(); @@ -72,7 +72,7 @@ public: const auto dofIdxCellCenter = scv.dofIndex(); const auto& posCellCenter = scv.dofPosition(); const auto analyticalSolutionCellCenter = problem.dirichletAtPos(posCellCenter)[Indices::pressureIdx]; - const auto numericalSolutionCellCenter = curSol[FVGridGeometry::cellCenterIdx()][dofIdxCellCenter][Indices::pressureIdx - ModelTraits::dim()]; + const auto numericalSolutionCellCenter = curSol[GridGeometry::cellCenterIdx()][dofIdxCellCenter][Indices::pressureIdx - ModelTraits::dim()]; sumError[Indices::pressureIdx] += squaredDiff_(analyticalSolutionCellCenter, numericalSolutionCellCenter) * scv.volume(); sumReference[Indices::pressureIdx] += analyticalSolutionCellCenter * analyticalSolutionCellCenter * scv.volume(); totalVolume += scv.volume(); @@ -83,7 +83,7 @@ public: const int dofIdxFace = scvf.dofIndex(); const int dirIdx = scvf.directionIndex(); const auto analyticalSolutionFace = problem.dirichletAtPos(scvf.center())[Indices::velocity(dirIdx)]; - const auto numericalSolutionFace = curSol[FVGridGeometry::faceIdx()][dofIdxFace][0]; + const auto numericalSolutionFace = curSol[GridGeometry::faceIdx()][dofIdxFace][0]; directionIndex[dofIdxFace] = dirIdx; errorVelocity[dofIdxFace] = squaredDiff_(analyticalSolutionFace, numericalSolutionFace); velocityReference[dofIdxFace] = squaredDiff_(analyticalSolutionFace, 0.0); diff --git a/test/freeflow/navierstokes/sincos/main.cc b/test/freeflow/navierstokes/sincos/main.cc index 5437aaa6c84688d982c2eabdc295098864ec2b4a..507ff765ca274320d2dcdab3e33761ca222aa6aa 100644 --- a/test/freeflow/navierstokes/sincos/main.cc +++ b/test/freeflow/navierstokes/sincos/main.cc @@ -57,8 +57,8 @@ template auto createAnalyticalSolution(const Scalar time, const Problem& problem) { - const auto& fvGridGeometry = problem.gridGeometry(); - using GridView = typename std::decay_t::GridView; + const auto& gridGeometry = problem.gridGeometry(); + using GridView = typename std::decay_t::GridView; static constexpr auto dim = GridView::dimension; static constexpr auto dimWorld = GridView::dimensionworld; @@ -69,14 +69,14 @@ auto createAnalyticalSolution(const Scalar time, const Problem& problem) std::vector analyticalVelocity; std::vector analyticalVelocityOnFace; - analyticalPressure.resize(fvGridGeometry.numCellCenterDofs()); - analyticalVelocity.resize(fvGridGeometry.numCellCenterDofs()); - analyticalVelocityOnFace.resize(fvGridGeometry.numFaceDofs()); + analyticalPressure.resize(gridGeometry.numCellCenterDofs()); + analyticalVelocity.resize(gridGeometry.numCellCenterDofs()); + analyticalVelocityOnFace.resize(gridGeometry.numFaceDofs()); using Indices = typename Problem::Indices; - for (const auto& element : elements(fvGridGeometry.gridView())) + for (const auto& element : elements(gridGeometry.gridView())) { - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bindElement(element); for (auto&& scv : scvs(fvGeometry)) { @@ -110,17 +110,17 @@ auto createSource(const Problem& problem) using Scalar = double; using Indices = typename Problem::Indices; - const auto& fvGridGeometry = problem.gridGeometry(); + const auto& gridGeometry = problem.gridGeometry(); std::array, Problem::ModelTraits::numEq()> source; for (auto& component : source) { - component.resize(fvGridGeometry.numCellCenterDofs()); + component.resize(gridGeometry.numCellCenterDofs()); } - for (const auto& element : elements(fvGridGeometry.gridView())) + for (const auto& element : elements(gridGeometry.gridView())) { - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); fvGeometry.bindElement(element); for (auto&& scv : scvs(fvGeometry)) { @@ -137,8 +137,8 @@ auto createSource(const Problem& problem) return source; } -template -void printL2Error(const Problem& problem, const SolutionVector& x, const FVGridGeometry& fvGridGeometry) +template +void printL2Error(const Problem& problem, const SolutionVector& x, const GridGeometry& gridGeometry) { using namespace Dumux; using Scalar = double; @@ -149,8 +149,8 @@ void printL2Error(const Problem& problem, const SolutionVector& x, const FVGridG using L2Error = NavierStokesTestL2Error; const auto l2error = L2Error::calculateL2Error(*problem, x); - const int numCellCenterDofs = fvGridGeometry->numCellCenterDofs(); - const int numFaceDofs = fvGridGeometry->numFaceDofs(); + const int numCellCenterDofs = gridGeometry->numCellCenterDofs(); + const int numFaceDofs = gridGeometry->numFaceDofs(); std::cout << std::setprecision(8) << "** L2 error (abs/rel) for " << std::setw(6) << numCellCenterDofs << " cc dofs and " << numFaceDofs << " face dofs (total: " << numCellCenterDofs + numFaceDofs << "): " << std::scientific @@ -195,9 +195,9 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // get some time loop parameters using Scalar = GetPropType; @@ -211,20 +211,20 @@ int main(int argc, char** argv) try // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); problem->updateTimeStepSize(timeLoop->timeStepSize()); // the solution vector using SolutionVector = GetPropType; SolutionVector x; - x[FVGridGeometry::cellCenterIdx()].resize(fvGridGeometry->numCellCenterDofs()); - x[FVGridGeometry::faceIdx()].resize(fvGridGeometry->numFaceDofs()); + x[GridGeometry::cellCenterIdx()].resize(gridGeometry->numCellCenterDofs()); + x[GridGeometry::faceIdx()].resize(gridGeometry->numFaceDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // initialize the vtk output module @@ -248,8 +248,8 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = StaggeredFVAssembler; - auto assembler = isStationary ? std::make_shared(problem, fvGridGeometry, gridVariables) - : std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = isStationary ? std::make_shared(problem, gridGeometry, gridVariables) + : std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::UMFPackBackend; @@ -269,7 +269,7 @@ int main(int argc, char** argv) try if (shouldPrintL2Error) { - printL2Error(problem, x, fvGridGeometry); + printL2Error(problem, x, gridGeometry); } // write vtk output @@ -297,7 +297,7 @@ int main(int argc, char** argv) try if (shouldPrintL2Error) { - printL2Error(problem, x, fvGridGeometry); + printL2Error(problem, x, gridGeometry); } // advance to the time loop to the next step diff --git a/test/freeflow/navierstokes/sincos/problem.hh b/test/freeflow/navierstokes/sincos/problem.hh index d4d1d407ebae39a787d730bf58ece450f75d5405..bef74ad581f5f82c6583ec93475298ac4e9bcb8d 100644 --- a/test/freeflow/navierstokes/sincos/problem.hh +++ b/test/freeflow/navierstokes/sincos/problem.hh @@ -86,17 +86,17 @@ class SincosTestProblem : public NavierStokesProblem using ParentType = NavierStokesProblem; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using NumEqVector = GetPropType; using PrimaryVariables = GetPropType; using Scalar = GetPropType; using SolutionVector = GetPropType; using TimeLoopPtr = std::shared_ptr>; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using FVElementGeometry = typename GridGeometry::LocalView; static constexpr auto dimWorld = GetPropType::dimensionworld; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; using VelocityVector = Dune::FieldVector; @@ -104,8 +104,8 @@ public: using ModelTraits = GetPropType; using Indices = typename GetPropType::Indices; - SincosTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry), time_(0.0), timeStepSize_(0.0) + SincosTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry), time_(0.0), timeStepSize_(0.0) { isStationary_ = getParam("Problem.IsStationary"); enableInertiaTerms_ = getParam("Problem.EnableInertiaTerms"); diff --git a/test/freeflow/navierstokesnc/channel/main.cc b/test/freeflow/navierstokesnc/channel/main.cc index a50a3442d217e09be323252d74a87a8343f56f38..d4df7d267b43246436d8a414e4370f7a2dae23f5 100644 --- a/test/freeflow/navierstokesnc/channel/main.cc +++ b/test/freeflow/navierstokesnc/channel/main.cc @@ -75,13 +75,13 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // get some time loop parameters using Scalar = GetPropType; @@ -97,14 +97,14 @@ int main(int argc, char** argv) try // the solution vector using SolutionVector = GetPropType; SolutionVector x; - x[FVGridGeometry::cellCenterIdx()].resize(fvGridGeometry->numCellCenterDofs()); - x[FVGridGeometry::faceIdx()].resize(fvGridGeometry->numFaceDofs()); + x[GridGeometry::cellCenterIdx()].resize(gridGeometry->numCellCenterDofs()); + x[GridGeometry::faceIdx()].resize(gridGeometry->numFaceDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // intialize the vtk output module @@ -116,7 +116,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = StaggeredFVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::UMFPackBackend; diff --git a/test/freeflow/navierstokesnc/channel/problem.hh b/test/freeflow/navierstokesnc/channel/problem.hh index 6e66aab472368367d480847dbfb4fccbae6fc9d9..4cf2ab0824972e795061218df451b5b3b9c3ca3f 100644 --- a/test/freeflow/navierstokesnc/channel/problem.hh +++ b/test/freeflow/navierstokesnc/channel/problem.hh @@ -111,7 +111,7 @@ class ChannelNCTestProblem : public NavierStokesProblem using BoundaryTypes = GetPropType; using FluidSystem = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Indices = typename GetPropType::Indices; using NumEqVector = GetPropType; using PrimaryVariables = GetPropType; @@ -127,8 +127,8 @@ class ChannelNCTestProblem : public NavierStokesProblem static constexpr auto transportEqIdx = Indices::conti0EqIdx + compIdx; public: - ChannelNCTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry), eps_(1e-6) + ChannelNCTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry), eps_(1e-6) { inletVelocity_ = getParam("Problem.InletVelocity"); FluidSystem::init(); diff --git a/test/freeflow/navierstokesnc/densitydrivenflow/main.cc b/test/freeflow/navierstokesnc/densitydrivenflow/main.cc index be73aafd0303ecd1ccbf586db5c2dfcb754efb08..59f53534bde6d234365d50aaa69142cbb6b3ade8 100644 --- a/test/freeflow/navierstokesnc/densitydrivenflow/main.cc +++ b/test/freeflow/navierstokesnc/densitydrivenflow/main.cc @@ -75,13 +75,13 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // get some time loop parameters using Scalar = GetPropType; @@ -96,14 +96,14 @@ int main(int argc, char** argv) try // the solution vector using SolutionVector = GetPropType; SolutionVector x; - x[FVGridGeometry::cellCenterIdx()].resize(fvGridGeometry->numCellCenterDofs()); - x[FVGridGeometry::faceIdx()].resize(fvGridGeometry->numFaceDofs()); + x[GridGeometry::cellCenterIdx()].resize(gridGeometry->numCellCenterDofs()); + x[GridGeometry::faceIdx()].resize(gridGeometry->numFaceDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // intialize the vtk output module @@ -115,7 +115,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = StaggeredFVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::UMFPackBackend; diff --git a/test/freeflow/navierstokesnc/densitydrivenflow/problem.hh b/test/freeflow/navierstokesnc/densitydrivenflow/problem.hh index 3cf9146102641ce5731a8bd2ff92dc6395ebcc44..f40cd66ff700b771d7bfd03cfc985be921af327e 100644 --- a/test/freeflow/navierstokesnc/densitydrivenflow/problem.hh +++ b/test/freeflow/navierstokesnc/densitydrivenflow/problem.hh @@ -98,13 +98,13 @@ class DensityDrivenFlowProblem : public NavierStokesProblem using BoundaryTypes = GetPropType; using FluidSystem = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Indices = typename GetPropType::Indices; using NumEqVector = GetPropType; using PrimaryVariables = GetPropType; using Scalar = GetPropType; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; using TimeLoopPtr = std::shared_ptr>; @@ -115,8 +115,8 @@ class DensityDrivenFlowProblem : public NavierStokesProblem static constexpr auto transportEqIdx = Indices::conti0EqIdx + 1; public: - DensityDrivenFlowProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry), eps_(1e-6) + DensityDrivenFlowProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry), eps_(1e-6) { useWholeLength_ = getParam("Problem.UseWholeLength"); FluidSystem::init(); diff --git a/test/freeflow/navierstokesnc/maxwellstefan/main.cc b/test/freeflow/navierstokesnc/maxwellstefan/main.cc index 0c54f21448b39580a8af60e5bbb911058f64fb71..d38fbe455ed6ce7a9427e9a2d67ec41b76b64d58 100644 --- a/test/freeflow/navierstokesnc/maxwellstefan/main.cc +++ b/test/freeflow/navierstokesnc/maxwellstefan/main.cc @@ -75,13 +75,13 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // get some time loop parameters using Scalar = GetPropType; @@ -96,14 +96,14 @@ int main(int argc, char** argv) try // the solution vector using SolutionVector = GetPropType; SolutionVector x; - x[FVGridGeometry::cellCenterIdx()].resize(fvGridGeometry->numCellCenterDofs()); - x[FVGridGeometry::faceIdx()].resize(fvGridGeometry->numFaceDofs()); + x[GridGeometry::cellCenterIdx()].resize(gridGeometry->numCellCenterDofs()); + x[GridGeometry::faceIdx()].resize(gridGeometry->numFaceDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // intialize the vtk output module @@ -114,7 +114,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = StaggeredFVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::UMFPackBackend; diff --git a/test/freeflow/navierstokesnc/maxwellstefan/problem.hh b/test/freeflow/navierstokesnc/maxwellstefan/problem.hh index f708da444c7b456c7a9154811347f6d88e703d34..7611da93aac51075bb7ca8b1d394e0e473d47be5 100644 --- a/test/freeflow/navierstokesnc/maxwellstefan/problem.hh +++ b/test/freeflow/navierstokesnc/maxwellstefan/problem.hh @@ -209,13 +209,13 @@ class MaxwellStefanNCTestProblem : public NavierStokesProblem using BoundaryTypes = GetPropType; using FluidSystem = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Indices = typename GetPropType::Indices; using NumEqVector = GetPropType; using PrimaryVariables = GetPropType; using Scalar = GetPropType; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; using TimeLoopPtr = std::shared_ptr>; @@ -226,8 +226,8 @@ class MaxwellStefanNCTestProblem : public NavierStokesProblem }; public: - MaxwellStefanNCTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + MaxwellStefanNCTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { plotOutput_ = getParam("Problem.PlotOutput", false); } diff --git a/test/freeflow/rans/main.cc b/test/freeflow/rans/main.cc index 2146a1810d557df30064e526e1e4c93ceeabaaed..3af7593cbb8b8acd5045875620016b5f1ab95b0a 100644 --- a/test/freeflow/rans/main.cc +++ b/test/freeflow/rans/main.cc @@ -99,13 +99,13 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // get some time loop parameters using Scalar = GetPropType; @@ -121,8 +121,8 @@ int main(int argc, char** argv) try // the solution vector using SolutionVector = GetPropType; SolutionVector x; - x[FVGridGeometry::cellCenterIdx()].resize(fvGridGeometry->numCellCenterDofs()); - x[FVGridGeometry::faceIdx()].resize(fvGridGeometry->numFaceDofs()); + x[GridGeometry::cellCenterIdx()].resize(gridGeometry->numCellCenterDofs()); + x[GridGeometry::faceIdx()].resize(gridGeometry->numFaceDofs()); problem->applyInitialSolution(x); problem->updateStaticWallProperties(); problem->updateDynamicWallProperties(x); @@ -130,7 +130,7 @@ int main(int argc, char** argv) try // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // intialize the vtk output module @@ -141,7 +141,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = StaggeredFVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::UMFPackBackend; diff --git a/test/freeflow/rans/problem.hh b/test/freeflow/rans/problem.hh index 472090c824a0ee5103a09e27f00d493c233b5b38..653711cb32a9358dd45d93a784eac4000fa433cf 100644 --- a/test/freeflow/rans/problem.hh +++ b/test/freeflow/rans/problem.hh @@ -115,14 +115,14 @@ class PipeLauferProblem : public RANSProblem using BoundaryTypes = GetPropType; using FluidSystem = GetPropType; using FluidState = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Indices = typename GetPropType::Indices; using NumEqVector = GetPropType; using PrimaryVariables = GetPropType; using Scalar = GetPropType; using ModelTraits = GetPropType; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; using FVElementGeometry = typename GetPropType::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; @@ -130,11 +130,11 @@ class PipeLauferProblem : public RANSProblem using TimeLoopPtr = std::shared_ptr>; - static constexpr auto dimWorld = FVGridGeometry::GridView::dimensionworld; + static constexpr auto dimWorld = GridGeometry::GridView::dimensionworld; public: - PipeLauferProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry), eps_(1e-6) + PipeLauferProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry), eps_(1e-6) { inletVelocity_ = getParam("Problem.InletVelocity"); inletTemperature_ = getParam("Problem.InletTemperature", 283.15); diff --git a/test/freeflow/ransnc/main.cc b/test/freeflow/ransnc/main.cc index ca5605684fc02e1388da32d4c2aa62458b897464..af8ae9117dcb13731b7ff1377332e557ad4a0e98 100644 --- a/test/freeflow/ransnc/main.cc +++ b/test/freeflow/ransnc/main.cc @@ -96,13 +96,13 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // get some time loop parameters using Scalar = GetPropType; @@ -118,8 +118,8 @@ int main(int argc, char** argv) try // the solution vector using SolutionVector = GetPropType; SolutionVector x; - x[FVGridGeometry::cellCenterIdx()].resize(fvGridGeometry->numCellCenterDofs()); - x[FVGridGeometry::faceIdx()].resize(fvGridGeometry->numFaceDofs()); + x[GridGeometry::cellCenterIdx()].resize(gridGeometry->numCellCenterDofs()); + x[GridGeometry::faceIdx()].resize(gridGeometry->numFaceDofs()); problem->applyInitialSolution(x); problem->updateStaticWallProperties(); problem->updateDynamicWallProperties(x); @@ -127,7 +127,7 @@ int main(int argc, char** argv) try // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // intialize the vtk output module @@ -138,7 +138,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = StaggeredFVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::UMFPackBackend; diff --git a/test/freeflow/ransnc/problem.hh b/test/freeflow/ransnc/problem.hh index 15e111ed591fd26f00131c9baae26f9dbf4e1175..ad36aa8a1fb2c3c4e604f211e90f3227b89852ed 100644 --- a/test/freeflow/ransnc/problem.hh +++ b/test/freeflow/ransnc/problem.hh @@ -122,14 +122,14 @@ class FlatPlateNCTestProblem : public RANSProblem using BoundaryTypes = GetPropType; using FluidSystem = GetPropType; using FluidState = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Indices = typename GetPropType::Indices; using NumEqVector = GetPropType; using PrimaryVariables = GetPropType; using Scalar = GetPropType; using ModelTraits = GetPropType; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; using FVElementGeometry = typename GetPropType::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; @@ -142,8 +142,8 @@ class FlatPlateNCTestProblem : public RANSProblem static constexpr auto transportCompIdx = Indices::conti0EqIdx + 1; public: - FlatPlateNCTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry), eps_(1e-6) + FlatPlateNCTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry), eps_(1e-6) { inletVelocity_ = getParam("Problem.InletVelocity", 0.1); inletTemperature_ = getParam("Problem.InletTemperature", 283.15); diff --git a/test/freeflow/shallowwater/dambreak/main.cc b/test/freeflow/shallowwater/dambreak/main.cc index 28a9a56ffeac7fb5cea05e881e5b75e3b4b76008..cacc8c9b336512679663dcef37ca9cac52f8b450 100644 --- a/test/freeflow/shallowwater/dambreak/main.cc +++ b/test/freeflow/shallowwater/dambreak/main.cc @@ -78,23 +78,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -119,11 +119,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NewtonSolver; diff --git a/test/freeflow/shallowwater/dambreak/problem.hh b/test/freeflow/shallowwater/dambreak/problem.hh index bd69eebd1c1b3e13fee74ddef208245f4897c81d..4b23aa6db7cbfb6ef3e2c9d590168625be2f6e67 100644 --- a/test/freeflow/shallowwater/dambreak/problem.hh +++ b/test/freeflow/shallowwater/dambreak/problem.hh @@ -66,10 +66,10 @@ template struct SpatialParams { private: - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; public: - using type = DamBreakSpatialParams; + using type = DamBreakSpatialParams; }; template @@ -113,7 +113,7 @@ class DamBreakProblem : public ShallowWaterProblem using BoundaryTypes = GetPropType; using Scalar = GetPropType; using Indices = typename GetPropType::Indices; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using NeumannFluxes = GetPropType; using GridVariables = GetPropType; @@ -126,12 +126,12 @@ class DamBreakProblem : public ShallowWaterProblem using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: - DamBreakProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + DamBreakProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { name_ = getParam("Problem.Name"); - exactWaterDepth_.resize(fvGridGeometry->numDofs(), 0.0); - exactVelocityX_.resize(fvGridGeometry->numDofs(), 0.0); + exactWaterDepth_.resize(gridGeometry->numDofs(), 0.0); + exactVelocityX_.resize(gridGeometry->numDofs(), 0.0); } //! Get the analytical water depth diff --git a/test/freeflow/shallowwater/dambreak/spatialparams.hh b/test/freeflow/shallowwater/dambreak/spatialparams.hh index c5c32c5440beaa9122c81abb34b2b8e27af62793..8b2a832b309a36d01c04652eb7b8c58a5b4b6ec0 100644 --- a/test/freeflow/shallowwater/dambreak/spatialparams.hh +++ b/test/freeflow/shallowwater/dambreak/spatialparams.hh @@ -33,22 +33,22 @@ namespace Dumux { * \brief The spatial parameters class for the dam break test. * */ -template +template class DamBreakSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using ThisType = DamBreakSpatialParams; - using ParentType = FVSpatialParams; - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using ThisType = DamBreakSpatialParams; + using ParentType = FVSpatialParams; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: - DamBreakSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + DamBreakSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) {} /*! \brief Define the porosity in [-]. diff --git a/test/freeflow/shallowwater/roughchannel/main.cc b/test/freeflow/shallowwater/roughchannel/main.cc index 1cd061ce57e4f1a506534a79107e587c15287abe..7931a8393c7b577c140ebab10c3974ea551e229f 100644 --- a/test/freeflow/shallowwater/roughchannel/main.cc +++ b/test/freeflow/shallowwater/roughchannel/main.cc @@ -76,23 +76,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -117,11 +117,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NewtonSolver; diff --git a/test/freeflow/shallowwater/roughchannel/problem.hh b/test/freeflow/shallowwater/roughchannel/problem.hh index c8d973ae4de814e5de1e2b4b8fdfa10d93622e9b..33cce2afbedefc042421e208ddd2cf0185461b49 100644 --- a/test/freeflow/shallowwater/roughchannel/problem.hh +++ b/test/freeflow/shallowwater/roughchannel/problem.hh @@ -60,12 +60,12 @@ template struct SpatialParams { private: - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; using ElementVolumeVariables = typename GetPropType::LocalView; using VolumeVariables = typename ElementVolumeVariables::VolumeVariables; public: - using type = RoughChannelSpatialParams; + using type = RoughChannelSpatialParams; }; template @@ -116,7 +116,7 @@ class RoughChannelProblem : public ShallowWaterProblem using BoundaryTypes = GetPropType; using Scalar = GetPropType; using Indices = typename GetPropType::Indices; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using NeumannFluxes = GetPropType; using ElementVolumeVariables = typename GetPropType::LocalView; using GridVariables = GetPropType; @@ -131,12 +131,12 @@ class RoughChannelProblem : public ShallowWaterProblem using SubControlVolume = typename FVElementGeometry::SubControlVolume; public: - RoughChannelProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + RoughChannelProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { name_ = getParam("Problem.Name"); - exactWaterDepth_.resize(fvGridGeometry->numDofs(), 0.0); - exactVelocityX_.resize(fvGridGeometry->numDofs(), 0.0); + exactWaterDepth_.resize(gridGeometry->numDofs(), 0.0); + exactVelocityX_.resize(gridGeometry->numDofs(), 0.0); constManningN_ = getParam("Problem.ManningN"); bedSlope_ = getParam("Problem.BedSlope"); discharge_ = getParam("Problem.Discharge"); diff --git a/test/freeflow/shallowwater/roughchannel/spatialparams.hh b/test/freeflow/shallowwater/roughchannel/spatialparams.hh index 87bea05d508e62ced47cb91866983ad7ec73fd8a..73864db30eb6e97521aa1ad5d5752db9528429e6 100644 --- a/test/freeflow/shallowwater/roughchannel/spatialparams.hh +++ b/test/freeflow/shallowwater/roughchannel/spatialparams.hh @@ -37,22 +37,22 @@ namespace Dumux { * \brief The spatial parameters class for the rough channel test. * */ -template +template class RoughChannelSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using ThisType = RoughChannelSpatialParams; - using ParentType = FVSpatialParams; - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using ThisType = RoughChannelSpatialParams; + using ParentType = FVSpatialParams; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: - RoughChannelSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + RoughChannelSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { gravity_ = getParam("Problem.Gravity"); bedSlope_ = getParam("Problem.BedSlope"); diff --git a/test/geomechanics/elastic/main.cc b/test/geomechanics/elastic/main.cc index 20d19c55dd37e45823832b023d2cde1cb279b159..f30d53280f337ff53cbdaaef4d094ebd7080c3a4 100644 --- a/test/geomechanics/elastic/main.cc +++ b/test/geomechanics/elastic/main.cc @@ -82,22 +82,22 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // intialize the vtk output module and add displacement @@ -105,9 +105,9 @@ int main(int argc, char** argv) try vtkWriter.addField(x, "u"); // also, add exact solution to the output - SolutionVector xExact(fvGridGeometry->numDofs()); + SolutionVector xExact(gridGeometry->numDofs()); for (const auto& v : vertices(leafGridView)) - xExact[ fvGridGeometry->vertexMapper().index(v) ] = problem->exactSolution(v.geometry().center()); + xExact[ gridGeometry->vertexMapper().index(v) ] = problem->exactSolution(v.geometry().center()); vtkWriter.addField(xExact, "u_exact"); // write initial solution @@ -115,11 +115,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables); // the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NewtonSolver; diff --git a/test/geomechanics/elastic/problem.hh b/test/geomechanics/elastic/problem.hh index cb73e24845d707c269c20738d829effafe7da90a..3a33fc0fc7a3651b7f11f45c5d52843463809631 100644 --- a/test/geomechanics/elastic/problem.hh +++ b/test/geomechanics/elastic/problem.hh @@ -77,10 +77,10 @@ class ElasticProblem : public GeomechanicsFVProblem using ElementVolumeVariables = typename GridVariables::GridVolumeVariables::LocalView; using ElementFluxVariablesCache = typename GridVariables::GridFluxVariablesCache::LocalView; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; using GridView = GetPropType; using Element = typename GridView::template Codim<0>::Entity; @@ -92,8 +92,8 @@ class ElasticProblem : public GeomechanicsFVProblem using GradU = Dune::FieldMatrix; public: - ElasticProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) {} + ElasticProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) {} //! Returns the temperature in the domain. static constexpr Scalar temperature() diff --git a/test/geomechanics/elastic/spatialparams.hh b/test/geomechanics/elastic/spatialparams.hh index edc588bf7fbe24cda26234cde318ad84da8a1b7a..c0f4b8104cac08134dceae434e715e2695047dd5 100644 --- a/test/geomechanics/elastic/spatialparams.hh +++ b/test/geomechanics/elastic/spatialparams.hh @@ -34,16 +34,16 @@ namespace Dumux { * \ingroup GeomechanicsTests * \brief Definition of the spatial parameters for the linear elasticity problem. */ -template +template class ElasticSpatialParams : public FVSpatialParamsElastic< Scalar, - FVGridGeometry, - ElasticSpatialParams > + GridGeometry, + ElasticSpatialParams > { - using ThisType = ElasticSpatialParams; - using ParentType = FVSpatialParamsElastic; + using ThisType = ElasticSpatialParams; + using ParentType = FVSpatialParamsElastic; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using GridView = typename FVGridGeometry::GridView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -51,8 +51,8 @@ public: //! Export the type of the lame parameters using LameParams = Dumux::LameParams; - ElasticSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + ElasticSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { lameParams_.setLambda(3e9); lameParams_.setMu(3e9); diff --git a/test/geomechanics/poroelastic/main.cc b/test/geomechanics/poroelastic/main.cc index f6f61d3990f05a3b7ee42d9aca03e6a6d0b07608..f1210550eb1f66cd515bb5d6a267af75a7655473 100644 --- a/test/geomechanics/poroelastic/main.cc +++ b/test/geomechanics/poroelastic/main.cc @@ -60,13 +60,13 @@ template< class StressType, void assembleElementStresses(SigmaStorage& sigmaStorage, SigmaStorage& effSigmaStorage, const Problem& problem, - const typename GridVariables::GridGeometry& fvGridGeometry, + const typename GridVariables::GridGeometry& gridGeometry, const GridVariables& gridVariables, const SolutionVector& x) { - for (const auto& element : elements(fvGridGeometry.gridView())) + for (const auto& element : elements(gridGeometry.gridView())) { - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); auto elemVolVars = localView(gridVariables.curGridVolVars()); fvGeometry.bind(element); @@ -82,10 +82,10 @@ void assembleElementStresses(SigmaStorage& sigmaStorage, const auto effSigma = StressType::effectiveStressTensor(problem, element, fvGeometry, elemVolVars, fluxVarsCache); // pass values into storage container - using FVGridGeometry = typename GridVariables::GridGeometry; - for (int dir = 0; dir < FVGridGeometry::GridView::dimension; ++dir) + using GridGeometry = typename GridVariables::GridGeometry; + for (int dir = 0; dir < GridGeometry::GridView::dimension; ++dir) { - const auto eIdx = fvGridGeometry.elementMapper().index(element); + const auto eIdx = gridGeometry.elementMapper().index(element); sigmaStorage[dir][eIdx] = sigma[dir]; effSigmaStorage[dir][eIdx] = effSigma[dir]; } @@ -125,22 +125,22 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // intialize the vtk output module and output fields @@ -150,14 +150,14 @@ int main(int argc, char** argv) try IOFields::initOutputModule(vtkWriter); // also, add exact solution to the output - SolutionVector xExact(fvGridGeometry->numDofs()); + SolutionVector xExact(gridGeometry->numDofs()); for (const auto& v : vertices(leafGridView)) - xExact[ fvGridGeometry->vertexMapper().index(v) ] = problem->exactSolution(v.geometry().center()); + xExact[ gridGeometry->vertexMapper().index(v) ] = problem->exactSolution(v.geometry().center()); vtkWriter.addField(xExact, "u_exact"); // Furthermore, write out element stress tensors - static constexpr int dim = FVGridGeometry::GridView::dimension; - static constexpr int dimWorld = FVGridGeometry::GridView::dimensionworld; + static constexpr int dim = GridGeometry::GridView::dimension; + static constexpr int dimWorld = GridGeometry::GridView::dimensionworld; using Scalar = GetPropType; using ForceVector = Dune::FieldVector< Scalar, dimWorld >; @@ -165,7 +165,7 @@ int main(int argc, char** argv) try std::array< std::vector, dim > sigmaStorage; std::array< std::vector, dim > effSigmaStorage; - const auto numCells = fvGridGeometry->gridView().size(0); + const auto numCells = gridGeometry->gridView().size(0); std::for_each(sigmaStorage.begin(), sigmaStorage.end(), [numCells] (auto& sigma) { sigma.resize(numCells); }); std::for_each(effSigmaStorage.begin(), effSigmaStorage.end(), [numCells] (auto& effSigma) { effSigma.resize(numCells); }); @@ -177,18 +177,18 @@ int main(int argc, char** argv) try // use convenience function to compute stresses using StressType = GetPropType; - assembleElementStresses(sigmaStorage, effSigmaStorage, *problem, *fvGridGeometry, *gridVariables, x); + assembleElementStresses(sigmaStorage, effSigmaStorage, *problem, *gridGeometry, *gridVariables, x); // write initial solution vtkWriter.write(0.0); // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables); // the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NewtonSolver; @@ -201,7 +201,7 @@ int main(int argc, char** argv) try gridVariables->update(x); // write vtk output - assembleElementStresses(sigmaStorage, effSigmaStorage, *problem, *fvGridGeometry, *gridVariables, x); + assembleElementStresses(sigmaStorage, effSigmaStorage, *problem, *gridGeometry, *gridVariables, x); vtkWriter.write(1.0); // print time and say goodbye diff --git a/test/geomechanics/poroelastic/problem.hh b/test/geomechanics/poroelastic/problem.hh index fffb217f911f8100c6764b21c36a73908184e7c5..350491a600ec33c48b10a4ccf078e9351516633f 100644 --- a/test/geomechanics/poroelastic/problem.hh +++ b/test/geomechanics/poroelastic/problem.hh @@ -85,10 +85,10 @@ class PoroElasticProblem : public GeomechanicsFVProblem using NumEqVector = GetPropType; using ElementVolumeVariables = typename GetPropType::LocalView; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; using GridView = GetPropType; using Element = typename GridView::template Codim<0>::Entity; @@ -100,8 +100,8 @@ class PoroElasticProblem : public GeomechanicsFVProblem using GradU = Dune::FieldMatrix; public: - PoroElasticProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + PoroElasticProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) {} //! Returns the temperature in the domain. diff --git a/test/geomechanics/poroelastic/spatialparams.hh b/test/geomechanics/poroelastic/spatialparams.hh index 4cb6a97b3048d0a66a0c0d997947062a5688de91..dbfb9541b517ae5fa76955c55f8507210f55436b 100644 --- a/test/geomechanics/poroelastic/spatialparams.hh +++ b/test/geomechanics/poroelastic/spatialparams.hh @@ -35,16 +35,16 @@ namespace Dumux { * \ingroup GeomechanicsTests * \brief Definition of the spatial parameters for the poro-elastic problem. */ -template +template class PoroElasticSpatialParams : public FVSpatialParamsPoroElastic< Scalar, - FVGridGeometry, - PoroElasticSpatialParams > + GridGeometry, + PoroElasticSpatialParams > { - using ThisType = PoroElasticSpatialParams; - using ParentType = FVSpatialParamsPoroElastic; + using ThisType = PoroElasticSpatialParams; + using ParentType = FVSpatialParamsPoroElastic; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using GridView = typename FVGridGeometry::GridView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -52,8 +52,8 @@ public: //! Export the type of the lame parameters using LameParams = Dumux::LameParams; - PoroElasticSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + PoroElasticSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { lameParams_.setLambda(2); lameParams_.setMu(2); diff --git a/test/io/gridmanager/gmshboundaryflagtest.hh b/test/io/gridmanager/gmshboundaryflagtest.hh index 6d73c3d35cbe8ce83b560c65c01fe64161a6ba96..4d242a469b410877ecdb5f6fd51d02a9b0327dc1 100644 --- a/test/io/gridmanager/gmshboundaryflagtest.hh +++ b/test/io/gridmanager/gmshboundaryflagtest.hh @@ -44,15 +44,15 @@ class GmshBoundaryFlagTest public: - template + template static void testGmshBoundaryFlag(const GridView& leafGridView, - std::shared_ptr fvGridGeometry, + std::shared_ptr gridGeometry, std::shared_ptr> gridData) { for(const auto& element : elements(leafGridView)) { - auto fvGeometry = localView(*fvGridGeometry); + auto fvGeometry = localView(*gridGeometry); fvGeometry.bind(element); for (auto&& scvf : scvfs(fvGeometry)) diff --git a/test/io/vtk/test_vtk_staggeredfreeflowpvnames.cc b/test/io/vtk/test_vtk_staggeredfreeflowpvnames.cc index f02538e0a4bb06823c2009f52b3932dbb3c6910b..58ab07b2be37ac5704c79ab2ed1381a939b30a71 100644 --- a/test/io/vtk/test_vtk_staggeredfreeflowpvnames.cc +++ b/test/io/vtk/test_vtk_staggeredfreeflowpvnames.cc @@ -188,8 +188,8 @@ void assignValues(SolutionVector& sol, Values values) } } -template -void testWriteAndReadVtk(std::shared_ptr fvGridGeometry, +template +void testWriteAndReadVtk(std::shared_ptr gridGeometry, const std::array, numValues>& values, const std::string& fileName, bool verbose = false, @@ -201,24 +201,24 @@ void testWriteAndReadVtk(std::shared_ptr fvGridGeometry, using SolutionVector = GetPropType; SolutionVector writeFrom; - writeFrom[FVGridGeometry::cellCenterIdx()].resize(fvGridGeometry->numCellCenterDofs()); - writeFrom[FVGridGeometry::faceIdx()].resize(fvGridGeometry->numFaceDofs()); + writeFrom[GridGeometry::cellCenterIdx()].resize(gridGeometry->numCellCenterDofs()); + writeFrom[GridGeometry::faceIdx()].resize(gridGeometry->numFaceDofs()); SolutionVector readTo = writeFrom; // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); - assignValues(writeFrom[FVGridGeometry::cellCenterIdx()], values); - assignValues(writeFrom[FVGridGeometry::faceIdx()], std::array, 1>{1.0}); + assignValues(writeFrom[GridGeometry::cellCenterIdx()], values); + assignValues(writeFrom[GridGeometry::faceIdx()], std::array, 1>{1.0}); problem->updateStaticWallProperties(); problem->updateDynamicWallProperties(writeFrom); // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(writeFrom); // initialize the vtk output module @@ -235,47 +235,47 @@ void testWriteAndReadVtk(std::shared_ptr fvGridGeometry, using FacePrimaryVariables = GetPropType; // cc dofs - loadSolution(readTo[FVGridGeometry::cellCenterIdx()], fileName + "-00000.vtu", + loadSolution(readTo[GridGeometry::cellCenterIdx()], fileName + "-00000.vtu", createCellCenterPVNameFunction(), - *fvGridGeometry); + *gridGeometry); if (verbose) { std::cout << "reference cc " << std::endl; - for (const auto& block : writeFrom[FVGridGeometry::cellCenterIdx()]) + for (const auto& block : writeFrom[GridGeometry::cellCenterIdx()]) std::cout << block << std::endl; std::cout << "result cc " << std::endl; - for (const auto& block : readTo[FVGridGeometry::cellCenterIdx()]) + for (const auto& block : readTo[GridGeometry::cellCenterIdx()]) std::cout << block << std::endl; } - for (int i = 0; i < readTo[FVGridGeometry::cellCenterIdx()].size(); ++i) + for (int i = 0; i < readTo[GridGeometry::cellCenterIdx()].size(); ++i) { - if (Dune::FloatCmp::ne(readTo[FVGridGeometry::cellCenterIdx()][i], writeFrom[FVGridGeometry::cellCenterIdx()][i])) - DUNE_THROW(Dune::IOError, "Values don't match: new " << readTo[FVGridGeometry::cellCenterIdx()][i] << ", old " << writeFrom[FVGridGeometry::cellCenterIdx()][i]); + if (Dune::FloatCmp::ne(readTo[GridGeometry::cellCenterIdx()][i], writeFrom[GridGeometry::cellCenterIdx()][i])) + DUNE_THROW(Dune::IOError, "Values don't match: new " << readTo[GridGeometry::cellCenterIdx()][i] << ", old " << writeFrom[GridGeometry::cellCenterIdx()][i]); } // face dofs - loadSolution(readTo[FVGridGeometry::faceIdx()], fileName + "-face-00000.vtp", + loadSolution(readTo[GridGeometry::faceIdx()], fileName + "-face-00000.vtp", createFacePVNameFunction(), - *fvGridGeometry); + *gridGeometry); if (verbose) { std::cout << "reference face " << std::endl; - for (const auto& block : writeFrom[FVGridGeometry::faceIdx()]) + for (const auto& block : writeFrom[GridGeometry::faceIdx()]) std::cout << block << std::endl; std::cout << "result face " << std::endl; - for (const auto& block : readTo[FVGridGeometry::faceIdx()]) + for (const auto& block : readTo[GridGeometry::faceIdx()]) std::cout << block << std::endl; } - for (int i = 0; i < readTo[FVGridGeometry::faceIdx()].size(); ++i) + for (int i = 0; i < readTo[GridGeometry::faceIdx()].size(); ++i) { - if (Dune::FloatCmp::ne(readTo[FVGridGeometry::faceIdx()][i], writeFrom[FVGridGeometry::faceIdx()][i])) - DUNE_THROW(Dune::IOError, "Values don't match: new " << readTo[FVGridGeometry::faceIdx()][i] << ", old " << writeFrom[FVGridGeometry::faceIdx()][i]); + if (Dune::FloatCmp::ne(readTo[GridGeometry::faceIdx()][i], writeFrom[GridGeometry::faceIdx()][i])) + DUNE_THROW(Dune::IOError, "Values don't match: new " << readTo[GridGeometry::faceIdx()][i] << ", old " << writeFrom[GridGeometry::faceIdx()][i]); } // clean up the folder @@ -313,7 +313,7 @@ int main(int argc, char** argv) try using CommonTypeTag = Properties::TTag::StaggeredPVNamesTestTypeTag; using Grid = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; using GlobalPosition = Dune::FieldVector; @@ -324,41 +324,41 @@ int main(int argc, char** argv) try const auto grid = Dune::StructuredGridFactory::createCubeGrid(lowerLeft, upperRight, cells); const auto gridView = grid->leafGridView(); - auto fvGridGeometry = std::make_shared(gridView); - fvGridGeometry->update(); + auto gridGeometry = std::make_shared(gridView); + gridGeometry->update(); using FluidSystem = GetPropType; FluidSystem::init(); - testWriteAndReadVtk(fvGridGeometry, std::array{1e5}, "navierstokes"); - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 300.0}, "navierstokesni"); - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 1e-3}, "navierstokesnc"); - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 1e-3, 300.0}, "navierstokesncni"); - - testWriteAndReadVtk(fvGridGeometry, std::array{1e5}, "zeroeq"); - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 300.0}, "zeroeqni"); - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 1e-3}, "zeroeqnc"); - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 1e-3, 300.0}, "zeroeqncni"); - - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 1.0}, "oneeq"); - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 1.0, 300.0}, "oneeqni"); - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 1e-3, 1.0}, "oneeqnc"); - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 1e-3, 1.0, 300.0}, "oneeqncni"); - - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 1.1, 1.2}, "kepsilon"); - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 1.1, 1.2, 300.0}, "kepsilonni"); - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 1e-3, 1.1, 1.2}, "kepsilonnc"); - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 1e-3, 1.1, 1.2, 300.0}, "kepsilonncni"); - - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 1.1, 1.2}, "lowrekepsilon"); - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 1.1, 1.2, 300.0}, "lowrekepsilonni"); - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 1e-3, 1.1, 1.2}, "lowrekepsilonnc"); - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 1e-3, 1.1, 1.2, 300.0}, "lowrekepsilonncni"); - - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 1.1, 1.2}, "komega"); - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 1.1, 1.2, 300.0}, "komegani"); - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 1e-3, 1.1, 1.2}, "komeganc"); - testWriteAndReadVtk(fvGridGeometry, std::array{1e5, 1e-3, 1.1, 1.2, 300.0}, "komegancni"); + testWriteAndReadVtk(gridGeometry, std::array{1e5}, "navierstokes"); + testWriteAndReadVtk(gridGeometry, std::array{1e5, 300.0}, "navierstokesni"); + testWriteAndReadVtk(gridGeometry, std::array{1e5, 1e-3}, "navierstokesnc"); + testWriteAndReadVtk(gridGeometry, std::array{1e5, 1e-3, 300.0}, "navierstokesncni"); + + testWriteAndReadVtk(gridGeometry, std::array{1e5}, "zeroeq"); + testWriteAndReadVtk(gridGeometry, std::array{1e5, 300.0}, "zeroeqni"); + testWriteAndReadVtk(gridGeometry, std::array{1e5, 1e-3}, "zeroeqnc"); + testWriteAndReadVtk(gridGeometry, std::array{1e5, 1e-3, 300.0}, "zeroeqncni"); + + testWriteAndReadVtk(gridGeometry, std::array{1e5, 1.0}, "oneeq"); + testWriteAndReadVtk(gridGeometry, std::array{1e5, 1.0, 300.0}, "oneeqni"); + testWriteAndReadVtk(gridGeometry, std::array{1e5, 1e-3, 1.0}, "oneeqnc"); + testWriteAndReadVtk(gridGeometry, std::array{1e5, 1e-3, 1.0, 300.0}, "oneeqncni"); + + testWriteAndReadVtk(gridGeometry, std::array{1e5, 1.1, 1.2}, "kepsilon"); + testWriteAndReadVtk(gridGeometry, std::array{1e5, 1.1, 1.2, 300.0}, "kepsilonni"); + testWriteAndReadVtk(gridGeometry, std::array{1e5, 1e-3, 1.1, 1.2}, "kepsilonnc"); + testWriteAndReadVtk(gridGeometry, std::array{1e5, 1e-3, 1.1, 1.2, 300.0}, "kepsilonncni"); + + testWriteAndReadVtk(gridGeometry, std::array{1e5, 1.1, 1.2}, "lowrekepsilon"); + testWriteAndReadVtk(gridGeometry, std::array{1e5, 1.1, 1.2, 300.0}, "lowrekepsilonni"); + testWriteAndReadVtk(gridGeometry, std::array{1e5, 1e-3, 1.1, 1.2}, "lowrekepsilonnc"); + testWriteAndReadVtk(gridGeometry, std::array{1e5, 1e-3, 1.1, 1.2, 300.0}, "lowrekepsilonncni"); + + testWriteAndReadVtk(gridGeometry, std::array{1e5, 1.1, 1.2}, "komega"); + testWriteAndReadVtk(gridGeometry, std::array{1e5, 1.1, 1.2, 300.0}, "komegani"); + testWriteAndReadVtk(gridGeometry, std::array{1e5, 1e-3, 1.1, 1.2}, "komeganc"); + testWriteAndReadVtk(gridGeometry, std::array{1e5, 1e-3, 1.1, 1.2, 300.0}, "komegancni"); //////////////////////////////////////////////////////////// // finalize, print dumux message to say goodbye diff --git a/test/multidomain/boundary/darcydarcy/1p_1p/main.cc b/test/multidomain/boundary/darcydarcy/1p_1p/main.cc index cf2743a37495587a83916d1fdab79ce0d946bbd4..5457baed25980ab6c313dc4c2b37f51b7e30cea4 100644 --- a/test/multidomain/boundary/darcydarcy/1p_1p/main.cc +++ b/test/multidomain/boundary/darcydarcy/1p_1p/main.cc @@ -188,9 +188,9 @@ int main(int argc, char** argv) try //////////////////////////////////////////////// // create the finite volume grid geometries - using FVGridGeometry = GetPropType; - auto fvGridGeometry0 = std::make_shared(gridView0); - auto fvGridGeometry1 = std::make_shared(gridView1); + using GridGeometry = GetPropType; + auto fvGridGeometry0 = std::make_shared(gridView0); + auto fvGridGeometry1 = std::make_shared(gridView1); fvGridGeometry0->update(); fvGridGeometry1->update(); @@ -299,8 +299,8 @@ int main(int argc, char** argv) try ////////////////////////////////////////////////////////////////////////// const auto& gridView = gridManager.grid().leafGridView(); - CCTpfaFVGridGeometry fvGridGeometry(gridView); - const auto& bBoxTree = fvGridGeometry.boundingBoxTree(); + CCTpfaFVGridGeometry gridGeometry(gridView); + const auto& bBoxTree = gridGeometry.boundingBoxTree(); // copy data from the subdomains to full domain data vectors std::vector processRank(gridView.size(0), 0); // sequential simulation std::vector pressure(gridView.size(0)); diff --git a/test/multidomain/boundary/darcydarcy/1p_1p/problem.hh b/test/multidomain/boundary/darcydarcy/1p_1p/problem.hh index 274d6eeacfdfed90a2d53862406ac82f46046a7e..287f1b1940a897d7cf288c9fb78d1fead1b956d2 100644 --- a/test/multidomain/boundary/darcydarcy/1p_1p/problem.hh +++ b/test/multidomain/boundary/darcydarcy/1p_1p/problem.hh @@ -45,10 +45,10 @@ class OnePTestProblem { using ParentType = PorousMediumFlowProblem; using CouplingManager = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using Scalar = GetPropType; using PrimaryVariables = GetPropType; @@ -60,10 +60,10 @@ class OnePTestProblem static constexpr auto domainIdx = Dune::index_constant{}; public: - OnePTestProblem(std::shared_ptr fvGridGeometry, + OnePTestProblem(std::shared_ptr gridGeometry, std::shared_ptr couplingManager, const std::string& paramGroup = "") - : ParentType(fvGridGeometry, paramGroup) + : ParentType(gridGeometry, paramGroup) , couplingManager_(couplingManager) { // set a default name for the problem diff --git a/test/multidomain/boundary/darcydarcy/1p_1p/spatialparams.hh b/test/multidomain/boundary/darcydarcy/1p_1p/spatialparams.hh index 145c91f6811ca5242c4442604b1b7b50f54ac6b2..67abf4af09a9af85dba413899afec931bd393b32 100644 --- a/test/multidomain/boundary/darcydarcy/1p_1p/spatialparams.hh +++ b/test/multidomain/boundary/darcydarcy/1p_1p/spatialparams.hh @@ -56,15 +56,15 @@ bool pointInLens(const GlobalPosition& globalPos, * \brief The spatial parameters class for the test problem using the * incompressible 1p model. */ -template +template class OnePTestSpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using ThisType = OnePTestSpatialParams; - using ParentType = FVSpatialParamsOneP; - using GridView = typename FVGridGeometry::GridView; + using ThisType = OnePTestSpatialParams; + using ParentType = FVSpatialParamsOneP; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; static constexpr int dimWorld = GridView::dimensionworld; @@ -72,8 +72,8 @@ class OnePTestSpatialParams public: using PermeabilityType = Scalar; - OnePTestSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + OnePTestSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) , lensLowerLeft_(std::numeric_limits::max()) , lensUpperRight_(std::numeric_limits::lowest()) { diff --git a/test/multidomain/boundary/darcydarcy/1p_2p/main.cc b/test/multidomain/boundary/darcydarcy/1p_2p/main.cc index 536ebcadc46b3d35015ac2a6d60794053d1a9bd1..2abb60e76ca6255f4970b19ec9f18c4c27d10641 100644 --- a/test/multidomain/boundary/darcydarcy/1p_2p/main.cc +++ b/test/multidomain/boundary/darcydarcy/1p_2p/main.cc @@ -174,9 +174,9 @@ int main(int argc, char** argv) try //////////////////////////////////////////////// // create the finite volume grid geometries - using FVGridGeometry = GetPropType; - auto fvGridGeometry0 = std::make_shared(gridView0); - auto fvGridGeometry1 = std::make_shared(gridView1); + using GridGeometry = GetPropType; + auto fvGridGeometry0 = std::make_shared(gridView0); + auto fvGridGeometry1 = std::make_shared(gridView1); fvGridGeometry0->update(); fvGridGeometry1->update(); diff --git a/test/multidomain/boundary/darcydarcy/1p_2p/problem.hh b/test/multidomain/boundary/darcydarcy/1p_2p/problem.hh index addcb649a3d2a09fe102103bebb578555c21821a..90a006399060c74d3dd831486af7592c1725cfde 100644 --- a/test/multidomain/boundary/darcydarcy/1p_2p/problem.hh +++ b/test/multidomain/boundary/darcydarcy/1p_2p/problem.hh @@ -46,10 +46,10 @@ class OnePTestProblem { using ParentType = PorousMediumFlowProblem; using CouplingManager = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using Scalar = GetPropType; using PrimaryVariables = GetPropType; @@ -62,10 +62,10 @@ class OnePTestProblem static constexpr auto domainIdx = Dune::index_constant{}; public: - OnePTestProblem(std::shared_ptr fvGridGeometry, + OnePTestProblem(std::shared_ptr gridGeometry, std::shared_ptr couplingManager, const std::string& paramGroup = "") - : ParentType(fvGridGeometry, paramGroup) + : ParentType(gridGeometry, paramGroup) , couplingManager_(couplingManager) { injectionRate_ = getParam("Problem.InjectionRate"); diff --git a/test/multidomain/boundary/darcydarcy/1p_2p/spatialparams.hh b/test/multidomain/boundary/darcydarcy/1p_2p/spatialparams.hh index e9a06ed4d6e4d463113b3437b7dd4251f1ec35d2..7cf67002da5f86550b4570bf17f6afdd07a5316a 100644 --- a/test/multidomain/boundary/darcydarcy/1p_2p/spatialparams.hh +++ b/test/multidomain/boundary/darcydarcy/1p_2p/spatialparams.hh @@ -36,15 +36,15 @@ namespace Dumux { * \brief The spatial parameters class for the test problem using the * incompressible 1p model. */ -template +template class TestSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using ThisType = TestSpatialParams; - using ParentType = FVSpatialParams; - using GridView = typename FVGridGeometry::GridView; + using ThisType = TestSpatialParams; + using ParentType = FVSpatialParams; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; static constexpr int dimWorld = GridView::dimensionworld; @@ -56,8 +56,8 @@ public: using PermeabilityType = Scalar; - TestSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + TestSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { materialParams_.setSwr(0.05); materialParams_.setSnr(0.0); diff --git a/test/multidomain/boundary/stokesdarcy/1p2c_1p2c/diffusionlawcomparison/problem_darcy.hh b/test/multidomain/boundary/stokesdarcy/1p2c_1p2c/diffusionlawcomparison/problem_darcy.hh index d236c9a2e0e243f474e2a063beb7a7b4a22d347f..16415514d1f5987f5f246bf831dd802e8b1ab315 100644 --- a/test/multidomain/boundary/stokesdarcy/1p2c_1p2c/diffusionlawcomparison/problem_darcy.hh +++ b/test/multidomain/boundary/stokesdarcy/1p2c_1p2c/diffusionlawcomparison/problem_darcy.hh @@ -95,9 +95,9 @@ struct MolecularDiffusionType { using type = DIFFU template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePSpatialParams; + using type = OnePSpatialParams; }; } // end namespace Properties @@ -114,7 +114,7 @@ class DarcySubProblem : public PorousMediumFlowProblem using FVElementGeometry = typename GetPropType::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using DiffusionCoefficientAveragingType = typename StokesDarcyCouplingOptions::DiffusionCoefficientAveragingType; // copy some indices for convenience @@ -135,9 +135,9 @@ class DarcySubProblem : public PorousMediumFlowProblem using CouplingManager = GetPropType; public: - DarcySubProblem(std::shared_ptr fvGridGeometry, + DarcySubProblem(std::shared_ptr gridGeometry, std::shared_ptr couplingManager) - : ParentType(fvGridGeometry, "Darcy"), eps_(1e-7), couplingManager_(couplingManager) + : ParentType(gridGeometry, "Darcy"), eps_(1e-7), couplingManager_(couplingManager) { pressure_ = getParamFromGroup(this->paramGroup(), "Problem.Pressure"); initialMoleFraction_ = getParamFromGroup(this->paramGroup(), "Problem.InitialMoleFraction"); diff --git a/test/multidomain/boundary/stokesdarcy/1p2c_1p2c/diffusionlawcomparison/problem_stokes.hh b/test/multidomain/boundary/stokesdarcy/1p2c_1p2c/diffusionlawcomparison/problem_stokes.hh index e0d55c6cb9c44344fcbda9613d365e1ead7c285f..bc60c5b72b6cbfbcb43f85c1aec84b4532a9299c 100644 --- a/test/multidomain/boundary/stokesdarcy/1p2c_1p2c/diffusionlawcomparison/problem_stokes.hh +++ b/test/multidomain/boundary/stokesdarcy/1p2c_1p2c/diffusionlawcomparison/problem_stokes.hh @@ -109,8 +109,8 @@ class StokesSubProblem : public NavierStokesProblem using Indices = typename GetPropType::Indices; using FluidSystem = GetPropType; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using PrimaryVariables = GetPropType; using NumEqVector = GetPropType; @@ -122,8 +122,8 @@ class StokesSubProblem : public NavierStokesProblem using DiffusionCoefficientAveragingType = typename StokesDarcyCouplingOptions::DiffusionCoefficientAveragingType; public: - StokesSubProblem(std::shared_ptr fvGridGeometry, std::shared_ptr couplingManager) - : ParentType(fvGridGeometry, "Stokes"), eps_(1e-6), injectionState_(false), couplingManager_(couplingManager) + StokesSubProblem(std::shared_ptr gridGeometry, std::shared_ptr couplingManager) + : ParentType(gridGeometry, "Stokes"), eps_(1e-6), injectionState_(false), couplingManager_(couplingManager) { inletVelocity_ = getParamFromGroup(this->paramGroup(), "Problem.Velocity"); pressure_ = getParamFromGroup(this->paramGroup(), "Problem.Pressure"); diff --git a/test/multidomain/boundary/stokesdarcy/1p2c_1p2c/problem_darcy.hh b/test/multidomain/boundary/stokesdarcy/1p2c_1p2c/problem_darcy.hh index b53c628daff989b3bcdf4a07b5f407165dfdd041..f536c2dbf1495e735a316c97e2ba28185e66297b 100644 --- a/test/multidomain/boundary/stokesdarcy/1p2c_1p2c/problem_darcy.hh +++ b/test/multidomain/boundary/stokesdarcy/1p2c_1p2c/problem_darcy.hh @@ -82,9 +82,9 @@ struct Grid { using type = Dune::YaspGrid<2>; }; template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePSpatialParams; + using type = OnePSpatialParams; }; } // end namespace Dumux @@ -92,8 +92,8 @@ template class DarcySubProblem : public PorousMediumFlowProblem { using ParentType = PorousMediumFlowProblem; - using FVGridGeometry = GetPropType; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = GetPropType; + using GridView = typename GridGeometry::GridView; using Scalar = GetPropType; using PrimaryVariables = GetPropType; using NumEqVector = GetPropType; @@ -110,9 +110,9 @@ class DarcySubProblem : public PorousMediumFlowProblem using TimeLoopPtr = std::shared_ptr>; public: - DarcySubProblem(std::shared_ptr fvGridGeometry, + DarcySubProblem(std::shared_ptr gridGeometry, std::shared_ptr couplingManager) - : ParentType(fvGridGeometry, "Darcy"), eps_(1e-7), couplingManager_(couplingManager) + : ParentType(gridGeometry, "Darcy"), eps_(1e-7), couplingManager_(couplingManager) { problemName_ = getParam("Vtk.OutputName") + "_" + getParamFromGroup(this->paramGroup(), "Problem.Name"); diff --git a/test/multidomain/boundary/stokesdarcy/1p2c_1p2c/problem_stokes.hh b/test/multidomain/boundary/stokesdarcy/1p2c_1p2c/problem_stokes.hh index ec8a1242f2e877e05f89061309dde98902e85201..2b82b15921bca10d6403b0e4d2b098744af98c36 100644 --- a/test/multidomain/boundary/stokesdarcy/1p2c_1p2c/problem_stokes.hh +++ b/test/multidomain/boundary/stokesdarcy/1p2c_1p2c/problem_stokes.hh @@ -91,8 +91,8 @@ class StokesSubProblem : public NavierStokesProblem using Scalar = GetPropType; using Indices = typename GetPropType::Indices; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using PrimaryVariables = GetPropType; using NumEqVector = GetPropType; @@ -104,8 +104,8 @@ class StokesSubProblem : public NavierStokesProblem using TimeLoopPtr = std::shared_ptr>; public: - StokesSubProblem(std::shared_ptr fvGridGeometry, std::shared_ptr couplingManager) - : ParentType(fvGridGeometry, "Stokes"), eps_(1e-6), couplingManager_(couplingManager) + StokesSubProblem(std::shared_ptr gridGeometry, std::shared_ptr couplingManager) + : ParentType(gridGeometry, "Stokes"), eps_(1e-6), couplingManager_(couplingManager) { problemName_ = getParam("Vtk.OutputName") + "_" + getParamFromGroup(this->paramGroup(), "Problem.Name"); diff --git a/test/multidomain/boundary/stokesdarcy/1p2c_1p2c/spatialparams.hh b/test/multidomain/boundary/stokesdarcy/1p2c_1p2c/spatialparams.hh index b4bcd82c16c42e70469b5ede17a5d9085069fd7d..71c0b03c0987f7bb201f46a81c6e1e34f29a64d0 100644 --- a/test/multidomain/boundary/stokesdarcy/1p2c_1p2c/spatialparams.hh +++ b/test/multidomain/boundary/stokesdarcy/1p2c_1p2c/spatialparams.hh @@ -34,14 +34,14 @@ namespace Dumux { * \brief The spatial parameters class for the test problem using the * 1p cc model. */ -template +template class OnePSpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using GridView = typename FVGridGeometry::GridView; - using ParentType = FVSpatialParamsOneP>; + using GridView = typename GridGeometry::GridView; + using ParentType = FVSpatialParamsOneP>; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -50,8 +50,8 @@ public: // export permeability type using PermeabilityType = Scalar; - OnePSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + OnePSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { permeability_ = getParam("SpatialParams.Permeability"); porosity_ = getParam("SpatialParams.Porosity"); diff --git a/test/multidomain/boundary/stokesdarcy/1p2c_2p2c/problem_darcy.hh b/test/multidomain/boundary/stokesdarcy/1p2c_2p2c/problem_darcy.hh index c618dd09d96aacf06133dd6b4309799bd2d96729..9b33da50be89c7a5fe7340fe5d7205b1e1cf985d 100644 --- a/test/multidomain/boundary/stokesdarcy/1p2c_2p2c/problem_darcy.hh +++ b/test/multidomain/boundary/stokesdarcy/1p2c_2p2c/problem_darcy.hh @@ -78,9 +78,9 @@ struct UseMoles { static constexpr bool value = tr template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = TwoPTwoCSpatialParams; + using type = TwoPTwoCSpatialParams; }; } // end namespace Properties @@ -98,7 +98,7 @@ class DarcySubProblem : public PorousMediumFlowProblem using FVElementGeometry = typename GetPropType::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using GridVariables = GetPropType; using ElementVolumeVariables = typename GridVariables::GridVolumeVariables::LocalView; using ElementFluxVariablesCache = typename GridVariables::GridFluxVariablesCache::LocalView; @@ -124,9 +124,9 @@ class DarcySubProblem : public PorousMediumFlowProblem using DiffusionCoefficientAveragingType = typename StokesDarcyCouplingOptions::DiffusionCoefficientAveragingType; public: - DarcySubProblem(std::shared_ptr fvGridGeometry, + DarcySubProblem(std::shared_ptr gridGeometry, std::shared_ptr couplingManager) - : ParentType(fvGridGeometry, "Darcy"), eps_(1e-7), couplingManager_(couplingManager) + : ParentType(gridGeometry, "Darcy"), eps_(1e-7), couplingManager_(couplingManager) { pressure_ = getParamFromGroup(this->paramGroup(), "Problem.Pressure"); initialSw_ = getParamFromGroup(this->paramGroup(), "Problem.Saturation"); diff --git a/test/multidomain/boundary/stokesdarcy/1p2c_2p2c/problem_stokes.hh b/test/multidomain/boundary/stokesdarcy/1p2c_2p2c/problem_stokes.hh index 4432b6710316a749c8e601bfca9f4d053bb59074..462476374aae947c401f2a1e83b67ffe4d118de8 100644 --- a/test/multidomain/boundary/stokesdarcy/1p2c_2p2c/problem_stokes.hh +++ b/test/multidomain/boundary/stokesdarcy/1p2c_2p2c/problem_stokes.hh @@ -99,8 +99,8 @@ class StokesSubProblem : public NavierStokesProblem using Indices = typename GetPropType::Indices; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using Element = typename GridView::template Codim<0>::Entity; using ElementVolumeVariables = typename GetPropType::LocalView; @@ -120,8 +120,8 @@ class StokesSubProblem : public NavierStokesProblem static constexpr bool useMoles = GetPropType::useMoles(); public: - StokesSubProblem(std::shared_ptr fvGridGeometry, std::shared_ptr couplingManager) - : ParentType(fvGridGeometry, "Stokes"), eps_(1e-6), couplingManager_(couplingManager) + StokesSubProblem(std::shared_ptr gridGeometry, std::shared_ptr couplingManager) + : ParentType(gridGeometry, "Stokes"), eps_(1e-6), couplingManager_(couplingManager) { refVelocity_ = getParamFromGroup(this->paramGroup(), "Problem.RefVelocity"); refPressure_ = getParamFromGroup(this->paramGroup(), "Problem.RefPressure"); diff --git a/test/multidomain/boundary/stokesdarcy/1p2c_2p2c/spatialparams.hh b/test/multidomain/boundary/stokesdarcy/1p2c_2p2c/spatialparams.hh index bd537c15089e851f99350de5cd48afb1b0e801cb..670788f6dc9b4986c833668b64ba7de450aafb91 100644 --- a/test/multidomain/boundary/stokesdarcy/1p2c_2p2c/spatialparams.hh +++ b/test/multidomain/boundary/stokesdarcy/1p2c_2p2c/spatialparams.hh @@ -38,15 +38,15 @@ namespace Dumux * \brief The spatial parameters class for the test problem using the * 1p cc model. */ -template +template class TwoPTwoCSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; - using ParentType = FVSpatialParams>; + using ParentType = FVSpatialParams>; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; using EffectiveLaw = RegularizedVanGenuchten; @@ -56,8 +56,8 @@ public: using MaterialLawParams = typename MaterialLaw::Params; using PermeabilityType = Scalar; - TwoPTwoCSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + TwoPTwoCSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { permeability_ = getParam("SpatialParams.Permeability"); porosity_ = getParam("SpatialParams.Porosity"); diff --git a/test/multidomain/boundary/stokesdarcy/1p3c_1p3c/problem_darcy.hh b/test/multidomain/boundary/stokesdarcy/1p3c_1p3c/problem_darcy.hh index f2ee08a05f581aa695852ee32f9714adba64d40a..9fdb6227b7f9fc673b15fcb1946d6181b748f14f 100644 --- a/test/multidomain/boundary/stokesdarcy/1p3c_1p3c/problem_darcy.hh +++ b/test/multidomain/boundary/stokesdarcy/1p3c_1p3c/problem_darcy.hh @@ -85,9 +85,9 @@ struct MolecularDiffusionType { using type = Max template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePSpatialParams; + using type = OnePSpatialParams; }; } // end namespace Properties @@ -105,7 +105,7 @@ class DarcySubProblem : public PorousMediumFlowProblem using FVElementGeometry = typename GetPropType::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using DiffusionCoefficientAveragingType = typename StokesDarcyCouplingOptions::DiffusionCoefficientAveragingType; // copy some indices for convenience @@ -126,9 +126,9 @@ class DarcySubProblem : public PorousMediumFlowProblem using CouplingManager = GetPropType; public: - DarcySubProblem(std::shared_ptr fvGridGeometry, + DarcySubProblem(std::shared_ptr gridGeometry, std::shared_ptr couplingManager) - : ParentType(fvGridGeometry, "Darcy"), eps_(1e-7), couplingManager_(couplingManager) + : ParentType(gridGeometry, "Darcy"), eps_(1e-7), couplingManager_(couplingManager) { pressure_ = getParamFromGroup(this->paramGroup(), "Problem.Pressure"); initialMoleFractionN2_ = getParamFromGroup(this->paramGroup(), "Problem.InitialMoleFractionN2"); diff --git a/test/multidomain/boundary/stokesdarcy/1p3c_1p3c/problem_stokes.hh b/test/multidomain/boundary/stokesdarcy/1p3c_1p3c/problem_stokes.hh index c6918e3ce030572ef28cbf53ba2305bf1c6e381e..72d391174baeb6b92b632ffc94b1022fb7fec449 100644 --- a/test/multidomain/boundary/stokesdarcy/1p3c_1p3c/problem_stokes.hh +++ b/test/multidomain/boundary/stokesdarcy/1p3c_1p3c/problem_stokes.hh @@ -94,8 +94,8 @@ class StokesSubProblem : public NavierStokesProblem using Indices = typename GetPropType::Indices; using FluidSystem = GetPropType; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using PrimaryVariables = GetPropType; using NumEqVector = GetPropType; @@ -107,8 +107,8 @@ class StokesSubProblem : public NavierStokesProblem using CouplingManager = GetPropType; public: - StokesSubProblem(std::shared_ptr fvGridGeometry, std::shared_ptr couplingManager) - : ParentType(fvGridGeometry, "Stokes"), eps_(1e-6), + StokesSubProblem(std::shared_ptr gridGeometry, std::shared_ptr couplingManager) + : ParentType(gridGeometry, "Stokes"), eps_(1e-6), couplingManager_(couplingManager) { inletVelocity_ = getParamFromGroup(this->paramGroup(), "Problem.Velocity"); diff --git a/test/multidomain/boundary/stokesdarcy/1p_1p/problem_darcy.hh b/test/multidomain/boundary/stokesdarcy/1p_1p/problem_darcy.hh index 2526dbc20b69ca51d8a6ba15981d6a4fdabcb3a5..fbd698133f6a8890470b1886da6b8ef1fc563a1b 100644 --- a/test/multidomain/boundary/stokesdarcy/1p_1p/problem_darcy.hh +++ b/test/multidomain/boundary/stokesdarcy/1p_1p/problem_darcy.hh @@ -66,9 +66,9 @@ struct Grid { using type = Dune::YaspGrid<2>; }; template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePSpatialParams; + using type = OnePSpatialParams; }; } // end namespace Properties @@ -85,7 +85,7 @@ class DarcySubProblem : public PorousMediumFlowProblem using FVElementGeometry = typename GetPropType::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Indices = typename GetPropType::Indices; @@ -95,9 +95,9 @@ class DarcySubProblem : public PorousMediumFlowProblem using CouplingManager = GetPropType; public: - DarcySubProblem(std::shared_ptr fvGridGeometry, + DarcySubProblem(std::shared_ptr gridGeometry, std::shared_ptr couplingManager) - : ParentType(fvGridGeometry, "Darcy"), eps_(1e-7), couplingManager_(couplingManager) + : ParentType(gridGeometry, "Darcy"), eps_(1e-7), couplingManager_(couplingManager) { problemName_ = getParam("Vtk.OutputName") + "_" + getParamFromGroup(this->paramGroup(), "Problem.Name"); diff --git a/test/multidomain/boundary/stokesdarcy/1p_1p/problem_stokes.hh b/test/multidomain/boundary/stokesdarcy/1p_1p/problem_stokes.hh index 52b9cc8ceb62fe26aef19846b526728b233a2f4e..41ab898ad273d41f20d1639ae41091a81fb1dfd4 100644 --- a/test/multidomain/boundary/stokesdarcy/1p_1p/problem_stokes.hh +++ b/test/multidomain/boundary/stokesdarcy/1p_1p/problem_stokes.hh @@ -86,8 +86,8 @@ class StokesSubProblem : public NavierStokesProblem using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using Element = typename GridView::template Codim<0>::Entity; @@ -99,8 +99,8 @@ class StokesSubProblem : public NavierStokesProblem using CouplingManager = GetPropType; public: - StokesSubProblem(std::shared_ptr fvGridGeometry, std::shared_ptr couplingManager) - : ParentType(fvGridGeometry, "Stokes"), eps_(1e-6), couplingManager_(couplingManager) + StokesSubProblem(std::shared_ptr gridGeometry, std::shared_ptr couplingManager) + : ParentType(gridGeometry, "Stokes"), eps_(1e-6), couplingManager_(couplingManager) { problemName_ = getParam("Vtk.OutputName") + "_" + getParamFromGroup(this->paramGroup(), "Problem.Name"); diff --git a/test/multidomain/boundary/stokesdarcy/1p_1p/spatialparams.hh b/test/multidomain/boundary/stokesdarcy/1p_1p/spatialparams.hh index fb0adabe6240371a406469339a2099ca259eff03..3ef8c3b2866bfee8573c7289ad69ec67f5146dc6 100644 --- a/test/multidomain/boundary/stokesdarcy/1p_1p/spatialparams.hh +++ b/test/multidomain/boundary/stokesdarcy/1p_1p/spatialparams.hh @@ -35,14 +35,14 @@ namespace Dumux * \brief The spatial parameters class for the test problem using the * 1p cc model. */ -template +template class OnePSpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using GridView = typename FVGridGeometry::GridView; - using ParentType = FVSpatialParamsOneP>; + using GridView = typename GridGeometry::GridView; + using ParentType = FVSpatialParamsOneP>; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -51,8 +51,8 @@ public: // export permeability type using PermeabilityType = Scalar; - OnePSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + OnePSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { permeability_ = getParam("Darcy.SpatialParams.Permeability"); alphaBJ_ = getParam("Darcy.SpatialParams.AlphaBeaversJoseph"); diff --git a/test/multidomain/boundary/stokesdarcy/1p_2p/problem_darcy.hh b/test/multidomain/boundary/stokesdarcy/1p_2p/problem_darcy.hh index a71e106b2983f343854f9d4a84953e5576dde66f..1450aafa40b66c02e1fcf134d8b757a116b94c76 100644 --- a/test/multidomain/boundary/stokesdarcy/1p_2p/problem_darcy.hh +++ b/test/multidomain/boundary/stokesdarcy/1p_2p/problem_darcy.hh @@ -63,9 +63,9 @@ struct UseMoles { static constexpr bool value = false; template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = ConservationSpatialParams; + using type = ConservationSpatialParams; }; //! Set the default formulation to pw-Sn: This can be over written in the problem. @@ -91,7 +91,7 @@ class DarcySubProblem : public PorousMediumFlowProblem using FVElementGeometry = typename GetPropType::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using FluidSystem = GetPropType; @@ -110,9 +110,9 @@ class DarcySubProblem : public PorousMediumFlowProblem using CouplingManager = GetPropType; public: - DarcySubProblem(std::shared_ptr fvGridGeometry, + DarcySubProblem(std::shared_ptr gridGeometry, std::shared_ptr couplingManager) - : ParentType(fvGridGeometry, "Darcy"), eps_(1e-7), couplingManager_(couplingManager) + : ParentType(gridGeometry, "Darcy"), eps_(1e-7), couplingManager_(couplingManager) { pressure_ = getParamFromGroup(this->paramGroup(), "Problem.Pressure"); saturation_ = getParamFromGroup(this->paramGroup(), "Problem.Saturation"); diff --git a/test/multidomain/boundary/stokesdarcy/1p_2p/problem_stokes.hh b/test/multidomain/boundary/stokesdarcy/1p_2p/problem_stokes.hh index a07ab5eee6ee9208d5c0433f53c5f0a41a5f768f..043344b9098fda1fcc8b27cf1b6f439483bca788 100644 --- a/test/multidomain/boundary/stokesdarcy/1p_2p/problem_stokes.hh +++ b/test/multidomain/boundary/stokesdarcy/1p_2p/problem_stokes.hh @@ -77,8 +77,8 @@ class StokesSubProblem : public NavierStokesProblem using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using Element = typename GridView::template Codim<0>::Entity; using ElementVolumeVariables = typename GetPropType::LocalView; @@ -92,8 +92,8 @@ class StokesSubProblem : public NavierStokesProblem using CouplingManager = GetPropType; public: - StokesSubProblem(std::shared_ptr fvGridGeometry, std::shared_ptr couplingManager) - : ParentType(fvGridGeometry, "Stokes"), eps_(1e-6), couplingManager_(couplingManager) + StokesSubProblem(std::shared_ptr gridGeometry, std::shared_ptr couplingManager) + : ParentType(gridGeometry, "Stokes"), eps_(1e-6), couplingManager_(couplingManager) { inletVelocity_ = getParamFromGroup(this->paramGroup(), "Problem.Velocity"); pressure_ = getParamFromGroup(this->paramGroup(), "Problem.Pressure"); diff --git a/test/multidomain/boundary/stokesdarcy/1p_2p/spatialparams.hh b/test/multidomain/boundary/stokesdarcy/1p_2p/spatialparams.hh index ec1ec8d0601cb4467dd06ea9c052a3b96be692f1..46405bb904498ccd18168c06e4e1321d835c809a 100644 --- a/test/multidomain/boundary/stokesdarcy/1p_2p/spatialparams.hh +++ b/test/multidomain/boundary/stokesdarcy/1p_2p/spatialparams.hh @@ -38,17 +38,17 @@ namespace Dumux { * \brief The spatial parameters class for the test problem using the * 1p cc model. */ -template +template class ConservationSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; - using ThisType = ConservationSpatialParams; - using ParentType = FVSpatialParams; + using ThisType = ConservationSpatialParams; + using ParentType = FVSpatialParams; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; using EffectiveLaw = RegularizedVanGenuchten; @@ -58,8 +58,8 @@ public: using MaterialLawParams = typename MaterialLaw::Params; using PermeabilityType = Scalar; - ConservationSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + ConservationSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { permeability_ = getParam("SpatialParams.Permeability"); porosity_ = getParam("SpatialParams.Porosity"); diff --git a/test/multidomain/embedded/1d3d/1p2c_richards2c/problem_root.hh b/test/multidomain/embedded/1d3d/1p2c_richards2c/problem_root.hh index f7767a164417878222fff8381265b42314b5f3ab..9ced92e868c7a0913297db25c27c83217d008407 100644 --- a/test/multidomain/embedded/1d3d/1p2c_richards2c/problem_root.hh +++ b/test/multidomain/embedded/1d3d/1p2c_richards2c/problem_root.hh @@ -108,12 +108,12 @@ class RootProblem : public PorousMediumFlowProblem using NeumannFluxes = GetPropType; using SourceValues = GetPropType; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using GlobalPosition = typename FVGridGeometry::GlobalCoordinate; + using GridGeometry = GetPropType; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using GlobalPosition = typename GridGeometry::GlobalCoordinate; using Element = typename GridView::template Codim<0>::Entity; using SolutionVector = GetPropType; using GridVariables = GetPropType; @@ -137,10 +137,10 @@ public: }; template - RootProblem(std::shared_ptr fvGridGeometry, + RootProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams, std::shared_ptr couplingManager) - : ParentType(fvGridGeometry, spatialParams, "Root") + : ParentType(gridGeometry, spatialParams, "Root") , couplingManager_(couplingManager) { // read parameters from input file diff --git a/test/multidomain/embedded/1d3d/1p2c_richards2c/problem_soil.hh b/test/multidomain/embedded/1d3d/1p2c_richards2c/problem_soil.hh index e2994882e90cdf3f05af1e9669e542dd5c568216..9f8f7ad2289a97fe4e20a882088dd239e3748289 100644 --- a/test/multidomain/embedded/1d3d/1p2c_richards2c/problem_soil.hh +++ b/test/multidomain/embedded/1d3d/1p2c_richards2c/problem_soil.hh @@ -116,11 +116,11 @@ class SoilProblem : public PorousMediumFlowProblem { using ParentType = PorousMediumFlowProblem; using Scalar = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using GridView = typename FVGridGeometry::GridView; - using GlobalPosition = typename FVGridGeometry::GlobalCoordinate; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using GridView = typename GridGeometry::GridView; + using GlobalPosition = typename GridGeometry::GlobalCoordinate; using PrimaryVariables = GetPropType; using NumEqVector = GetPropType; using SolutionVector = GetPropType; @@ -147,9 +147,9 @@ public: liquidPhaseIdx = FluidSystem::liquidPhaseIdx }; - SoilProblem(std::shared_ptr fvGridGeometry, + SoilProblem(std::shared_ptr gridGeometry, std::shared_ptr couplingManager) - : ParentType(fvGridGeometry, "Soil") + : ParentType(gridGeometry, "Soil") , couplingManager_(couplingManager) { //read parameters from input file @@ -159,7 +159,7 @@ public: // for initial conditions const Scalar sw = getParam("Problem.InitTopSaturation", 0.3); // start with 30% saturation on top using MaterialLaw = typename GetPropType::MaterialLaw; - pcTop_ = MaterialLaw::pc(this->spatialParams().materialLawParamsAtPos(fvGridGeometry->bBoxMax()), sw); + pcTop_ = MaterialLaw::pc(this->spatialParams().materialLawParamsAtPos(gridGeometry->bBoxMax()), sw); } /*! diff --git a/test/multidomain/embedded/1d3d/1p2c_richards2c/spatialparams_root.hh b/test/multidomain/embedded/1d3d/1p2c_richards2c/spatialparams_root.hh index 9c871659b6d8de8b01b55ff4c2c4edeece0c840e..ea54f7846e41c22faac54521ef628b1290ebfb0c 100644 --- a/test/multidomain/embedded/1d3d/1p2c_richards2c/spatialparams_root.hh +++ b/test/multidomain/embedded/1d3d/1p2c_richards2c/spatialparams_root.hh @@ -36,16 +36,16 @@ namespace Dumux { * \ingroup EmbeddedTests * \brief Definition of the spatial parameters for the root xylem flow. */ -template +template class RootSpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using ThisType = RootSpatialParams; - using ParentType = FVSpatialParamsOneP; - using Grid = typename FVGridGeometry::Grid; - using GridView = typename FVGridGeometry::GridView; + using ThisType = RootSpatialParams; + using ParentType = FVSpatialParamsOneP; + using Grid = typename GridGeometry::Grid; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; + using SubControlVolume = typename GridGeometry::SubControlVolume; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; //! Indices to access the parameters in the dgf file @@ -61,15 +61,15 @@ public: // export permeability type using PermeabilityType = Scalar; - RootSpatialParams(std::shared_ptr fvGridGeometry, + RootSpatialParams(std::shared_ptr gridGeometry, std::shared_ptr> gridData) - : ParentType(fvGridGeometry), gridData_(gridData) + : ParentType(gridGeometry), gridData_(gridData) { porosity_ = getParam("Root.SpatialParams.Porosity", 0.4); constantKx_ = getParam("Root.SpatialParams.Kx", 5.0968e-17); constantKr_ = getParam("Root.SpatialParams.Kr", 2.04e-13); - const auto& gv = fvGridGeometry->gridView(); + const auto& gv = gridGeometry->gridView(); radii_.resize(gv.size(0)); for (const auto& element : elements(gv)) { diff --git a/test/multidomain/embedded/1d3d/1p2c_richards2c/spatialparams_soil.hh b/test/multidomain/embedded/1d3d/1p2c_richards2c/spatialparams_soil.hh index 618e3eeca84593d9a76fd6f6a3641ef340928535..342eb9079ec7a1bcdb3671462e7d065b1d31d340 100644 --- a/test/multidomain/embedded/1d3d/1p2c_richards2c/spatialparams_soil.hh +++ b/test/multidomain/embedded/1d3d/1p2c_richards2c/spatialparams_soil.hh @@ -36,15 +36,15 @@ namespace Dumux { * \ingroup EmbeddedTests * \brief Definition of the spatial parameters for the soil problem. */ -template +template class SoilSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using ThisType = SoilSpatialParams; - using ParentType = FVSpatialParams; - using GridView = typename FVGridGeometry::GridView; + using ThisType = SoilSpatialParams; + using ParentType = FVSpatialParams; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; + using SubControlVolume = typename GridGeometry::SubControlVolume; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: @@ -55,8 +55,8 @@ public: // export material law params using MaterialLawParams = typename MaterialLaw::Params; - SoilSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + SoilSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { // residual saturations materialParams_.setSwr(0.05); diff --git a/test/multidomain/embedded/1d3d/1p_1p/problem_bloodflow.hh b/test/multidomain/embedded/1d3d/1p_1p/problem_bloodflow.hh index 1fc60bc8bdfad9b60949b87a5f0a2859b3d1166c..d1fb0288d37a0faed61c6c94d883c7c7a805ca60 100644 --- a/test/multidomain/embedded/1d3d/1p_1p/problem_bloodflow.hh +++ b/test/multidomain/embedded/1d3d/1p_1p/problem_bloodflow.hh @@ -112,20 +112,20 @@ class BloodFlowProblem : public PorousMediumFlowProblem using Indices = typename GetPropType::Indices; using PrimaryVariables = GetPropType; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; + using GridGeometry = GetPropType; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; using SolutionVector = GetPropType; using GridVariables = GetPropType; using Element = typename GridView::template Codim<0>::Entity; - using GlobalPosition = typename FVGridGeometry::GlobalCoordinate; + using GlobalPosition = typename GridGeometry::GlobalCoordinate; using CouplingManager = GetPropType; public: - BloodFlowProblem(std::shared_ptr fvGridGeometry, + BloodFlowProblem(std::shared_ptr gridGeometry, std::shared_ptr couplingManager) - : ParentType(fvGridGeometry, "Vessel") + : ParentType(gridGeometry, "Vessel") , couplingManager_(couplingManager) { //read parameters from input file diff --git a/test/multidomain/embedded/1d3d/1p_1p/problem_tissue.hh b/test/multidomain/embedded/1d3d/1p_1p/problem_tissue.hh index b1a255cfe746203e337e65c1c1a7280a1e4888b7..6515785addccb005d16fa3caff2258985a010dc9 100644 --- a/test/multidomain/embedded/1d3d/1p_1p/problem_tissue.hh +++ b/test/multidomain/embedded/1d3d/1p_1p/problem_tissue.hh @@ -116,10 +116,10 @@ class TissueProblem : public PorousMediumFlowProblem { using ParentType = PorousMediumFlowProblem; using Scalar = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using GridView = typename GridGeometry::GridView; using PrimaryVariables = GetPropType; using NumEqVector = GetPropType; using SolutionVector = GetPropType; @@ -128,14 +128,14 @@ class TissueProblem : public PorousMediumFlowProblem using PointSource = GetPropType; using Indices = typename GetPropType::Indices; using Element = typename GridView::template Codim<0>::Entity; - using GlobalPosition = typename FVGridGeometry::GlobalCoordinate; + using GlobalPosition = typename GridGeometry::GlobalCoordinate; using CouplingManager = GetPropType; public: - TissueProblem(std::shared_ptr fvGridGeometry, + TissueProblem(std::shared_ptr gridGeometry, std::shared_ptr couplingManager) - : ParentType(fvGridGeometry, "Tissue") + : ParentType(gridGeometry, "Tissue") , couplingManager_(couplingManager) { // read parameters from input file diff --git a/test/multidomain/embedded/1d3d/1p_1p/spatialparams_bloodflow.hh b/test/multidomain/embedded/1d3d/1p_1p/spatialparams_bloodflow.hh index 4d8f63293c7266db40ddce22059244c5b702f68a..358c6f16c03f3ac43799b0ff2d7e38d239ac2e4a 100644 --- a/test/multidomain/embedded/1d3d/1p_1p/spatialparams_bloodflow.hh +++ b/test/multidomain/embedded/1d3d/1p_1p/spatialparams_bloodflow.hh @@ -33,20 +33,20 @@ namespace Dumux { * \ingroup EmbeddedTests * \brief Definition of the spatial parameters for the blood flow problem. */ -template +template class BloodFlowSpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using ThisType = BloodFlowSpatialParams; - using ParentType = FVSpatialParamsOneP; - using GlobalPosition = typename FVGridGeometry::GlobalCoordinate; + using ThisType = BloodFlowSpatialParams; + using ParentType = FVSpatialParamsOneP; + using GlobalPosition = typename GridGeometry::GlobalCoordinate; public: // export permeability type using PermeabilityType = Scalar; - BloodFlowSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + BloodFlowSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { radius_ = getParam("SpatialParams.Radius"); } diff --git a/test/multidomain/embedded/1d3d/1p_1p/spatialparams_tissue.hh b/test/multidomain/embedded/1d3d/1p_1p/spatialparams_tissue.hh index 82874171dddf8d489f8855b593d292b96880fb35..b9e6ab9445b67db5a4f53feb62bf36aca195fba8 100644 --- a/test/multidomain/embedded/1d3d/1p_1p/spatialparams_tissue.hh +++ b/test/multidomain/embedded/1d3d/1p_1p/spatialparams_tissue.hh @@ -33,21 +33,21 @@ namespace Dumux { * \ingroup EmbeddedTests * \brief Definition of the spatial parameters for the tissue problem. */ -template +template class TissueSpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using ThisType = TissueSpatialParams; - using ParentType = FVSpatialParamsOneP; - using GridView = typename FVGridGeometry::GridView; + using ThisType = TissueSpatialParams; + using ParentType = FVSpatialParamsOneP; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; + using SubControlVolume = typename GridGeometry::SubControlVolume; public: // export permeability type using PermeabilityType = Scalar; - TissueSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + TissueSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { permeability_ = getParam("SpatialParams.PermeabilityTissue"); porosity_ = 1.0; diff --git a/test/multidomain/embedded/1d3d/1p_richards/problem_root.hh b/test/multidomain/embedded/1d3d/1p_richards/problem_root.hh index 0a22eb6a15a6cdfa835db72962d97b7742c00856..66979692310ab54028eb926c1f09754cdf890103 100644 --- a/test/multidomain/embedded/1d3d/1p_richards/problem_root.hh +++ b/test/multidomain/embedded/1d3d/1p_richards/problem_root.hh @@ -108,12 +108,12 @@ class RootProblem : public PorousMediumFlowProblem using PrimaryVariables = GetPropType; using NeumannFluxes = GetPropType; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using GlobalPosition = typename FVGridGeometry::GlobalCoordinate; + using GridGeometry = GetPropType; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using GlobalPosition = typename GridGeometry::GlobalCoordinate; using SolutionVector = GetPropType; using GridVariables = GetPropType; using Element = typename GridView::template Codim<0>::Entity; @@ -122,10 +122,10 @@ class RootProblem : public PorousMediumFlowProblem public: template - RootProblem(std::shared_ptr fvGridGeometry, + RootProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams, std::shared_ptr couplingManager) - : ParentType(fvGridGeometry, spatialParams, "Root") + : ParentType(gridGeometry, spatialParams, "Root") , couplingManager_(couplingManager) { // read parameters from input file diff --git a/test/multidomain/embedded/1d3d/1p_richards/problem_soil.hh b/test/multidomain/embedded/1d3d/1p_richards/problem_soil.hh index 883f51a8bbff0c82b9cc17203ae6b60bdbfe3708..a44d3824bd73ef997ec7e0aebf44e307bab5e857 100644 --- a/test/multidomain/embedded/1d3d/1p_richards/problem_soil.hh +++ b/test/multidomain/embedded/1d3d/1p_richards/problem_soil.hh @@ -97,11 +97,11 @@ class SoilProblem : public PorousMediumFlowProblem { using ParentType = PorousMediumFlowProblem; using Scalar = GetPropType; - using FVGridGeometry = GetPropType; - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using GlobalPosition = typename FVGridGeometry::GlobalCoordinate; + using GridGeometry = GetPropType; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using GlobalPosition = typename GridGeometry::GlobalCoordinate; using Element = typename GridView::template Codim<0>::Entity; using PrimaryVariables = GetPropType; using SolutionVector = GetPropType; @@ -112,9 +112,9 @@ class SoilProblem : public PorousMediumFlowProblem using CouplingManager = GetPropType; public: - SoilProblem(std::shared_ptr fvGridGeometry, + SoilProblem(std::shared_ptr gridGeometry, std::shared_ptr couplingManager) - : ParentType(fvGridGeometry, "Soil") + : ParentType(gridGeometry, "Soil") , couplingManager_(couplingManager) { // read parameters from input file diff --git a/test/multidomain/embedded/1d3d/1p_richards/spatialparams_root.hh b/test/multidomain/embedded/1d3d/1p_richards/spatialparams_root.hh index 42a3b62a17d93c7907f082696a8a26affc1fc064..d580b693c57d1cd687ddc5ffda45ae3571ae79ac 100644 --- a/test/multidomain/embedded/1d3d/1p_richards/spatialparams_root.hh +++ b/test/multidomain/embedded/1d3d/1p_richards/spatialparams_root.hh @@ -36,16 +36,16 @@ namespace Dumux { * \ingroup EmbeddedTests * \brief Definition of the spatial parameters for the blood flow problem. */ -template +template class RootSpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using ThisType = RootSpatialParams; - using ParentType = FVSpatialParamsOneP; - using Grid = typename FVGridGeometry::Grid; - using GridView = typename FVGridGeometry::GridView; + using ThisType = RootSpatialParams; + using ParentType = FVSpatialParamsOneP; + using Grid = typename GridGeometry::Grid; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; + using SubControlVolume = typename GridGeometry::SubControlVolume; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; //! Indices to access the parameters in the dgf file @@ -61,15 +61,15 @@ public: // export permeability type using PermeabilityType = Scalar; - RootSpatialParams(std::shared_ptr fvGridGeometry, + RootSpatialParams(std::shared_ptr gridGeometry, std::shared_ptr> gridData) - : ParentType(fvGridGeometry), gridData_(gridData) + : ParentType(gridGeometry), gridData_(gridData) { porosity_ = getParam("Root.SpatialParams.Porosity", 0.4); constantKx_ = getParam("SpatialParams.Kx", 5.0968e-17); constantKr_ = getParam("SpatialParams.Kr", 2.04e-13); - const auto& gv = fvGridGeometry->gridView(); + const auto& gv = gridGeometry->gridView(); radii_.resize(gv.size(0)); for (const auto& element : elements(gv)) { diff --git a/test/multidomain/embedded/1d3d/1p_richards/spatialparams_soil.hh b/test/multidomain/embedded/1d3d/1p_richards/spatialparams_soil.hh index e4a5504b193f43f7450ca99f8d3d640c93d42f16..f2baa36fd3730a66a79e1346bed9acdfe3239f79 100644 --- a/test/multidomain/embedded/1d3d/1p_richards/spatialparams_soil.hh +++ b/test/multidomain/embedded/1d3d/1p_richards/spatialparams_soil.hh @@ -36,15 +36,15 @@ namespace Dumux { * \ingroup EmbeddedTests * \brief Definition of the spatial parameters for the tissue problem. */ -template +template class SoilSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using ThisType = SoilSpatialParams; - using ParentType = FVSpatialParams; - using GridView = typename FVGridGeometry::GridView; + using ThisType = SoilSpatialParams; + using ParentType = FVSpatialParams; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; + using SubControlVolume = typename GridGeometry::SubControlVolume; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: @@ -55,8 +55,8 @@ public: // export material law params using MaterialLawParams = typename MaterialLaw::Params; - SoilSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + SoilSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { // residual saturations materialParams_.setSwr(0.05); diff --git a/test/multidomain/embedded/2d3d/1p_1p/problem_fracture.hh b/test/multidomain/embedded/2d3d/1p_1p/problem_fracture.hh index 17fff01a7ac1fe6efaac7352a21f6f06af853171..bb0b52952342976f4f65b4ce6052695b4aa79e69 100644 --- a/test/multidomain/embedded/2d3d/1p_1p/problem_fracture.hh +++ b/test/multidomain/embedded/2d3d/1p_1p/problem_fracture.hh @@ -107,10 +107,10 @@ class FractureProblem : public PorousMediumFlowProblem using PrimaryVariables = GetPropType; using NumEqVector = GetPropType; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; + using GridGeometry = GetPropType; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; using SolutionVector = GetPropType; using GridVariables = GetPropType; using Element = typename GridView::template Codim<0>::Entity; @@ -119,11 +119,11 @@ class FractureProblem : public PorousMediumFlowProblem using CouplingManager = GetPropType; public: - FractureProblem(std::shared_ptr fvGridGeometry, + FractureProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams, std::shared_ptr couplingManager, const std::string& paramGroup = "Fracture") - : ParentType(fvGridGeometry, spatialParams, paramGroup) + : ParentType(gridGeometry, spatialParams, paramGroup) , couplingManager_(couplingManager) { // read parameters from input file diff --git a/test/multidomain/embedded/2d3d/1p_1p/problem_matrix.hh b/test/multidomain/embedded/2d3d/1p_1p/problem_matrix.hh index e775429903faa57f85a4a4cd1ffcdaf1661dba87..c078d8deaf434937312783287bc6063b6686b86b 100644 --- a/test/multidomain/embedded/2d3d/1p_1p/problem_matrix.hh +++ b/test/multidomain/embedded/2d3d/1p_1p/problem_matrix.hh @@ -108,10 +108,10 @@ class MatrixProblem : public PorousMediumFlowProblem { using ParentType = PorousMediumFlowProblem; using Scalar = GetPropType; - using FVGridGeometry = GetPropType; - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; + using GridGeometry = GetPropType; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; using PrimaryVariables = GetPropType; using NumEqVector = GetPropType; using SolutionVector = GetPropType; @@ -132,11 +132,11 @@ class MatrixProblem : public PorousMediumFlowProblem using CouplingManager = GetPropType; public: - MatrixProblem(std::shared_ptr fvGridGeometry, + MatrixProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams, std::shared_ptr couplingManager, const std::string& paramGroup = "Matrix") - : ParentType(fvGridGeometry, spatialParams, paramGroup) + : ParentType(gridGeometry, spatialParams, paramGroup) , couplingManager_(couplingManager) { // read parameters from input file diff --git a/test/multidomain/embedded/2d3d/1p_1p/spatialparams.hh b/test/multidomain/embedded/2d3d/1p_1p/spatialparams.hh index 602b775adec328217ff99eab0b3416cdfa823368..9118a933d838631fbcb004740a286fd01e8e62b2 100644 --- a/test/multidomain/embedded/2d3d/1p_1p/spatialparams.hh +++ b/test/multidomain/embedded/2d3d/1p_1p/spatialparams.hh @@ -33,23 +33,23 @@ namespace Dumux { * \ingroup EmbeddedTests * \brief Definition of the spatial parameters for the matrix and fracture problem. */ -template +template class MatrixFractureSpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using ThisType = MatrixFractureSpatialParams; - using ParentType = FVSpatialParamsOneP; - using GridView = typename FVGridGeometry::GridView; + using ThisType = MatrixFractureSpatialParams; + using ParentType = FVSpatialParamsOneP; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; + using SubControlVolume = typename GridGeometry::SubControlVolume; public: // export permeability type using PermeabilityType = Scalar; - MatrixFractureSpatialParams(std::shared_ptr fvGridGeometry, + MatrixFractureSpatialParams(std::shared_ptr gridGeometry, const std::string& paramGroup = "") - : ParentType(fvGridGeometry) + : ParentType(gridGeometry) { permeability_ = getParamFromGroup(paramGroup, "SpatialParams.Permeability"); porosity_ = getParamFromGroup(paramGroup, "SpatialParams.Porosity", 1.0); diff --git a/test/multidomain/facet/1p_1p/analytical/main.cc b/test/multidomain/facet/1p_1p/analytical/main.cc index f148770eb4942c21669a600cba5a04af5c24af12..26644b774bc583d00ec73da74e0b77d6829e5836 100644 --- a/test/multidomain/facet/1p_1p/analytical/main.cc +++ b/test/multidomain/facet/1p_1p/analytical/main.cc @@ -160,31 +160,31 @@ computeL2Norm(const GridView& gridView, * we have to create additional faces on interior boundaries, which wouldn't be * created in the standard scheme. */ -template< class FVGridGeometry, +template< class GridGeometry, class GridManager, class LowDimGridView, - std::enable_if_t = 0 > -void updateBulkFVGridGeometry(FVGridGeometry& fvGridGeometry, + std::enable_if_t = 0 > +void updateBulkFVGridGeometry(GridGeometry& gridGeometry, const GridManager& gridManager, const LowDimGridView& lowDimGridView) { using BulkFacetGridAdapter = Dumux::CodimOneGridAdapter; BulkFacetGridAdapter facetGridAdapter(gridManager.getEmbeddings()); - fvGridGeometry.update(lowDimGridView, facetGridAdapter); + gridGeometry.update(lowDimGridView, facetGridAdapter); } /*! * \brief Updates the finite volume grid geometry for the cell-centered schemes. */ -template< class FVGridGeometry, +template< class GridGeometry, class GridManager, class LowDimGridView, - std::enable_if_t = 0 > -void updateBulkFVGridGeometry(FVGridGeometry& fvGridGeometry, + std::enable_if_t = 0 > +void updateBulkFVGridGeometry(GridGeometry& gridGeometry, const GridManager& gridManager, const LowDimGridView& lowDimGridView) { - fvGridGeometry.update(); + gridGeometry.update(); } // main program diff --git a/test/multidomain/facet/1p_1p/analytical/problem_bulk.hh b/test/multidomain/facet/1p_1p/analytical/problem_bulk.hh index ffde496f2cc77c031f80576f9f1ffb58f5389b3f..8071cdbf2aa9eb5544af01e418a594944baffc0d 100644 --- a/test/multidomain/facet/1p_1p/analytical/problem_bulk.hh +++ b/test/multidomain/facet/1p_1p/analytical/problem_bulk.hh @@ -91,11 +91,11 @@ class OnePBulkProblem : public PorousMediumFlowProblem using PrimaryVariables = typename GridVariables::PrimaryVariables; using Scalar = typename GridVariables::Scalar; - using FVGridGeometry = typename GridVariables::GridGeometry; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = typename GridVariables::GridGeometry; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -104,11 +104,11 @@ class OnePBulkProblem : public PorousMediumFlowProblem using NumEqVector = GetPropType; public: - OnePBulkProblem(std::shared_ptr fvGridGeometry, + OnePBulkProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams, std::shared_ptr couplingManagerPtr, const std::string& paramGroup = "Bulk") - : ParentType(fvGridGeometry, spatialParams, paramGroup) + : ParentType(gridGeometry, spatialParams, paramGroup) , couplingManagerPtr_(couplingManagerPtr) , lowDimPermeability_(getParam("LowDim.SpatialParams.Permeability")) , aperture_(getParam("Problem.FractureAperture")) diff --git a/test/multidomain/facet/1p_1p/analytical/problem_lowdim.hh b/test/multidomain/facet/1p_1p/analytical/problem_lowdim.hh index 76b5d56108dbfcb894acb2744361509c307c5f23..93e0307bb81bd4f419dcdda0c8b4f02bb4801f8e 100644 --- a/test/multidomain/facet/1p_1p/analytical/problem_lowdim.hh +++ b/test/multidomain/facet/1p_1p/analytical/problem_lowdim.hh @@ -91,10 +91,10 @@ class OnePLowDimProblem : public PorousMediumFlowProblem using PrimaryVariables = typename GridVariables::PrimaryVariables; using Scalar = typename GridVariables::Scalar; - using FVGridGeometry = typename GridVariables::GridGeometry; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = typename GridVariables::GridGeometry; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -103,11 +103,11 @@ class OnePLowDimProblem : public PorousMediumFlowProblem using NumEqVector = GetPropType; public: - OnePLowDimProblem(std::shared_ptr fvGridGeometry, + OnePLowDimProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams, std::shared_ptr couplingManagerPtr, const std::string& paramGroup = "LowDim") - : ParentType(fvGridGeometry, spatialParams, paramGroup) + : ParentType(gridGeometry, spatialParams, paramGroup) , couplingManagerPtr_(couplingManagerPtr) , aperture_(getParam("Problem.FractureAperture")) { diff --git a/test/multidomain/facet/1p_1p/analytical/spatialparams.hh b/test/multidomain/facet/1p_1p/analytical/spatialparams.hh index 139b3ab9df39b5769f3423db391b48a57467d082..d99a2de765cb1e2bb3310dacd638cf6b125a7b75 100644 --- a/test/multidomain/facet/1p_1p/analytical/spatialparams.hh +++ b/test/multidomain/facet/1p_1p/analytical/spatialparams.hh @@ -33,14 +33,14 @@ namespace Dumux { * \ingroup FacetTests * \brief The spatial parameters for the single-phase facet coupling test. */ -template< class FVGridGeometry, class Scalar > +template< class GridGeometry, class Scalar > class OnePSpatialParams -: public FVSpatialParamsOneP< FVGridGeometry, Scalar, OnePSpatialParams > +: public FVSpatialParamsOneP< GridGeometry, Scalar, OnePSpatialParams > { - using ThisType = OnePSpatialParams< FVGridGeometry, Scalar >; - using ParentType = FVSpatialParamsOneP< FVGridGeometry, Scalar, ThisType >; + using ThisType = OnePSpatialParams< GridGeometry, Scalar >; + using ParentType = FVSpatialParamsOneP< GridGeometry, Scalar, ThisType >; - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -48,8 +48,8 @@ public: //! Export the type used for permeabilities using PermeabilityType = Scalar; - OnePSpatialParams(std::shared_ptr fvGridGeometry, const std::string& paramGroup = "") - : ParentType(fvGridGeometry) + OnePSpatialParams(std::shared_ptr gridGeometry, const std::string& paramGroup = "") + : ParentType(gridGeometry) { permeability_ = getParamFromGroup(paramGroup, "SpatialParams.Permeability"); } diff --git a/test/multidomain/facet/1p_1p/gravity/problem_bulk.hh b/test/multidomain/facet/1p_1p/gravity/problem_bulk.hh index 25d145cd07daf6f3b0cdc127bc63b1017618d821..60e29e7ffc805ff932e89da41834b19cd9fddae1 100644 --- a/test/multidomain/facet/1p_1p/gravity/problem_bulk.hh +++ b/test/multidomain/facet/1p_1p/gravity/problem_bulk.hh @@ -95,11 +95,11 @@ class OnePBulkProblem : public PorousMediumFlowProblem using PrimaryVariables = typename GridVariables::PrimaryVariables; using Scalar = typename GridVariables::Scalar; - using FVGridGeometry = typename GridVariables::GridGeometry; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = typename GridVariables::GridGeometry; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -110,11 +110,11 @@ class OnePBulkProblem : public PorousMediumFlowProblem static constexpr int dimWorld = GridView::dimensionworld; public: - OnePBulkProblem(std::shared_ptr fvGridGeometry, + OnePBulkProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams, std::shared_ptr couplingManager, const std::string& paramGroup = "") - : ParentType(fvGridGeometry, spatialParams, paramGroup) + : ParentType(gridGeometry, spatialParams, paramGroup) , couplingManagerPtr_(couplingManager) { problemName_ = getParam("Vtk.OutputName") + "_" + diff --git a/test/multidomain/facet/1p_1p/gravity/problem_lowdim.hh b/test/multidomain/facet/1p_1p/gravity/problem_lowdim.hh index cab046aefba27545e9778a91859de800961013f5..39163d0e1a5c8b84e22f0317f7d25dabd3c3b79b 100644 --- a/test/multidomain/facet/1p_1p/gravity/problem_lowdim.hh +++ b/test/multidomain/facet/1p_1p/gravity/problem_lowdim.hh @@ -97,10 +97,10 @@ class OnePLowDimProblem : public PorousMediumFlowProblem using PrimaryVariables = typename GridVariables::PrimaryVariables; using Scalar = typename GridVariables::Scalar; - using FVGridGeometry = typename GridVariables::GridGeometry; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = typename GridVariables::GridGeometry; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -111,11 +111,11 @@ class OnePLowDimProblem : public PorousMediumFlowProblem static constexpr int dimWorld = GridView::dimensionworld; public: - OnePLowDimProblem(std::shared_ptr fvGridGeometry, + OnePLowDimProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams, std::shared_ptr couplingManager, const std::string& paramGroup = "") - : ParentType(fvGridGeometry, spatialParams, paramGroup) + : ParentType(gridGeometry, spatialParams, paramGroup) , couplingManagerPtr_(couplingManager) , aperture_(getParam("Problem.FractureAperture")) { diff --git a/test/multidomain/facet/1p_1p/gravity/spatialparams.hh b/test/multidomain/facet/1p_1p/gravity/spatialparams.hh index e04fd0aae9fa6e672315c07f34a133f56175e026..a56a110a144f3b3c6c9862cb649ea523f6e513d8 100644 --- a/test/multidomain/facet/1p_1p/gravity/spatialparams.hh +++ b/test/multidomain/facet/1p_1p/gravity/spatialparams.hh @@ -32,14 +32,14 @@ namespace Dumux { * \ingroup FacetTests * \brief The spatial parameters for the single-phase facet coupling test. */ -template< class FVGridGeometry, class Scalar > +template< class GridGeometry, class Scalar > class OnePSpatialParams -: public FVSpatialParamsOneP< FVGridGeometry, Scalar, OnePSpatialParams > +: public FVSpatialParamsOneP< GridGeometry, Scalar, OnePSpatialParams > { - using ThisType = OnePSpatialParams< FVGridGeometry, Scalar >; - using ParentType = FVSpatialParamsOneP< FVGridGeometry, Scalar, ThisType >; + using ThisType = OnePSpatialParams< GridGeometry, Scalar >; + using ParentType = FVSpatialParamsOneP< GridGeometry, Scalar, ThisType >; - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -47,8 +47,8 @@ public: //! Export the type used for permeabilities using PermeabilityType = Scalar; - OnePSpatialParams(std::shared_ptr fvGridGeometry, const std::string& paramGroup = "") - : ParentType(fvGridGeometry) + OnePSpatialParams(std::shared_ptr gridGeometry, const std::string& paramGroup = "") + : ParentType(gridGeometry) { permeability_ = getParamFromGroup(paramGroup, "SpatialParams.Permeability"); } diff --git a/test/multidomain/facet/1p_1p/linearprofile/problem_bulk.hh b/test/multidomain/facet/1p_1p/linearprofile/problem_bulk.hh index dfd2fadc4c098319dc7b71af8de56095fd7696f3..783ac21ac7066c0e5333ef07bcbe26ed0f36b5e7 100644 --- a/test/multidomain/facet/1p_1p/linearprofile/problem_bulk.hh +++ b/test/multidomain/facet/1p_1p/linearprofile/problem_bulk.hh @@ -96,11 +96,11 @@ class OnePBulkProblem : public PorousMediumFlowProblem using PrimaryVariables = typename GridVariables::PrimaryVariables; using Scalar = typename GridVariables::Scalar; - using FVGridGeometry = typename GridVariables::GridGeometry; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = typename GridVariables::GridGeometry; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -109,11 +109,11 @@ class OnePBulkProblem : public PorousMediumFlowProblem using NumEqVector = GetPropType; public: - OnePBulkProblem(std::shared_ptr fvGridGeometry, + OnePBulkProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams, std::shared_ptr couplingManager, const std::string& paramGroup = "") - : ParentType(fvGridGeometry, spatialParams, paramGroup) + : ParentType(gridGeometry, spatialParams, paramGroup) , couplingManagerPtr_(couplingManager) { problemName_ = getParam("Vtk.OutputName") + "_" + diff --git a/test/multidomain/facet/1p_1p/linearprofile/problem_lowdim.hh b/test/multidomain/facet/1p_1p/linearprofile/problem_lowdim.hh index 793178315d17d66f473c05c0cc196cdfec447330..8fb742a17fda3cd56813afe6e644816a247e965d 100644 --- a/test/multidomain/facet/1p_1p/linearprofile/problem_lowdim.hh +++ b/test/multidomain/facet/1p_1p/linearprofile/problem_lowdim.hh @@ -97,10 +97,10 @@ class OnePLowDimProblem : public PorousMediumFlowProblem using PrimaryVariables = typename GridVariables::PrimaryVariables; using Scalar = typename GridVariables::Scalar; - using FVGridGeometry = typename GridVariables::GridGeometry; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = typename GridVariables::GridGeometry; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -109,11 +109,11 @@ class OnePLowDimProblem : public PorousMediumFlowProblem using NumEqVector = GetPropType; public: - OnePLowDimProblem(std::shared_ptr fvGridGeometry, + OnePLowDimProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams, std::shared_ptr couplingManager, const std::string& paramGroup = "") - : ParentType(fvGridGeometry, spatialParams, paramGroup) + : ParentType(gridGeometry, spatialParams, paramGroup) , couplingManagerPtr_(couplingManager) , aperture_(getParam("Problem.FractureAperture")) { diff --git a/test/multidomain/facet/1p_1p/linearprofile/spatialparams.hh b/test/multidomain/facet/1p_1p/linearprofile/spatialparams.hh index 139b3ab9df39b5769f3423db391b48a57467d082..d99a2de765cb1e2bb3310dacd638cf6b125a7b75 100644 --- a/test/multidomain/facet/1p_1p/linearprofile/spatialparams.hh +++ b/test/multidomain/facet/1p_1p/linearprofile/spatialparams.hh @@ -33,14 +33,14 @@ namespace Dumux { * \ingroup FacetTests * \brief The spatial parameters for the single-phase facet coupling test. */ -template< class FVGridGeometry, class Scalar > +template< class GridGeometry, class Scalar > class OnePSpatialParams -: public FVSpatialParamsOneP< FVGridGeometry, Scalar, OnePSpatialParams > +: public FVSpatialParamsOneP< GridGeometry, Scalar, OnePSpatialParams > { - using ThisType = OnePSpatialParams< FVGridGeometry, Scalar >; - using ParentType = FVSpatialParamsOneP< FVGridGeometry, Scalar, ThisType >; + using ThisType = OnePSpatialParams< GridGeometry, Scalar >; + using ParentType = FVSpatialParamsOneP< GridGeometry, Scalar, ThisType >; - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -48,8 +48,8 @@ public: //! Export the type used for permeabilities using PermeabilityType = Scalar; - OnePSpatialParams(std::shared_ptr fvGridGeometry, const std::string& paramGroup = "") - : ParentType(fvGridGeometry) + OnePSpatialParams(std::shared_ptr gridGeometry, const std::string& paramGroup = "") + : ParentType(gridGeometry) { permeability_ = getParamFromGroup(paramGroup, "SpatialParams.Permeability"); } diff --git a/test/multidomain/facet/1p_1p/threedomain/main.cc b/test/multidomain/facet/1p_1p/threedomain/main.cc index a0de169837a8fde1faa4b53e3a5434862171fb8f..85de4b83f594859b0c801f27c1d2ec2bbc67398a 100644 --- a/test/multidomain/facet/1p_1p/threedomain/main.cc +++ b/test/multidomain/facet/1p_1p/threedomain/main.cc @@ -105,32 +105,32 @@ struct CouplingManager { using type = typename BoxTr * we have to create additional faces on interior boundaries, which wouldn't be * created in the standard scheme. */ -template< class FVGridGeometry, +template< class GridGeometry, class GridManager, class LowDimGridView, - std::enable_if_t = 0 > -void updateFVGridGeometry(FVGridGeometry& fvGridGeometry, + std::enable_if_t = 0 > +void updateFVGridGeometry(GridGeometry& gridGeometry, const GridManager& gridManager, const LowDimGridView& lowDimGridView) { - static constexpr int higherGridId = int(FVGridGeometry::GridView::dimension) == 3 ? 0 : 1; + static constexpr int higherGridId = int(GridGeometry::GridView::dimension) == 3 ? 0 : 1; using BulkFacetGridAdapter = Dumux::CodimOneGridAdapter; BulkFacetGridAdapter facetGridAdapter(gridManager.getEmbeddings()); - fvGridGeometry.update(lowDimGridView, facetGridAdapter); + gridGeometry.update(lowDimGridView, facetGridAdapter); } /*! * \brief Updates the finite volume grid geometry for the cell-centered schemes. */ -template< class FVGridGeometry, +template< class GridGeometry, class GridManager, class LowDimGridView, - std::enable_if_t = 0 > -void updateFVGridGeometry(FVGridGeometry& fvGridGeometry, + std::enable_if_t = 0 > +void updateFVGridGeometry(GridGeometry& gridGeometry, const GridManager& gridManager, const LowDimGridView& lowDimGridView) { - fvGridGeometry.update(); + gridGeometry.update(); } int main(int argc, char** argv) try @@ -180,10 +180,10 @@ int main(int argc, char** argv) try const auto& edgeGridView = gridManager.template grid().leafGridView(); // create the finite volume grid geometries - MultiDomainFVGridGeometry fvGridGeometry(std::make_tuple(bulkGridView, facetGridView, edgeGridView)); - updateFVGridGeometry(fvGridGeometry[bulkId], gridManager, facetGridView); - updateFVGridGeometry(fvGridGeometry[facetId], gridManager, edgeGridView); - fvGridGeometry[edgeId].update(); + MultiDomainFVGridGeometry gridGeometry(std::make_tuple(bulkGridView, facetGridView, edgeGridView)); + updateFVGridGeometry(gridGeometry[bulkId], gridManager, facetGridView); + updateFVGridGeometry(gridGeometry[facetId], gridManager, edgeGridView); + gridGeometry[edgeId].update(); // the coupling manager using CouplingManager = typename ThisTestTraits::CouplingManager; @@ -196,13 +196,13 @@ int main(int argc, char** argv) try using FacetProblem = MultiDomainFVProblem::template Type; using EdgeProblem = MultiDomainFVProblem::template Type; - auto bulkSpatialParams = std::make_shared(fvGridGeometry.get(bulkId), "Bulk"); - auto facetSpatialParams = std::make_shared(fvGridGeometry.get(facetId), "Facet"); - auto edgeSpatialParams = std::make_shared(fvGridGeometry.get(edgeId), "Edge"); + auto bulkSpatialParams = std::make_shared(gridGeometry.get(bulkId), "Bulk"); + auto facetSpatialParams = std::make_shared(gridGeometry.get(facetId), "Facet"); + auto edgeSpatialParams = std::make_shared(gridGeometry.get(edgeId), "Edge"); - problem.set(std::make_shared(fvGridGeometry.get(bulkId), bulkSpatialParams, couplingManager, "Bulk"), bulkId); - problem.set(std::make_shared(fvGridGeometry.get(facetId), facetSpatialParams, couplingManager, "Facet"), facetId); - problem.set(std::make_shared(fvGridGeometry.get(edgeId), edgeSpatialParams, couplingManager, "Edge"), edgeId); + problem.set(std::make_shared(gridGeometry.get(bulkId), bulkSpatialParams, couplingManager, "Bulk"), bulkId); + problem.set(std::make_shared(gridGeometry.get(facetId), facetSpatialParams, couplingManager, "Facet"), facetId); + problem.set(std::make_shared(gridGeometry.get(edgeId), edgeSpatialParams, couplingManager, "Edge"), edgeId); // the solution vector typename Traits::SolutionVector x; @@ -211,14 +211,14 @@ int main(int argc, char** argv) try // the coupling mapper using CouplingMapper = typename ThisTestTraits::CouplingMapper; auto couplingMapper = std::make_shared(); - couplingMapper->update(fvGridGeometry[bulkId], fvGridGeometry[facetId], fvGridGeometry[edgeId], gridManager.getEmbeddings()); + couplingMapper->update(gridGeometry[bulkId], gridGeometry[facetId], gridGeometry[edgeId], gridManager.getEmbeddings()); // initialize the coupling manager couplingManager->init(problem.get(bulkId), problem.get(facetId), problem.get(edgeId), couplingMapper, x); // the grid variables using GridVariables = MultiDomainFVGridVariables; - GridVariables gridVars(fvGridGeometry.getTuple(), problem.getTuple()); + GridVariables gridVars(gridGeometry.getTuple(), problem.getTuple()); gridVars.init(x); // intialize the vtk output module @@ -229,7 +229,7 @@ int main(int argc, char** argv) try // the assembler using Assembler = MultiDomainFVAssembler; - auto assembler = std::make_shared( problem.getTuple(), fvGridGeometry.getTuple(), gridVars.getTuple(), couplingManager); + auto assembler = std::make_shared( problem.getTuple(), gridGeometry.getTuple(), gridVars.getTuple(), couplingManager); // the linear solver using LinearSolver = ILU0BiCGSTABBackend; diff --git a/test/multidomain/facet/1p_1p/threedomain/problem_bulk.hh b/test/multidomain/facet/1p_1p/threedomain/problem_bulk.hh index f37b45af45dd18d20b201b85826c8eafb75b2f04..4d77a6a7169cbeaa114fcdcb0b6d8e3c6fb1dfd5 100644 --- a/test/multidomain/facet/1p_1p/threedomain/problem_bulk.hh +++ b/test/multidomain/facet/1p_1p/threedomain/problem_bulk.hh @@ -62,9 +62,9 @@ struct Problem { using type = OnePBulkProblem; template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePSpatialParams; + using type = OnePSpatialParams; }; // the fluid system @@ -94,9 +94,9 @@ class OnePBulkProblem : public PorousMediumFlowProblem using PrimaryVariables = typename GridVariables::PrimaryVariables; using Scalar = typename GridVariables::Scalar; - using FVGridGeometry = typename GridVariables::GridGeometry; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = typename GridVariables::GridGeometry; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -105,11 +105,11 @@ class OnePBulkProblem : public PorousMediumFlowProblem public: //! The constructor - OnePBulkProblem(std::shared_ptr fvGridGeometry, + OnePBulkProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams, std::shared_ptr couplingManagerPtr, const std::string& paramGroup = "Bulk") - : ParentType(fvGridGeometry, spatialParams, paramGroup) + : ParentType(gridGeometry, spatialParams, paramGroup) , couplingManagerPtr_(couplingManagerPtr) { problemName_ = getParam("Vtk.OutputName") + "_" + getParamFromGroup(this->paramGroup(), "Problem.Name"); diff --git a/test/multidomain/facet/1p_1p/threedomain/problem_edge.hh b/test/multidomain/facet/1p_1p/threedomain/problem_edge.hh index c8423409dfafe55901aa7306350dd8931e760a14..6f47d87b4fe66266311be127a582388bb99f318a 100644 --- a/test/multidomain/facet/1p_1p/threedomain/problem_edge.hh +++ b/test/multidomain/facet/1p_1p/threedomain/problem_edge.hh @@ -64,9 +64,9 @@ struct Problem { using type = OnePEdgeProblem; template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePSpatialParams; + using type = OnePSpatialParams; }; // the fluid system @@ -97,11 +97,11 @@ class OnePEdgeProblem : public PorousMediumFlowProblem using PrimaryVariables = typename GridVariables::PrimaryVariables; using Scalar = typename GridVariables::Scalar; - using FVGridGeometry = typename GridVariables::GridGeometry; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = typename GridVariables::GridGeometry; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -109,11 +109,11 @@ class OnePEdgeProblem : public PorousMediumFlowProblem using CouplingManager = GetPropType; public: - OnePEdgeProblem(std::shared_ptr fvGridGeometry, + OnePEdgeProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams, std::shared_ptr couplingManagerPtr, const std::string& paramGroup = "Edge") - : ParentType(fvGridGeometry, spatialParams, paramGroup) + : ParentType(gridGeometry, spatialParams, paramGroup) , couplingManagerPtr_(couplingManagerPtr) { const auto a = getParam("Extrusion.Aperture"); diff --git a/test/multidomain/facet/1p_1p/threedomain/problem_facet.hh b/test/multidomain/facet/1p_1p/threedomain/problem_facet.hh index c52cc5ba268d2cfb3ae413ff38b56d8483d09a30..bce69a373cea7f9a8396decb5c0f0ff52ce824fb 100644 --- a/test/multidomain/facet/1p_1p/threedomain/problem_facet.hh +++ b/test/multidomain/facet/1p_1p/threedomain/problem_facet.hh @@ -63,9 +63,9 @@ struct Problem { using type = OnePFacetProblem struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePSpatialParams; + using type = OnePSpatialParams; }; // the fluid system @@ -96,11 +96,11 @@ class OnePFacetProblem : public PorousMediumFlowProblem using PrimaryVariables = typename GridVariables::PrimaryVariables; using Scalar = typename GridVariables::Scalar; - using FVGridGeometry = typename GridVariables::GridGeometry; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = typename GridVariables::GridGeometry; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -108,11 +108,11 @@ class OnePFacetProblem : public PorousMediumFlowProblem using CouplingManager = GetPropType; public: - OnePFacetProblem(std::shared_ptr fvGridGeometry, + OnePFacetProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams, std::shared_ptr couplingManagerPtr, const std::string& paramGroup = "Facet") - : ParentType(fvGridGeometry, spatialParams, paramGroup) + : ParentType(gridGeometry, spatialParams, paramGroup) , couplingManagerPtr_(couplingManagerPtr) , aperture_(getParam("Extrusion.Aperture")) { diff --git a/test/multidomain/facet/1p_1p/threedomain/spatialparams.hh b/test/multidomain/facet/1p_1p/threedomain/spatialparams.hh index 47fe1a395410373585b29b98133338853363b1ad..8a1485932c193a64c1d7e9bc5e443f04cfaffbfc 100644 --- a/test/multidomain/facet/1p_1p/threedomain/spatialparams.hh +++ b/test/multidomain/facet/1p_1p/threedomain/spatialparams.hh @@ -33,23 +33,23 @@ namespace Dumux { * \ingroup FacetTests * \brief The spatial parameters for the single-phase facet coupling test. */ -template -class OnePSpatialParams : public FVSpatialParamsOneP> +template +class OnePSpatialParams : public FVSpatialParamsOneP> { - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; - using ThisType = OnePSpatialParams; - using ParentType = FVSpatialParamsOneP; + using ThisType = OnePSpatialParams; + using ParentType = FVSpatialParamsOneP; public: //! Export the type used for permeability using PermeabilityType = Scalar; - OnePSpatialParams(std::shared_ptr fvGridGeometry, const std::string& paramGroup = "") - : ParentType(fvGridGeometry) + OnePSpatialParams(std::shared_ptr gridGeometry, const std::string& paramGroup = "") + : ParentType(gridGeometry) { permeability_ = getParamFromGroup(paramGroup, "SpatialParams.Permeability"); } diff --git a/test/multidomain/facet/tracer_tracer/main.cc b/test/multidomain/facet/tracer_tracer/main.cc index 00b9b4a8eda4ba788e57e5b5dd2e10ef7d4b1c0e..e71e4427b725d3624f6c603229be6d6aad3cfafa 100644 --- a/test/multidomain/facet/tracer_tracer/main.cc +++ b/test/multidomain/facet/tracer_tracer/main.cc @@ -119,31 +119,31 @@ struct CouplingManager { using type = typename * have to create additional faces on interior boundaries, which wouldn't be * created in the standard scheme. */ -template< class FVGridGeometry, +template< class GridGeometry, class GridManager, class LowDimGridView, - std::enable_if_t = 0 > -void updateBulkFVGridGeometry(FVGridGeometry& fvGridGeometry, + std::enable_if_t = 0 > +void updateBulkFVGridGeometry(GridGeometry& gridGeometry, const GridManager& gridManager, const LowDimGridView& lowDimGridView) { using BulkFacetGridAdapter = Dumux::CodimOneGridAdapter; BulkFacetGridAdapter facetGridAdapter(gridManager.getEmbeddings()); - fvGridGeometry.update(lowDimGridView, facetGridAdapter); + gridGeometry.update(lowDimGridView, facetGridAdapter); } /*! * \brief Updates the finite volume grid geometry for the cell centered schemes. */ - template< class FVGridGeometry, + template< class GridGeometry, class GridManager, class LowDimGridView, - std::enable_if_t = 0 > -void updateBulkFVGridGeometry(FVGridGeometry& fvGridGeometry, + std::enable_if_t = 0 > +void updateBulkFVGridGeometry(GridGeometry& gridGeometry, const GridManager& gridManager, const LowDimGridView& lowDimGridView) { - fvGridGeometry.update(); + gridGeometry.update(); } //! Computes the volume fluxes on all scvfs for a sub-domain. @@ -152,7 +152,7 @@ void computeVolumeFluxes(Storage& volumeFluxes, CM& couplingManager, const Assembler& assembler, const Prob& problem, - const typename GV::GridGeometry& fvGridGeometry, + const typename GV::GridGeometry& gridGeometry, const GV& gridVariables, const Sol& sol, Dune::index_constant domainId) @@ -160,17 +160,17 @@ void computeVolumeFluxes(Storage& volumeFluxes, static constexpr bool isBox = GV::GridGeometry::discMethod == Dumux::DiscretizationMethod::box; // resize depending on the scheme - if (!isBox) volumeFluxes.assign(fvGridGeometry.numScvf(), {0.0}); - else volumeFluxes.assign(fvGridGeometry.gridView().size(0), {0.0}); + if (!isBox) volumeFluxes.assign(gridGeometry.numScvf(), {0.0}); + else volumeFluxes.assign(gridGeometry.gridView().size(0), {0.0}); auto upwindTerm = [](const auto& volVars) { return volVars.mobility(0); }; - for (const auto& element : elements(fvGridGeometry.gridView())) + for (const auto& element : elements(gridGeometry.gridView())) { - const auto eIdx = fvGridGeometry.elementMapper().index(element); + const auto eIdx = gridGeometry.elementMapper().index(element); // bind local views couplingManager.bindCouplingContext(domainId, element, assembler); - auto fvGeometry = localView(fvGridGeometry); + auto fvGeometry = localView(gridGeometry); auto elemVolVars = localView(gridVariables.curGridVolVars()); auto elemFluxVars = localView(gridVariables.gridFluxVarsCache()); fvGeometry.bind(element); @@ -194,10 +194,10 @@ void computeVolumeFluxes(Storage& volumeFluxes, && problem.boundaryTypes(element, fvGeometry.scv(scvf.insideScvIdx())).hasOnlyDirichlet()) { // reconstruct flux - const auto elemSol = elementSolution(element, sol, fvGridGeometry); + const auto elemSol = elementSolution(element, sol, gridGeometry); const auto gradP = evalGradients(element, element.geometry(), - fvGridGeometry, + gridGeometry, elemSol, scvf.ipGlobal())[0]; const auto& insideVolVars = elemVolVars[fvGeometry.scv(scvf.insideScvIdx())]; diff --git a/test/multidomain/facet/tracer_tracer/problem_1p_bulk.hh b/test/multidomain/facet/tracer_tracer/problem_1p_bulk.hh index 92a4b7269e4c34c2523ea9cb28c8806864446f76..9c4f4f4aece92864bd04822d8673a8774d8e298f 100644 --- a/test/multidomain/facet/tracer_tracer/problem_1p_bulk.hh +++ b/test/multidomain/facet/tracer_tracer/problem_1p_bulk.hh @@ -94,11 +94,11 @@ class OnePBulkProblem : public PorousMediumFlowProblem using PrimaryVariables = typename GridVariables::PrimaryVariables; using Scalar = typename GridVariables::Scalar; - using FVGridGeometry = typename GridVariables::GridGeometry; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = typename GridVariables::GridGeometry; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -108,11 +108,11 @@ class OnePBulkProblem : public PorousMediumFlowProblem using Indices = typename GetPropType::Indices; public: - OnePBulkProblem(std::shared_ptr fvGridGeometry, + OnePBulkProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams, std::shared_ptr couplingManager, const std::string& paramGroup = "") - : ParentType(fvGridGeometry, spatialParams, paramGroup) + : ParentType(gridGeometry, spatialParams, paramGroup) , couplingManagerPtr_(couplingManager) , overPressure_(getParamFromGroup(paramGroup, "Problem.BoundaryOverpressure")) { diff --git a/test/multidomain/facet/tracer_tracer/problem_1p_lowdim.hh b/test/multidomain/facet/tracer_tracer/problem_1p_lowdim.hh index cd333643b92fa5548139a0a6a38f1ba9e75399ea..5147486dae9bb15c5d83a1b1a2ba56e4b8456b14 100644 --- a/test/multidomain/facet/tracer_tracer/problem_1p_lowdim.hh +++ b/test/multidomain/facet/tracer_tracer/problem_1p_lowdim.hh @@ -93,10 +93,10 @@ class OnePLowDimProblem : public PorousMediumFlowProblem using PrimaryVariables = typename GridVariables::PrimaryVariables; using Scalar = typename GridVariables::Scalar; - using FVGridGeometry = typename GridVariables::GridGeometry; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = typename GridVariables::GridGeometry; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -106,11 +106,11 @@ class OnePLowDimProblem : public PorousMediumFlowProblem using Indices = typename GetPropType::Indices; public: - OnePLowDimProblem(std::shared_ptr fvGridGeometry, + OnePLowDimProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams, std::shared_ptr couplingManager, const std::string& paramGroup = "") - : ParentType(fvGridGeometry, spatialParams, paramGroup) + : ParentType(gridGeometry, spatialParams, paramGroup) , couplingManagerPtr_(couplingManager) , aperture_(getParamFromGroup(paramGroup, "Problem.FractureAperture")) { diff --git a/test/multidomain/facet/tracer_tracer/problem_tracer_bulk.hh b/test/multidomain/facet/tracer_tracer/problem_tracer_bulk.hh index 04ddab7dce0a2ea7c79fed265e0e9a02176dd507..680fff33dedc1502e5c2c5d95e147b49b5854f1f 100644 --- a/test/multidomain/facet/tracer_tracer/problem_tracer_bulk.hh +++ b/test/multidomain/facet/tracer_tracer/problem_tracer_bulk.hh @@ -74,9 +74,9 @@ struct Problem { using type = TracerBulkProblem struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = TracerSpatialParams; + using type = TracerSpatialParams; }; // Define whether mole(true) or mass (false) fractions are used @@ -111,9 +111,9 @@ class TracerBulkProblem : public PorousMediumFlowProblem using Scalar = GetPropType; using Indices = typename GetPropType::Indices; using GridView = GetPropType; - using FVGridGeometry = GetPropType; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = GetPropType; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; + using FVElementGeometry = typename GridGeometry::LocalView; using BoundaryTypes = GetPropType; using PrimaryVariables = GetPropType; using NumEqVector = GetPropType; @@ -123,17 +123,17 @@ class TracerBulkProblem : public PorousMediumFlowProblem //! property that defines whether mole or mass fractions are used static constexpr bool useMoles = getPropValue(); - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: using typename ParentType::SpatialParams; - TracerBulkProblem(std::shared_ptr fvGridGeom, + TracerBulkProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams, std::shared_ptr couplingManager, const std::string& paramGroup = "") - : ParentType(fvGridGeom, spatialParams, paramGroup) + : ParentType(gridGeometry, spatialParams, paramGroup) , couplingManagerPtr_(couplingManager) , initialMassFraction_(getParamFromGroup(paramGroup, "Problem.ContaminationMassFraction")) { diff --git a/test/multidomain/facet/tracer_tracer/problem_tracer_lowdim.hh b/test/multidomain/facet/tracer_tracer/problem_tracer_lowdim.hh index 19e2db2beb22b62ece5f0ad813f180cca1f7cd22..04aa633a7a51400eff41de8ebfabc6a9c6c2ddc5 100644 --- a/test/multidomain/facet/tracer_tracer/problem_tracer_lowdim.hh +++ b/test/multidomain/facet/tracer_tracer/problem_tracer_lowdim.hh @@ -67,9 +67,9 @@ struct Problem { using type = TracerLowDimProbl template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = TracerSpatialParams; + using type = TracerSpatialParams; }; // Define whether mole(true) or mass (false) fractions are used @@ -104,8 +104,8 @@ class TracerLowDimProblem : public PorousMediumFlowProblem using Scalar = GetPropType; using Indices = typename GetPropType::Indices; using GridView = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using BoundaryTypes = GetPropType; using PrimaryVariables = GetPropType; @@ -116,17 +116,17 @@ class TracerLowDimProblem : public PorousMediumFlowProblem //! property that defines whether mole or mass fractions are used static constexpr bool useMoles = getPropValue(); - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: using typename ParentType::SpatialParams; - TracerLowDimProblem(std::shared_ptr fvGridGeom, + TracerLowDimProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams, std::shared_ptr couplingManager, const std::string& paramGroup = "") - : ParentType(fvGridGeom, spatialParams, paramGroup) + : ParentType(gridGeometry, spatialParams, paramGroup) , couplingManagerPtr_(couplingManager) , aperture_(getParamFromGroup(paramGroup, "Problem.FractureAperture")) { diff --git a/test/multidomain/facet/tracer_tracer/spatialparams_1p.hh b/test/multidomain/facet/tracer_tracer/spatialparams_1p.hh index f5c564ebb516812b9a13bbc4870a8cdb1fe739bb..041d4d04949e3c3ecd31fa6ab145251199dcb701 100644 --- a/test/multidomain/facet/tracer_tracer/spatialparams_1p.hh +++ b/test/multidomain/facet/tracer_tracer/spatialparams_1p.hh @@ -36,14 +36,14 @@ namespace Dumux * \brief The spatial parameters of the single-phase problem * within the tracer facet coupling test. */ -template< class FVGridGeometry, class Scalar > +template< class GridGeometry, class Scalar > class OnePSpatialParams -: public FVSpatialParamsOneP< FVGridGeometry, Scalar, OnePSpatialParams > +: public FVSpatialParamsOneP< GridGeometry, Scalar, OnePSpatialParams > { - using ThisType = OnePSpatialParams< FVGridGeometry, Scalar >; - using ParentType = FVSpatialParamsOneP< FVGridGeometry, Scalar, ThisType >; + using ThisType = OnePSpatialParams< GridGeometry, Scalar >; + using ParentType = FVSpatialParamsOneP< GridGeometry, Scalar, ThisType >; - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -51,8 +51,8 @@ public: //! Export the type used for permeabilities using PermeabilityType = Scalar; - OnePSpatialParams(std::shared_ptr fvGridGeometry, const std::string& paramGroup = "") - : ParentType(fvGridGeometry) + OnePSpatialParams(std::shared_ptr gridGeometry, const std::string& paramGroup = "") + : ParentType(gridGeometry) , permeability_(getParamFromGroup(paramGroup, "SpatialParams.Permeability")) , porosity_(getParamFromGroup(paramGroup, "SpatialParams.Porosity")) {} diff --git a/test/multidomain/facet/tracer_tracer/spatialparams_tracer.hh b/test/multidomain/facet/tracer_tracer/spatialparams_tracer.hh index 0b787d974d8545c439406e607d8276bfb49929e0..a1472f565e024e293dbf2235a2adb08fccbc991e 100644 --- a/test/multidomain/facet/tracer_tracer/spatialparams_tracer.hh +++ b/test/multidomain/facet/tracer_tracer/spatialparams_tracer.hh @@ -34,29 +34,29 @@ namespace Dumux { * \ingroup FacetTests * \brief Definition of the spatial parameters for the tracer problem. */ -template +template class TracerSpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParamsOneP>; + using ParentType = FVSpatialParamsOneP>; - static constexpr bool isBox = FVGridGeometry::discMethod == DiscretizationMethod::box; + static constexpr bool isBox = GridGeometry::discMethod == DiscretizationMethod::box; static constexpr int dimWorld = GridView::dimensionworld; using GlobalPosition = typename Dune::FieldVector; public: - TracerSpatialParams(std::shared_ptr fvGridGeometry, + TracerSpatialParams(std::shared_ptr gridGeometry, const std::vector< std::vector >& volumeFluxes, const std::string& paramGroup = "") - : ParentType(fvGridGeometry) + : ParentType(gridGeometry) , volumeFlux_(volumeFluxes) , porosity_(getParamFromGroup(paramGroup, "SpatialParams.Porosity")) {} diff --git a/test/multidomain/poromechanics/el1p/problem_1p.hh b/test/multidomain/poromechanics/el1p/problem_1p.hh index 25516dac45e28206af012b85aa62bcf0f724c6b1..478ef62a952afb73091579f2a198627cab831829 100644 --- a/test/multidomain/poromechanics/el1p/problem_1p.hh +++ b/test/multidomain/poromechanics/el1p/problem_1p.hh @@ -67,10 +67,10 @@ struct Problem { using type = OnePSubProblem ; template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; using CouplingManager = GetPropType; - using type = OnePSpatialParams; + using type = OnePSpatialParams; }; } // end namespace Properties @@ -94,13 +94,13 @@ class OnePSubProblem : public PorousMediumFlowProblem using NumEqVector = GetPropType; using PrimaryVariables = GetPropType; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; public: - OnePSubProblem(std::shared_ptr fvGridGeometry, + OnePSubProblem(std::shared_ptr gridGeometry, std::shared_ptr> spatialParams, const std::string& paramGroup = "OneP") - : ParentType(fvGridGeometry, spatialParams, paramGroup) + : ParentType(gridGeometry, spatialParams, paramGroup) { problemName_ = getParam("Vtk.OutputName") + "_" + getParamFromGroup(this->paramGroup(), "Problem.Name"); } diff --git a/test/multidomain/poromechanics/el1p/problem_poroelastic.hh b/test/multidomain/poromechanics/el1p/problem_poroelastic.hh index def8e598b56dbd99081b0d67abae7daac155f895..7fbe2e2c6e9f0f102d31233a4821ec4e55ae75e1 100644 --- a/test/multidomain/poromechanics/el1p/problem_poroelastic.hh +++ b/test/multidomain/poromechanics/el1p/problem_poroelastic.hh @@ -87,9 +87,9 @@ class PoroElasticSubProblem : public GeomechanicsFVProblem using PrimaryVariables = GetPropType; using ElementVolumeVariables = typename GetPropType::LocalView; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; using GridView = GetPropType; using Element = typename GridView::template Codim<0>::Entity; @@ -100,10 +100,10 @@ class PoroElasticSubProblem : public GeomechanicsFVProblem using GradU = Dune::FieldMatrix; public: - PoroElasticSubProblem(std::shared_ptr fvGridGeometry, + PoroElasticSubProblem(std::shared_ptr gridGeometry, std::shared_ptr couplingManagerPtr, const std::string& paramGroup = "PoroElastic") - : ParentType(fvGridGeometry, paramGroup) + : ParentType(gridGeometry, paramGroup) , couplingManagerPtr_(couplingManagerPtr) { problemName_ = getParam("Vtk.OutputName") + "_" + getParamFromGroup(this->paramGroup(), "Problem.Name"); diff --git a/test/multidomain/poromechanics/el1p/spatialparams_1p.hh b/test/multidomain/poromechanics/el1p/spatialparams_1p.hh index e5331893b2e43c2aa758f837edd8aff6c1edc495..ddff0f7dcadc7028050df5cd21a840b7f79df72e 100644 --- a/test/multidomain/poromechanics/el1p/spatialparams_1p.hh +++ b/test/multidomain/poromechanics/el1p/spatialparams_1p.hh @@ -39,25 +39,25 @@ namespace Dumux { * \brief The spatial parameters class for the test problem using the * 1p box model. */ -template -class OnePSpatialParams : public FVSpatialParamsOneP> +template +class OnePSpatialParams : public FVSpatialParamsOneP> { - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using GridView = typename FVGridGeometry::GridView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; - using ThisType = OnePSpatialParams; - using ParentType = FVSpatialParamsOneP; + using ThisType = OnePSpatialParams; + using ParentType = FVSpatialParamsOneP; public: // export permeability type using PermeabilityType = Scalar; - OnePSpatialParams(std::shared_ptr fvGridGeometry, + OnePSpatialParams(std::shared_ptr gridGeometry, std::shared_ptr couplingManagerPtr) - : ParentType(fvGridGeometry) + : ParentType(gridGeometry) , couplingManagerPtr_(couplingManagerPtr) , permeability_(getParam("SpatialParams.Permeability")) , initPorosity_(getParam("SpatialParams.InitialPorosity")) diff --git a/test/multidomain/poromechanics/el1p/spatialparams_poroelastic.hh b/test/multidomain/poromechanics/el1p/spatialparams_poroelastic.hh index 4416db2d9e015285f51cc962ee4184cbee0da844..fa9b37fbf642d4a78a858fd7fafe132ba603b714 100644 --- a/test/multidomain/poromechanics/el1p/spatialparams_poroelastic.hh +++ b/test/multidomain/poromechanics/el1p/spatialparams_poroelastic.hh @@ -35,16 +35,16 @@ namespace Dumux { * \brief Definition of the spatial parameters for the poro-elastic * sub-problem in the coupled poro-mechanical el1p problem. */ -template +template class PoroElasticSpatialParams : public FVSpatialParamsPoroElastic< Scalar, - FVGridGeometry, - PoroElasticSpatialParams > + GridGeometry, + PoroElasticSpatialParams > { - using ThisType = PoroElasticSpatialParams; - using ParentType = FVSpatialParamsPoroElastic; + using ThisType = PoroElasticSpatialParams; + using ParentType = FVSpatialParamsPoroElastic; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using GridView = typename FVGridGeometry::GridView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -52,8 +52,8 @@ public: //! Export the type of the lame parameters using LameParams = Dumux::LameParams; - PoroElasticSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + PoroElasticSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) , initPorosity_(getParam("SpatialParams.InitialPorosity")) { // Young's modulus [Pa] diff --git a/test/multidomain/poromechanics/el2p/problem_2p.hh b/test/multidomain/poromechanics/el2p/problem_2p.hh index 8db13e8e4b884fc87e5614da75d0cf7854bd3524..60abeddcd50da1f66310f2530afd21fcc4c027cf 100644 --- a/test/multidomain/poromechanics/el2p/problem_2p.hh +++ b/test/multidomain/poromechanics/el2p/problem_2p.hh @@ -68,10 +68,10 @@ struct Problem { using type = TwoPSubProblem ; template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; using CouplingManager = GetPropType; - using type = TwoPSpatialParams; + using type = TwoPSpatialParams; }; } // end namespace Properties @@ -102,13 +102,13 @@ class TwoPSubProblem : public PorousMediumFlowProblem using NumEqVector = GetPropType; using PrimaryVariables = GetPropType; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; public: - TwoPSubProblem(std::shared_ptr fvGridGeometry, + TwoPSubProblem(std::shared_ptr gridGeometry, std::shared_ptr> spatialParams, const std::string& paramGroup = "TwoP") - : ParentType(fvGridGeometry, spatialParams, paramGroup) + : ParentType(gridGeometry, spatialParams, paramGroup) { FluidSystem::init(); problemName_ = getParam("Vtk.OutputName") + "_" + getParamFromGroup(this->paramGroup(), "Problem.Name"); diff --git a/test/multidomain/poromechanics/el2p/problem_poroelastic.hh b/test/multidomain/poromechanics/el2p/problem_poroelastic.hh index 602b27628f72253bbf92c549cc471a0840df167f..c7fa0cab716593de7b5caa44383f8fb38e352cba 100644 --- a/test/multidomain/poromechanics/el2p/problem_poroelastic.hh +++ b/test/multidomain/poromechanics/el2p/problem_poroelastic.hh @@ -89,9 +89,9 @@ class PoroElasticSubProblem : public GeomechanicsFVProblem using PrimaryVariables = GetPropType; using ElementVolumeVariables = typename GetPropType::LocalView; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; using GridView = GetPropType; using Element = typename GridView::template Codim<0>::Entity; @@ -102,10 +102,10 @@ class PoroElasticSubProblem : public GeomechanicsFVProblem using GradU = Dune::FieldMatrix; public: - PoroElasticSubProblem(std::shared_ptr fvGridGeometry, + PoroElasticSubProblem(std::shared_ptr gridGeometry, std::shared_ptr couplingManagerPtr, const std::string& paramGroup = "PoroElastic") - : ParentType(fvGridGeometry, paramGroup) + : ParentType(gridGeometry, paramGroup) , couplingManagerPtr_(couplingManagerPtr) { problemName_ = getParam("Vtk.OutputName") + "_" + getParamFromGroup(this->paramGroup(), "Problem.Name"); diff --git a/test/multidomain/poromechanics/el2p/spatialparams_2p.hh b/test/multidomain/poromechanics/el2p/spatialparams_2p.hh index e33c97f6227e4f1f330683aa372abf9681d3ba73..543c5660b0473276ef7679cf3ee5a2b94279b646 100644 --- a/test/multidomain/poromechanics/el2p/spatialparams_2p.hh +++ b/test/multidomain/poromechanics/el2p/spatialparams_2p.hh @@ -40,17 +40,17 @@ namespace Dumux { * \ingroup PoromechanicsTests * \brief The spatial parameters class for the two-phase sub problem in the el2p test problem. */ -template -class TwoPSpatialParams : public FVSpatialParams> +template +class TwoPSpatialParams : public FVSpatialParams> { - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using GridView = typename FVGridGeometry::GridView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; - using ThisType = TwoPSpatialParams; - using ParentType = FVSpatialParams; + using ThisType = TwoPSpatialParams; + using ParentType = FVSpatialParams; public: using EffectiveLaw = RegularizedBrooksCorey; @@ -59,9 +59,9 @@ public: // export permeability type using PermeabilityType = Scalar; - TwoPSpatialParams(std::shared_ptr fvGridGeometry, + TwoPSpatialParams(std::shared_ptr gridGeometry, std::shared_ptr couplingManagerPtr) - : ParentType(fvGridGeometry) + : ParentType(gridGeometry) , couplingManagerPtr_(couplingManagerPtr) , initPermeability_(getParam("SpatialParams.Permeability")) , initPorosity_(getParam("SpatialParams.InitialPorosity")) diff --git a/test/multidomain/poromechanics/el2p/spatialparams_poroelastic.hh b/test/multidomain/poromechanics/el2p/spatialparams_poroelastic.hh index 4416db2d9e015285f51cc962ee4184cbee0da844..fa9b37fbf642d4a78a858fd7fafe132ba603b714 100644 --- a/test/multidomain/poromechanics/el2p/spatialparams_poroelastic.hh +++ b/test/multidomain/poromechanics/el2p/spatialparams_poroelastic.hh @@ -35,16 +35,16 @@ namespace Dumux { * \brief Definition of the spatial parameters for the poro-elastic * sub-problem in the coupled poro-mechanical el1p problem. */ -template +template class PoroElasticSpatialParams : public FVSpatialParamsPoroElastic< Scalar, - FVGridGeometry, - PoroElasticSpatialParams > + GridGeometry, + PoroElasticSpatialParams > { - using ThisType = PoroElasticSpatialParams; - using ParentType = FVSpatialParamsPoroElastic; + using ThisType = PoroElasticSpatialParams; + using ParentType = FVSpatialParamsPoroElastic; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using GridView = typename FVGridGeometry::GridView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -52,8 +52,8 @@ public: //! Export the type of the lame parameters using LameParams = Dumux::LameParams; - PoroElasticSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + PoroElasticSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) , initPorosity_(getParam("SpatialParams.InitialPorosity")) { // Young's modulus [Pa] diff --git a/test/porousmediumflow/1p/implicit/compressible/instationary/main.cc b/test/porousmediumflow/1p/implicit/compressible/instationary/main.cc index 10ce65de398ba0a1165e0d9e67a11f6084ef845d..ddf18f530593b2b94650ae1e05c76fdfb3f6a6d9 100644 --- a/test/porousmediumflow/1p/implicit/compressible/instationary/main.cc +++ b/test/porousmediumflow/1p/implicit/compressible/instationary/main.cc @@ -84,23 +84,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -123,7 +123,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = ILU0BiCGSTABBackend; diff --git a/test/porousmediumflow/1p/implicit/compressible/instationary/problem.hh b/test/porousmediumflow/1p/implicit/compressible/instationary/problem.hh index 90b065496341db382e6cc80b65e33891b20f9b19..e3c2ae728fcc93cf05f10d2ba5acb27893be8ee9 100644 --- a/test/porousmediumflow/1p/implicit/compressible/instationary/problem.hh +++ b/test/porousmediumflow/1p/implicit/compressible/instationary/problem.hh @@ -66,9 +66,9 @@ struct Problem { using type = OnePTestProblem struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePTestSpatialParams; + using type = OnePTestSpatialParams; }; // the fluid system @@ -105,14 +105,14 @@ class OnePTestProblem : public PorousMediumFlowProblem using Element = typename GridView::template Codim<0>::Entity; using Scalar = GetPropType; using PrimaryVariables = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using BoundaryTypes = GetPropType; static constexpr int dimWorld = GridView::dimensionworld; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: - OnePTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + OnePTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { Components::TabulatedComponent>::init(272.15, 294.15, 10, 1.0e4, 1.0e6, 200); diff --git a/test/porousmediumflow/1p/implicit/compressible/instationary/spatialparams.hh b/test/porousmediumflow/1p/implicit/compressible/instationary/spatialparams.hh index 04b3baf4b7747fa76d7e58ff94f1fd3d9b6605df..870426b05409d552496b308ccbcf0f4a4ffde89c 100644 --- a/test/porousmediumflow/1p/implicit/compressible/instationary/spatialparams.hh +++ b/test/porousmediumflow/1p/implicit/compressible/instationary/spatialparams.hh @@ -35,25 +35,25 @@ namespace Dumux { * \brief The spatial parameters class for the test problem using the * compressible 1p model. */ -template +template class OnePTestSpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; - using ParentType = FVSpatialParamsOneP>; + using ParentType = FVSpatialParamsOneP>; static constexpr int dimWorld = GridView::dimensionworld; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: using PermeabilityType = Scalar; - OnePTestSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + OnePTestSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { permeability_ = getParam("SpatialParams.Permeability"); permeabilityLens_ = getParam("SpatialParams.PermeabilityLens"); diff --git a/test/porousmediumflow/1p/implicit/compressible/stationary/main.cc b/test/porousmediumflow/1p/implicit/compressible/stationary/main.cc index 4a61085b581582de1b7cfa165c85762fb07e7247..6e9e6c3bbb74986d56913b19ede72dc18362944d 100644 --- a/test/porousmediumflow/1p/implicit/compressible/stationary/main.cc +++ b/test/porousmediumflow/1p/implicit/compressible/stationary/main.cc @@ -82,21 +82,21 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // intialize the vtk output module @@ -109,7 +109,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables); // the linear solver using LinearSolver = ILU0BiCGSTABBackend; diff --git a/test/porousmediumflow/1p/implicit/compressible/stationary/problem.hh b/test/porousmediumflow/1p/implicit/compressible/stationary/problem.hh index 90b065496341db382e6cc80b65e33891b20f9b19..e3c2ae728fcc93cf05f10d2ba5acb27893be8ee9 100644 --- a/test/porousmediumflow/1p/implicit/compressible/stationary/problem.hh +++ b/test/porousmediumflow/1p/implicit/compressible/stationary/problem.hh @@ -66,9 +66,9 @@ struct Problem { using type = OnePTestProblem struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePTestSpatialParams; + using type = OnePTestSpatialParams; }; // the fluid system @@ -105,14 +105,14 @@ class OnePTestProblem : public PorousMediumFlowProblem using Element = typename GridView::template Codim<0>::Entity; using Scalar = GetPropType; using PrimaryVariables = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using BoundaryTypes = GetPropType; static constexpr int dimWorld = GridView::dimensionworld; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: - OnePTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + OnePTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { Components::TabulatedComponent>::init(272.15, 294.15, 10, 1.0e4, 1.0e6, 200); diff --git a/test/porousmediumflow/1p/implicit/compressible/stationary/spatialparams.hh b/test/porousmediumflow/1p/implicit/compressible/stationary/spatialparams.hh index 90901ac692924f17fd86e9d38d10e322a2cf347d..c34f9bf6ad58efa3a94ae714aca07789eb9d809f 100644 --- a/test/porousmediumflow/1p/implicit/compressible/stationary/spatialparams.hh +++ b/test/porousmediumflow/1p/implicit/compressible/stationary/spatialparams.hh @@ -35,25 +35,25 @@ namespace Dumux { * \brief The spatial parameters class for the test problem using the * compressible 1p model */ -template +template class OnePTestSpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; - using ParentType = FVSpatialParamsOneP>; + using ParentType = FVSpatialParamsOneP>; static constexpr int dimWorld = GridView::dimensionworld; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: using PermeabilityType = Scalar; - OnePTestSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + OnePTestSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { permeability_ = getParam("SpatialParams.Permeability"); permeabilityLens_ = getParam("SpatialParams.PermeabilityLens"); diff --git a/test/porousmediumflow/1p/implicit/convergence/problem.hh b/test/porousmediumflow/1p/implicit/convergence/problem.hh index 3df9ebca6cb507bdd3d3d4702d3c58aaebaa3676..a1bfcceeb2511882e853aee657b6e1e579a436c0 100644 --- a/test/porousmediumflow/1p/implicit/convergence/problem.hh +++ b/test/porousmediumflow/1p/implicit/convergence/problem.hh @@ -67,9 +67,9 @@ struct Problem { using type = OnePTestProblem template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePTestSpatialParams; + using type = OnePTestSpatialParams; }; // use the incompressible local residual (provides analytic jacobian) @@ -100,20 +100,20 @@ class OnePTestProblem : public PorousMediumFlowProblem using PrimaryVariables = GetPropType; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: /*! * \brief The constructor. - * \param fvGridGeometry The finite-volume grid geometry + * \param gridGeometry The finite-volume grid geometry */ - OnePTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + OnePTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) {} /*! diff --git a/test/porousmediumflow/1p/implicit/convergence/solver.hh b/test/porousmediumflow/1p/implicit/convergence/solver.hh index ea178eb0d30b6d42b1fe9b8e1ccaad43a51e08c8..371324473a00b8671b937be604f779900866464a 100644 --- a/test/porousmediumflow/1p/implicit/convergence/solver.hh +++ b/test/porousmediumflow/1p/implicit/convergence/solver.hh @@ -88,26 +88,26 @@ SolutionStorage solveRefinementLevel(int numCells) Dune::Timer timer; // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - auto x = std::make_shared(fvGridGeometry->numDofs()); + auto x = std::make_shared(gridGeometry->numDofs()); // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(*x); // create assembler & linear solver using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables); using LinearSolver = ILU0BiCGSTABBackend; auto linearSolver = std::make_shared(); @@ -125,11 +125,11 @@ SolutionStorage solveRefinementLevel(int numCells) // add exact solution using Scalar = GetPropType; - std::vector exact(fvGridGeometry->numDofs()); + std::vector exact(gridGeometry->numDofs()); - for (const auto& element : elements(fvGridGeometry->gridView())) + for (const auto& element : elements(gridGeometry->gridView())) { - auto fvGeometry = localView(*fvGridGeometry); + auto fvGeometry = localView(*gridGeometry); fvGeometry.bindElement(element); for (const auto& scv : scvs(fvGeometry)) @@ -141,7 +141,7 @@ SolutionStorage solveRefinementLevel(int numCells) } // fill storage and return - storage.gridGeometry = fvGridGeometry; + storage.gridGeometry = gridGeometry; storage.solution = x; return storage; } diff --git a/test/porousmediumflow/1p/implicit/convergence/spatialparams.hh b/test/porousmediumflow/1p/implicit/convergence/spatialparams.hh index 9c245763e3a329a15d57c080a7dee1a9c0a00109..af69b25b1a18b0939ccdeea876e36c3a8a597610 100644 --- a/test/porousmediumflow/1p/implicit/convergence/spatialparams.hh +++ b/test/porousmediumflow/1p/implicit/convergence/spatialparams.hh @@ -33,15 +33,15 @@ namespace Dumux { * \ingroup OnePTests * \brief The spatial params of the incompressible single-phase convergence test */ -template +template class OnePTestSpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using ThisType = OnePTestSpatialParams; - using ParentType = FVSpatialParamsOneP; + using ThisType = OnePTestSpatialParams; + using ParentType = FVSpatialParamsOneP; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: @@ -49,10 +49,10 @@ public: /*! * \brief The constructor. - * \param fvGridGeometry The finite-volume grid geometry + * \param gridGeometry The finite-volume grid geometry */ - OnePTestSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + OnePTestSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) {} /*! diff --git a/test/porousmediumflow/1p/implicit/fracture2d3d/main.cc b/test/porousmediumflow/1p/implicit/fracture2d3d/main.cc index 15b1f325918bf35d2252090482054529d03729f5..592f892d8050e494de8356c0747719b7c734b748 100644 --- a/test/porousmediumflow/1p/implicit/fracture2d3d/main.cc +++ b/test/porousmediumflow/1p/implicit/fracture2d3d/main.cc @@ -105,23 +105,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -144,11 +144,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NewtonSolver; diff --git a/test/porousmediumflow/1p/implicit/fracture2d3d/problem.hh b/test/porousmediumflow/1p/implicit/fracture2d3d/problem.hh index c6a4786a1a2fde8b52e9242b9245a40c4eda1ffd..94894add8a74a63bb5f546b23ed8e7edf59e4682 100644 --- a/test/porousmediumflow/1p/implicit/fracture2d3d/problem.hh +++ b/test/porousmediumflow/1p/implicit/fracture2d3d/problem.hh @@ -84,9 +84,9 @@ struct FluidSystem template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = FractureSpatialParams; + using type = FractureSpatialParams; }; } // end namespace Properties @@ -117,11 +117,11 @@ class FractureProblem : public PorousMediumFlowProblem using Scalar = GetPropType; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; public: - FractureProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + FractureProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { name_ = getParam("Problem.Name"); } diff --git a/test/porousmediumflow/1p/implicit/fracture2d3d/spatialparams.hh b/test/porousmediumflow/1p/implicit/fracture2d3d/spatialparams.hh index 696eba51129164afcbd3700e4eb6d9dddda4912f..edbb0617e29259fb0f7201f62c6171d039f8c6c1 100644 --- a/test/porousmediumflow/1p/implicit/fracture2d3d/spatialparams.hh +++ b/test/porousmediumflow/1p/implicit/fracture2d3d/spatialparams.hh @@ -36,14 +36,14 @@ namespace Dumux { * \brief The spatial parameters for the LensProblem which uses the * two-phase fully implicit model. */ -template +template class FractureSpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using GridView = typename FVGridGeometry::GridView; - using ParentType = FVSpatialParamsOneP>; + using GridView = typename GridGeometry::GridView; + using ParentType = FVSpatialParamsOneP>; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -52,8 +52,8 @@ public: // export permeability type using PermeabilityType = Scalar; - FractureSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + FractureSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) {} /*! diff --git a/test/porousmediumflow/1p/implicit/incompressible/main.cc b/test/porousmediumflow/1p/implicit/incompressible/main.cc index 541327d37f2994e466acc15021dac61d2fea0bd0..22ef9abbd39a90ac5f52046bbbda3cbe475517d5 100644 --- a/test/porousmediumflow/1p/implicit/incompressible/main.cc +++ b/test/porousmediumflow/1p/implicit/incompressible/main.cc @@ -57,25 +57,25 @@ #include "../internaldirichlet/problem.hh" //! Function to write out the scv-wise velocities (overload for mpfa) -template = 0> -void writeMpfaVelocities(const FVGridGeometry& fvGridGeometry, +template = 0> +void writeMpfaVelocities(const GridGeometry& gridGeometry, const GridVariables& gridVariables, const Sol& x) { using Scalar = typename GridVariables::Scalar; - using GlobalPos = typename FVGridGeometry::SubControlVolume::GlobalPosition; + using GlobalPos = typename GridGeometry::SubControlVolume::GlobalPosition; - const auto velocities = Dumux::CCMpfaScvGradients::computeVelocities(fvGridGeometry, gridVariables, x, /*phaseIdx*/0); + const auto velocities = Dumux::CCMpfaScvGradients::computeVelocities(gridGeometry, gridVariables, x, /*phaseIdx*/0); Dumux::PointCloudVtkWriter writer(velocities.first); writer.addPointData(velocities.second, "velocity (m/s)"); writer.write("mpfa_scv_velocities"); } //! Function to write out the scv-wise velocities (overload for NOT mpfa) -template = 0> -void writeMpfaVelocities(const FVGridGeometry& fvGridGeometry, +template = 0> +void writeMpfaVelocities(const GridGeometry& gridGeometry, const GridVariables& gridVariables, const Sol& x) {} @@ -114,21 +114,21 @@ int main(int argc, char** argv) try Dune::Timer timer; // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // intialize the vtk output module @@ -141,7 +141,7 @@ int main(int argc, char** argv) try // create assembler & linear solver using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables); using LinearSolver = SSORCGBackend; auto linearSolver = std::make_shared(); @@ -163,10 +163,10 @@ int main(int argc, char** argv) try using VelocityVector = typename VelocityOutput::VelocityVector; VelocityVector velocity; - constexpr bool isBox = FVGridGeometry::discMethod == Dumux::DiscretizationMethod::box; - constexpr int dimWorld = FVGridGeometry::GridView::dimensionworld; + constexpr bool isBox = GridGeometry::discMethod == Dumux::DiscretizationMethod::box; + constexpr int dimWorld = GridGeometry::GridView::dimensionworld; const auto numCells = leafGridView.size(0); - const auto numDofs = fvGridGeometry->numDofs(); + const auto numDofs = gridGeometry->numDofs(); auto numVelocities = (isBox && dimWorld == 1) ? numCells : numDofs; velocity.resize(numVelocities); @@ -175,9 +175,9 @@ int main(int argc, char** argv) try for (const auto& element : elements(leafGridView, Dune::Partitions::interior)) { - const auto eIdx = fvGridGeometry->elementMapper().index(element); + const auto eIdx = gridGeometry->elementMapper().index(element); - auto fvGeometry = localView(*fvGridGeometry); + auto fvGeometry = localView(*gridGeometry); auto elemVolVars = localView(gridVariables->curGridVolVars()); auto elemFluxVarsCache = localView(gridVariables->gridFluxVarsCache()); @@ -205,7 +205,7 @@ int main(int argc, char** argv) try // For the mpfa test, write out the gradients in the scv centers if (getParam("IO.WriteMpfaVelocities", false)) - writeMpfaVelocities(*fvGridGeometry, *gridVariables, x); + writeMpfaVelocities(*gridGeometry, *gridVariables, x); if (mpiHelper.rank() == 0) Parameters::print(); diff --git a/test/porousmediumflow/1p/implicit/incompressible/problem.hh b/test/porousmediumflow/1p/implicit/incompressible/problem.hh index d7ea6a085ea4f9d346f5e510dab842522609f731..c6b430a9aabe2859dfce05bf2a08276a90851d1c 100644 --- a/test/porousmediumflow/1p/implicit/incompressible/problem.hh +++ b/test/porousmediumflow/1p/implicit/incompressible/problem.hh @@ -73,9 +73,9 @@ struct Problem { using type = OnePTestProblem template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePTestSpatialParams; + using type = OnePTestSpatialParams; }; // use the incompressible local residual (provides analytic jacobian) @@ -120,15 +120,15 @@ class OnePTestProblem : public PorousMediumFlowProblem using Element = typename GridView::template Codim<0>::Entity; using Scalar = GetPropType; using PrimaryVariables = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using FluidSystem = GetPropType; using BoundaryTypes = GetPropType; static constexpr int dimWorld = GridView::dimensionworld; using GlobalPosition = Dune::FieldVector; public: - OnePTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry), velocity_(0.0) + OnePTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry), velocity_(0.0) { extrusionFactor_ = getParam("Problem.ExtrusionFactor"); Scalar permeability = getParam("SpatialParams.Permeability"); diff --git a/test/porousmediumflow/1p/implicit/incompressible/spatialparams.hh b/test/porousmediumflow/1p/implicit/incompressible/spatialparams.hh index 0b0758dda33538ba996c695c6a7b3d597e9b5dde..bfaf1baeec8e4e3ebdf50cb6801cbb37671550c0 100644 --- a/test/porousmediumflow/1p/implicit/incompressible/spatialparams.hh +++ b/test/porousmediumflow/1p/implicit/incompressible/spatialparams.hh @@ -35,25 +35,25 @@ namespace Dumux { * \brief The spatial parameters class for the test problem using the * incompressible 1p model */ -template +template class OnePTestSpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; - using ParentType = FVSpatialParamsOneP>; + using ParentType = FVSpatialParamsOneP>; static constexpr int dimWorld = GridView::dimensionworld; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: using PermeabilityType = Scalar; - OnePTestSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + OnePTestSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { permeability_ = getParam("SpatialParams.Permeability"); permeabilityLens_ = getParam("SpatialParams.PermeabilityLens"); diff --git a/test/porousmediumflow/1p/implicit/internaldirichlet/problem.hh b/test/porousmediumflow/1p/implicit/internaldirichlet/problem.hh index 6708ff689c26bc6e812f88aaf755bf429ba5c896..67fd704f16d15722f34514df87101f5066161a01 100644 --- a/test/porousmediumflow/1p/implicit/internaldirichlet/problem.hh +++ b/test/porousmediumflow/1p/implicit/internaldirichlet/problem.hh @@ -61,13 +61,13 @@ class OnePTestProblemInternalDirichlet : public OnePTestProblem using PrimaryVariables = GetPropType; using NeumannValues = GetPropType; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; + using GridGeometry = GetPropType; + using SubControlVolume = typename GridGeometry::SubControlVolume; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: - OnePTestProblemInternalDirichlet(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + OnePTestProblemInternalDirichlet(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) {} /*! diff --git a/test/porousmediumflow/1p/implicit/isothermal/main.cc b/test/porousmediumflow/1p/implicit/isothermal/main.cc index 260882ed01264a3d10c3a805a29d72926f3f788b..3b9bea6e65c8c7bf5235ac6ceee77a07a3d3bdce 100644 --- a/test/porousmediumflow/1p/implicit/isothermal/main.cc +++ b/test/porousmediumflow/1p/implicit/isothermal/main.cc @@ -111,23 +111,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -155,11 +155,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NewtonSolver; diff --git a/test/porousmediumflow/1p/implicit/isothermal/spatialparams.hh b/test/porousmediumflow/1p/implicit/isothermal/spatialparams.hh index 9a748b72dda1b81487be6256b4ef7d07bc10652d..35239e43e77253562edc616aab74f630be82c6c6 100644 --- a/test/porousmediumflow/1p/implicit/isothermal/spatialparams.hh +++ b/test/porousmediumflow/1p/implicit/isothermal/spatialparams.hh @@ -37,17 +37,17 @@ namespace Dumux { * \brief The spatial parameters class for the test problem using the * 1p box model. */ -template +template class OnePTestSpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using IndexSet = typename GridView::IndexSet; - using ParentType = FVSpatialParamsOneP>; + using ParentType = FVSpatialParamsOneP>; enum { dim=GridView::dimension, @@ -61,17 +61,17 @@ public: // export permeability type using PermeabilityType = Scalar; - OnePTestSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry), - randomPermeability_(fvGridGeometry->gridView().size(dim), 0.0), - indexSet_(fvGridGeometry->gridView().indexSet()) + OnePTestSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry), + randomPermeability_(gridGeometry->gridView().size(dim), 0.0), + indexSet_(gridGeometry->gridView().indexSet()) { randomField_ = getParam("SpatialParams.RandomField", false); permeability_ = getParam("SpatialParams.Permeability"); if(!randomField_) permeabilityLens_ = getParam("SpatialParams.PermeabilityLens"); else - initRandomField(*fvGridGeometry); + initRandomField(*gridGeometry); lensLowerLeft_ = getParam("SpatialParams.LensLowerLeft"); lensUpperRight_ = getParam("SpatialParams.LensUpperRight"); @@ -113,7 +113,7 @@ public: * * \param gg The finite-volume grid geometry used by the problem */ - void initRandomField(const FVGridGeometry& gg) + void initRandomField(const GridGeometry& gg) { const auto& gridView = gg.gridView(); const auto& elementMapper = gg.elementMapper(); diff --git a/test/porousmediumflow/1p/implicit/network1d3d/main.cc b/test/porousmediumflow/1p/implicit/network1d3d/main.cc index b13d508365007b4f960705e2c1d0d3575897cd5e..2827e8b95c451ccdc6c21e35328a7a364a4fc334 100644 --- a/test/porousmediumflow/1p/implicit/network1d3d/main.cc +++ b/test/porousmediumflow/1p/implicit/network1d3d/main.cc @@ -105,23 +105,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -144,11 +144,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NewtonSolver; diff --git a/test/porousmediumflow/1p/implicit/network1d3d/problem.hh b/test/porousmediumflow/1p/implicit/network1d3d/problem.hh index 67133df7c50fcad313cbaa6b466553d4b9fd3420..3e2ca07f92b568b49baf77d1ca37a22c28937f22 100644 --- a/test/porousmediumflow/1p/implicit/network1d3d/problem.hh +++ b/test/porousmediumflow/1p/implicit/network1d3d/problem.hh @@ -112,9 +112,9 @@ struct Problem { using type = TubesTestProblem struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = TubesTestSpatialParams; + using type = TubesTestSpatialParams; }; // the fluid system @@ -154,7 +154,7 @@ class TubesTestProblem : public PorousMediumFlowProblem using BoundaryTypes = GetPropType; using NumEqVector = GetPropType; using Element = typename GridView::template Codim<0>::Entity; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using SolutionVector = GetPropType; using FVElementGeometry = typename GetPropType::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; @@ -163,14 +163,14 @@ class TubesTestProblem : public PorousMediumFlowProblem enum { isBox = GetPropType::discMethod == DiscretizationMethod::box }; public: - TubesTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + TubesTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { name_ = getParam("Problem.Name"); //get hMax_ of the grid hMax_ = 0.0; - for (const auto& element : elements(fvGridGeometry->gridView())) + for (const auto& element : elements(gridGeometry->gridView())) hMax_ = std::max(element.geometry().volume(), hMax_); } diff --git a/test/porousmediumflow/1p/implicit/network1d3d/spatialparams.hh b/test/porousmediumflow/1p/implicit/network1d3d/spatialparams.hh index d5abb2fba2a471db818d041bfcc53e124f00cb7b..3d2383faebf1bad3ee6ff783374a7c065e49f986 100644 --- a/test/porousmediumflow/1p/implicit/network1d3d/spatialparams.hh +++ b/test/porousmediumflow/1p/implicit/network1d3d/spatialparams.hh @@ -36,17 +36,17 @@ namespace Dumux { * \brief A test problem for the 1p model: A pipe system with circular cross-section * and a branching point embedded in a three-dimensional world */ -template +template class TubesTestSpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParamsOneP>; + using ParentType = FVSpatialParamsOneP>; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -54,8 +54,8 @@ public: // export permeability type using PermeabilityType = Scalar; - TubesTestSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + TubesTestSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { radius_ = 1.0; diff --git a/test/porousmediumflow/1p/implicit/nonisothermal/main.cc b/test/porousmediumflow/1p/implicit/nonisothermal/main.cc index d5c20b5452cce4a4f2dbcb575d27a4e0c02ae5c5..e4ad2594c0c3e8149431b4723108f923d405cdab 100644 --- a/test/porousmediumflow/1p/implicit/nonisothermal/main.cc +++ b/test/porousmediumflow/1p/implicit/nonisothermal/main.cc @@ -108,14 +108,14 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - const std::string paramGroup = FVGridGeometry::discMethod == DiscretizationMethod::ccmpfa ? "MpfaTest" : ""; - auto problem = std::make_shared(fvGridGeometry, paramGroup); + const std::string paramGroup = GridGeometry::discMethod == DiscretizationMethod::ccmpfa ? "MpfaTest" : ""; + auto problem = std::make_shared(gridGeometry, paramGroup); // get some time loop parameters using Scalar = GetPropType; @@ -128,14 +128,14 @@ int main(int argc, char** argv) try // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); if (restartTime > 0) { using IOFields = GetPropType; using PrimaryVariables = GetPropType; using ModelTraits = GetPropType; const auto fileName = getParam("Restart.File"); - loadSolution(x, fileName, createPVNameFunction(), *fvGridGeometry); + loadSolution(x, fileName, createPVNameFunction(), *gridGeometry); } else problem->applyInitialSolution(x); @@ -143,7 +143,7 @@ int main(int argc, char** argv) try // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // intialize the vtk output module @@ -164,11 +164,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NewtonSolver; diff --git a/test/porousmediumflow/1p/implicit/nonisothermal/problem_conduction.hh b/test/porousmediumflow/1p/implicit/nonisothermal/problem_conduction.hh index 64dd602a39ac237e4b4923450b35a8ea0d86a6ec..22ae3df812523537fe9427957f341f5f1679f7f4 100644 --- a/test/porousmediumflow/1p/implicit/nonisothermal/problem_conduction.hh +++ b/test/porousmediumflow/1p/implicit/nonisothermal/problem_conduction.hh @@ -77,9 +77,9 @@ struct FluidSystem template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePNISpatialParams; + using type = OnePNISpatialParams; }; } @@ -131,18 +131,18 @@ class OnePNIConductionProblem : public PorousMediumFlowProblem using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; public: - OnePNIConductionProblem(std::shared_ptr fvGridGeometry, const std::string& paramGroup) - : ParentType(fvGridGeometry, paramGroup) + OnePNIConductionProblem(std::shared_ptr gridGeometry, const std::string& paramGroup) + : ParentType(gridGeometry, paramGroup) { //initialize fluid system FluidSystem::init(); name_ = getParam("Problem.Name"); temperatureHigh_ = 300.0; - temperatureExact_.resize(fvGridGeometry->numDofs()); + temperatureExact_.resize(gridGeometry->numDofs()); } //! Get the analytical temperature diff --git a/test/porousmediumflow/1p/implicit/nonisothermal/problem_convection.hh b/test/porousmediumflow/1p/implicit/nonisothermal/problem_convection.hh index fc9ce339eb8c86cab63c7cbdb9fe93e33a05757b..fd99103799027f24f2e2407a3f1cd0537f93dfac 100644 --- a/test/porousmediumflow/1p/implicit/nonisothermal/problem_convection.hh +++ b/test/porousmediumflow/1p/implicit/nonisothermal/problem_convection.hh @@ -77,9 +77,9 @@ struct FluidSystem template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePNISpatialParams; + using type = OnePNISpatialParams; }; } // end namespace Properties @@ -143,11 +143,11 @@ class OnePNIConvectionProblem : public PorousMediumFlowProblem using NumEqVector = GetPropType; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; public: - OnePNIConvectionProblem(std::shared_ptr fvGridGeometry, const std::string& paramGroup) - : ParentType(fvGridGeometry, paramGroup) + OnePNIConvectionProblem(std::shared_ptr gridGeometry, const std::string& paramGroup) + : ParentType(gridGeometry, paramGroup) { //initialize fluid system FluidSystem::init(); diff --git a/test/porousmediumflow/1p/implicit/nonisothermal/spatialparams.hh b/test/porousmediumflow/1p/implicit/nonisothermal/spatialparams.hh index 435a4095cd440beabc0cd9cf48a672a0d1209ecd..860a13b7158822a198635abbb332ac5789da2108 100644 --- a/test/porousmediumflow/1p/implicit/nonisothermal/spatialparams.hh +++ b/test/porousmediumflow/1p/implicit/nonisothermal/spatialparams.hh @@ -34,14 +34,14 @@ namespace Dumux { * \ingroup OnePTests * \brief Definition of the spatial parameters for the 1pni problems. */ -template +template class OnePNISpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using GridView = typename FVGridGeometry::GridView; - using ParentType = FVSpatialParamsOneP>; + using GridView = typename GridGeometry::GridView; + using ParentType = FVSpatialParamsOneP>; static const int dimWorld = GridView::dimensionworld; using Element = typename GridView::template Codim<0>::Entity; @@ -51,8 +51,8 @@ public: // export permeability type using PermeabilityType = Scalar; - OnePNISpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) {} + OnePNISpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) {} /*! * \brief Defines the intrinsic permeability \f$\mathrm{[m^2]}\f$. diff --git a/test/porousmediumflow/1p/implicit/periodicbc/main.cc b/test/porousmediumflow/1p/implicit/periodicbc/main.cc index 393ca05ee9926c824a8a65f4b39a8be4980d4120..cfc8188336d26a12e0556761f0c687216db2183b 100644 --- a/test/porousmediumflow/1p/implicit/periodicbc/main.cc +++ b/test/porousmediumflow/1p/implicit/periodicbc/main.cc @@ -77,27 +77,27 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry (and make it periodic) - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); - bool periodic = fvGridGeometry->isPeriodic(); - periodic = fvGridGeometry->gridView().comm().max(periodic); + bool periodic = gridGeometry->isPeriodic(); + periodic = gridGeometry->gridView().comm().max(periodic); if (!periodic) DUNE_THROW(Dune::GridError, "Your grid is not periodic. Maybe the grid manager doesn't support periodic boundaries."); // the problem (boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); problem->computePointSourceMap(); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // intialize the vtk output module @@ -108,7 +108,7 @@ int main(int argc, char** argv) try // make assemble and attach linear system using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables); using JacobianMatrix = GetPropType; auto A = std::make_shared(); auto r = std::make_shared(); @@ -128,7 +128,7 @@ int main(int argc, char** argv) try // solve the linear system Dune::Timer solverTimer; using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(fvGridGeometry->gridView(), fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(gridGeometry->gridView(), gridGeometry->dofMapper()); if (mpiHelper.rank() == 0) std::cout << "Solving linear system using " + linearSolver->name() + "..." << std::flush; linearSolver->solve(*A, x, *r); diff --git a/test/porousmediumflow/1p/implicit/periodicbc/problem.hh b/test/porousmediumflow/1p/implicit/periodicbc/problem.hh index cb78df459f2e39fbb630d18187e70bef56315a6c..41a50d7febf77d4aad469c20ca9d7b61135cffa2 100644 --- a/test/porousmediumflow/1p/implicit/periodicbc/problem.hh +++ b/test/porousmediumflow/1p/implicit/periodicbc/problem.hh @@ -113,14 +113,14 @@ class OnePTestProblem : public PorousMediumFlowProblem using Scalar = GetPropType; using PrimaryVariables = GetPropType; using SourceValues = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using BoundaryTypes = GetPropType; static constexpr int dimWorld = GridView::dimensionworld; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: - OnePTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + OnePTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { sourcePosition_ = getParam("Source.Position"); sourceValues_ = getParam("Source.Values"); diff --git a/test/porousmediumflow/1p/implicit/periodicbc/spatialparams.hh b/test/porousmediumflow/1p/implicit/periodicbc/spatialparams.hh index 73a25ecd30dd7238d8486048493d492bb85c22a6..c677ea1f9ea06d92f0d19d3ec2deb84f490cd20b 100644 --- a/test/porousmediumflow/1p/implicit/periodicbc/spatialparams.hh +++ b/test/porousmediumflow/1p/implicit/periodicbc/spatialparams.hh @@ -41,20 +41,20 @@ class OnePTestSpatialParams OnePTestSpatialParams> { using Scalar = GetPropType; - using FVGridGeometry = GetPropType; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = GetPropType; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; - using ParentType = FVSpatialParamsOneP>; + using ParentType = FVSpatialParamsOneP>; static constexpr int dimWorld = GridView::dimensionworld; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: using PermeabilityType = Scalar; - OnePTestSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + OnePTestSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { permeability_ = getParam("SpatialParams.Permeability"); permeabilityLens_ = getParam("SpatialParams.PermeabilityLens"); diff --git a/test/porousmediumflow/1p/implicit/pointsources/spatialparams.hh b/test/porousmediumflow/1p/implicit/pointsources/spatialparams.hh index 642d30772e92eeb7beefaef1a6eec27a66baa403..03ef1b3845ebf2eb8d28d2bb6e0915ba6901337f 100644 --- a/test/porousmediumflow/1p/implicit/pointsources/spatialparams.hh +++ b/test/porousmediumflow/1p/implicit/pointsources/spatialparams.hh @@ -36,25 +36,25 @@ namespace Dumux { * \brief The spatial parameters class for the test problem using the * 1p model with point sources. */ -template +template class OnePSingularitySpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParamsOneP>; + using ParentType = FVSpatialParamsOneP>; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: // export permeability type using PermeabilityType = Scalar; - OnePSingularitySpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + OnePSingularitySpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { permeability_ = getParam("SpatialParams.Permeability"); porosity_= getParam("SpatialParams.Porosity"); diff --git a/test/porousmediumflow/1p/implicit/pointsources/timedependent/main.cc b/test/porousmediumflow/1p/implicit/pointsources/timedependent/main.cc index e1c7cafab6405f31b190ea9dc9ec306527252eb6..23a5a542c81bacae65e0c75e0ac242b2f66830d2 100644 --- a/test/porousmediumflow/1p/implicit/pointsources/timedependent/main.cc +++ b/test/porousmediumflow/1p/implicit/pointsources/timedependent/main.cc @@ -80,24 +80,24 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); problem->computePointSourceMap(); // enable point sources // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -120,11 +120,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NewtonSolver; diff --git a/test/porousmediumflow/1p/implicit/pointsources/timedependent/problem.hh b/test/porousmediumflow/1p/implicit/pointsources/timedependent/problem.hh index d3c9d1bd7ea36d1c370b011fc3a01304cfd47433..902f784774510538ce94806853594391fbaa3e5f 100644 --- a/test/porousmediumflow/1p/implicit/pointsources/timedependent/problem.hh +++ b/test/porousmediumflow/1p/implicit/pointsources/timedependent/problem.hh @@ -75,11 +75,11 @@ class OnePSingularityProblemTimeDependent : public OnePSingularityProblem::LocalView; using ElementVolumeVariables = typename GetPropType::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; public: - OnePSingularityProblemTimeDependent(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + OnePSingularityProblemTimeDependent(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) {} /*! diff --git a/test/porousmediumflow/1p/implicit/pointsources/timeindependent/main.cc b/test/porousmediumflow/1p/implicit/pointsources/timeindependent/main.cc index d10892dea3360f6f3aef09952ef3f0d59477d164..c5789a9f4748bdc962e728794e3fca1d52e62cb6 100644 --- a/test/porousmediumflow/1p/implicit/pointsources/timeindependent/main.cc +++ b/test/porousmediumflow/1p/implicit/pointsources/timeindependent/main.cc @@ -80,24 +80,24 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); problem->computePointSourceMap(); // enable point sources // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -120,11 +120,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NewtonSolver; diff --git a/test/porousmediumflow/1p/implicit/pointsources/timeindependent/problem.hh b/test/porousmediumflow/1p/implicit/pointsources/timeindependent/problem.hh index 816eed96a0584e0a1d111d22dccd8bd1fe4fb8f8..3f2acb0d76f16853ad20586d17aa6c9efbd044b5 100644 --- a/test/porousmediumflow/1p/implicit/pointsources/timeindependent/problem.hh +++ b/test/porousmediumflow/1p/implicit/pointsources/timeindependent/problem.hh @@ -75,9 +75,9 @@ struct Problem { using type = OnePSingularityPro template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePSingularitySpatialParams; + using type = OnePSingularitySpatialParams; }; } @@ -112,13 +112,13 @@ class OnePSingularityProblem : public PorousMediumFlowProblem using PrimaryVariables = GetPropType; using BoundaryTypes = GetPropType; using PointSource = GetPropType; - using FVGridGeometry = GetPropType; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using GridGeometry = GetPropType; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: - OnePSingularityProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + OnePSingularityProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { name_ = getParam("Problem.Name"); } diff --git a/test/porousmediumflow/1pnc/implicit/1p2c/isothermal/main.cc b/test/porousmediumflow/1pnc/implicit/1p2c/isothermal/main.cc index 0a26f5f85f15e1093d9e89acf2f0e09de4f3e66d..2664ba957cc1100217bcf8fcc86d6ef35ace9eaa 100644 --- a/test/porousmediumflow/1pnc/implicit/1p2c/isothermal/main.cc +++ b/test/porousmediumflow/1pnc/implicit/1p2c/isothermal/main.cc @@ -84,23 +84,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -123,7 +123,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = ILU0BiCGSTABBackend; diff --git a/test/porousmediumflow/1pnc/implicit/1p2c/isothermal/problem.hh b/test/porousmediumflow/1pnc/implicit/1p2c/isothermal/problem.hh index ad481750832c0781c02c35a99532e489c10ad4ae..f187f283da8f4c25f3c6a843ffbd089f044553ce 100644 --- a/test/porousmediumflow/1pnc/implicit/1p2c/isothermal/problem.hh +++ b/test/porousmediumflow/1pnc/implicit/1p2c/isothermal/problem.hh @@ -86,9 +86,9 @@ struct FluidSystem template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePNCTestSpatialParams; + using type = OnePNCTestSpatialParams; }; // Define whether mole(true) or mass (false) fractions are used @@ -134,7 +134,7 @@ class OnePTwoCTestProblem : public PorousMediumFlowProblem using GridView = GetPropType; using Element = typename GridView::template Codim<0>::Entity; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using FVElementGeometry = typename GetPropType::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; @@ -167,8 +167,8 @@ class OnePTwoCTestProblem : public PorousMediumFlowProblem using GlobalPosition = typename SubControlVolumeFace::GlobalPosition; public: - OnePTwoCTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry), useNitscheTypeBc_(getParam("Problem.UseNitscheTypeBc", false)) + OnePTwoCTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry), useNitscheTypeBc_(getParam("Problem.UseNitscheTypeBc", false)) { //initialize fluid system FluidSystem::init(); diff --git a/test/porousmediumflow/1pnc/implicit/1p2c/isothermal/saltwaterintrusion/main.cc b/test/porousmediumflow/1pnc/implicit/1p2c/isothermal/saltwaterintrusion/main.cc index adbf3fb55a1c6c4ccb3fef48af32bdbfcbd2a394..f55bc9d6106350e2f01f4d475cfbb1dd48f48079 100644 --- a/test/porousmediumflow/1pnc/implicit/1p2c/isothermal/saltwaterintrusion/main.cc +++ b/test/porousmediumflow/1pnc/implicit/1p2c/isothermal/saltwaterintrusion/main.cc @@ -84,23 +84,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -123,7 +123,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = ILU0BiCGSTABBackend; diff --git a/test/porousmediumflow/1pnc/implicit/1p2c/isothermal/saltwaterintrusion/problem.hh b/test/porousmediumflow/1pnc/implicit/1p2c/isothermal/saltwaterintrusion/problem.hh index 2e96781678b74b8817bc526edc413c4315b84840..1f6e4eec60c917c846d3c2108949a45e268f4b6f 100644 --- a/test/porousmediumflow/1pnc/implicit/1p2c/isothermal/saltwaterintrusion/problem.hh +++ b/test/porousmediumflow/1pnc/implicit/1p2c/isothermal/saltwaterintrusion/problem.hh @@ -63,9 +63,9 @@ struct FluidSystem template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePNCTestSpatialParams; + using type = OnePNCTestSpatialParams; }; // Use mass fractions to set salinity conveniently @@ -97,7 +97,7 @@ class SaltWaterIntrusionTestProblem : public PorousMediumFlowProblem using FluidSystem = GetPropType; using BoundaryTypes = GetPropType; using PrimaryVariables = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; // copy pressure index for convenience enum { pressureIdx = Indices::pressureIdx }; @@ -106,8 +106,8 @@ class SaltWaterIntrusionTestProblem : public PorousMediumFlowProblem static_assert(!getPropValue(), "This test uses mass fractions!"); public: - SaltWaterIntrusionTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + SaltWaterIntrusionTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { //initialize fluid system FluidSystem::init(); diff --git a/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/conduction/main.cc b/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/conduction/main.cc index fd9ad1d16d042ecd2d45381fbc9c414b0558c57b..50835dea1b56d386c196143d3e05d8830d001b71 100644 --- a/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/conduction/main.cc +++ b/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/conduction/main.cc @@ -84,23 +84,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -126,7 +126,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver // using LinearSolver = UMFPackBackend; diff --git a/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/conduction/problem.hh b/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/conduction/problem.hh index 627739a67f7234cf0d36d29b134f8b9adc4dc848..460e7b8ebf5de4f7a4bf75fe904c0618dec97e5d 100644 --- a/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/conduction/problem.hh +++ b/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/conduction/problem.hh @@ -83,9 +83,9 @@ struct FluidSystem template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePNCTestSpatialParams; + using type = OnePNCTestSpatialParams; }; // Define whether mole(true) or mass (false) fractions are used @@ -128,7 +128,7 @@ class OnePTwoCNIConductionProblem : public PorousMediumFlowProblem using FluidSystem = GetPropType; using BoundaryTypes = GetPropType; using PrimaryVariables = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using NumEqVector = GetPropType; using Element = typename GridView::template Codim<0>::Entity; using ThermalConductivityModel = GetPropType; @@ -152,8 +152,8 @@ class OnePTwoCNIConductionProblem : public PorousMediumFlowProblem using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: - OnePTwoCNIConductionProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry), temperatureHigh_(300.0) + OnePTwoCNIConductionProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry), temperatureHigh_(300.0) { //initialize fluid system FluidSystem::init(); @@ -164,7 +164,7 @@ public: else std::cout<<"problem uses mass fractions"<numDofs(), 290.0); + temperatureExact_.resize(gridGeometry->numDofs(), 290.0); } //! Get the analytical temperature diff --git a/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/convection/main.cc b/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/convection/main.cc index c7deaed5a0d7cfbbcf9b31b205cf61ff650e4276..203a5a63fc09ea65b85d8041f53ff7f32a04fe1d 100644 --- a/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/convection/main.cc +++ b/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/convection/main.cc @@ -84,23 +84,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -126,7 +126,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver // using LinearSolver = UMFPackBackend; diff --git a/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/convection/problem.hh b/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/convection/problem.hh index 8002ec769d6aefcc70007d52dcd62596fd014071..726c81f49665d08159f80226a30745178b492974 100644 --- a/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/convection/problem.hh +++ b/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/convection/problem.hh @@ -84,9 +84,9 @@ struct FluidSystem template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePNCTestSpatialParams; + using type = OnePNCTestSpatialParams; }; // Define whether mole(true) or mass (false) fractions are used @@ -130,7 +130,7 @@ class OnePTwoCNIConvectionProblem : public PorousMediumFlowProblem using FluidSystem = GetPropType; using BoundaryTypes = GetPropType; using PrimaryVariables = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using FVElementGeometry = typename GetPropType::LocalView; using NumEqVector = GetPropType; @@ -167,8 +167,8 @@ class OnePTwoCNIConvectionProblem : public PorousMediumFlowProblem using GlobalPosition = typename SubControlVolumeFace::GlobalPosition; public: - OnePTwoCNIConvectionProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + OnePTwoCNIConvectionProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { //initialize fluid system FluidSystem::init(); @@ -179,7 +179,7 @@ public: else std::cout<<"problem uses mass fractions"<numDofs(), 290.0); + temperatureExact_.resize(gridGeometry->numDofs(), 290.0); darcyVelocity_ = getParam("Problem.DarcyVelocity"); diff --git a/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/transientbc/main.cc b/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/transientbc/main.cc index f9564773e87a906b8c5bc4d8b0da7280a32ca7a1..2f9d5764717e9dd13932f480c45ab8520511ecad 100644 --- a/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/transientbc/main.cc +++ b/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/transientbc/main.cc @@ -84,23 +84,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -125,7 +125,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = ILU0BiCGSTABBackend; diff --git a/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/transientbc/problem.hh b/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/transientbc/problem.hh index 2be743d10a53318cfaa44e3cc100ee4885892df8..4a9113505dde3ae70c0c580adf9087d2435adb80 100644 --- a/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/transientbc/problem.hh +++ b/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/transientbc/problem.hh @@ -83,9 +83,9 @@ struct FluidSystem template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePNCTestSpatialParams; + using type = OnePNCTestSpatialParams; }; // Define whether mole(true) or mass (false) fractions are used @@ -141,7 +141,7 @@ class OnePTwoCNITransientBCProblem : public PorousMediumFlowProblem using FluidSystem = GetPropType; using BoundaryTypes = GetPropType; using PrimaryVariables = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using FVElementGeometry = typename GetPropType::LocalView; using NumEqVector = GetPropType; using ElementVolumeVariables = typename GetPropType::LocalView; @@ -174,8 +174,8 @@ class OnePTwoCNITransientBCProblem : public PorousMediumFlowProblem using GlobalPosition = typename SubControlVolumeFace::GlobalPosition; public: - OnePTwoCNITransientBCProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + OnePTwoCNITransientBCProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { //initialize fluid system FluidSystem::init(); diff --git a/test/porousmediumflow/1pnc/implicit/1p2c/spatialparams.hh b/test/porousmediumflow/1pnc/implicit/1p2c/spatialparams.hh index b397abab17eea73afef5a9a546e878997e0afd09..a4d16e26d08150f6c1f1a7147fa3daf325d5e474 100644 --- a/test/porousmediumflow/1pnc/implicit/1p2c/spatialparams.hh +++ b/test/porousmediumflow/1pnc/implicit/1p2c/spatialparams.hh @@ -34,17 +34,17 @@ namespace Dumux { * \ingroup OnePNCTests * \brief Definition of the spatial parameters for the 1pnc test problems. */ -template +template class OnePNCTestSpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParamsOneP>; + using ParentType = FVSpatialParamsOneP>; static const int dimWorld = GridView::dimensionworld; using GlobalPosition = typename Dune::FieldVector; @@ -53,8 +53,8 @@ public: // export permeability type using PermeabilityType = Scalar; - OnePNCTestSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + OnePNCTestSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { permeability_ = 1e-10; porosity_ = 0.4; diff --git a/test/porousmediumflow/1pnc/implicit/1p3c/main.cc b/test/porousmediumflow/1pnc/implicit/1p3c/main.cc index 5d5c2cf24abd2f843e01340472e7d5c4dc14bbe1..d39483e874960d2f8e5e7794cb8fa22e34fc8f58 100644 --- a/test/porousmediumflow/1pnc/implicit/1p3c/main.cc +++ b/test/porousmediumflow/1pnc/implicit/1p3c/main.cc @@ -85,23 +85,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -124,7 +124,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop); // the linear solver using LinearSolver = ILU0BiCGSTABBackend; diff --git a/test/porousmediumflow/1pnc/implicit/1p3c/problem.hh b/test/porousmediumflow/1pnc/implicit/1p3c/problem.hh index 7bcc590505a796492d763ff8718d04d75f249c6f..3b236cdc66202d0114962181ce41498d4add35e5 100644 --- a/test/porousmediumflow/1pnc/implicit/1p3c/problem.hh +++ b/test/porousmediumflow/1pnc/implicit/1p3c/problem.hh @@ -209,9 +209,9 @@ struct FluidSystem template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePNCTestSpatialParams; + using type = OnePNCTestSpatialParams; }; // Define whether mole(true) or mass (false) fractions are used @@ -248,19 +248,19 @@ class MaxwellStefanOnePThreeCTestProblem : public PorousMediumFlowProblem; using NumEqVector = GetPropType; using FluidSystem = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using SolutionVector = GetPropType; using VolumeVariables = GetPropType; //! property that defines whether mole or mass fractions are used static constexpr bool useMoles = getPropValue(); - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: - MaxwellStefanOnePThreeCTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + MaxwellStefanOnePThreeCTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { name_ = getParam("Problem.Name"); diff --git a/test/porousmediumflow/1pnc/implicit/nonequilibrium/main.cc b/test/porousmediumflow/1pnc/implicit/nonequilibrium/main.cc index 0b75cd7a96469267a61b929024a3ac63b795ba38..d1d06385722e5f86fc3d3be79849df2a32184929 100644 --- a/test/porousmediumflow/1pnc/implicit/nonequilibrium/main.cc +++ b/test/porousmediumflow/1pnc/implicit/nonequilibrium/main.cc @@ -84,23 +84,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); problem->setGridVariables(gridVariables); @@ -124,7 +124,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver // using LinearSolver = UMFPackBackend; diff --git a/test/porousmediumflow/1pnc/implicit/nonequilibrium/problem.hh b/test/porousmediumflow/1pnc/implicit/nonequilibrium/problem.hh index ebc2a80e2fa90ee7e6c280a0f3365dc4b892b82d..c89e04bbfd980d6205c1970dd0f85c2a84544941 100644 --- a/test/porousmediumflow/1pnc/implicit/nonequilibrium/problem.hh +++ b/test/porousmediumflow/1pnc/implicit/nonequilibrium/problem.hh @@ -76,9 +76,9 @@ struct FluidSystem template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = OnePNCNonequilibriumTestSpatialParams; + using type = OnePNCNonequilibriumTestSpatialParams; }; // Define whether mole(true) or mass (false) fractions are used @@ -114,7 +114,7 @@ class OnePTwoCThermalNonequilibriumProblem : public PorousMediumFlowProblem; using BoundaryTypes = GetPropType; using PrimaryVariables = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using FVElementGeometry = typename GetPropType::LocalView; using NumEqVector = GetPropType; @@ -152,8 +152,8 @@ class OnePTwoCThermalNonequilibriumProblem : public PorousMediumFlowProblem fvGridGeometry) - : ParentType(fvGridGeometry) + OnePTwoCThermalNonequilibriumProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { //initialize fluid system FluidSystem::init(); diff --git a/test/porousmediumflow/1pnc/implicit/nonequilibrium/spatialparams.hh b/test/porousmediumflow/1pnc/implicit/nonequilibrium/spatialparams.hh index 98ba14f99238820c68ef098ca63273786c7d3bb5..2835d16ed6a5facbd05a98ec4d0b5c4dba142339 100644 --- a/test/porousmediumflow/1pnc/implicit/nonequilibrium/spatialparams.hh +++ b/test/porousmediumflow/1pnc/implicit/nonequilibrium/spatialparams.hh @@ -36,17 +36,17 @@ namespace Dumux { * \ingroup OnePNCTests * \brief Definition of the spatial parameters for the 1pnc test problems. */ -template +template class OnePNCNonequilibriumTestSpatialParams -: public FVNonEquilibriumSpatialParams> +: public FVNonEquilibriumSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVNonEquilibriumSpatialParams>; + using ParentType = FVNonEquilibriumSpatialParams>; static const int dimWorld = GridView::dimensionworld; using GlobalPosition = typename Dune::FieldVector; @@ -56,8 +56,8 @@ public: using PermeabilityType = Scalar; using FluidSolidInterfacialAreaFormulation = FluidSolidInterfacialAreaShiWang; - OnePNCNonequilibriumTestSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + OnePNCNonequilibriumTestSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { permeability_ = 1e-11; porosity_ = 0.4; diff --git a/test/porousmediumflow/1pncmin/implicit/nonisothermal/main.cc b/test/porousmediumflow/1pncmin/implicit/nonisothermal/main.cc index 324908de81a0c2a4583c44b87fb9f604d9c03eff..07157a6e5f00fd66ee729dba9bd6ed626f7edd2c 100644 --- a/test/porousmediumflow/1pncmin/implicit/nonisothermal/main.cc +++ b/test/porousmediumflow/1pncmin/implicit/nonisothermal/main.cc @@ -110,23 +110,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -155,7 +155,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = ILU0BiCGSTABBackend; diff --git a/test/porousmediumflow/1pncmin/implicit/nonisothermal/problem.hh b/test/porousmediumflow/1pncmin/implicit/nonisothermal/problem.hh index 67d8627fea18d259ed94063cceda41646d6adfe5..54255c0aee0fdb8fc5c415b5bdadeb511538cb5d 100644 --- a/test/porousmediumflow/1pncmin/implicit/nonisothermal/problem.hh +++ b/test/porousmediumflow/1pncmin/implicit/nonisothermal/problem.hh @@ -90,9 +90,9 @@ struct SolidSystem template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = ThermoChemSpatialParams; + using type = ThermoChemSpatialParams; }; // Define whether mole(true) or mass (false) fractions are used @@ -134,7 +134,7 @@ class ThermoChemProblem : public PorousMediumFlowProblem using FVElementGeometry = typename GetPropType::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using NumEqVector = GetPropType; using SolutionVector = GetPropType; using ReactionRate = ThermoChemReaction; @@ -164,8 +164,8 @@ class ThermoChemProblem : public PorousMediumFlowProblem using GlobalPosition = typename SubControlVolumeFace::GlobalPosition; public: - ThermoChemProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + ThermoChemProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { name_ = getParam("Problem.Name"); FluidSystem::init(/*tempMin=*/473.15, @@ -181,9 +181,9 @@ public: boundaryTemperature_ = getParam("Problem.BoundaryTemperature"); unsigned int codim = GetPropType::discMethod == DiscretizationMethod::box ? dim : 0; - permeability_.resize(fvGridGeometry->gridView().size(codim)); - porosity_.resize(fvGridGeometry->gridView().size(codim)); - reactionRate_.resize(fvGridGeometry->gridView().size(codim)); + permeability_.resize(gridGeometry->gridView().size(codim)); + porosity_.resize(gridGeometry->gridView().size(codim)); + reactionRate_.resize(gridGeometry->gridView().size(codim)); } /*! diff --git a/test/porousmediumflow/1pncmin/implicit/nonisothermal/spatialparams.hh b/test/porousmediumflow/1pncmin/implicit/nonisothermal/spatialparams.hh index 662fb4fe6d79e289952c305c504322f8a23f7c0e..2bd4d6ece0b83d81e98160e37d0648be2d7f1fc6 100644 --- a/test/porousmediumflow/1pncmin/implicit/nonisothermal/spatialparams.hh +++ b/test/porousmediumflow/1pncmin/implicit/nonisothermal/spatialparams.hh @@ -35,17 +35,17 @@ namespace Dumux { * \brief Definition of the spatial parameters for the thermochemistry * problem which uses the non-insothermal 1pncmin model. */ -template +template class ThermoChemSpatialParams -: public FVSpatialParamsOneP> +: public FVSpatialParamsOneP> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParamsOneP>; + using ParentType = FVSpatialParamsOneP>; enum { dimWorld=GridView::dimensionworld }; @@ -55,8 +55,8 @@ public: // type used for the permeability (i.e. tensor or scalar) using PermeabilityType = Scalar; - ThermoChemSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + ThermoChemSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) {} /*! diff --git a/test/porousmediumflow/2p/implicit/adaptive/main.cc b/test/porousmediumflow/2p/implicit/adaptive/main.cc index dabb29b258ea3b797409c3b6791531641d135bd4..43b0ccba983c05b720d3bd4819793b86dc433d98 100644 --- a/test/porousmediumflow/2p/implicit/adaptive/main.cc +++ b/test/porousmediumflow/2p/implicit/adaptive/main.cc @@ -123,35 +123,35 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); problem->computePointSourceMap(); // enable point sources // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // instantiate indicator & data transfer, read parameters for indicator using Scalar = GetPropType; const Scalar refineTol = getParam("Adaptive.RefineTolerance"); const Scalar coarsenTol = getParam("Adaptive.CoarsenTolerance"); - TwoPGridAdaptIndicator indicator(fvGridGeometry); - TwoPGridDataTransfer dataTransfer(problem, fvGridGeometry, gridVariables, x); + TwoPGridAdaptIndicator indicator(gridGeometry); + TwoPGridDataTransfer dataTransfer(problem, gridGeometry, gridVariables, x); // Do initial refinement around sources/BCs - GridAdaptInitializationIndicator initIndicator(problem, fvGridGeometry, gridVariables); + GridAdaptInitializationIndicator initIndicator(problem, gridGeometry, gridVariables); // refine up to the maximum level const auto maxLevel = getParam("Adaptive.MaxLevel", 0); @@ -207,11 +207,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NewtonSolver; diff --git a/test/porousmediumflow/2p/implicit/adaptive/problem.hh b/test/porousmediumflow/2p/implicit/adaptive/problem.hh index 3de0f798f2e980ff690e2a6f47bf87d00ba04d14..ad937e92d4ce548bc591ac64ec800abd2a5566fb 100644 --- a/test/porousmediumflow/2p/implicit/adaptive/problem.hh +++ b/test/porousmediumflow/2p/implicit/adaptive/problem.hh @@ -46,13 +46,13 @@ class TwoPTestProblemAdaptive : public TwoPTestProblem using Vertex = typename GridView::template Codim::Entity; using Scalar = GetPropType; using PrimaryVariables = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; - static constexpr bool isBox = FVGridGeometry::discMethod == DiscretizationMethod::box; + static constexpr bool isBox = GridGeometry::discMethod == DiscretizationMethod::box; public: - TwoPTestProblemAdaptive(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + TwoPTestProblemAdaptive(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { if(!isBox) initialValues_ = readFileToContainer>("initialsolutioncc.txt"); diff --git a/test/porousmediumflow/2p/implicit/boxdfm/main.cc b/test/porousmediumflow/2p/implicit/boxdfm/main.cc index 32090672e92cc90f7f365faffac903898f2c18be..7ba60bfd884218e7801a0777cd6fec14296e9a3d 100644 --- a/test/porousmediumflow/2p/implicit/boxdfm/main.cc +++ b/test/porousmediumflow/2p/implicit/boxdfm/main.cc @@ -117,17 +117,17 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.template grid<0>().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(fractureGridAdapter); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(fractureGridAdapter); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; @@ -136,7 +136,7 @@ int main(int argc, char** argv) try // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -158,7 +158,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = ILU0BiCGSTABBackend; diff --git a/test/porousmediumflow/2p/implicit/boxdfm/problem.hh b/test/porousmediumflow/2p/implicit/boxdfm/problem.hh index 7e7d92ff11c93f2407f4e3ca41a46b74db4a8d9e..e2d04c208d3b39f222ab228ad6f1d90c28928632 100644 --- a/test/porousmediumflow/2p/implicit/boxdfm/problem.hh +++ b/test/porousmediumflow/2p/implicit/boxdfm/problem.hh @@ -125,8 +125,8 @@ class TwoPTestProblem : public PorousMediumFlowProblem using PrimaryVariables = GetPropType; using NumEqVector = GetPropType; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; - using SubControlVolume = typename FVGridGeometry::SubControlVolume; + using GridGeometry = GetPropType; + using SubControlVolume = typename GridGeometry::SubControlVolume; // some indices for convenience using FluidSystem = GetPropType; @@ -144,8 +144,8 @@ class TwoPTestProblem : public PorousMediumFlowProblem static constexpr int dimWorld = GridView::dimensionworld; public: - TwoPTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + TwoPTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) {} /*! diff --git a/test/porousmediumflow/2p/implicit/boxdfm/spatialparams.hh b/test/porousmediumflow/2p/implicit/boxdfm/spatialparams.hh index 68e4011439413810c026f53a0deab9d26acf5c8a..21e983c73eff2099e69bdaf6dabfcde6513045b7 100644 --- a/test/porousmediumflow/2p/implicit/boxdfm/spatialparams.hh +++ b/test/porousmediumflow/2p/implicit/boxdfm/spatialparams.hh @@ -39,17 +39,17 @@ namespace Dumux { * \ingroup TwoPTests * \brief The spatial params for the incompressible 2p test. */ -template -class TwoPTestSpatialParams : public FVSpatialParams< FVGridGeometry, Scalar, TwoPTestSpatialParams > +template +class TwoPTestSpatialParams : public FVSpatialParams< GridGeometry, Scalar, TwoPTestSpatialParams > { - using ThisType = TwoPTestSpatialParams; - using ParentType = FVSpatialParams; + using ThisType = TwoPTestSpatialParams; + using ParentType = FVSpatialParams; - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; static constexpr int dimWorld = GridView::dimensionworld; @@ -59,7 +59,7 @@ public: using MaterialLawParams = typename MaterialLaw::Params; using PermeabilityType = Scalar; - TwoPTestSpatialParams(std::shared_ptr fvGridGeometry) : ParentType(fvGridGeometry) + TwoPTestSpatialParams(std::shared_ptr gridGeometry) : ParentType(gridGeometry) { // residual saturations matrixMaterialParams_.setSwr(0.18); diff --git a/test/porousmediumflow/2p/implicit/cornerpoint/main.cc b/test/porousmediumflow/2p/implicit/cornerpoint/main.cc index 1b55d6dd8a0626781f50c8aa729ba42862dfc104..fc6fe48521ad1c65ef75b960525e2b28c7434b2a 100644 --- a/test/porousmediumflow/2p/implicit/cornerpoint/main.cc +++ b/test/porousmediumflow/2p/implicit/cornerpoint/main.cc @@ -118,24 +118,24 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto spatialParams = std::make_shared(fvGridGeometry, gridManager.getDeck()); - auto problem = std::make_shared(fvGridGeometry, spatialParams); + auto spatialParams = std::make_shared(gridGeometry, gridManager.getDeck()); + auto problem = std::make_shared(gridGeometry, spatialParams); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -160,11 +160,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NewtonSolver; diff --git a/test/porousmediumflow/2p/implicit/cornerpoint/problem.hh b/test/porousmediumflow/2p/implicit/cornerpoint/problem.hh index 2f31bd79a3a9abc4539981c1887c6115cbf6f37e..586810ce737ec5aabc72de99fc93daa2f9b8ae18 100644 --- a/test/porousmediumflow/2p/implicit/cornerpoint/problem.hh +++ b/test/porousmediumflow/2p/implicit/cornerpoint/problem.hh @@ -77,10 +77,10 @@ template struct SpatialParams { private: - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; public: - using type = TwoPCornerPointTestSpatialParams; + using type = TwoPCornerPointTestSpatialParams; }; // Enable caching @@ -104,10 +104,10 @@ class TwoPCornerPointTestProblem : public PorousMediumFlowProblem using FluidSystem = GetPropType; using PrimaryVariables = GetPropType; using ElementVolumeVariables = typename GetPropType::LocalView; - using FVGridGeometry = GetPropType; - using GridView = typename FVGridGeometry::GridView; + using GridGeometry = GetPropType; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -117,9 +117,9 @@ class TwoPCornerPointTestProblem : public PorousMediumFlowProblem enum { dimWorld = GridView::dimensionworld }; public: - TwoPCornerPointTestProblem(std::shared_ptr fvGridGeometry, + TwoPCornerPointTestProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams) - : ParentType(fvGridGeometry, spatialParams) + : ParentType(gridGeometry, spatialParams) { gravity_ = {0, 0, 9.81}; injectionElement_ = getParam("Problem.InjectionElement"); diff --git a/test/porousmediumflow/2p/implicit/cornerpoint/spatialparams.hh b/test/porousmediumflow/2p/implicit/cornerpoint/spatialparams.hh index 81ef9bfcd09f92fbd77522090d2bf4f88ea7853b..e01602f20605655964480082f2feb4b8a9d835f1 100644 --- a/test/porousmediumflow/2p/implicit/cornerpoint/spatialparams.hh +++ b/test/porousmediumflow/2p/implicit/cornerpoint/spatialparams.hh @@ -37,16 +37,16 @@ namespace Dumux { * \ingroup TwoPTests * \brief The spatial params for the incompressible 2p test. */ -template +template class TwoPCornerPointTestSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; - using ThisType = TwoPCornerPointTestSpatialParams; - using ParentType = FVSpatialParams; + using ThisType = TwoPCornerPointTestSpatialParams; + using ParentType = FVSpatialParams; static constexpr int dimWorld = GridView::dimensionworld; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -60,9 +60,9 @@ public: using MaterialLawParams = typename MaterialLaw::Params; using PermeabilityType = DimWorldMatrix; - TwoPCornerPointTestSpatialParams(std::shared_ptr fvGridGeometry, + TwoPCornerPointTestSpatialParams(std::shared_ptr gridGeometry, std::shared_ptr deck) - : ParentType(fvGridGeometry) + : ParentType(gridGeometry) , deck_(deck) { homogeneous_ = getParam("Problem.Homogeneous"); diff --git a/test/porousmediumflow/2p/implicit/fracture/main.cc b/test/porousmediumflow/2p/implicit/fracture/main.cc index 6ed7851dc15bd9776ce262d2e6e59b973c3b1c8d..9953b25784d13b09e6de16ec40bb62903f82efae 100644 --- a/test/porousmediumflow/2p/implicit/fracture/main.cc +++ b/test/porousmediumflow/2p/implicit/fracture/main.cc @@ -93,23 +93,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -133,11 +133,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NewtonSolver; diff --git a/test/porousmediumflow/2p/implicit/fracture/problem.hh b/test/porousmediumflow/2p/implicit/fracture/problem.hh index 0d725b27c51f8a689518defdc48763697aed2fc7..99dd4c67225d6b285adf7b12bc21da344cc7a470 100644 --- a/test/porousmediumflow/2p/implicit/fracture/problem.hh +++ b/test/porousmediumflow/2p/implicit/fracture/problem.hh @@ -82,9 +82,9 @@ struct FluidSystem template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = FractureSpatialParams; + using type = FractureSpatialParams; }; // Use global caching @@ -111,7 +111,7 @@ class FractureProblem : public PorousMediumFlowProblem using Scalar = GetPropType; using GridView = GetPropType; using FluidSystem = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Indices = typename GetPropType::Indices; using PrimaryVariables = GetPropType; using BoundaryTypes = GetPropType; @@ -133,8 +133,8 @@ class FractureProblem : public PorousMediumFlowProblem using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: - FractureProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) {} + FractureProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) {} /*! * \name Problem parameters diff --git a/test/porousmediumflow/2p/implicit/fracture/spatialparams.hh b/test/porousmediumflow/2p/implicit/fracture/spatialparams.hh index 24a019cdeb3296e04bafea426a77d9dbdf25c7d7..d9d13cedc8f5687e2623570b38c4d24eaf2403f2 100644 --- a/test/porousmediumflow/2p/implicit/fracture/spatialparams.hh +++ b/test/porousmediumflow/2p/implicit/fracture/spatialparams.hh @@ -40,17 +40,17 @@ namespace Dumux { * \brief The spatial parameters for the LensProblem which uses the * two-phase fully implicit model. */ -template +template class FractureSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParams>; + using ParentType = FVSpatialParams>; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -63,8 +63,8 @@ public: using MaterialLaw = EffToAbsLaw; using MaterialLawParams = typename MaterialLaw::Params; - FractureSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + FractureSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { // residual saturations materialParams_.setSwr(0.05); diff --git a/test/porousmediumflow/2p/implicit/incompressible/main.cc b/test/porousmediumflow/2p/implicit/incompressible/main.cc index d493c01fb6ef36d5fadf897abb0ad8c9d094c3de..676ac8e40e558f71b06f8ede10540557ec167ab2 100644 --- a/test/porousmediumflow/2p/implicit/incompressible/main.cc +++ b/test/porousmediumflow/2p/implicit/incompressible/main.cc @@ -113,13 +113,13 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // get some time loop parameters using Scalar = GetPropType; @@ -132,7 +132,7 @@ int main(int argc, char** argv) try // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); if (restartTime > 0) { using IOFields = GetPropType; @@ -140,7 +140,7 @@ int main(int argc, char** argv) try using ModelTraits = GetPropType; using FluidSystem = GetPropType; const auto fileName = getParam("Restart.File"); - loadSolution(x, fileName, createPVNameFunction(), *fvGridGeometry); + loadSolution(x, fileName, createPVNameFunction(), *gridGeometry); } else problem->applyInitialSolution(x); @@ -152,7 +152,7 @@ int main(int argc, char** argv) try // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // intialize the vtk output module @@ -173,11 +173,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NewtonSolver; diff --git a/test/porousmediumflow/2p/implicit/incompressible/problem.hh b/test/porousmediumflow/2p/implicit/incompressible/problem.hh index fafda26c0f45dfb98978b96bc04b41fd468d881c..1b64ca9dc52b66babbf8225fbc3775c7fb2d6d83 100644 --- a/test/porousmediumflow/2p/implicit/incompressible/problem.hh +++ b/test/porousmediumflow/2p/implicit/incompressible/problem.hh @@ -84,10 +84,10 @@ template struct SpatialParams { private: - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; public: - using type = TwoPTestSpatialParams; + using type = TwoPTestSpatialParams; }; // Enable caching @@ -116,7 +116,7 @@ class TwoPTestProblem : public PorousMediumFlowProblem using Scalar = GetPropType; using FluidSystem = GetPropType; using PrimaryVariables = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using BoundaryTypes = GetPropType; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; using NumEqVector = GetPropType; @@ -130,8 +130,8 @@ class TwoPTestProblem : public PorousMediumFlowProblem }; public: - TwoPTestProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) {} + TwoPTestProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) {} /*! * \brief Specifies which kind of boundary condition should be diff --git a/test/porousmediumflow/2p/implicit/incompressible/spatialparams.hh b/test/porousmediumflow/2p/implicit/incompressible/spatialparams.hh index 5a7558ba780af768647203a317eb4393ca098efd..d0912b6feefaf7f947921f4d4fc0888acdbfefde 100644 --- a/test/porousmediumflow/2p/implicit/incompressible/spatialparams.hh +++ b/test/porousmediumflow/2p/implicit/incompressible/spatialparams.hh @@ -36,16 +36,16 @@ namespace Dumux { * \ingroup TwoPTests * \brief The spatial params for the incompressible 2p test. */ -template +template class TwoPTestSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; + using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; - using ThisType = TwoPTestSpatialParams; - using ParentType = FVSpatialParams; + using ThisType = TwoPTestSpatialParams; + using ParentType = FVSpatialParams; static constexpr int dimWorld = GridView::dimensionworld; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -57,8 +57,8 @@ public: using MaterialLawParams = typename MaterialLaw::Params; using PermeabilityType = Scalar; - TwoPTestSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + TwoPTestSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { lensIsOilWet_ = getParam("SpatialParams.LensIsOilWet", false); @@ -150,7 +150,7 @@ public: template void updateMaterialInterfaceParams(const SolutionVector& x) { - if (FVGridGeometry::discMethod == DiscretizationMethod::box) + if (GridGeometry::discMethod == DiscretizationMethod::box) materialInterfaceParams_.update(this->gridGeometry(), *this, x); } diff --git a/test/porousmediumflow/2p/implicit/nonisothermal/main.cc b/test/porousmediumflow/2p/implicit/nonisothermal/main.cc index bcb1684233c7240a64c9d901f9287ed71e387ce8..27c2bbb504965102dd22ced515e7b6694f3102ec 100644 --- a/test/porousmediumflow/2p/implicit/nonisothermal/main.cc +++ b/test/porousmediumflow/2p/implicit/nonisothermal/main.cc @@ -104,23 +104,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -143,7 +143,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::ILU0BiCGSTABBackend; @@ -154,8 +154,8 @@ int main(int argc, char** argv) try NewtonSolver nonLinearSolver(assembler, linearSolver); //the convergence writer - using NewtonConvergenceWriter = Dumux::NewtonConvergenceWriter; - auto convergenceWriter = std::make_shared(*fvGridGeometry); + using NewtonConvergenceWriter = Dumux::NewtonConvergenceWriter; + auto convergenceWriter = std::make_shared(*gridGeometry); nonLinearSolver.attachConvergenceWriter(convergenceWriter); // time loop diff --git a/test/porousmediumflow/2p/implicit/nonisothermal/problem.hh b/test/porousmediumflow/2p/implicit/nonisothermal/problem.hh index 97554608aa266a3c9f382ba49b295bda7d4c793d..bbd97e0d70baac48fc25012eaba16e4b48d23d14 100644 --- a/test/porousmediumflow/2p/implicit/nonisothermal/problem.hh +++ b/test/porousmediumflow/2p/implicit/nonisothermal/problem.hh @@ -82,9 +82,9 @@ struct FluidSystem { using type = FluidSyst template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = InjectionSpatialParams; + using type = InjectionSpatialParams; }; } // namespace Properties @@ -151,15 +151,15 @@ class InjectionProblem2PNI : public PorousMediumFlowProblem using PrimaryVariables = GetPropType; using NumEqVector = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using ElementVolumeVariables = typename GetPropType::LocalView; using FVElementGeometry = typename GetPropType::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using BoundaryTypes = GetPropType; public: - InjectionProblem2PNI(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + InjectionProblem2PNI(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { maxDepth_ = 2700.0; // [m] diff --git a/test/porousmediumflow/2p1c/implicit/main.cc b/test/porousmediumflow/2p1c/implicit/main.cc index d5516a4fdf6dd23ab424f4d5ec083c56606b1154..beb0ebb083499daf805d49e0acc0ad827b7f8cf3 100644 --- a/test/porousmediumflow/2p1c/implicit/main.cc +++ b/test/porousmediumflow/2p1c/implicit/main.cc @@ -84,23 +84,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -121,7 +121,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = ILU0BiCGSTABBackend; diff --git a/test/porousmediumflow/2p1c/implicit/problem.hh b/test/porousmediumflow/2p1c/implicit/problem.hh index 2708c8fa5d57f1bc7239ace97761c2a2a317f6b8..e779b9732c2800bbc18733ec54753f69d989bae6 100644 --- a/test/porousmediumflow/2p1c/implicit/problem.hh +++ b/test/porousmediumflow/2p1c/implicit/problem.hh @@ -74,9 +74,9 @@ public: template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = InjectionProblemSpatialParams; + using type = InjectionProblemSpatialParams; }; //Define whether spurious cold-water flow into the steam is blocked @@ -111,7 +111,7 @@ class InjectionProblem : public PorousMediumFlowProblem using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using GridView = GetPropType; using Element = typename GridView::template Codim<0>::Entity; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; // copy some indices for convenience enum { @@ -129,8 +129,8 @@ class InjectionProblem : public PorousMediumFlowProblem using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: - InjectionProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + InjectionProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { FluidSystem::init(); } /*! diff --git a/test/porousmediumflow/2p1c/implicit/spatialparams.hh b/test/porousmediumflow/2p1c/implicit/spatialparams.hh index 53e900fc79d437a4b703b4544e7030c9f51c56a7..b298ab78a125aa8f96c0aa55a1611abfd46ef559 100644 --- a/test/porousmediumflow/2p1c/implicit/spatialparams.hh +++ b/test/porousmediumflow/2p1c/implicit/spatialparams.hh @@ -35,17 +35,17 @@ namespace Dumux { * \ingroup TwoPOneCTests * \brief Definition of the spatial parameters for various steam injection problems. */ -template +template class InjectionProblemSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParams>; + using ParentType = FVSpatialParams>; static constexpr int dimWorld = GridView::dimensionworld; @@ -60,8 +60,8 @@ public: using MaterialLawParams = typename MaterialLaw::Params; using PermeabilityType = DimWorldMatrix; - InjectionProblemSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + InjectionProblemSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { gasWetting_ = getParam("SpatialParams.GasWetting", false); diff --git a/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/main.cc b/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/main.cc index 161016f4bbc61956473fd6e3d6d65029958a0f41..4b9a47339ac5b1999729a2515c593af4eb526825 100644 --- a/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/main.cc +++ b/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/main.cc @@ -105,23 +105,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); problem->setGridVariables(gridVariables); @@ -148,11 +148,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NonEquilibriumNewtonSolver; diff --git a/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/problem.hh b/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/problem.hh index a2767464f2e253e4cc906af0dfe5d7cfbf4988bb..0994bf5b9eb244194240541020223262d07068ca 100644 --- a/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/problem.hh +++ b/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/problem.hh @@ -82,9 +82,9 @@ public: template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = TwoPTwoCChemicalNonequilibriumSpatialParams; + using type = TwoPTwoCChemicalNonequilibriumSpatialParams; }; // decide which type to use for floating values (double / quad) @@ -138,7 +138,7 @@ class TwoPTwoCChemicalNonequilibriumProblem : public PorousMediumFlowProblem; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using SolutionVector = GetPropType; using VolumeVariables = GetPropType; @@ -147,11 +147,11 @@ class TwoPTwoCChemicalNonequilibriumProblem : public PorousMediumFlowProblem fvGridGeometry) - : ParentType(fvGridGeometry) + TwoPTwoCChemicalNonequilibriumProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { temperature_ = 273.15 + 25; // -> 25°C diff --git a/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/spatialparams.hh b/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/spatialparams.hh index d77fb8e87dea38afb1946281a88c00f2bc087a77..a8fb9a3f61d9780fb29d751e33520a633994ce1f 100644 --- a/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/spatialparams.hh +++ b/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/spatialparams.hh @@ -44,18 +44,18 @@ namespace Dumux { * \ingroup TwoPTwoCTests * \brief The spatial parameters for the 2p2c chemical nonequilibrium problem. */ -template +template class TwoPTwoCChemicalNonequilibriumSpatialParams -: public FVNonEquilibriumSpatialParams> +: public FVNonEquilibriumSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVNonEquilibriumSpatialParams>; + using ParentType = FVNonEquilibriumSpatialParams>; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -73,8 +73,8 @@ public: using AwnSurface = EffToAbsLawIA; using AwnSurfaceParams = typename AwnSurface::Params; - TwoPTwoCChemicalNonequilibriumSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + TwoPTwoCChemicalNonequilibriumSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { // intrinsic permeabilities coarseK_ = 1e-11; diff --git a/test/porousmediumflow/2p2c/implicit/injection/main.cc b/test/porousmediumflow/2p2c/implicit/injection/main.cc index 61861d1c67b52e55b4fee6b86c87ccc17c4bd5ef..94f5f62a1bc481a97322719646e44a503beb76d9 100644 --- a/test/porousmediumflow/2p2c/implicit/injection/main.cc +++ b/test/porousmediumflow/2p2c/implicit/injection/main.cc @@ -80,13 +80,13 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // get some time loop parameters using Scalar = GetPropType; @@ -99,7 +99,7 @@ int main(int argc, char** argv) try // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); if (restartTime > 0) { using IOFields = GetPropType; @@ -108,7 +108,7 @@ int main(int argc, char** argv) try using FluidSystem = GetPropType; const auto fileName = getParam("Restart.File"); const auto pvName = createPVNameFunction(); - loadSolution(x, fileName, pvName, *fvGridGeometry); + loadSolution(x, fileName, pvName, *gridGeometry); } else problem->applyInitialSolution(x); @@ -116,7 +116,7 @@ int main(int argc, char** argv) try // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // intialize the vtk output module @@ -133,11 +133,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = NewtonSolver; diff --git a/test/porousmediumflow/2p2c/implicit/injection/problem.hh b/test/porousmediumflow/2p2c/implicit/injection/problem.hh index 19e1b09295ba6607a3130e73386d34f5f22cf575..5f2db9277054608f104870c1183d11c95bd37fda 100644 --- a/test/porousmediumflow/2p2c/implicit/injection/problem.hh +++ b/test/porousmediumflow/2p2c/implicit/injection/problem.hh @@ -76,9 +76,9 @@ struct FluidSystem template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = InjectionSpatialParams; + using type = InjectionSpatialParams; }; // Define whether mole(true) or mass (false) fractions are used @@ -143,7 +143,7 @@ class InjectionProblem : public PorousMediumFlowProblem { using ParentType = PorousMediumFlowProblem; using GridView = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; using FluidSystem = GetPropType; @@ -190,8 +190,8 @@ class InjectionProblem : public PorousMediumFlowProblem static constexpr bool useMoles = ModelTraits::useMoles(); public: - InjectionProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + InjectionProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { nTemperature_ = getParam("Problem.NTemperature"); nPressure_ = getParam("Problem.NPressure"); diff --git a/test/porousmediumflow/2p2c/implicit/injection/spatialparams.hh b/test/porousmediumflow/2p2c/implicit/injection/spatialparams.hh index d1e4cbe35f02b7d52718464a4573d7a3c55a1500..d23d12282e1e3e3e4892014ff082da307f2a5822 100644 --- a/test/porousmediumflow/2p2c/implicit/injection/spatialparams.hh +++ b/test/porousmediumflow/2p2c/implicit/injection/spatialparams.hh @@ -38,16 +38,16 @@ namespace Dumux { * \brief Definition of the spatial parameters for the injection problem * which uses the isothermal two-phase two-component fully implicit model. */ -template +template class InjectionSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParams>; + using ParentType = FVSpatialParams>; static constexpr int dimWorld = GridView::dimensionworld; @@ -62,8 +62,8 @@ public: using MaterialLaw = EffToAbsLaw; using MaterialLawParams = typename MaterialLaw::Params; - InjectionSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + InjectionSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { layerBottom_ = 22.5; diff --git a/test/porousmediumflow/2p2c/implicit/mpnccomparison/main.cc b/test/porousmediumflow/2p2c/implicit/mpnccomparison/main.cc index 3500d484b1a07749b21359f7135a38ad4f7ef7f2..bafd1a872cfafebdf226803c0bc396416417c29c 100644 --- a/test/porousmediumflow/2p2c/implicit/mpnccomparison/main.cc +++ b/test/porousmediumflow/2p2c/implicit/mpnccomparison/main.cc @@ -105,23 +105,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -144,11 +144,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = NewtonSolver; diff --git a/test/porousmediumflow/2p2c/implicit/mpnccomparison/problem.hh b/test/porousmediumflow/2p2c/implicit/mpnccomparison/problem.hh index 8b2d14ae5c28171dd128b8baec0caa3c9ecf7ab7..2d9cc9fec12d1b5f7381e1dbf2a593364073d29a 100644 --- a/test/porousmediumflow/2p2c/implicit/mpnccomparison/problem.hh +++ b/test/porousmediumflow/2p2c/implicit/mpnccomparison/problem.hh @@ -76,9 +76,9 @@ struct FluidSystem template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = TwoPTwoCComparisonSpatialParams; + using type = TwoPTwoCComparisonSpatialParams; }; // decide which type to use for floating values (double / quad) @@ -118,14 +118,14 @@ class TwoPTwoCComparisonProblem : public PorousMediumFlowProblem using GridView = GetPropType; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using ModelTraits = GetPropType; using Indices = typename ModelTraits::Indices; public: - TwoPTwoCComparisonProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + TwoPTwoCComparisonProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { temperature_ = 273.15 + 25; // -> 25°C diff --git a/test/porousmediumflow/2p2c/implicit/mpnccomparison/spatialparams.hh b/test/porousmediumflow/2p2c/implicit/mpnccomparison/spatialparams.hh index 4214c894ee0a94dc7b30fc3e1136c16527492841..d984c54cb98e7ee6de914dc9aa97cafc21fd9f60 100644 --- a/test/porousmediumflow/2p2c/implicit/mpnccomparison/spatialparams.hh +++ b/test/porousmediumflow/2p2c/implicit/mpnccomparison/spatialparams.hh @@ -38,18 +38,18 @@ namespace Dumux { * \ingroup TwoPTwoCTests * \brief The spatial parameters for the 2p2c mpnc comparison problem. */ -template +template class TwoPTwoCComparisonSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParams>; + using ParentType = FVSpatialParams>; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -65,7 +65,7 @@ public: using MaterialLawParams = typename MaterialLaw::Params; - TwoPTwoCComparisonSpatialParams(std::shared_ptr fvGridGeometry) : ParentType(fvGridGeometry) + TwoPTwoCComparisonSpatialParams(std::shared_ptr gridGeometry) : ParentType(gridGeometry) { // intrinsic permeabilities coarseK_ = 1e-12; diff --git a/test/porousmediumflow/2p2c/implicit/waterair/main.cc b/test/porousmediumflow/2p2c/implicit/waterair/main.cc index a8a818205e6fdcc32654f6f57cb60923ee1666a4..c3d685aac63a31dca42477602a10e7f991014038 100644 --- a/test/porousmediumflow/2p2c/implicit/waterair/main.cc +++ b/test/porousmediumflow/2p2c/implicit/waterair/main.cc @@ -80,13 +80,13 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // get some time loop parameters using Scalar = GetPropType; @@ -99,7 +99,7 @@ int main(int argc, char** argv) try // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); if (restartTime > 0) { using IOFields = GetPropType; @@ -108,7 +108,7 @@ int main(int argc, char** argv) try using FluidSystem = GetPropType; const auto fileName = getParam("Restart.File"); const auto pvName = createPVNameFunction(); - loadSolution(x, fileName, pvName, *fvGridGeometry); + loadSolution(x, fileName, pvName, *gridGeometry); } else problem->applyInitialSolution(x); @@ -116,7 +116,7 @@ int main(int argc, char** argv) try // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // intialize the vtk output module @@ -133,11 +133,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = NewtonSolver; diff --git a/test/porousmediumflow/2p2c/implicit/waterair/problem.hh b/test/porousmediumflow/2p2c/implicit/waterair/problem.hh index a95f2fde0165f090208a1572a2b9e4788eae91fc..9a7cd74fea5effde7e6864368178a3369451c866 100644 --- a/test/porousmediumflow/2p2c/implicit/waterair/problem.hh +++ b/test/porousmediumflow/2p2c/implicit/waterair/problem.hh @@ -68,9 +68,9 @@ struct FluidSystem { using type = FluidSystems::H2ON2 struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = WaterAirSpatialParams; + using type = WaterAirSpatialParams; }; // Define whether mole(true) or mass (false) fractions are used @@ -150,7 +150,7 @@ class WaterAirProblem : public PorousMediumFlowProblem using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; using FVElementGeometry = typename GetPropType::LocalView; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using ElementVolumeVariables = typename GetPropType::LocalView; @@ -158,8 +158,8 @@ class WaterAirProblem : public PorousMediumFlowProblem static constexpr bool useMoles = ModelTraits::useMoles(); public: - WaterAirProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + WaterAirProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { maxDepth_ = 1000.0; // [m] diff --git a/test/porousmediumflow/2p2c/implicit/waterair/spatialparams.hh b/test/porousmediumflow/2p2c/implicit/waterair/spatialparams.hh index 17d7efd06d89c05502872d3a164f64d87dd5bd2c..ed0bbe01f9e520357c809616f2ac81eb05cd91eb 100644 --- a/test/porousmediumflow/2p2c/implicit/waterair/spatialparams.hh +++ b/test/porousmediumflow/2p2c/implicit/waterair/spatialparams.hh @@ -39,17 +39,17 @@ namespace Dumux { * \ingroup TwoPTwoCModel * \brief Definition of the spatial parameters for the water-air problem. */ -template +template class WaterAirSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParams>; + using ParentType = FVSpatialParams>; static constexpr int dimWorld = GridView::dimensionworld; @@ -64,7 +64,7 @@ public: using MaterialLaw = EffToAbsLaw; using MaterialLawParams = typename MaterialLaw::Params; - WaterAirSpatialParams(std::shared_ptr fvGridGeometry) : ParentType(fvGridGeometry) + WaterAirSpatialParams(std::shared_ptr gridGeometry) : ParentType(gridGeometry) { layerBottom_ = 22.0; diff --git a/test/porousmediumflow/2pnc/implicit/diffusion/main.cc b/test/porousmediumflow/2pnc/implicit/diffusion/main.cc index ebb030d8ae5b66146854814fa0c1a16521a4efd9..7e980f260bd876b23911f1d3d1f0d2a0c40448f9 100644 --- a/test/porousmediumflow/2pnc/implicit/diffusion/main.cc +++ b/test/porousmediumflow/2pnc/implicit/diffusion/main.cc @@ -102,23 +102,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -141,11 +141,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = NewtonSolver; diff --git a/test/porousmediumflow/2pnc/implicit/diffusion/problem.hh b/test/porousmediumflow/2pnc/implicit/diffusion/problem.hh index 2c8a3cae7a030d1c05200952092145a877f98f81..91dbd1d19977f747823ce6d8ca99bde45d28ea78 100644 --- a/test/porousmediumflow/2pnc/implicit/diffusion/problem.hh +++ b/test/porousmediumflow/2pnc/implicit/diffusion/problem.hh @@ -71,9 +71,9 @@ struct FluidSystem template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = TwoPNCDiffusionSpatialParams; + using type = TwoPNCDiffusionSpatialParams; }; // Define whether mole(true) or mass (false) fractions are used @@ -116,14 +116,14 @@ class TwoPNCDiffusionProblem : public PorousMediumFlowProblem using BoundaryTypes = GetPropType; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; //! Property that defines whether mole or mass fractions are used static constexpr bool useMoles = getPropValue(); public: - TwoPNCDiffusionProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + TwoPNCDiffusionProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { // initialize the tables of the fluid system FluidSystem::init(); diff --git a/test/porousmediumflow/2pnc/implicit/diffusion/spatialparams.hh b/test/porousmediumflow/2pnc/implicit/diffusion/spatialparams.hh index b8ecf3fc8064335eb8d6ffabed99151c14d551da..dcbcfce6cf24771446ac4fcd4cead35bba358a57 100644 --- a/test/porousmediumflow/2pnc/implicit/diffusion/spatialparams.hh +++ b/test/porousmediumflow/2pnc/implicit/diffusion/spatialparams.hh @@ -39,14 +39,14 @@ namespace Dumux { * \brief Definition of the spatial parameters for the TwoPNCDiffusion * problem which uses the isothermal 2p2c box model. */ -template +template class TwoPNCDiffusionSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using ParentType = FVSpatialParams>; + using GridView = typename GridGeometry::GridView; + using ParentType = FVSpatialParams>; static constexpr int dimWorld = GridView::dimensionworld; @@ -63,8 +63,8 @@ public: using MaterialLaw = EffToAbsLaw; using MaterialLawParams = typename MaterialLaw::Params; - TwoPNCDiffusionSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry), K_(0) + TwoPNCDiffusionSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry), K_(0) { // intrinsic permeabilities K_[0][0] = 5e-11; diff --git a/test/porousmediumflow/2pnc/implicit/fuelcell/main.cc b/test/porousmediumflow/2pnc/implicit/fuelcell/main.cc index 795b08881b9841a196399bb20c329c6ea1ad0ae4..9aad61b7fb885d320a87f572f7549dd26ad79e8c 100644 --- a/test/porousmediumflow/2pnc/implicit/fuelcell/main.cc +++ b/test/porousmediumflow/2pnc/implicit/fuelcell/main.cc @@ -102,23 +102,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -142,11 +142,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = NewtonSolver; diff --git a/test/porousmediumflow/2pnc/implicit/fuelcell/problem.hh b/test/porousmediumflow/2pnc/implicit/fuelcell/problem.hh index 6ef872e50c712630329869b72186e91d2df8a13f..5d8843c106101fc92e25bd023126f6d5c5a2e7b4 100644 --- a/test/porousmediumflow/2pnc/implicit/fuelcell/problem.hh +++ b/test/porousmediumflow/2pnc/implicit/fuelcell/problem.hh @@ -74,9 +74,9 @@ struct Problem { using type = FuelCellProblem; template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = FuelCellSpatialParams; + using type = FuelCellSpatialParams; }; // Set the primary variable combination for the 2pnc model @@ -118,24 +118,24 @@ class FuelCellProblem : public PorousMediumFlowProblem using SubControlVolume = typename FVElementGeometry::SubControlVolume; using GridView = GetPropType; using Element = typename GridView::template Codim<0>::Entity; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using SolutionVector = GetPropType; using VolumeVariables = GetPropType; // Select the electrochemistry method #ifdef NONISOTHERMAL - using ElectroChemistry = typename Dumux::ElectroChemistryNI; + using ElectroChemistry = typename Dumux::ElectroChemistryNI; #else - using ElectroChemistry = typename Dumux::ElectroChemistry; + using ElectroChemistry = typename Dumux::ElectroChemistry; #endif static constexpr int dim = GridView::dimension; static constexpr int dimWorld = GridView::dimensionworld; - static constexpr bool isBox = FVGridGeometry::discMethod == DiscretizationMethod::box; + static constexpr bool isBox = GridGeometry::discMethod == DiscretizationMethod::box; using GlobalPosition = typename SubControlVolume::GlobalPosition; enum { dofCodim = isBox ? dim : 0 }; public: - FuelCellProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + FuelCellProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { nTemperature_ = getParam("Problem.NTemperature"); nPressure_ = getParam("Problem.NPressure"); diff --git a/test/porousmediumflow/2pnc/implicit/fuelcell/spatialparams.hh b/test/porousmediumflow/2pnc/implicit/fuelcell/spatialparams.hh index d2c7714d821843c8b6012bfa553d2514524ec442..668a1cde91ea892f1f5df2a0ac7f47a4538fe9a5 100644 --- a/test/porousmediumflow/2pnc/implicit/fuelcell/spatialparams.hh +++ b/test/porousmediumflow/2pnc/implicit/fuelcell/spatialparams.hh @@ -39,18 +39,18 @@ namespace Dumux { * \brief Definition of the spatial parameters for the FuelCell * problem which uses the isothermal 2p2c box model. */ -template +template class FuelCellSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using ParentType = FVSpatialParams>; + using GridView = typename GridGeometry::GridView; + using ParentType = FVSpatialParams>; static constexpr int dimWorld = GridView::dimensionworld; - using Element = typename FVGridGeometry::GridView::template Codim<0>::Entity; + using Element = typename GridGeometry::GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; using DimWorldMatrix = Dune::FieldMatrix; @@ -62,8 +62,8 @@ public: using MaterialLawParams = typename MaterialLaw::Params; using PermeabilityType = DimWorldMatrix; - FuelCellSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry), K_(0) + FuelCellSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry), K_(0) { // intrinsic permeabilities K_[0][0] = 5e-11; diff --git a/test/porousmediumflow/2pncmin/implicit/isothermal/main.cc b/test/porousmediumflow/2pncmin/implicit/isothermal/main.cc index e4a26d328b570cbb0425f02ba54e76b6cc0c22ce..3e0868b32061f153b8a5b56e42ccd02693cecb1c 100644 --- a/test/porousmediumflow/2pncmin/implicit/isothermal/main.cc +++ b/test/porousmediumflow/2pncmin/implicit/isothermal/main.cc @@ -103,13 +103,13 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // get some time loop parameters using Scalar = GetPropType; @@ -122,7 +122,7 @@ int main(int argc, char** argv) try // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); if (restartTime > 0) { using IOFields = GetPropType; @@ -132,7 +132,7 @@ int main(int argc, char** argv) try using SolidSystem = GetPropType; const auto fileName = getParam("Restart.File"); const auto pvName = createPVNameFunction(); - loadSolution(x, fileName, pvName, *fvGridGeometry); + loadSolution(x, fileName, pvName, *gridGeometry); } else problem->applyInitialSolution(x); @@ -140,7 +140,7 @@ int main(int argc, char** argv) try // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // initialize the vtk output module @@ -161,11 +161,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = NewtonSolver; diff --git a/test/porousmediumflow/2pncmin/implicit/isothermal/problem.hh b/test/porousmediumflow/2pncmin/implicit/isothermal/problem.hh index dcac0dd49177720e017fee07efcb900816c551cf..c69c5ca7f1914b066b0c39ceb41e6856d4d570bb 100644 --- a/test/porousmediumflow/2pncmin/implicit/isothermal/problem.hh +++ b/test/porousmediumflow/2pncmin/implicit/isothermal/problem.hh @@ -86,9 +86,9 @@ struct SolidSystem template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = DissolutionSpatialParams; + using type = DissolutionSpatialParams; }; // Set properties here to override the default property settings @@ -178,15 +178,15 @@ class DissolutionProblem : public PorousMediumFlowProblem using BoundaryTypes = GetPropType; using ElementVolumeVariables = typename GetPropType::LocalView; using Element = typename GridView::template Codim<0>::Entity; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using SolutionVector = GetPropType; using FVElementGeometry = typename GetPropType::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using GlobalPosition = typename SubControlVolume::GlobalPosition; public: - DissolutionProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + DissolutionProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { outerSalinity_ = getParam("Problem.OuterSalinity"); temperature_ = getParam("Problem.Temperature"); @@ -210,7 +210,7 @@ public: name_ = getParam("Problem.Name"); unsigned int codim = GetPropType::discMethod == DiscretizationMethod::box ? dim : 0; - permeability_.resize(fvGridGeometry->gridView().size(codim)); + permeability_.resize(gridGeometry->gridView().size(codim)); FluidSystem::init(/*Tmin=*/temperatureLow_, /*Tmax=*/temperatureHigh_, diff --git a/test/porousmediumflow/2pncmin/implicit/isothermal/spatialparams.hh b/test/porousmediumflow/2pncmin/implicit/isothermal/spatialparams.hh index 1b0806f3c7f5a3440ca7236bca61b4c04d20894d..bcdb15a870c63a5ec9de6ff55b0733d063eac1b2 100644 --- a/test/porousmediumflow/2pncmin/implicit/isothermal/spatialparams.hh +++ b/test/porousmediumflow/2pncmin/implicit/isothermal/spatialparams.hh @@ -40,18 +40,18 @@ namespace Dumux { * \brief Spatial parameters for the dissolution problem * where water is injected in a for flushing precipitated salt clogging a gas reservoir. */ -template +template class DissolutionSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParams>; + using ParentType = FVSpatialParams>; using EffectiveLaw = RegularizedBrooksCorey; @@ -64,8 +64,8 @@ public: using MaterialLaw = EffToAbsLaw; using MaterialLawParams = typename MaterialLaw::Params; - DissolutionSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + DissolutionSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { solubilityLimit_ = getParam("SpatialParams.SolubilityLimit", 0.26); referencePorosity_ = getParam("SpatialParams.referencePorosity", 0.11); diff --git a/test/porousmediumflow/3p/implicit/conduction/main.cc b/test/porousmediumflow/3p/implicit/conduction/main.cc index 49cef2fc618a5555d27febb396adafd45cb26c82..43232452cc57d036250b61f272a61dc227ecc16c 100644 --- a/test/porousmediumflow/3p/implicit/conduction/main.cc +++ b/test/porousmediumflow/3p/implicit/conduction/main.cc @@ -109,23 +109,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -151,11 +151,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NewtonSolver; diff --git a/test/porousmediumflow/3p/implicit/conduction/problem.hh b/test/porousmediumflow/3p/implicit/conduction/problem.hh index 7ec8bbbfeae6a9158155f21110b66ac4f6ff0597..162ed18bc5da669d752760508d86ab291d73d965 100644 --- a/test/porousmediumflow/3p/implicit/conduction/problem.hh +++ b/test/porousmediumflow/3p/implicit/conduction/problem.hh @@ -73,9 +73,9 @@ struct FluidSystem template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = ThreePNISpatialParams; + using type = ThreePNISpatialParams; }; }// end namespace Properties @@ -112,7 +112,7 @@ class ThreePNIConductionProblem : public PorousMediumFlowProblem using GridView = GetPropType; using Scalar = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using PrimaryVariables = GetPropType; using FluidSystem = GetPropType; using BoundaryTypes = GetPropType; @@ -139,15 +139,15 @@ class ThreePNIConductionProblem : public PorousMediumFlowProblem using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: - ThreePNIConductionProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + ThreePNIConductionProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { //initialize fluid system FluidSystem::init(); name_ = getParam("Problem.Name"); temperatureHigh_ = 300.0; - temperatureExact_.resize(fvGridGeometry->numDofs()); + temperatureExact_.resize(gridGeometry->numDofs()); } //! Get the analytical temperature diff --git a/test/porousmediumflow/3p/implicit/conduction/spatialparams.hh b/test/porousmediumflow/3p/implicit/conduction/spatialparams.hh index 20462a83392446304d32520067ae38ede21d077b..6fa0971a8e5c32d2586b8c42dba346db593ae88d 100644 --- a/test/porousmediumflow/3p/implicit/conduction/spatialparams.hh +++ b/test/porousmediumflow/3p/implicit/conduction/spatialparams.hh @@ -37,17 +37,17 @@ namespace Dumux { * \ingroup ThreePTests * \brief Definition of the spatial parameters for the 3pni problems. */ -template +template class ThreePNISpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParams>; + using ParentType = FVSpatialParams>; using EffectiveLaw = RegularizedParkerVanGen3P; @@ -60,8 +60,8 @@ public: using MaterialLaw = EffToAbsLaw; using MaterialLawParams = typename MaterialLaw::Params; - ThreePNISpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + ThreePNISpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { permeability_ = 1e-10; porosity_ = 0.4; diff --git a/test/porousmediumflow/3p/implicit/convection/main.cc b/test/porousmediumflow/3p/implicit/convection/main.cc index 3b4ce393db1bb42a651db44709d1c89013650de4..9262a76fea1ead23cc5ee7e32eb87ea0c1b13e08 100644 --- a/test/porousmediumflow/3p/implicit/convection/main.cc +++ b/test/porousmediumflow/3p/implicit/convection/main.cc @@ -109,23 +109,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -151,11 +151,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NewtonSolver; diff --git a/test/porousmediumflow/3p/implicit/convection/problem.hh b/test/porousmediumflow/3p/implicit/convection/problem.hh index bcdff72d3f2c1d73b18cc101117d393d91fe7a77..ac7f00a36ecbadc86b466e953a48228ab62ef0ef 100644 --- a/test/porousmediumflow/3p/implicit/convection/problem.hh +++ b/test/porousmediumflow/3p/implicit/convection/problem.hh @@ -75,9 +75,9 @@ struct FluidSystem template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = ThreePNISpatialParams; + using type = ThreePNISpatialParams; }; } // end namespace Properties @@ -115,7 +115,7 @@ class ThreePNIConvectionProblem : public PorousMediumFlowProblem using GridView = GetPropType; using Scalar = GetPropType; using FVElementGeometry = typename GetPropType::LocalView; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using PrimaryVariables = GetPropType; using NumEqVector = GetPropType; using FluidSystem = GetPropType; @@ -149,8 +149,8 @@ class ThreePNIConvectionProblem : public PorousMediumFlowProblem using GlobalPosition = typename SubControlVolumeFace::GlobalPosition; public: - ThreePNIConvectionProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + ThreePNIConvectionProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { //initialize fluid system FluidSystem::init(); diff --git a/test/porousmediumflow/3p/implicit/infiltration/main.cc b/test/porousmediumflow/3p/implicit/infiltration/main.cc index 7226c3ae8f140670f848fa9bfdd9f6bae66bc815..9aed50b55f44de19f2263f2718176b23c3c17dc4 100644 --- a/test/porousmediumflow/3p/implicit/infiltration/main.cc +++ b/test/porousmediumflow/3p/implicit/infiltration/main.cc @@ -109,23 +109,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -148,11 +148,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NewtonSolver; diff --git a/test/porousmediumflow/3p/implicit/infiltration/problem.hh b/test/porousmediumflow/3p/implicit/infiltration/problem.hh index 699f999ceffd534017b2b161f7bc08277344c9fa..8c936d70a313789971ce29d8d5b85c44a203fcb4 100644 --- a/test/porousmediumflow/3p/implicit/infiltration/problem.hh +++ b/test/porousmediumflow/3p/implicit/infiltration/problem.hh @@ -83,9 +83,9 @@ public: template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = InfiltrationThreePSpatialParams; + using type = InfiltrationThreePSpatialParams; }; }// end namespace Properties @@ -141,14 +141,14 @@ class InfiltrationThreePProblem : public PorousMediumFlowProblem using NumEqVector = GetPropType; using BoundaryTypes = GetPropType; using FluidSystem = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: - InfiltrationThreePProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + InfiltrationThreePProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { temperature_ = 273.15 + 10.0; // -> 10 degrees Celsius FluidSystem::init(282.15, 284.15, 3, 8e4, 3e5, 200); diff --git a/test/porousmediumflow/3p/implicit/infiltration/spatialparams.hh b/test/porousmediumflow/3p/implicit/infiltration/spatialparams.hh index 8b499b675c640795867393660cbbb57d7ec1a4e8..6fe052f3188aa81072e2fb3889d9218e2e86c4b4 100644 --- a/test/porousmediumflow/3p/implicit/infiltration/spatialparams.hh +++ b/test/porousmediumflow/3p/implicit/infiltration/spatialparams.hh @@ -39,17 +39,17 @@ namespace Dumux { * \ingroup ThreePTests * \brief Definition of the spatial parameters for the infiltration problem */ -template +template class InfiltrationThreePSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParams>; + using ParentType = FVSpatialParams>; using GlobalPosition = typename SubControlVolume::GlobalPosition; @@ -63,8 +63,8 @@ public: using MaterialLaw = EffToAbsLaw; using MaterialLawParams = typename MaterialLaw::Params; - InfiltrationThreePSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + InfiltrationThreePSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { // intrinsic permeabilities fineK_ = getParam("SpatialParams.permeability"); diff --git a/test/porousmediumflow/3p3c/implicit/columnxylol/main.cc b/test/porousmediumflow/3p3c/implicit/columnxylol/main.cc index 32d93ba26f490a6a2be517da9704bfdf26630b11..ea6edcb4048817bcdf3cca61d92331be18a6e5b3 100644 --- a/test/porousmediumflow/3p3c/implicit/columnxylol/main.cc +++ b/test/porousmediumflow/3p3c/implicit/columnxylol/main.cc @@ -107,23 +107,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -147,11 +147,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = NewtonSolver; diff --git a/test/porousmediumflow/3p3c/implicit/columnxylol/problem.hh b/test/porousmediumflow/3p3c/implicit/columnxylol/problem.hh index 8cea3a60ca5add650f68b36a74f4e9943c60574c..4b372c502e1ea7668d89a2dd8c95a351b0cc7c2d 100644 --- a/test/porousmediumflow/3p3c/implicit/columnxylol/problem.hh +++ b/test/porousmediumflow/3p3c/implicit/columnxylol/problem.hh @@ -95,9 +95,9 @@ public: template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = ColumnSpatialParams; + using type = ColumnSpatialParams; }; } // end namespace Properties @@ -161,13 +161,13 @@ class ColumnProblem : public PorousMediumFlowProblem using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; using FVElementGeometry = typename GetPropType::LocalView; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using ElementVolumeVariables = typename GetPropType::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; public: - ColumnProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + ColumnProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { FluidSystem::init(); name_ = getParam("Problem.Name"); diff --git a/test/porousmediumflow/3p3c/implicit/columnxylol/spatialparams.hh b/test/porousmediumflow/3p3c/implicit/columnxylol/spatialparams.hh index cb2b187527d6601f4b9ac16a7dc68738e54fa432..4de10b8032374a6a9a8eb9bb503cc8e6ea368f1c 100644 --- a/test/porousmediumflow/3p3c/implicit/columnxylol/spatialparams.hh +++ b/test/porousmediumflow/3p3c/implicit/columnxylol/spatialparams.hh @@ -36,18 +36,18 @@ namespace Dumux { * \ingroup ThreePThreeCModel * \brief Definition of the spatial parameters for the column problem. */ -template +template class ColumnSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParams>; + using ParentType = FVSpatialParams>; using GlobalPosition = typename SubControlVolume::GlobalPosition; using EffectiveLaw = RegularizedParkerVanGen3P; @@ -57,8 +57,8 @@ public: using MaterialLawParams = typename MaterialLaw::Params; using PermeabilityType = Scalar; - ColumnSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + ColumnSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { // intrinsic permeabilities fineK_ = 1.4e-11; diff --git a/test/porousmediumflow/3p3c/implicit/infiltration/main.cc b/test/porousmediumflow/3p3c/implicit/infiltration/main.cc index 32d93ba26f490a6a2be517da9704bfdf26630b11..ea6edcb4048817bcdf3cca61d92331be18a6e5b3 100644 --- a/test/porousmediumflow/3p3c/implicit/infiltration/main.cc +++ b/test/porousmediumflow/3p3c/implicit/infiltration/main.cc @@ -107,23 +107,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -147,11 +147,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = NewtonSolver; diff --git a/test/porousmediumflow/3p3c/implicit/infiltration/problem.hh b/test/porousmediumflow/3p3c/implicit/infiltration/problem.hh index 35e4691d9420140c7e6645fb92c5d03084b5f49f..51908096983de1ea040681ad253883c1c9adc6ee 100644 --- a/test/porousmediumflow/3p3c/implicit/infiltration/problem.hh +++ b/test/porousmediumflow/3p3c/implicit/infiltration/problem.hh @@ -66,9 +66,9 @@ struct Problem { using type = Infiltrat template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = InfiltrationThreePThreeCSpatialParams; + using type = InfiltrationThreePThreeCSpatialParams; }; // Set the fluid system @@ -138,14 +138,14 @@ class InfiltrationThreePThreeCProblem : public PorousMediumFlowProblem using PrimaryVariables = GetPropType; using NumEqVector = GetPropType; using BoundaryTypes = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: - InfiltrationThreePThreeCProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + InfiltrationThreePThreeCProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { temperature_ = 273.15 + 10.0; // -> 10 degrees Celsius FluidSystem::init(/*tempMin=*/temperature_ - 1, diff --git a/test/porousmediumflow/3p3c/implicit/infiltration/spatialparams.hh b/test/porousmediumflow/3p3c/implicit/infiltration/spatialparams.hh index fbb20acdedd81b69e2c0aa1dc5b3a0594b0ac6e9..2b7f665c5568643d3210bd937cf9e654a533b4ec 100644 --- a/test/porousmediumflow/3p3c/implicit/infiltration/spatialparams.hh +++ b/test/porousmediumflow/3p3c/implicit/infiltration/spatialparams.hh @@ -39,17 +39,17 @@ namespace Dumux { * \ingroup ThreePThreeCTests * \brief Definition of the spatial parameters for the infiltration problem */ -template +template class InfiltrationThreePThreeCSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParams>; + using ParentType = FVSpatialParams>; using EffectiveLaw = RegularizedParkerVanGen3P; @@ -60,8 +60,8 @@ public: using MaterialLawParams = typename MaterialLaw::Params; using PermeabilityType = Scalar; - InfiltrationThreePThreeCSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + InfiltrationThreePThreeCSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { // intrinsic permeabilities fineK_ = 1.e-11; diff --git a/test/porousmediumflow/3p3c/implicit/kuevette/main.cc b/test/porousmediumflow/3p3c/implicit/kuevette/main.cc index 32d93ba26f490a6a2be517da9704bfdf26630b11..ea6edcb4048817bcdf3cca61d92331be18a6e5b3 100644 --- a/test/porousmediumflow/3p3c/implicit/kuevette/main.cc +++ b/test/porousmediumflow/3p3c/implicit/kuevette/main.cc @@ -107,23 +107,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -147,11 +147,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = NewtonSolver; diff --git a/test/porousmediumflow/3p3c/implicit/kuevette/problem.hh b/test/porousmediumflow/3p3c/implicit/kuevette/problem.hh index f73ab7dfa09b6b58cb5fe3c34822176e651b2072..dbda4c15f63ca740322cfdd72622f9936d3b4322 100644 --- a/test/porousmediumflow/3p3c/implicit/kuevette/problem.hh +++ b/test/porousmediumflow/3p3c/implicit/kuevette/problem.hh @@ -72,9 +72,9 @@ struct Problem { using type = KuevetteProblem; template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = KuevetteSpatialParams; + using type = KuevetteSpatialParams; }; // Set the fluid system @@ -145,7 +145,7 @@ class KuevetteProblem : public PorousMediumFlowProblem using NumEqVector = GetPropType; using BoundaryTypes = GetPropType; using Element = typename GridView::template Codim<0>::Entity; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using FVElementGeometry = typename GetPropType::LocalView; using GridVariables = GetPropType; using ElementVolumeVariables = typename GridVariables::GridVolumeVariables::LocalView; @@ -155,8 +155,8 @@ class KuevetteProblem : public PorousMediumFlowProblem using GlobalPosition = typename SubControlVolumeFace::GlobalPosition; public: - KuevetteProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + KuevetteProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { FluidSystem::init(); name_ = getParam("Problem.Name"); diff --git a/test/porousmediumflow/3p3c/implicit/kuevette/spatialparams.hh b/test/porousmediumflow/3p3c/implicit/kuevette/spatialparams.hh index d901cb3c072aaf717ed3e1a3a55acb33cd910d99..4f9bb865bbc23b1732461d6c4018232c5203b937 100644 --- a/test/porousmediumflow/3p3c/implicit/kuevette/spatialparams.hh +++ b/test/porousmediumflow/3p3c/implicit/kuevette/spatialparams.hh @@ -39,18 +39,18 @@ namespace Dumux { * \ingroup ThreePThreeCTests * \brief Definition of the spatial parameters for the kuevette problem */ -template +template class KuevetteSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParams>; + using ParentType = FVSpatialParams>; using GlobalPosition = typename SubControlVolume::GlobalPosition; @@ -61,8 +61,8 @@ public: using MaterialLawParams = typename MaterialLaw::Params; using PermeabilityType = Scalar; - KuevetteSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + KuevetteSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { // intrinsic permeabilities fineK_ = 6.28e-12; diff --git a/test/porousmediumflow/3pwateroil/implicit/main.cc b/test/porousmediumflow/3pwateroil/implicit/main.cc index 13fe934e550f8dc7b6508ef87e47cc48cb45c1f1..6733382473ed514e30937d261c314f0d6fb8b54b 100644 --- a/test/porousmediumflow/3pwateroil/implicit/main.cc +++ b/test/porousmediumflow/3pwateroil/implicit/main.cc @@ -107,23 +107,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -147,11 +147,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = NewtonSolver; diff --git a/test/porousmediumflow/3pwateroil/implicit/problem.hh b/test/porousmediumflow/3pwateroil/implicit/problem.hh index 448a3d2ec013b263e50f182682d8f190c34ed001..2e7baddc8b47d0659cd607174cd21329d5f2b9ac 100644 --- a/test/porousmediumflow/3pwateroil/implicit/problem.hh +++ b/test/porousmediumflow/3pwateroil/implicit/problem.hh @@ -62,9 +62,9 @@ struct Problem { using type = Dumux::SagdProblem; template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = SagdSpatialParams; + using type = SagdSpatialParams; }; // Set the fluid system @@ -99,7 +99,7 @@ class SagdProblem : public PorousMediumFlowProblem { using ParentType = PorousMediumFlowProblem; using GridView = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; using FluidSystem = GetPropType; using Indices = typename GetPropType::Indices; @@ -136,8 +136,8 @@ class SagdProblem : public PorousMediumFlowProblem public: - SagdProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry), pOut_(4e6) + SagdProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry), pOut_(4e6) { maxDepth_ = 400.0; // [m] FluidSystem::init(); diff --git a/test/porousmediumflow/3pwateroil/implicit/spatialparams.hh b/test/porousmediumflow/3pwateroil/implicit/spatialparams.hh index 543d2dd099508b2edccfc1ae9b9307aedca8cf74..94790c03570605340441641b7034921ddcea5bcf 100644 --- a/test/porousmediumflow/3pwateroil/implicit/spatialparams.hh +++ b/test/porousmediumflow/3pwateroil/implicit/spatialparams.hh @@ -40,13 +40,13 @@ namespace Dumux { * \ingroup ThreePWaterOilTests * \brief Definition of the spatial parameters for the SAGD problem */ -template +template class SagdSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; enum { dimWorld=GridView::dimensionworld }; @@ -54,8 +54,8 @@ class SagdSpatialParams using GlobalPosition = typename SubControlVolume::GlobalPosition; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParams>; + using ParentType = FVSpatialParams>; using EffectiveLaw = RegularizedParkerVanGen3P; @@ -64,8 +64,8 @@ public: using MaterialLawParams = typename MaterialLaw::Params; using PermeabilityType = Scalar; - SagdSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry), eps_(1e-6) + SagdSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry), eps_(1e-6) { layerBottom_ = 35.0; diff --git a/test/porousmediumflow/co2/implicit/main.cc b/test/porousmediumflow/co2/implicit/main.cc index cdbc9af8b5997fba9e8abcdb2d254aad8dc00807..7c18c0909dd1248c6d7b9f3e5d79b8715dc5f19f 100644 --- a/test/porousmediumflow/co2/implicit/main.cc +++ b/test/porousmediumflow/co2/implicit/main.cc @@ -79,27 +79,27 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the spatial parameters using SpatialParams = GetPropType; - auto spatialParams = std::make_shared(fvGridGeometry, gridManager.getGridData()); + auto spatialParams = std::make_shared(gridGeometry, gridManager.getGridData()); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry, spatialParams); + auto problem = std::make_shared(gridGeometry, spatialParams); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -123,11 +123,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = NewtonSolver; diff --git a/test/porousmediumflow/co2/implicit/problem.hh b/test/porousmediumflow/co2/implicit/problem.hh index 46e7a10a9cab627549615889fbb4a3f6be085bc6..cbeb37669a95a8fcf969119a67578acab29127c2 100644 --- a/test/porousmediumflow/co2/implicit/problem.hh +++ b/test/porousmediumflow/co2/implicit/problem.hh @@ -205,7 +205,7 @@ class HeterogeneousProblem : public PorousMediumFlowProblem using BoundaryTypes = GetPropType; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using FVElementGeometry = typename GetPropType::LocalView; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using SubControlVolume = typename FVElementGeometry::SubControlVolume; @@ -223,8 +223,8 @@ class HeterogeneousProblem : public PorousMediumFlowProblem public: template - HeterogeneousProblem(std::shared_ptr fvGridGeometry, std::shared_ptr spatialParams) - : ParentType(fvGridGeometry, spatialParams) + HeterogeneousProblem(std::shared_ptr gridGeometry, std::shared_ptr spatialParams) + : ParentType(gridGeometry, spatialParams) , injectionTop_(1) , injectionBottom_(2) , dirichletBoundary_(3) diff --git a/test/porousmediumflow/co2/implicit/spatialparams.hh b/test/porousmediumflow/co2/implicit/spatialparams.hh index 278289e22312d63f191048d74048590b2b0ae8ef..d858b2dab749e3c0f4a81ffb0f727fac3d1f1598 100644 --- a/test/porousmediumflow/co2/implicit/spatialparams.hh +++ b/test/porousmediumflow/co2/implicit/spatialparams.hh @@ -42,18 +42,18 @@ namespace Dumux { * problem which uses the non-isothermal or isothermal CO2 * fully implicit model. */ -template +template class HeterogeneousSpatialParams -: public FVSpatialParams> + HeterogeneousSpatialParams> { - using Grid = typename FVGridGeometry::Grid; - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using Grid = typename GridGeometry::Grid; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParams>; + using ParentType = FVSpatialParams>; using GlobalPosition = typename SubControlVolume::GlobalPosition; @@ -64,9 +64,9 @@ public: using MaterialLawParams = typename MaterialLaw::Params; using PermeabilityType = Scalar; - HeterogeneousSpatialParams(std::shared_ptr fvGridGeometry, + HeterogeneousSpatialParams(std::shared_ptr gridGeometry, std::shared_ptr> gridData) - : ParentType(fvGridGeometry), gridData_(gridData) + : ParentType(gridGeometry), gridData_(gridData) { // Set the permeability for the layers diff --git a/test/porousmediumflow/mpnc/implicit/2p2ccomparison/main.cc b/test/porousmediumflow/mpnc/implicit/2p2ccomparison/main.cc index af5d82834f89040203d0f51e89da5e217db5a77a..2bae1e10dcb6ac4cf430101101d5d2c71b89cf16 100644 --- a/test/porousmediumflow/mpnc/implicit/2p2ccomparison/main.cc +++ b/test/porousmediumflow/mpnc/implicit/2p2ccomparison/main.cc @@ -111,23 +111,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -150,11 +150,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NewtonSolver; diff --git a/test/porousmediumflow/mpnc/implicit/2p2ccomparison/problem.hh b/test/porousmediumflow/mpnc/implicit/2p2ccomparison/problem.hh index d70f84ffbd451e5ea3f799791c19ebe7447aad67..64d20457b476d900b1d15a3d1f1a38267fc2db83 100644 --- a/test/porousmediumflow/mpnc/implicit/2p2ccomparison/problem.hh +++ b/test/porousmediumflow/mpnc/implicit/2p2ccomparison/problem.hh @@ -73,9 +73,9 @@ struct Problem { using type = MPNCComparisonProbl template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = MPNCComparisonSpatialParams; + using type = MPNCComparisonSpatialParams; }; // Set fluid configuration @@ -118,7 +118,7 @@ class MPNCComparisonProblem using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using GridView = GetPropType; using Element = typename GridView::template Codim<0>::Entity; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using FluidState = GetPropType; using ParameterCache = typename FluidSystem::ParameterCache; @@ -137,8 +137,8 @@ class MPNCComparisonProblem static constexpr bool isBox = GetPropType::discMethod == DiscretizationMethod::box; public: - MPNCComparisonProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + MPNCComparisonProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { temperature_ = 273.15 + 25; // -> 25°C diff --git a/test/porousmediumflow/mpnc/implicit/2p2ccomparison/spatialparams.hh b/test/porousmediumflow/mpnc/implicit/2p2ccomparison/spatialparams.hh index f78aaa105f5f09454712d68f24a3338e1b0d1296..b3697ee9d1fadd515aa16b1bcddddd65f4afae09 100644 --- a/test/porousmediumflow/mpnc/implicit/2p2ccomparison/spatialparams.hh +++ b/test/porousmediumflow/mpnc/implicit/2p2ccomparison/spatialparams.hh @@ -39,18 +39,18 @@ namespace Dumux { * \brief Definition of the spatial params properties for the obstacle problem * */ -template +template class MPNCComparisonSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParams>; + using ParentType = FVSpatialParams>; using GlobalPosition = typename SubControlVolume::GlobalPosition; using EffectiveLaw = RegularizedBrooksCorey; @@ -60,7 +60,7 @@ public: using MaterialLaw = EffToAbsLaw; using MaterialLawParams = typename MaterialLaw::Params; - MPNCComparisonSpatialParams(std::shared_ptr fvGridGeometry) : ParentType(fvGridGeometry) + MPNCComparisonSpatialParams(std::shared_ptr gridGeometry) : ParentType(gridGeometry) { // intrinsic permeabilities coarseK_ = 1e-12; diff --git a/test/porousmediumflow/mpnc/implicit/kinetic/main.cc b/test/porousmediumflow/mpnc/implicit/kinetic/main.cc index 104d5baa29a248eede3e60be9c6ff3ae7e3bd690..9daf38b6e33d78b59e24d7ceafeacb7c6ba1c560 100644 --- a/test/porousmediumflow/mpnc/implicit/kinetic/main.cc +++ b/test/porousmediumflow/mpnc/implicit/kinetic/main.cc @@ -108,13 +108,13 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using GridView = GetPropType; @@ -125,7 +125,7 @@ int main(int argc, char** argv) try // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); problem->setGridVariables(gridVariables); @@ -149,11 +149,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NonEquilibriumNewtonSolver; diff --git a/test/porousmediumflow/mpnc/implicit/kinetic/spatialparams.hh b/test/porousmediumflow/mpnc/implicit/kinetic/spatialparams.hh index 092879eea3079fbb2dfe8bfd9e37a9ea678d5652..c7cc923f7263c9d6289efbd3ad04c062af255e34 100644 --- a/test/porousmediumflow/mpnc/implicit/kinetic/spatialparams.hh +++ b/test/porousmediumflow/mpnc/implicit/kinetic/spatialparams.hh @@ -46,17 +46,17 @@ namespace Dumux { /** * \brief Definition of the spatial parameters for the evaporation atmosphere Problem (using a "poor man's coupling") */ -template +template class EvaporationAtmosphereSpatialParams -: public FVNonEquilibriumSpatialParams> +: public FVNonEquilibriumSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ThisType = EvaporationAtmosphereSpatialParams; - using ParentType = FVNonEquilibriumSpatialParams; + using ThisType = EvaporationAtmosphereSpatialParams; + using ParentType = FVNonEquilibriumSpatialParams; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -81,8 +81,8 @@ public: using AwsSurfaceParams = typename AwsSurface::Params; using AnsSurfaceParams = typename AnsSurface::Params; - EvaporationAtmosphereSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + EvaporationAtmosphereSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { heightPM_ = getParam>("Grid.Positions1")[1]; heightDomain_ = getParam>("Grid.Positions1")[2]; diff --git a/test/porousmediumflow/mpnc/implicit/obstacle/main.cc b/test/porousmediumflow/mpnc/implicit/obstacle/main.cc index af5d82834f89040203d0f51e89da5e217db5a77a..2bae1e10dcb6ac4cf430101101d5d2c71b89cf16 100644 --- a/test/porousmediumflow/mpnc/implicit/obstacle/main.cc +++ b/test/porousmediumflow/mpnc/implicit/obstacle/main.cc @@ -111,23 +111,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -150,11 +150,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NewtonSolver; diff --git a/test/porousmediumflow/mpnc/implicit/obstacle/problem.hh b/test/porousmediumflow/mpnc/implicit/obstacle/problem.hh index c70f1bdc7def56cc8bc507daebf825c729b001e2..6f6ab94d2d8107b4d6ae5a7bfc07a6e124266590 100644 --- a/test/porousmediumflow/mpnc/implicit/obstacle/problem.hh +++ b/test/porousmediumflow/mpnc/implicit/obstacle/problem.hh @@ -76,9 +76,9 @@ struct Problem { using type = ObstacleProblem; template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = ObstacleSpatialParams; + using type = ObstacleSpatialParams; }; // Set fluid configuration @@ -139,7 +139,7 @@ class ObstacleProblem using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; using GridView = GetPropType; using Element = typename GridView::template Codim<0>::Entity; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using FluidState = GetPropType; using ParameterCache = typename FluidSystem::ParameterCache; @@ -161,8 +161,8 @@ class ObstacleProblem using PhaseVector = Dune::FieldVector; public: - ObstacleProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + ObstacleProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { temperature_ = 273.15 + 25; // -> 25°C diff --git a/test/porousmediumflow/mpnc/implicit/obstacle/spatialparams.hh b/test/porousmediumflow/mpnc/implicit/obstacle/spatialparams.hh index fee0f4d77a7f788a16657a5851da791a85513884..1272af0a7e6b339d5a1a4c158f0f627b52e7596f 100644 --- a/test/porousmediumflow/mpnc/implicit/obstacle/spatialparams.hh +++ b/test/porousmediumflow/mpnc/implicit/obstacle/spatialparams.hh @@ -37,17 +37,17 @@ namespace Dumux { * \brief Definition of the spatial params properties for the obstacle problem. * */ -template +template class ObstacleSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParams>; + using ParentType = FVSpatialParams>; enum {dimWorld=GridView::dimensionworld}; using GlobalPosition = typename SubControlVolume::GlobalPosition; @@ -60,7 +60,7 @@ public: using MaterialLaw = EffToAbsLaw; using MaterialLawParams = typename MaterialLaw::Params; - ObstacleSpatialParams(std::shared_ptr fvGridGeometry) : ParentType(fvGridGeometry) + ObstacleSpatialParams(std::shared_ptr gridGeometry) : ParentType(gridGeometry) { // intrinsic permeabilities coarseK_ = 1e-12; diff --git a/test/porousmediumflow/mpnc/implicit/thermalnonequilibrium/main.cc b/test/porousmediumflow/mpnc/implicit/thermalnonequilibrium/main.cc index e7e39d72200c5deceb6140d1415ea9883f90cfb4..9f8d215c762cc69daf2e80941099783c66509624 100644 --- a/test/porousmediumflow/mpnc/implicit/thermalnonequilibrium/main.cc +++ b/test/porousmediumflow/mpnc/implicit/thermalnonequilibrium/main.cc @@ -108,23 +108,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); problem->setGridVariables(gridVariables); @@ -148,11 +148,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::NonEquilibriumNewtonSolver; diff --git a/test/porousmediumflow/mpnc/implicit/thermalnonequilibrium/spatialparams.hh b/test/porousmediumflow/mpnc/implicit/thermalnonequilibrium/spatialparams.hh index e02efcdd6f5352ebe622db0516386f6cc9afdff6..47999c82dd34aee54f545887e389e4344f950005 100644 --- a/test/porousmediumflow/mpnc/implicit/thermalnonequilibrium/spatialparams.hh +++ b/test/porousmediumflow/mpnc/implicit/thermalnonequilibrium/spatialparams.hh @@ -42,17 +42,17 @@ namespace Dumux { /** * \brief Definition of the spatial parameters for the one component combustion problem */ -template +template class CombustionSpatialParams -: public FVNonEquilibriumSpatialParams> +: public FVNonEquilibriumSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ThisType = CombustionSpatialParams; - using ParentType = FVNonEquilibriumSpatialParams; + using ThisType = CombustionSpatialParams; + using ParentType = FVNonEquilibriumSpatialParams; enum {dimWorld = GridView::dimensionworld}; using GlobalPosition = typename SubControlVolume::GlobalPosition; @@ -67,7 +67,7 @@ public: using MaterialLawParams = typename MaterialLaw::Params; using FluidSolidInterfacialAreaFormulation = FluidSolidInterfacialAreaShiWang; - CombustionSpatialParams(std::shared_ptr fvGridGeometry) : ParentType(fvGridGeometry) + CombustionSpatialParams(std::shared_ptr gridGeometry) : ParentType(gridGeometry) { // this is the parameter value from file part porosity_ = getParam("SpatialParams.PorousMedium.porosity"); diff --git a/test/porousmediumflow/richards/implicit/analytical/main.cc b/test/porousmediumflow/richards/implicit/analytical/main.cc index 13f69c103f60ae4f1d8266b8471eaa37872c00f7..4769399d6617ba8c909d002d43c61df46c19b0b3 100644 --- a/test/porousmediumflow/richards/implicit/analytical/main.cc +++ b/test/porousmediumflow/richards/implicit/analytical/main.cc @@ -105,23 +105,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -144,7 +144,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::ILU0BiCGSTABBackend; diff --git a/test/porousmediumflow/richards/implicit/analytical/problem.hh b/test/porousmediumflow/richards/implicit/analytical/problem.hh index 03620950b6677e6592c89d42cda2a593c7b3afcd..5f240079e2c66997eb5b3d55e3112814d209bf51 100644 --- a/test/porousmediumflow/richards/implicit/analytical/problem.hh +++ b/test/porousmediumflow/richards/implicit/analytical/problem.hh @@ -79,9 +79,9 @@ struct Problem { using type = RichardsAnalyti template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = RichardsAnalyticalSpatialParams; + using type = RichardsAnalyticalSpatialParams; }; } // end namespace Properties @@ -110,7 +110,7 @@ class RichardsAnalyticalProblem : public PorousMediumFlowProblem using NumEqVector = GetPropType; using Scalar = GetPropType; using Indices = typename GetPropType::Indices; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using SolutionVector = GetPropType; enum { // copy some indices for convenience @@ -125,8 +125,8 @@ class RichardsAnalyticalProblem : public PorousMediumFlowProblem using Geometry = typename GridView::template Codim<0>::Entity::Geometry; public: - RichardsAnalyticalProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + RichardsAnalyticalProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { pnRef_ = 1e5; // air pressure name_ = getParam("Problem.Name"); diff --git a/test/porousmediumflow/richards/implicit/analytical/spatialparams.hh b/test/porousmediumflow/richards/implicit/analytical/spatialparams.hh index 7e941f4ac2c25a2ba0e9e85ef78836a2235fd05f..3f384608b25fe2d750fdf049b72010d50a02bf0b 100644 --- a/test/porousmediumflow/richards/implicit/analytical/spatialparams.hh +++ b/test/porousmediumflow/richards/implicit/analytical/spatialparams.hh @@ -41,14 +41,14 @@ namespace Dumux { * \ingroup ImplicitTestProblems * \brief The spatial parameters for the RichardsAnalyticalProblem. */ -template +template class RichardsAnalyticalSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using ParentType = FVSpatialParams>; + using GridView = typename GridGeometry::GridView; + using ParentType = FVSpatialParams>; enum { dimWorld=GridView::dimensionworld }; using Element = typename GridView::template Codim<0>::Entity; @@ -64,8 +64,8 @@ public: // export permeability type using PermeabilityType = Scalar; - RichardsAnalyticalSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + RichardsAnalyticalSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { K_ = 5e-12; materialParams_.setSwr(0.0); diff --git a/test/porousmediumflow/richards/implicit/lens/main.cc b/test/porousmediumflow/richards/implicit/lens/main.cc index 868611ddb69570348a8ff0fd71994ce9dea4ba9f..3c461e469a097f765566c16182b7ad4e254a69e5 100644 --- a/test/porousmediumflow/richards/implicit/lens/main.cc +++ b/test/porousmediumflow/richards/implicit/lens/main.cc @@ -85,13 +85,13 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // check if we are about to restart a previously interrupted simulation using Scalar = GetPropType; @@ -99,7 +99,7 @@ int main(int argc, char** argv) try // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); if (restartTime > 0) { using IOFields = GetPropType; @@ -107,7 +107,7 @@ int main(int argc, char** argv) try using ModelTraits = GetPropType; using FluidSystem = GetPropType; const auto fileName = getParam("Restart.File"); - loadSolution(x, fileName, createPVNameFunction(), *fvGridGeometry); + loadSolution(x, fileName, createPVNameFunction(), *gridGeometry); } else { @@ -118,7 +118,7 @@ int main(int argc, char** argv) try // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // intialize the vtk output module @@ -140,11 +140,11 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::AMGBackend; - auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + auto linearSolver = std::make_shared(leafGridView, gridGeometry->dofMapper()); // the non-linear solver using NewtonSolver = Dumux::RichardsNewtonSolver; diff --git a/test/porousmediumflow/richards/implicit/lens/problem.hh b/test/porousmediumflow/richards/implicit/lens/problem.hh index 3dbb14b98f6b1d015f5a1d0702ef4c18a774ece9..779e80aeebeb016f909bac024223930769b3a019 100644 --- a/test/porousmediumflow/richards/implicit/lens/problem.hh +++ b/test/porousmediumflow/richards/implicit/lens/problem.hh @@ -118,7 +118,7 @@ class RichardsLensProblem : public PorousMediumFlowProblem using NumEqVector = GetPropType; using Scalar = GetPropType; using Indices = typename GetPropType::Indices; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; enum { // copy some indices for convenience pressureIdx = Indices::pressureIdx, @@ -133,8 +133,8 @@ class RichardsLensProblem : public PorousMediumFlowProblem using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: - RichardsLensProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + RichardsLensProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { name_ = getParam("Problem.Name"); } diff --git a/test/porousmediumflow/richards/implicit/lens/spatialparams.hh b/test/porousmediumflow/richards/implicit/lens/spatialparams.hh index 960739e5cc588967ca89f11635a1dac629f9a1bb..100ecb90da7aacc9e53d3a7e7919a3d1e1c34e25 100644 --- a/test/porousmediumflow/richards/implicit/lens/spatialparams.hh +++ b/test/porousmediumflow/richards/implicit/lens/spatialparams.hh @@ -37,14 +37,14 @@ namespace Dumux { * \ingroup RichardsTests * \brief The spatial parameters for the RichardsLensProblem. */ -template +template class RichardsLensSpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using ThisType = RichardsLensSpatialParams; - using ParentType = FVSpatialParams; - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using ThisType = RichardsLensSpatialParams; + using ParentType = FVSpatialParams; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = typename Element::Geometry::GlobalCoordinate; @@ -57,8 +57,8 @@ public: // export permeability type using PermeabilityType = Scalar; - RichardsLensSpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + RichardsLensSpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { lensLowerLeft_ = {1.0, 2.0}; diff --git a/test/porousmediumflow/richards/implicit/nonisothermal/conduction/main.cc b/test/porousmediumflow/richards/implicit/nonisothermal/conduction/main.cc index 15b210a10930b67e81ed2b2ae0aac4a93abb1321..0655c611bcde0ae96d53aed4ac02420707303d73 100644 --- a/test/porousmediumflow/richards/implicit/nonisothermal/conduction/main.cc +++ b/test/porousmediumflow/richards/implicit/nonisothermal/conduction/main.cc @@ -105,23 +105,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -145,7 +145,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::ILU0BiCGSTABBackend; diff --git a/test/porousmediumflow/richards/implicit/nonisothermal/conduction/problem.hh b/test/porousmediumflow/richards/implicit/nonisothermal/conduction/problem.hh index bbf972c8d8f8aeebef62ea10e3bce13b24f21b3d..50168159a9f34d5735e65eade1c3504ea5708b9f 100644 --- a/test/porousmediumflow/richards/implicit/nonisothermal/conduction/problem.hh +++ b/test/porousmediumflow/richards/implicit/nonisothermal/conduction/problem.hh @@ -73,9 +73,9 @@ struct FluidSystem { using type = FluidSyst template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = RichardsNISpatialParams; + using type = RichardsNISpatialParams; }; } // end namespace Properties @@ -108,7 +108,7 @@ class RichardsNIConductionProblem :public PorousMediumFlowProblem using GridView = GetPropType; using Scalar = GetPropType; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using PrimaryVariables = GetPropType; using FluidSystem = GetPropType; using BoundaryTypes = GetPropType; @@ -133,15 +133,15 @@ class RichardsNIConductionProblem :public PorousMediumFlowProblem using GlobalPosition = typename Element::Geometry::GlobalCoordinate; public: - RichardsNIConductionProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + RichardsNIConductionProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { //initialize fluid system FluidSystem::init(); name_ = getParam("Problem.Name"); temperatureHigh_ = 300.; - temperatureExact_.resize(fvGridGeometry->numDofs()); + temperatureExact_.resize(gridGeometry->numDofs()); } //! Get the analytical temperature diff --git a/test/porousmediumflow/richards/implicit/nonisothermal/convection/main.cc b/test/porousmediumflow/richards/implicit/nonisothermal/convection/main.cc index 15b210a10930b67e81ed2b2ae0aac4a93abb1321..0655c611bcde0ae96d53aed4ac02420707303d73 100644 --- a/test/porousmediumflow/richards/implicit/nonisothermal/convection/main.cc +++ b/test/porousmediumflow/richards/implicit/nonisothermal/convection/main.cc @@ -105,23 +105,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -145,7 +145,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::ILU0BiCGSTABBackend; diff --git a/test/porousmediumflow/richards/implicit/nonisothermal/convection/problem.hh b/test/porousmediumflow/richards/implicit/nonisothermal/convection/problem.hh index 557f23e79fe845c750e6344ad1e73c38c7414c0a..ef57233b7771d0710b288c096b1eb3bcfb783bb3 100644 --- a/test/porousmediumflow/richards/implicit/nonisothermal/convection/problem.hh +++ b/test/porousmediumflow/richards/implicit/nonisothermal/convection/problem.hh @@ -74,9 +74,9 @@ struct FluidSystem { using type = FluidSyst template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = RichardsNISpatialParams; + using type = RichardsNISpatialParams; }; } // end namespace Properties @@ -111,7 +111,7 @@ class RichardsNIConvectionProblem : public PorousMediumFlowProblem using GridView = GetPropType; using Scalar = GetPropType; using FVElementGeometry = typename GetPropType::LocalView; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using PrimaryVariables = GetPropType; using NumEqVector = GetPropType; using FluidSystem = GetPropType; @@ -141,8 +141,8 @@ class RichardsNIConvectionProblem : public PorousMediumFlowProblem using GlobalPosition = typename SubControlVolumeFace::GlobalPosition; public: - RichardsNIConvectionProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + RichardsNIConvectionProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { // initialize fluid system FluidSystem::init(); @@ -153,7 +153,7 @@ public: temperatureLow_ = 290.; pressureHigh_ = 2e5; pressureLow_ = 1e5; - temperatureExact_.resize(fvGridGeometry->numDofs()); + temperatureExact_.resize(gridGeometry->numDofs()); } //! Get the analytical temperature diff --git a/test/porousmediumflow/richards/implicit/nonisothermal/evaporation/main.cc b/test/porousmediumflow/richards/implicit/nonisothermal/evaporation/main.cc index c272af71881a02fbd056bb38992da8f68cd2e5a3..7fa13f7e18ceec73634451e35f03380560ca511f 100644 --- a/test/porousmediumflow/richards/implicit/nonisothermal/evaporation/main.cc +++ b/test/porousmediumflow/richards/implicit/nonisothermal/evaporation/main.cc @@ -79,23 +79,23 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -118,7 +118,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::ILU0BiCGSTABBackend; diff --git a/test/porousmediumflow/richards/implicit/nonisothermal/evaporation/problem.hh b/test/porousmediumflow/richards/implicit/nonisothermal/evaporation/problem.hh index bc9a28d6fa1cebb7b86de0b8dcd990081d5bcfa7..cadba22725ca2fcb98023484b0928ae1955bb811 100644 --- a/test/porousmediumflow/richards/implicit/nonisothermal/evaporation/problem.hh +++ b/test/porousmediumflow/richards/implicit/nonisothermal/evaporation/problem.hh @@ -72,9 +72,9 @@ struct FluidSystem { using type = FluidSys template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = RichardsNISpatialParams; + using type = RichardsNISpatialParams; }; template @@ -100,9 +100,9 @@ class RichardsNIEvaporationProblem : public PorousMediumFlowProblem using GridView = GetPropType; using Scalar = GetPropType; - using FVGridGeometry = GetPropType; - using FVElementGeometry = typename FVGridGeometry::LocalView; - using SubControlVolumeFace = typename FVGridGeometry::SubControlVolumeFace; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolumeFace = typename GridGeometry::SubControlVolumeFace; using PrimaryVariables = GetPropType; using NumEqVector = GetPropType; using FluidSystem = GetPropType; @@ -130,8 +130,8 @@ class RichardsNIEvaporationProblem : public PorousMediumFlowProblem using GlobalPosition = typename SubControlVolumeFace::GlobalPosition; public: - RichardsNIEvaporationProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + RichardsNIEvaporationProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { // initialize fluid system FluidSystem::init(); diff --git a/test/porousmediumflow/richards/implicit/nonisothermal/spatialparams.hh b/test/porousmediumflow/richards/implicit/nonisothermal/spatialparams.hh index 93c5c9f80542f340d68aa99f246726352fe4d7d4..6b6da0eb446682db076772b5257a92724424deb7 100644 --- a/test/porousmediumflow/richards/implicit/nonisothermal/spatialparams.hh +++ b/test/porousmediumflow/richards/implicit/nonisothermal/spatialparams.hh @@ -33,17 +33,17 @@ namespace Dumux { -template +template class RichardsNISpatialParams -: public FVSpatialParams> +: public FVSpatialParams> { - using GridView = typename FVGridGeometry::GridView; - using FVElementGeometry = typename FVGridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using Element = typename GridView::template Codim<0>::Entity; - using ParentType = FVSpatialParams>; + using ParentType = FVSpatialParams>; enum { dimWorld=GridView::dimensionworld }; @@ -58,8 +58,8 @@ public: using MaterialLaw = EffToAbsLaw; using MaterialLawParams = typename MaterialLaw::Params; - RichardsNISpatialParams(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + RichardsNISpatialParams(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { permeability_ = 1e-10; porosity_ = 0.4; diff --git a/test/porousmediumflow/richardsnc/implicit/main.cc b/test/porousmediumflow/richardsnc/implicit/main.cc index 495346abe623723209aba794ff7d4971f215cd5e..584db772add680b4e87af3bf1fb1eccbfd83be2e 100644 --- a/test/porousmediumflow/richardsnc/implicit/main.cc +++ b/test/porousmediumflow/richardsnc/implicit/main.cc @@ -105,24 +105,24 @@ int main(int argc, char** argv) try const auto& leafGridView = gridManager.grid().leafGridView(); // create the finite volume grid geometry - using FVGridGeometry = GetPropType; - auto fvGridGeometry = std::make_shared(leafGridView); - fvGridGeometry->update(); + using GridGeometry = GetPropType; + auto gridGeometry = std::make_shared(leafGridView); + gridGeometry->update(); // the problem (initial and boundary conditions) using Problem = GetPropType; - auto problem = std::make_shared(fvGridGeometry); + auto problem = std::make_shared(gridGeometry); problem->computePointSourceMap(); // enable point sources // the solution vector using SolutionVector = GetPropType; - SolutionVector x(fvGridGeometry->numDofs()); + SolutionVector x(gridGeometry->numDofs()); problem->applyInitialSolution(x); auto xOld = x; // the grid variables using GridVariables = GetPropType; - auto gridVariables = std::make_shared(problem, fvGridGeometry); + auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); // get some time loop parameters @@ -145,7 +145,7 @@ int main(int argc, char** argv) try // the assembler with time loop for instationary problem using Assembler = FVAssembler; - auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop, xOld); + auto assembler = std::make_shared(problem, gridGeometry, gridVariables, timeLoop, xOld); // the linear solver using LinearSolver = Dumux::ILU0BiCGSTABBackend; diff --git a/test/porousmediumflow/richardsnc/implicit/problem.hh b/test/porousmediumflow/richardsnc/implicit/problem.hh index 6fc6476eca61201d1e885c0929c2c6d6cf9fa3f4..9020c3d4966fb70ef28399a447511614a172a493 100644 --- a/test/porousmediumflow/richardsnc/implicit/problem.hh +++ b/test/porousmediumflow/richardsnc/implicit/problem.hh @@ -69,9 +69,9 @@ struct Problem { using type = RichardsWellTra template struct SpatialParams { - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using Scalar = GetPropType; - using type = RichardsWellTracerSpatialParams; + using type = RichardsWellTracerSpatialParams; }; // Set the physical problem to be solved @@ -121,7 +121,7 @@ class RichardsWellTracerProblem : public PorousMediumFlowProblem using FluidSystem = GetPropType; using Scalar = GetPropType; using Indices = typename GetPropType::Indices; - using FVGridGeometry = GetPropType; + using GridGeometry = GetPropType; using SolutionVector = GetPropType; using GridVariables = GetPropType; enum { @@ -134,8 +134,8 @@ class RichardsWellTracerProblem : public PorousMediumFlowProblem using GlobalPosition = typename SubControlVolume::GlobalPosition; public: - RichardsWellTracerProblem(std::shared_ptr fvGridGeometry) - : ParentType(fvGridGeometry) + RichardsWellTracerProblem(std::shared_ptr gridGeometry) + : ParentType(gridGeometry) { name_ = getParam("Problem.Name"); contaminantMoleFraction_ = getParam("Problem.ContaminantMoleFraction"); diff --git a/test/porousmediumflow/richardsnc/implicit/spatialparams.hh b/test/porousmediumflow/richardsnc/implicit/spatialparams.hh index b99dcc7c42504584a932b1be2f339b311cb76361..a1