From dc7557c74c8de117e91be8c43d548c169f10387e Mon Sep 17 00:00:00 2001
From: Kilian Weishaupt <kilian.weishaupt@iws.uni-stuttgart.de>
Date: Sat, 10 Mar 2018 10:01:05 +0100
Subject: [PATCH] [staggered] Remove TypeTag from Grid/ElementVolumeVariables

---
 .../staggered/elementvolumevariables.hh       | 54 +++++++----------
 .../discretization/staggered/gridvariables.hh |  6 +-
 .../staggered/gridvolumevariables.hh          | 58 ++++++++-----------
 dumux/discretization/staggered/properties.hh  | 22 ++++++-
 4 files changed, 69 insertions(+), 71 deletions(-)

diff --git a/dumux/discretization/staggered/elementvolumevariables.hh b/dumux/discretization/staggered/elementvolumevariables.hh
index 67e320d629..fbce3036e9 100644
--- a/dumux/discretization/staggered/elementvolumevariables.hh
+++ b/dumux/discretization/staggered/elementvolumevariables.hh
@@ -24,9 +24,9 @@
 #ifndef DUMUX_DISCRETIZATION_STAGGERED_ELEMENT_VOLUMEVARIABLES_HH
 #define DUMUX_DISCRETIZATION_STAGGERED_ELEMENT_VOLUMEVARIABLES_HH
 
+#include <algorithm>
+#include <iterator>
 #include <dune/common/exceptions.hh>
-#include <dumux/common/properties.hh>
-#include <dumux/discretization/staggered/elementsolution.hh>
 
 namespace Dumux {
 
@@ -34,7 +34,7 @@ namespace Dumux {
  * \ingroup StaggeredDiscretization
  * \brief Base class for the element volume variables vector for the staggered model
  */
-template<class TypeTag, bool enableGridVolVarsCache>
+template<class FVGridGeometry, class GridVolumeVariables, bool enableGridVolVarsCache>
 class StaggeredElementVolumeVariables
 {};
 
@@ -43,23 +43,18 @@ class StaggeredElementVolumeVariables
  * \brief Class for the element volume variables vector for the staggered model.
           Specialization in case the volume variables are stored globally.
  */
-template<class TypeTag>
-class StaggeredElementVolumeVariables<TypeTag, /*enableGridVolVarsCache*/true>
+template<class FVGridGeometry, class GridVolumeVariables>
+class StaggeredElementVolumeVariables<FVGridGeometry, GridVolumeVariables, /*enableGridVolVarsCache*/true>
 {
-    using Problem = typename GET_PROP_TYPE(TypeTag, Problem);
-    using GridView = typename GET_PROP_TYPE(TypeTag, GridView);
-    using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry)::LocalView;
-    using VolumeVariables = typename GET_PROP_TYPE(TypeTag, VolumeVariables);
-    using GridVolumeVariables = typename GET_PROP_TYPE(TypeTag, GridVolumeVariables);
+    using GridView = typename FVGridGeometry::GridView;
+    using FVElementGeometry = typename FVGridGeometry::LocalView;
+    using VolumeVariables =  typename GridVolumeVariables::VolumeVariables;
     using SubControlVolume = typename FVElementGeometry::SubControlVolume;
     using IndexType = typename GridView::IndexSet::IndexType;
 
-    static const int dim = GridView::dimension;
     using Element = typename GridView::template Codim<0>::Entity;
 
 public:
-    //! Export type of the solution vector
-    using SolutionVector = typename GET_PROP_TYPE(TypeTag, SolutionVector);
 
     //! Constructor
     StaggeredElementVolumeVariables(const GridVolumeVariables& gridVolVars)
@@ -76,12 +71,14 @@ public:
 
     //! For compatibility reasons with the case of not storing the vol vars.
     //! function to be called before assembling an element, preparing the vol vars within the stencil
+    template<class SolutionVector>
     void bind(const Element& element,
               const FVElementGeometry& fvGeometry,
               const SolutionVector& sol)
     {}
 
     //! function to prepare the vol vars within the element
+    template<class SolutionVector>
     void bindElement(const Element& element,
                      const FVElementGeometry& fvGeometry,
                      const SolutionVector& sol)
@@ -101,32 +98,21 @@ private:
  * \brief Class for the element volume variables vector for the staggered model.
           Specialization in case the volume variables are not stored globally.
  */
-template<class TypeTag>
-class StaggeredElementVolumeVariables<TypeTag, /*enableGridVolVarsCache*/false>
+template<class FVGridGeometry, class GridVolumeVariables>
+class StaggeredElementVolumeVariables<FVGridGeometry, GridVolumeVariables, /*enableGridVolVarsCache*/false>
 {
-    using Problem = typename GET_PROP_TYPE(TypeTag, Problem);
-    using GridView = typename GET_PROP_TYPE(TypeTag, GridView);
-    using Indices = typename GET_PROP_TYPE(TypeTag, Indices);
-    using VolumeVariables = typename GET_PROP_TYPE(TypeTag, VolumeVariables);
-    using CellCenterPrimaryVariables = typename GET_PROP_TYPE(TypeTag, CellCenterPrimaryVariables);
-    using GridVolumeVariables = typename GET_PROP_TYPE(TypeTag, GridVolumeVariables);
-    using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry);
+    using CellCenterPrimaryVariables = typename GridVolumeVariables::CellCenterPrimaryVariables;
+    using GridView = typename FVGridGeometry::GridView;
     using FVElementGeometry = typename FVGridGeometry::LocalView;
-    using SubControlVolume = typename FVGridGeometry::SubControlVolume;
+    using VolumeVariables =  typename GridVolumeVariables::VolumeVariables;
+    using SubControlVolume = typename FVElementGeometry::SubControlVolume;
     using IndexType = typename GridView::IndexSet::IndexType;
+    using Indices = typename GridVolumeVariables::Indices;
 
-    static const int dim = GridView::dimension;
     using Element = typename GridView::template Codim<0>::Entity;
-
-    using DofTypeIndices = typename GET_PROP(TypeTag, DofTypeIndices);
-    typename DofTypeIndices::CellCenterIdx cellCenterIdx;
-    typename DofTypeIndices::FaceIdx faceIdx;
-
-    static constexpr auto numEqCellCenter = GET_PROP_VALUE(TypeTag, NumEqCellCenter);
+    static constexpr auto cellCenterIdx = FVGridGeometry::cellCenterIdx();
 
 public:
-    //! Export type of the solution vector
-    using SolutionVector = typename GET_PROP_TYPE(TypeTag, SolutionVector);
 
     //! Constructor
     StaggeredElementVolumeVariables(const GridVolumeVariables& gridVolVars)
@@ -134,6 +120,7 @@ public:
 
     //! Binding of an element, prepares the volume variables within the element stencil
     //! called by the local jacobian to prepare element assembly
+    template<class SolutionVector>
     void bind(const Element& element,
               const FVElementGeometry& fvGeometry,
               const SolutionVector& sol)
@@ -181,7 +168,7 @@ public:
 
             CellCenterPrimaryVariables boundaryPriVars(0.0);
 
-            for(int eqIdx = 0; eqIdx < numEqCellCenter; ++eqIdx)
+            for(int eqIdx = 0; eqIdx < CellCenterPrimaryVariables::dimension; ++eqIdx)
             {
                 if(bcTypes.isDirichlet(eqIdx) || bcTypes.isDirichletCell(eqIdx))
                     boundaryPriVars[eqIdx] = problem.dirichlet(element, scvf)[cellCenterIdx][eqIdx];
@@ -209,6 +196,7 @@ public:
 
     //! Binding of an element, prepares only the volume variables of the element.
     //! Specialization for Staggered models
+    template<class SolutionVector>
     void bindElement(const Element& element,
                      const FVElementGeometry& fvGeometry,
                      const SolutionVector& sol)
diff --git a/dumux/discretization/staggered/gridvariables.hh b/dumux/discretization/staggered/gridvariables.hh
index 36db1d84e3..dd7643ff2c 100644
--- a/dumux/discretization/staggered/gridvariables.hh
+++ b/dumux/discretization/staggered/gridvariables.hh
@@ -66,7 +66,7 @@ public:
     template<class SolutionVector>
     void update(const SolutionVector& curSol)
     {
-        ParentType::update(curSol);
+        ParentType::update(curSol[cellCenterIdx]);
         curGridFaceVariables_.update(*this->fvGridGeometry_, curSol[faceIdx]);
     }
 
@@ -74,7 +74,7 @@ public:
     template<class SolutionVector>
     void init(const SolutionVector& curSol)
     {
-        ParentType::init(curSol);
+        ParentType::init(curSol[cellCenterIdx]);
         curGridFaceVariables_.update(*this->fvGridGeometry_, curSol[faceIdx]);
     }
 
@@ -82,7 +82,7 @@ public:
     template<class SolutionVector>
     void init(const SolutionVector& curSol, const SolutionVector& initSol)
     {
-        ParentType::init(curSol, initSol);
+        ParentType::init(curSol[cellCenterIdx], initSol[cellCenterIdx]);
         curGridFaceVariables_.update(*this->fvGridGeometry_, curSol[faceIdx]);
         prevGridFaceVariables_.update(*this->fvGridGeometry_, initSol[faceIdx]);
     }
diff --git a/dumux/discretization/staggered/gridvolumevariables.hh b/dumux/discretization/staggered/gridvolumevariables.hh
index 4138264aab..218b9997d4 100644
--- a/dumux/discretization/staggered/gridvolumevariables.hh
+++ b/dumux/discretization/staggered/gridvolumevariables.hh
@@ -25,7 +25,6 @@
 #define DUMUX_DISCRETIZATION_STAGGERED_GRID_VOLUMEVARIABLES_HH
 
 #include <dune/common/exceptions.hh>
-#include <dumux/common/properties.hh>
 
 //! make the local view function available whenever we use this class
 #include <dumux/discretization/localview.hh>
@@ -37,7 +36,7 @@ namespace Dumux {
  * \ingroup StaggeredDiscretization
  * \brief Grid volume variables class for staggered models
  */
-template<class TypeTag, bool enableGridVolVarsCache>
+template<class FVGridGeometry, class Traits, bool enableGridVolVarsCache>
 class StaggeredGridVolumeVariables;
 
 /*!
@@ -45,31 +44,21 @@ class StaggeredGridVolumeVariables;
  * \brief Grid volume variables class for staggered models.
           Specialization in case of storing the volume variables
  */
-template<class TypeTag>
-class StaggeredGridVolumeVariables<TypeTag, /*enableGridVolVarsCache*/true>
+template<class FVGridGeometry, class Traits>
+class StaggeredGridVolumeVariables<FVGridGeometry, Traits, /*enableGridVolVarsCache*/true>
 {
-    using Problem = typename GET_PROP_TYPE(TypeTag, Problem);
-    using GridView = typename GET_PROP_TYPE(TypeTag, GridView);
-    using SolutionVector = typename GET_PROP_TYPE(TypeTag, SolutionVector);
-    using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry);
-    using VolumeVariables = typename GET_PROP_TYPE(TypeTag, VolumeVariables);
+    using ThisType = StaggeredGridVolumeVariables<FVGridGeometry, Traits, true>;
+    using Problem = typename Traits::Problem;
     using FVElementGeometry = typename FVGridGeometry::LocalView;
     using SubControlVolume = typename FVElementGeometry::SubControlVolume;
-    using Indices = typename GET_PROP_TYPE(TypeTag, Indices);
-    using IndexType = typename GridView::IndexSet::IndexType;
-
-    using DofTypeIndices = typename GET_PROP(TypeTag, DofTypeIndices);
-    typename DofTypeIndices::CellCenterIdx cellCenterIdx;
-
-    static const int dim = GridView::dimension;
-    using Element = typename GridView::template Codim<0>::Entity;
-    using CellCenterPrimaryVariables = typename GET_PROP_TYPE(TypeTag, CellCenterPrimaryVariables);
-
-    enum { numEqCellCenter = GET_PROP_VALUE(TypeTag, NumEqCellCenter) };
+    using Indices = typename Traits::Indices;
+    using IndexType = typename FVGridGeometry::GridView::IndexSet::IndexType;
 
 public:
+    //! export the type of the VolumeVariables
+    using VolumeVariables = typename Traits::VolumeVariables;
     //! export the type of the local view
-    using LocalView = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables);
+    using LocalView = typename Traits::template LocalView<FVGridGeometry, ThisType, true>;
 
     //! make it possible to query if caching is enabled
     static constexpr bool cachingEnabled = true;
@@ -77,8 +66,10 @@ public:
     StaggeredGridVolumeVariables(const Problem& problem) : problemPtr_(&problem) {}
 
     //! Update all volume variables
+    template<class SolutionVector>
     void update(const FVGridGeometry& fvGridGeometry, const SolutionVector& sol)
     {
+        using CellCenterPrimaryVariables = typename SolutionVector::value_type;
         auto numScv = fvGridGeometry.numScv();
         auto numBoundaryScvf = fvGridGeometry.numBoundaryScvf();
 
@@ -90,8 +81,7 @@ public:
 
             for (auto&& scv : scvs(fvGeometry))
             {
-                CellCenterPrimaryVariables priVars(0.0);
-                priVars = sol[cellCenterIdx][scv.dofIndex()];
+                CellCenterPrimaryVariables priVars = sol[scv.dofIndex()];
                 auto elemSol = elementSolution<FVElementGeometry>(std::move(priVars));
                 volumeVariables_[scv.dofIndex()].update(elemSol, problem(), element, scv);
             }
@@ -109,12 +99,12 @@ public:
 
                 CellCenterPrimaryVariables boundaryPriVars(0.0);
 
-                for(int eqIdx = 0; eqIdx < numEqCellCenter; ++eqIdx)
+                for(int eqIdx = 0; eqIdx < CellCenterPrimaryVariables::dimension; ++eqIdx)
                 {
                     if(bcTypes.isDirichlet(eqIdx) || bcTypes.isDirichletCell(eqIdx))
                         boundaryPriVars[eqIdx] = problem().dirichlet(element, scvf)[eqIdx];
                     else if(bcTypes.isNeumann(eqIdx) || bcTypes.isOutflow(eqIdx) || bcTypes.isSymmetry())
-                        boundaryPriVars[eqIdx] = sol[cellCenterIdx][scvf.insideScvIdx()][eqIdx];
+                        boundaryPriVars[eqIdx] = sol[scvf.insideScvIdx()][eqIdx];
                     //TODO: this assumes a zero-gradient for e.g. the pressure on the boundary
                     // could be made more general by allowing a non-zero-gradient, provided in problem file
                     else
@@ -133,10 +123,10 @@ public:
     VolumeVariables& volVars(const IndexType scvIdx)
     { return volumeVariables_[scvIdx]; }
 
-    const VolumeVariables& volVars(const SubControlVolume scv) const
+    const VolumeVariables& volVars(const SubControlVolume& scv) const
     { return volumeVariables_[scv.dofIndex()]; }
 
-    VolumeVariables& volVars(const SubControlVolume scv)
+    VolumeVariables& volVars(const SubControlVolume& scv)
     { return volumeVariables_[scv.dofIndex()]; }
 
     const Problem& problem() const
@@ -153,22 +143,24 @@ private:
  * \brief Grid volume variables class for staggered models.
           Specialization in case of not storing the volume variables
  */
-template<class TypeTag>
-class StaggeredGridVolumeVariables<TypeTag, /*enableGridVolVarsCache*/false>
+template<class FVGridGeometry, class Traits>
+class StaggeredGridVolumeVariables<FVGridGeometry, Traits, /*enableGridVolVarsCache*/false>
 {
-    using Problem = typename GET_PROP_TYPE(TypeTag, Problem);
-    using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry);
-    using SolutionVector = typename GET_PROP_TYPE(TypeTag, SolutionVector);
+    using ThisType = StaggeredGridVolumeVariables<FVGridGeometry, Traits, false>;
+    using Problem = typename Traits::Problem;
 
 public:
+    //! export the type of the VolumeVariables
+    using VolumeVariables = typename Traits::VolumeVariables;
     //! export the type of the local view
-    using LocalView = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables);
+    using LocalView = typename Traits::template LocalView<FVGridGeometry, ThisType, true>;
 
     //! make it possible to query if caching is enabled
     static constexpr bool cachingEnabled = false;
 
     StaggeredGridVolumeVariables(const Problem& problem) : problemPtr_(&problem) {}
 
+    template<class SolutionVector>
     void update(const FVGridGeometry& fvGridGeometry, const SolutionVector& sol) {}
 
     const Problem& problem() const
diff --git a/dumux/discretization/staggered/properties.hh b/dumux/discretization/staggered/properties.hh
index 42b8d01c7a..1f141ff3e4 100644
--- a/dumux/discretization/staggered/properties.hh
+++ b/dumux/discretization/staggered/properties.hh
@@ -83,10 +83,28 @@ public:
 SET_BOOL_PROP(StaggeredModel, EnableGridFaceVariablesCache, true);
 
 //! Set the default global volume variables cache vector class
-SET_TYPE_PROP(StaggeredModel, GridVolumeVariables, StaggeredGridVolumeVariables<TypeTag, GET_PROP_VALUE(TypeTag, EnableGridVolumeVariablesCache)>);
+SET_PROP(StaggeredModel, GridVolumeVariables)
+{
+private:
+    using CellCenterPrimaryVariables = typename GET_PROP_TYPE(TypeTag, CellCenterPrimaryVariables);
+    using VolumeVariables = typename GET_PROP_TYPE(TypeTag, VolumeVariables);
+    using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry);
+    using Indices = typename GET_PROP_TYPE(TypeTag, Indices);
+    using Problem = typename GET_PROP_TYPE(TypeTag, Problem);
+
+    static constexpr auto enableCache = GET_PROP_VALUE(TypeTag, EnableGridVolumeVariablesCache);
+
+    using Traits = StaggeredGridVolumeVariablesTraits<VolumeVariables, Problem, CellCenterPrimaryVariables, Indices>;
+
+public:
+    using type = StaggeredGridVolumeVariables<FVGridGeometry, Traits, enableCache>;
+};
 
 //! Set the element volume variables class
-SET_TYPE_PROP(StaggeredModel, ElementVolumeVariables, StaggeredElementVolumeVariables<TypeTag, GET_PROP_VALUE(TypeTag, EnableGridVolumeVariablesCache)>);
+SET_PROP(StaggeredModel, ElementVolumeVariables)
+{
+    using type = typename GET_PROP_TYPE(TypeTag, GridVolumeVariables)::LocalView;
+};
 
 //! Set the global flux variables cache vector class
 SET_TYPE_PROP(StaggeredModel, GridFluxVariablesCache, StaggeredGridFluxVariablesCache<TypeTag, GET_PROP_VALUE(TypeTag, EnableGridFluxVariablesCache)>);
-- 
GitLab