From 4ee0b0c92909b715cb14fee4883aa48c6da789b9 Mon Sep 17 00:00:00 2001
From: Kilian Weishaupt <kilian.weishaupt@iws.uni-stuttgart.de>
Date: Fri, 18 Nov 2016 16:58:15 +0100
Subject: [PATCH] [staggered] Add basic test

*This is just a copy of the standard 1p test to have something that
 acutally compiles
* Needs to be reworked completely!
---
 test/freeflow/staggered/1ptestproblem.hh      | 261 ++++++++++++++++++
 .../freeflow/staggered/1ptestspatialparams.hh | 126 +++++++++
 test/freeflow/staggered/CMakeLists.txt        |  16 ++
 test/freeflow/staggered/test_cc1p.cc          |  64 +++++
 test/freeflow/staggered/test_cc1p.input       |  23 ++
 5 files changed, 490 insertions(+)
 create mode 100644 test/freeflow/staggered/1ptestproblem.hh
 create mode 100644 test/freeflow/staggered/1ptestspatialparams.hh
 create mode 100644 test/freeflow/staggered/CMakeLists.txt
 create mode 100644 test/freeflow/staggered/test_cc1p.cc
 create mode 100644 test/freeflow/staggered/test_cc1p.input

diff --git a/test/freeflow/staggered/1ptestproblem.hh b/test/freeflow/staggered/1ptestproblem.hh
new file mode 100644
index 0000000000..13dd4faea4
--- /dev/null
+++ b/test/freeflow/staggered/1ptestproblem.hh
@@ -0,0 +1,261 @@
+// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
+// vi: set et ts=4 sw=4 sts=4:
+/*****************************************************************************
+ *   See the file COPYING for full copying permissions.                      *
+ *                                                                           *
+ *   This program is free software: you can redistribute it and/or modify    *
+ *   it under the terms of the GNU General Public License as published by    *
+ *   the Free Software Foundation, either version 2 of the License, or       *
+ *   (at your option) any later version.                                     *
+ *                                                                           *
+ *   This program is distributed in the hope that it will be useful,         *
+ *   but WITHOUT ANY WARRANTY; without even the implied warranty of          *
+ *   MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the            *
+ *   GNU General Public License for more details.                            *
+ *                                                                           *
+ *   You should have received a copy of the GNU General Public License       *
+ *   along with this program.  If not, see <http://www.gnu.org/licenses/>.   *
+ *****************************************************************************/
+/*!
+ * \file
+ *
+ * \brief A test problem for the one-phase model:
+ * water is flowing from bottom to top through and around a low permeable lens.
+ */
+#ifndef DUMUX_1PTEST_PROBLEM_HH
+#define DUMUX_1PTEST_PROBLEM_HH
+
+// #include <dumux/implicit/cellcentered/tpfa/properties.hh>
+#include <dumux/implicit/staggered/properties.hh>
+#include <dumux/freeflow/staggered/model.hh>
+#include <dumux/porousmediumflow/implicit/problem.hh>
+#include <dumux/material/components/simpleh2o.hh>
+#include <dumux/material/fluidsystems/liquidphase.hh>
+
+#include <dumux/linear/amgbackend.hh>
+
+#include "1ptestspatialparams.hh"
+
+namespace Dumux
+{
+template <class TypeTag>
+class OnePTestProblem;
+
+namespace Capabilities
+{
+    template<class TypeTag>
+    struct isStationary<OnePTestProblem<TypeTag>>
+    { static const bool value = true; };
+}
+
+namespace Properties
+{
+NEW_TYPE_TAG(OnePTestProblem, INHERITS_FROM(OneP));
+// NEW_TYPE_TAG(OnePTestBoxProblem, INHERITS_FROM(BoxModel, OnePTestProblem));
+NEW_TYPE_TAG(OnePTestCCProblem, INHERITS_FROM(StaggeredModel, OnePTestProblem));
+
+SET_PROP(OnePTestProblem, Fluid)
+{
+private:
+    typedef typename GET_PROP_TYPE(TypeTag, Scalar) Scalar;
+public:
+    typedef Dumux::LiquidPhase<Scalar, Dumux::SimpleH2O<Scalar> > type;
+};
+
+// Set the grid type
+SET_TYPE_PROP(OnePTestProblem, Grid, Dune::YaspGrid<2>);
+
+// Set the problem property
+SET_TYPE_PROP(OnePTestProblem, Problem, Dumux::OnePTestProblem<TypeTag> );
+
+// Set the spatial parameters
+SET_TYPE_PROP(OnePTestProblem, SpatialParams, Dumux::OnePTestSpatialParams<TypeTag> );
+
+SET_BOOL_PROP(OnePTestProblem, EnableGlobalFVGeometryCache, true);
+
+
+// Enable gravity
+SET_BOOL_PROP(OnePTestProblem, ProblemEnableGravity, true);
+}
+
+/*!
+ * \ingroup OnePModel
+ * \ingroup ImplicitTestProblems
+ * \brief  Test problem for the one-phase model:
+ * water is flowing from bottom to top through and around a low permeable lens.
+ *
+ * The domain is box shaped. All sides are closed (Neumann 0 boundary)
+ * except the top and bottom boundaries (Dirichlet), where water is
+ * flowing from bottom to top.
+ *
+ * In the middle of the domain, a lens with low permeability (\f$K=10e-12\f$)
+ * compared to the surrounding material (\f$ K=10e-10\f$) is defined.
+ *
+ * To run the simulation execute the following line in shell:
+ * <tt>./test_box1p -parameterFile test_box1p.input</tt> or
+ * <tt>./test_cc1p -parameterFile test_cc1p.input</tt>
+ *
+ * The same parameter file can be also used for 3d simulation but you need to change line
+ * <tt>typedef Dune::YaspGrid<2> type;</tt> to
+ * <tt>typedef Dune::YaspGrid<3> type;</tt> in the problem file
+ * and use <tt>test_1p_3d.dgf</tt> in the parameter file.
+ */
+template <class TypeTag>
+class OnePTestProblem : public ImplicitPorousMediaProblem<TypeTag>
+{
+    typedef ImplicitPorousMediaProblem<TypeTag> ParentType;
+
+    typedef typename GET_PROP_TYPE(TypeTag, GridView) GridView;
+    typedef typename GET_PROP_TYPE(TypeTag, Scalar) Scalar;
+
+    // copy some indices for convenience
+    typedef typename GET_PROP_TYPE(TypeTag, Indices) Indices;
+    enum {
+        // Grid and world dimension
+        dim = GridView::dimension,
+        dimWorld = GridView::dimensionworld
+    };
+    enum {
+        // indices of the primary variables
+        conti0EqIdx = Indices::conti0EqIdx,
+        pressureIdx = Indices::pressureIdx
+    };
+
+    typedef typename GET_PROP_TYPE(TypeTag, PrimaryVariables) PrimaryVariables;
+    typedef typename GET_PROP_TYPE(TypeTag, BoundaryTypes) BoundaryTypes;
+    typedef typename GET_PROP_TYPE(TypeTag, TimeManager) TimeManager;
+
+    typedef typename GridView::template Codim<0>::Entity Element;
+    typedef typename GridView::Intersection Intersection;
+
+    typedef typename GET_PROP_TYPE(TypeTag, FVElementGeometry) FVElementGeometry;
+    typedef typename GET_PROP_TYPE(TypeTag, SubControlVolume) SubControlVolume;
+
+    typedef Dune::FieldVector<Scalar, dimWorld> GlobalPosition;
+
+public:
+    OnePTestProblem(TimeManager &timeManager, const GridView &gridView)
+    : ParentType(timeManager, gridView)
+    {
+        name_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag,
+                                             std::string,
+                                             Problem,
+                                             Name);
+    }
+
+    /*!
+     * \name Problem parameters
+     */
+    // \{
+
+    /*!
+     * \brief The problem name.
+     *
+     * This is used as a prefix for files generated by the simulation.
+     */
+    std::string name() const
+    {
+        return name_;
+    }
+
+    /*!
+     * \brief Return the temperature within the domain in [K].
+     *
+     * This problem assumes a temperature of 10 degrees Celsius.
+     */
+    Scalar temperature() const
+    { return 273.15 + 10; } // 10C
+
+    /*!
+     * \brief Return the sources within the domain.
+     *
+     * \param values Stores the source values, acts as return value
+     * \param globalPos The global position
+     */
+    PrimaryVariables sourceAtPos(const GlobalPosition &globalPos) const
+    {
+        return PrimaryVariables(0);
+    }
+    // \}
+    /*!
+     * \name Boundary conditions
+     */
+    // \{
+
+    /*!
+     * \brief Specifies which kind of boundary condition should be
+     *        used for which equation on a given boundary control volume.
+     *
+     * \param values The boundary types for the conservation equations
+     * \param globalPos The position of the center of the finite volume
+     */
+    BoundaryTypes boundaryTypesAtPos(const GlobalPosition &globalPos) const
+    {
+        BoundaryTypes values;
+
+        Scalar eps = 1.0e-6;
+        if (globalPos[dimWorld-1] < eps || globalPos[dimWorld-1] > this->bBoxMax()[dimWorld-1] - eps)
+            values.setAllDirichlet();
+        else
+            values.setAllNeumann();
+
+        return values;
+    }
+
+    /*!
+     * \brief Evaluate the boundary conditions for a dirichlet
+     *        control volume.
+     *
+     * \param values The dirichlet values for the primary variables
+     * \param globalPos The center of the finite volume which ought to be set.
+     *
+     * For this method, the \a values parameter stores primary variables.
+     */
+    PrimaryVariables dirichletAtPos(const GlobalPosition &globalPos) const
+    {
+        PrimaryVariables values(0);
+        values[pressureIdx] = 1.0e+5*(2.0 - globalPos[dimWorld-1]);
+        return values;
+    }
+
+    /*!
+     * \brief Evaluate the boundary conditions for a neumann
+     *        boundary segment.
+     *
+     * For this method, the \a priVars parameter stores the mass flux
+     * in normal direction of each component. Negative values mean
+     * influx.
+     */
+    PrimaryVariables neumannAtPos(const GlobalPosition& globalPos) const
+    {
+        return PrimaryVariables(0);
+    }
+
+    // \}
+
+    /*!
+     * \name Volume terms
+     */
+    // \{
+
+    /*!
+     * \brief Evaluate the initial value for a control volume.
+     *
+     * For this method, the \a priVars parameter stores primary
+     * variables.
+     */
+    PrimaryVariables initial(const SubControlVolume& scv) const
+    {
+        PrimaryVariables priVars(0);
+        priVars[pressureIdx] = 1.0e+5;
+        return priVars;
+    }
+
+    // \}
+
+private:
+    std::string name_;
+};
+} //end namespace
+
+#endif
diff --git a/test/freeflow/staggered/1ptestspatialparams.hh b/test/freeflow/staggered/1ptestspatialparams.hh
new file mode 100644
index 0000000000..c1cc94a914
--- /dev/null
+++ b/test/freeflow/staggered/1ptestspatialparams.hh
@@ -0,0 +1,126 @@
+// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
+// vi: set et ts=4 sw=4 sts=4:
+/*****************************************************************************
+ *   See the file COPYING for full copying permissions.                      *
+ *                                                                           *
+ *   This program is free software: you can redistribute it and/or modify    *
+ *   it under the terms of the GNU General Public License as published by    *
+ *   the Free Software Foundation, either version 2 of the License, or       *
+ *   (at your option) any later version.                                     *
+ *                                                                           *
+ *   This program is distributed in the hope that it will be useful,         *
+ *   but WITHOUT ANY WARRANTY; without even the implied warranty of          *
+ *   MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the            *
+ *   GNU General Public License for more details.                            *
+ *                                                                           *
+ *   You should have received a copy of the GNU General Public License       *
+ *   along with this program.  If not, see <http://www.gnu.org/licenses/>.   *
+ *****************************************************************************/
+/*!
+ * \file
+ *
+ * \brief The spatial parameters class for the test problem using the
+ *        1p box model
+ */
+#ifndef DUMUX_1P_TEST_SPATIALPARAMS_HH
+#define DUMUX_1P_TEST_SPATIALPARAMS_HH
+
+#include <dumux/material/spatialparams/implicit1p.hh>
+
+namespace Dumux
+{
+
+/*!
+ * \ingroup OnePModel
+ * \ingroup ImplicitTestProblems
+ *
+ * \brief The spatial parameters class for the test problem using the
+ *        1p box model
+ */
+template<class TypeTag>
+class OnePTestSpatialParams : public ImplicitSpatialParamsOneP<TypeTag>
+{
+    using ParentType = ImplicitSpatialParamsOneP<TypeTag>;
+    using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar);
+    using Problem = typename GET_PROP_TYPE(TypeTag, Problem);
+    using GridView = typename GET_PROP_TYPE(TypeTag, GridView);
+    using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry);
+    using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume);
+    using VolumeVariables = typename GET_PROP_TYPE(TypeTag, VolumeVariables);
+
+    enum {
+        dim=GridView::dimension,
+        dimWorld=GridView::dimensionworld
+    };
+
+    using GlobalPosition = Dune::FieldVector<Scalar,dimWorld>;
+    using Element = typename GridView::template Codim<0>::Entity;
+
+public:
+    OnePTestSpatialParams(const Problem& problem, const GridView& gridView)
+        : ParentType(problem, gridView)
+    {
+        eps_ = 1.5e-7;
+
+            lensLowerLeft_[0] = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParams.LensLowerLeftX);
+            if (dimWorld > 1)
+                lensLowerLeft_[1] = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParams.LensLowerLeftY);
+            if (dimWorld > 2)
+                lensLowerLeft_[2] = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParams.LensLowerLeftZ);
+
+            lensUpperRight_[0] = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParams.LensUpperRightX);
+            if (dimWorld > 1)
+                lensUpperRight_[1] = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParams.LensUpperRightY);
+            if (dimWorld > 2)
+                lensUpperRight_[2] = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParams.LensUpperRightZ);
+
+            permeability_ = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParams.Permeability);
+            permeabilityLens_=GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParams.PermeabilityLens);
+    }
+
+    /*!
+     * \brief Return the intrinsic permeability for the current sub-control volume in [m^2].
+     *
+     * \param element The current finite element
+     * \param fvGeometry The current finite volume geometry of the element
+     * \param scvIdx The index sub-control volume face where the
+     *                      intrinsic velocity ought to be calculated.
+     */
+    Scalar intrinsicPermeability(const SubControlVolume& scv,
+                                 const VolumeVariables& volVars = VolumeVariables()) const
+    {
+        if (isInLens_(scv.dofPosition()))
+            return permeabilityLens_;
+        else
+            return permeability_;
+    }
+
+    /*! \brief Define the porosity in [-].
+   *
+   * \param element The finite element
+   * \param fvGeometry The finite volume geometry
+   * \param scvIdx The local index of the sub-control volume where
+   */
+    Scalar porosity(const SubControlVolume &scv) const
+    { return 0.4; }
+
+private:
+    bool isInLens_(const GlobalPosition &globalPos) const
+    {
+        for (int i = 0; i < dimWorld; ++i) {
+            if (globalPos[i] < lensLowerLeft_[i] + eps_ || globalPos[i] > lensUpperRight_[i] - eps_)
+                return false;
+        }
+        return true;
+    }
+
+    GlobalPosition lensLowerLeft_;
+    GlobalPosition lensUpperRight_;
+
+    Scalar permeability_, permeabilityLens_;
+    Scalar eps_;
+};
+
+} // end namespace
+
+#endif
diff --git a/test/freeflow/staggered/CMakeLists.txt b/test/freeflow/staggered/CMakeLists.txt
new file mode 100644
index 0000000000..1e03deceef
--- /dev/null
+++ b/test/freeflow/staggered/CMakeLists.txt
@@ -0,0 +1,16 @@
+add_input_file_links()
+
+add_dumux_test(test_cc1p test_cc1p test_cc1p.cc
+               python ${CMAKE_SOURCE_DIR}/bin/runtest.py
+                 --script fuzzy
+                 --files ${CMAKE_SOURCE_DIR}/test/references/1ptestcc-reference.vtu
+                         ${CMAKE_CURRENT_BINARY_DIR}/1ptestcc-00002.vtu
+                 --command "${CMAKE_CURRENT_BINARY_DIR}/test_cc1p")
+
+
+#install sources
+install(FILES
+1ptestproblem.hh
+1ptestspatialparams.hh
+test_cc1p.cc
+DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/test/implicit/1p)
diff --git a/test/freeflow/staggered/test_cc1p.cc b/test/freeflow/staggered/test_cc1p.cc
new file mode 100644
index 0000000000..83b357c6dc
--- /dev/null
+++ b/test/freeflow/staggered/test_cc1p.cc
@@ -0,0 +1,64 @@
+// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
+// vi: set et ts=4 sw=4 sts=4:
+/*****************************************************************************
+ *   See the file COPYING for full copying permissions.                      *
+ *                                                                           *
+ *   This program is free software: you can redistribute it and/or modify    *
+ *   it under the terms of the GNU General Public License as published by    *
+ *   the Free Software Foundation, either version 2 of the License, or       *
+ *   (at your option) any later version.                                     *
+ *                                                                           *
+ *   This program is distributed in the hope that it will be useful,         *
+ *   but WITHOUT ANY WARRANTY; without even the implied warranty of          *
+ *   MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the            *
+ *   GNU General Public License for more details.                            *
+ *                                                                           *
+ *   You should have received a copy of the GNU General Public License       *
+ *   along with this program.  If not, see <http://www.gnu.org/licenses/>.   *
+ *****************************************************************************/
+/*!
+ * \file
+ *
+ * \brief test for the one-phase CC model
+ */
+#include <config.h>
+#include "1ptestproblem.hh"
+#include <dumux/common/start.hh>
+
+/*!
+ * \brief Provides an interface for customizing error messages associated with
+ *        reading in parameters.
+ *
+ * \param progName  The name of the program, that was tried to be started.
+ * \param errorMsg  The error message that was issued by the start function.
+ *                  Comprises the thing that went wrong and a general help message.
+ */
+void usage(const char *progName, const std::string &errorMsg)
+{
+    if (errorMsg.size() > 0) {
+        std::string errorMessageOut = "\nUsage: ";
+                    errorMessageOut += progName;
+                    errorMessageOut += " [options]\n";
+                    errorMessageOut += errorMsg;
+                    errorMessageOut += "\n\nThe list of mandatory arguments for this program is:\n"
+                                        "\t-TimeManager.TEnd               End of the simulation [s] \n"
+                                        "\t-TimeManager.DtInitial          Initial timestep size [s] \n"
+                                        "\t-Grid.File                      Name of the file containing the grid \n"
+                                        "\t                                definition in DGF format\n"
+                                        "\t-SpatialParams.LensLowerLeftX   x-coordinate of the lower left corner of the lens [m] \n"
+                                        "\t-SpatialParams.LensLowerLeftY   y-coordinate of the lower left corner of the lens [m] \n"
+                                        "\t-SpatialParams.LensUpperRightX  x-coordinate of the upper right corner of the lens [m] \n"
+                                        "\t-SpatialParams.LensUpperRightY  y-coordinate of the upper right corner of the lens [m] \n"
+                                        "\t-SpatialParams.Permeability     Permeability of the domain [m^2] \n"
+                                        "\t-SpatialParams.PermeabilityLens Permeability of the lens [m^2] \n";
+
+        std::cout << errorMessageOut
+                  << "\n";
+    }
+}
+
+int main(int argc, char** argv)
+{
+    typedef TTAG(OnePTestCCProblem) ProblemTypeTag;
+    return Dumux::start<ProblemTypeTag>(argc, argv, usage);
+}
diff --git a/test/freeflow/staggered/test_cc1p.input b/test/freeflow/staggered/test_cc1p.input
new file mode 100644
index 0000000000..c7890bf3f0
--- /dev/null
+++ b/test/freeflow/staggered/test_cc1p.input
@@ -0,0 +1,23 @@
+[TimeManager]
+DtInitial = 1 # [s]
+TEnd = 1 # [s]
+
+[Grid]
+# File = ./grids/test_1p_2d.dgf
+UpperRight = 1 1
+Cells = 2 2
+
+[Problem]
+Name = 1ptestbox # name passed to the output routines
+
+[SpatialParams]
+LensLowerLeftX = 0.25 # [m]
+LensLowerLeftY = 0.25 # [m]
+LensLowerLeftZ = 0.25 # [m]
+LensUpperRightX = 0.75 # [m]
+LensUpperRightY = 0.75 # [m]
+LensUpperRightZ = 0.75 # [m]
+
+Permeability = 1e-10 # [m^2]
+PermeabilityLens = 1e-12 # [m^2]
+
-- 
GitLab