From 0a723760bb1bd5377fc035fcb82b09b4f56372b2 Mon Sep 17 00:00:00 2001 From: Alexander Kissinger <alexander.kissinger@iws.uni-stuttgart.de> Date: Thu, 10 May 2012 09:58:44 +0000 Subject: [PATCH] new naming convention for test 3p3cni git-svn-id: svn://svn.iws.uni-stuttgart.de/DUMUX/dumux/trunk@8289 2fb0f335-1f38-0410-981e-8018bf24f1b0 --- test/boxmodels/3p3cni/columnxylolproblem.hh | 14 ++-- ...ameters.hh => columnxylolspatialparams.hh} | 82 +++++++++--------- test/boxmodels/3p3cni/kuevetteproblem.hh | 18 ++-- ...parameters.hh => kuevettespatialparams.hh} | 84 +++++++++---------- test/boxmodels/3p3cni/test_3p3cni.cc | 8 +- 5 files changed, 103 insertions(+), 103 deletions(-) rename test/boxmodels/3p3cni/{columnxylolspatialparameters.hh => columnxylolspatialparams.hh} (79%) rename test/boxmodels/3p3cni/{kuevettespatialparameters.hh => kuevettespatialparams.hh} (78%) diff --git a/test/boxmodels/3p3cni/columnxylolproblem.hh b/test/boxmodels/3p3cni/columnxylolproblem.hh index 39630a2dd7..e769609ccd 100644 --- a/test/boxmodels/3p3cni/columnxylolproblem.hh +++ b/test/boxmodels/3p3cni/columnxylolproblem.hh @@ -38,7 +38,7 @@ #include <dumux/boxmodels/3p3cni/3p3cnimodel.hh> #include <dumux/boxmodels/common/porousmediaboxproblem.hh> -#include "columnxylolspatialparameters.hh" +#include "columnxylolspatialparams.hh" #define ISOTHERMAL 0 @@ -49,7 +49,7 @@ class ColumnProblem; namespace Properties { -NEW_TYPE_TAG(ColumnProblem, INHERITS_FROM(BoxThreePThreeCNI, ColumnSpatialParameters)); +NEW_TYPE_TAG(ColumnProblem, INHERITS_FROM(BoxThreePThreeCNI, ColumnSpatialParams)); // Set the grid type SET_PROP(ColumnProblem, Grid) @@ -206,7 +206,7 @@ public: * * \param values The neumann values for the conservation equations * \param element The finite element - * \param fvElemGeom The finite-volume geometry in the box scheme + * \param fvGeomtry The finite-volume geometry in the box scheme * \param is The intersection between element and boundary * \param scvIdx The local vertex index * \param boundaryFaceIdx The index of the boundary face @@ -216,9 +216,9 @@ public: */ void neumann(PrimaryVariables &values, const Element &element, - const FVElementGeometry &fvElemGeom, + const FVElementGeometry &fvGeomtry, const Intersection &is, - int scvIdx, + const int scvIdx, int boundaryFaceIdx) const { const GlobalPosition &globalPos = element.geometry().corner(scvIdx); @@ -254,8 +254,8 @@ public: */ void initial(PrimaryVariables &values, const Element &element, - const FVElementGeometry &fvElemGeom, - int scvIdx) const + const FVElementGeometry &fvGeomtry, + const int scvIdx) const { const GlobalPosition &globalPos = element.geometry().corner(scvIdx); diff --git a/test/boxmodels/3p3cni/columnxylolspatialparameters.hh b/test/boxmodels/3p3cni/columnxylolspatialparams.hh similarity index 79% rename from test/boxmodels/3p3cni/columnxylolspatialparameters.hh rename to test/boxmodels/3p3cni/columnxylolspatialparams.hh index 65e9571df5..3c15542ffd 100644 --- a/test/boxmodels/3p3cni/columnxylolspatialparameters.hh +++ b/test/boxmodels/3p3cni/columnxylolspatialparams.hh @@ -26,11 +26,11 @@ * * \brief Definition of the spatial parameters for the column problem. */ -#ifndef DUMUX_COLUMNXYLOL_SPATIAL_PARAMETERS_HH -#define DUMUX_COLUMNXYLOL_SPATIAL_PARAMETERS_HH +#ifndef DUMUX_COLUMNXYLOL_SPATIAL_PARAMS_HH +#define DUMUX_COLUMNXYLOL_SPATIAL_PARAMS_HH #include <dumux/boxmodels/3p3c/3p3cindices.hh> -#include <dumux/material/spatialparameters/boxspatialparameters.hh> +#include <dumux/material/spatialparams/boxspatialparams.hh> #include <dumux/material/fluidmatrixinteractions/3p/parkerVanGen3p.hh> #include <dumux/material/fluidmatrixinteractions/3p/parkerVanGen3pparams.hh> @@ -39,18 +39,18 @@ namespace Dumux //forward declaration template<class TypeTag> -class ColumnSpatialParameters; +class ColumnSpatialParams; namespace Properties { // The spatial parameters TypeTag -NEW_TYPE_TAG(ColumnSpatialParameters); +NEW_TYPE_TAG(ColumnSpatialParams); // Set the spatial parameters -SET_TYPE_PROP(ColumnSpatialParameters, SpatialParams, Dumux::ColumnSpatialParameters<TypeTag>); +SET_TYPE_PROP(ColumnSpatialParams, SpatialParams, Dumux::ColumnSpatialParams<TypeTag>); // Set the material Law -SET_PROP(ColumnSpatialParameters, MaterialLaw) +SET_PROP(ColumnSpatialParams, MaterialLaw) { private: typedef typename GET_PROP_TYPE(TypeTag, Scalar) Scalar; @@ -65,9 +65,9 @@ SET_PROP(ColumnSpatialParameters, MaterialLaw) * \brief Definition of the spatial parameters for the column problem */ template<class TypeTag> -class ColumnSpatialParameters : public BoxSpatialParameters<TypeTag> +class ColumnSpatialParams : public BoxSpatialParams<TypeTag> { - typedef BoxSpatialParameters<TypeTag> ParentType; + typedef BoxSpatialParams<TypeTag> ParentType; typedef typename GET_PROP_TYPE(TypeTag, Grid) Grid; typedef typename GET_PROP_TYPE(TypeTag, GridView) GridView; @@ -85,7 +85,7 @@ class ColumnSpatialParameters : public BoxSpatialParameters<TypeTag> }; typedef Dune::FieldVector<CoordScalar,dimWorld> GlobalPosition; - typedef Dune::FieldVector<CoordScalar,dimWorld> Vector; + typedef Dune::FieldVector<CoordScalar,dimWorld> DimVector; typedef typename GET_PROP_TYPE(TypeTag, SolutionVector) SolutionVector; @@ -106,8 +106,8 @@ public: * * \param gv The grid view */ - ColumnSpatialParameters(const GridView &gv) - : ParentType(gv) + ColumnSpatialParams(const GridView &gridView) + : ParentType(gridView) { // intrinsic permeabilities fineK_ = 1.4e-11; @@ -147,7 +147,7 @@ public: fineMaterialParams_.setRhoBulk(1500.); } - ~ColumnSpatialParameters() + ~ColumnSpatialParams() {} @@ -183,15 +183,15 @@ public: * \brief Define the porosity \f$[-]\f$ of the spatial parameters * * \param element The finite element - * \param fvElemGeom The finite volume geometry + * \param fvGeometry The finite volume geometry * \param scvIdx The local index of the sub-control volume where * the porosity needs to be defined */ double porosity(const Element &element, - const FVElementGeometry &fvElemGeom, - int scvIdx) const + const FVElementGeometry &fvGeomtry, + const int scvIdx) const { - const GlobalPosition &pos = fvElemGeom.subContVol[scvIdx].global; + const GlobalPosition &pos = fvGeomtry.subContVol[scvIdx].global; if (isFineMaterial_(pos)) return finePorosity_; else @@ -203,14 +203,14 @@ public: * \brief return the parameter object for the Brooks-Corey material law which depends on the position * * \param element The current finite element - * \param fvElemGeom The current finite volume geometry of the element + * \param fvGeomtry The current finite volume geometry of the element * \param scvIdx The index of the sub-control volume */ const MaterialLawParams& materialLawParams(const Element &element, - const FVElementGeometry &fvElemGeom, - int scvIdx) const + const FVElementGeometry &fvGeomtry, + const int scvIdx) const { - const GlobalPosition &pos = fvElemGeom.subContVol[scvIdx].global; + const GlobalPosition &pos = fvGeomtry.subContVol[scvIdx].global; if (isFineMaterial_(pos)) return fineMaterialParams_; else @@ -223,21 +223,21 @@ public: * This is only required for non-isothermal models. * * \param element The finite element - * \param fvElemGeom The finite volume geometry + * \param fvGeomtry The finite volume geometry * \param scvIdx The local index of the sub-control volume where * the heat capacity needs to be defined */ double heatCapacity(const Element &element, - const FVElementGeometry &fvElemGeom, - int scvIdx) const + const FVElementGeometry &fvGeomtry, + const int scvIdx) const { - const GlobalPosition &pos = fvElemGeom.subContVol[scvIdx].global; + const GlobalPosition &pos = fvGeomtry.subContVol[scvIdx].global; if (isFineMaterial_(pos)) return fineHeatCap_ * 2650 // density of sand [kg/m^3] - * (1 - porosity(element, fvElemGeom, scvIdx)); + * (1 - porosity(element, fvGeomtry, scvIdx)); else return coarseHeatCap_ * 2650 // density of sand [kg/m^3] - * (1 - porosity(element, fvElemGeom, scvIdx)); + * (1 - porosity(element, fvGeomtry, scvIdx)); } /*! @@ -248,32 +248,32 @@ public: * * \param heatFlux The resulting heat flux vector * \param fluxDat The flux variables - * \param vDat The volume variables + * \param elemVolVarst The volume variables * \param tempGrad The temperature gradient * \param element The current finite element - * \param fvElemGeom The finite volume geometry of the current element - * \param scvfIdx The local index of the sub-control volume face where + * \param fvGeomtry The finite volume geometry of the current element + * \param faceIdx The local index of the sub-control volume face where * the matrix heat flux should be calculated */ - void matrixHeatFlux(Vector &heatFlux, + void matrixHeatFlux(DimVector &heatFlux, const FluxVariables &fluxDat, - const ElementVolumeVariables &vDat, - const Vector &tempGrad, + const ElementVolumeVariables &elemVolVars, + const DimVector &tempGrad, const Element &element, - const FVElementGeometry &fvElemGeom, - int scvfIdx) const + const FVElementGeometry &fvGeomtry, + int faceIdx) const { static const Scalar ldry = 0.35; static const Scalar lSw1 = 1.8; static const Scalar lSn1 = 0.65; // arithmetic mean of the liquid saturation and the porosity - const int i = fvElemGeom.subContVolFace[scvfIdx].i; - const int j = fvElemGeom.subContVolFace[scvfIdx].j; - Scalar Sw = std::max(0.0, (vDat[i].saturation(wPhaseIdx) + - vDat[j].saturation(wPhaseIdx)) / 2); - Scalar Sn = std::max(0.0, (vDat[i].saturation(nPhaseIdx) + - vDat[j].saturation(nPhaseIdx)) / 2); + const int i = fvGeomtry.subContVolFace[faceIdx].i; + const int j = fvGeomtry.subContVolFace[faceIdx].j; + Scalar Sw = std::max(0.0, (elemVolVars[i].saturation(wPhaseIdx) + + elemVolVars[j].saturation(wPhaseIdx)) / 2); + Scalar Sn = std::max(0.0, (elemVolVars[i].saturation(nPhaseIdx) + + elemVolVars[j].saturation(nPhaseIdx)) / 2); // the heat conductivity of the matrix. in general this is a // tensorial value, but we assume isotropic heat conductivity. diff --git a/test/boxmodels/3p3cni/kuevetteproblem.hh b/test/boxmodels/3p3cni/kuevetteproblem.hh index 506ae866b3..0ae9249f5e 100644 --- a/test/boxmodels/3p3cni/kuevetteproblem.hh +++ b/test/boxmodels/3p3cni/kuevetteproblem.hh @@ -38,7 +38,7 @@ #include <dumux/boxmodels/3p3cni/3p3cnimodel.hh> #include <dumux/boxmodels/common/porousmediaboxproblem.hh> -#include "kuevettespatialparameters.hh" +#include "kuevettespatialparams.hh" #define ISOTHERMAL 0 @@ -49,7 +49,7 @@ class KuevetteProblem; namespace Properties { -NEW_TYPE_TAG(KuevetteProblem, INHERITS_FROM(BoxThreePThreeCNI, KuevetteSpatialParameters)); +NEW_TYPE_TAG(KuevetteProblem, INHERITS_FROM(BoxThreePThreeCNI, KuevetteSpatialParams)); // Set the grid type SET_PROP(KuevetteProblem, Grid) @@ -241,7 +241,7 @@ public: * * \param values The neumann values for the conservation equations * \param element The finite element - * \param fvElemGeom The finite-volume geometry in the box scheme + * \param fvGeomtry The finite-volume geometry in the box scheme * \param is The intersection between element and boundary * \param scvIdx The local vertex index * \param boundaryFaceIdx The index of the boundary face @@ -251,9 +251,9 @@ public: */ void neumann(PrimaryVariables &values, const Element &element, - const FVElementGeometry &fvElemGeom, + const FVElementGeometry &fvGeomtry, const Intersection &is, - int scvIdx, + const int scvIdx, int boundaryFaceIdx) const { const GlobalPosition &globalPos = element.geometry().corner(scvIdx); @@ -281,7 +281,7 @@ public: * * \param values The initial values for the primary variables * \param element The finite element - * \param fvElemGeom The finite-volume geometry in the box scheme + * \param fvGeomtry The finite-volume geometry in the box scheme * \param scvIdx The local vertex index * * For this method, the \a values parameter stores primary @@ -289,8 +289,8 @@ public: */ void initial(PrimaryVariables &values, const Element &element, - const FVElementGeometry &fvElemGeom, - int scvIdx) const + const FVElementGeometry &fvGeomtry, + const int scvIdx) const { const GlobalPosition &globalPos = element.geometry().corner(scvIdx); @@ -306,7 +306,7 @@ public: * \param globalPos The global position */ int initialPhasePresence(const Vertex &vert, - int &globalIdx, + const int &globalIdx, const GlobalPosition &globalPos) const { if((globalPos[0] >= 0.20) && (globalPos[0] <= 0.80) && (globalPos[1] >= 0.4) && (globalPos[1] <= 0.65)) diff --git a/test/boxmodels/3p3cni/kuevettespatialparameters.hh b/test/boxmodels/3p3cni/kuevettespatialparams.hh similarity index 78% rename from test/boxmodels/3p3cni/kuevettespatialparameters.hh rename to test/boxmodels/3p3cni/kuevettespatialparams.hh index 925955cabe..1bb3ef2257 100644 --- a/test/boxmodels/3p3cni/kuevettespatialparameters.hh +++ b/test/boxmodels/3p3cni/kuevettespatialparams.hh @@ -26,11 +26,11 @@ * * \brief Definition of the spatial parameters for the kuevette problem. */ -#ifndef DUMUX_KUEVETTE3P3CNI_SPATIAL_PARAMETERS_HH -#define DUMUX_KUEVETTE3P3CNI_SPATIAL_PARAMETERS_HH +#ifndef DUMUX_KUEVETTE3P3CNI_SPATIAL_PARAMS_HH +#define DUMUX_KUEVETTE3P3CNI_SPATIAL_PARAMS_HH #include <dumux/boxmodels/3p3c/3p3cindices.hh> -#include <dumux/material/spatialparameters/boxspatialparameters.hh> +#include <dumux/material/spatialparams/boxspatialparams.hh> #include <dumux/material/fluidmatrixinteractions/3p/parkerVanGen3p.hh> #include <dumux/material/fluidmatrixinteractions/3p/parkerVanGen3pparams.hh> @@ -39,18 +39,18 @@ namespace Dumux //forward declaration template<class TypeTag> -class KuevetteSpatialParameters; +class KuevetteSpatialParams; namespace Properties { // The spatial parameters TypeTag -NEW_TYPE_TAG(KuevetteSpatialParameters); +NEW_TYPE_TAG(KuevetteSpatialParams); // Set the spatial parameters -SET_TYPE_PROP(KuevetteSpatialParameters, SpatialParams, Dumux::KuevetteSpatialParameters<TypeTag>); +SET_TYPE_PROP(KuevetteSpatialParams, SpatialParams, Dumux::KuevetteSpatialParams<TypeTag>); // Set the material Law -SET_PROP(KuevetteSpatialParameters, MaterialLaw) +SET_PROP(KuevetteSpatialParams, MaterialLaw) { private: typedef typename GET_PROP_TYPE(TypeTag, Scalar) Scalar; @@ -67,9 +67,9 @@ SET_PROP(KuevetteSpatialParameters, MaterialLaw) * \brief Definition of the spatial parameters for the kuevette problem */ template<class TypeTag> -class KuevetteSpatialParameters : public BoxSpatialParameters<TypeTag> +class KuevetteSpatialParams : public BoxSpatialParams<TypeTag> { - typedef BoxSpatialParameters<TypeTag> ParentType; + typedef BoxSpatialParams<TypeTag> ParentType; typedef typename GET_PROP_TYPE(TypeTag, Grid) Grid; typedef typename GET_PROP_TYPE(TypeTag, GridView) GridView; @@ -87,7 +87,7 @@ class KuevetteSpatialParameters : public BoxSpatialParameters<TypeTag> }; typedef Dune::FieldVector<CoordScalar,dimWorld> GlobalPosition; - typedef Dune::FieldVector<CoordScalar,dimWorld> Vector; + typedef Dune::FieldVector<CoordScalar,dim> DimVector; typedef typename GET_PROP_TYPE(TypeTag, SolutionVector) SolutionVector; @@ -108,8 +108,8 @@ public: * * \param gv The grid view */ - KuevetteSpatialParameters(const GridView &gv) - : ParentType(gv) + KuevetteSpatialParams(const GridView &gridView) + : ParentType(gridView) { // intrinsic permeabilities fineK_ = 6.28e-12; @@ -145,7 +145,7 @@ public: fineMaterialParams_.setRhoBulk(1500.); } - ~KuevetteSpatialParameters() + ~KuevetteSpatialParams() {} @@ -164,14 +164,14 @@ public: * potential gradient. * * \param element The current finite element - * \param fvElemGeom The current finite volume geometry of the element + * \param fvGeomtry The current finite volume geometry of the element * \param scvIdx The index of the sub-control volume */ const Scalar intrinsicPermeability(const Element &element, - const FVElementGeometry &fvElemGeom, - int scvIdx) const + const FVElementGeometry &fvGeomtry, + const int scvIdx) const { - const GlobalPosition &pos = fvElemGeom.subContVol[scvIdx].global; + const GlobalPosition &pos = fvGeomtry.subContVol[scvIdx].global; if (isFineMaterial_(pos)) return fineK_; return coarseK_; @@ -181,15 +181,15 @@ public: * \brief Define the porosity \f$[-]\f$ of the spatial parameters * * \param element The finite element - * \param fvElemGeom The finite volume geometry + * \param fvGeomtry The finite volume geometry * \param scvIdx The local index of the sub-control volume where * the porosity needs to be defined */ double porosity(const Element &element, - const FVElementGeometry &fvElemGeom, - int scvIdx) const + const FVElementGeometry &fvGeomtry, + const int scvIdx) const { - const GlobalPosition &pos = fvElemGeom.subContVol[scvIdx].global; + const GlobalPosition &pos = fvGeomtry.subContVol[scvIdx].global; if (isFineMaterial_(pos)) return finePorosity_; else @@ -201,14 +201,14 @@ public: * \brief return the parameter object for the Brooks-Corey material law which depends on the position * * \param element The current finite element - * \param fvElemGeom The current finite volume geometry of the element + * \param fvGeomtry The current finite volume geometry of the element * \param scvIdx The index of the sub-control volume */ const MaterialLawParams& materialLawParams(const Element &element, - const FVElementGeometry &fvElemGeom, - int scvIdx) const + const FVElementGeometry &fvGeomtry, + const int scvIdx) const { - const GlobalPosition &pos = fvElemGeom.subContVol[scvIdx].global; + const GlobalPosition &pos = fvGeomtry.subContVol[scvIdx].global; if (isFineMaterial_(pos)) return fineMaterialParams_; else @@ -226,13 +226,13 @@ public: * the heat capacity needs to be defined */ double heatCapacity(const Element &element, - const FVElementGeometry &fvElemGeom, - int scvIdx) const + const FVElementGeometry &fvGeomtry, + const int scvIdx) const { return 850 // specific heat capacity [J / (kg K)] * 2650 // density of sand [kg/m^3] - * (1 - porosity(element, fvElemGeom, scvIdx)); + * (1 - porosity(element, fvGeomtry, scvIdx)); } /*! @@ -243,32 +243,32 @@ public: * * \param heatFlux The resulting heat flux vector * \param fluxDat The flux variables - * \param vDat The volume variables + * \param elemVolVars The volume variables * \param tempGrad The temperature gradient * \param element The current finite element - * \param fvElemGeom The finite volume geometry of the current element - * \param scvfIdx The local index of the sub-control volume face where + * \param fvGeomtry The finite volume geometry of the current element + * \param faceIdx The local index of the sub-control volume face where * the matrix heat flux should be calculated */ - void matrixHeatFlux(Vector &heatFlux, + void matrixHeatFlux(DimVector &heatFlux, const FluxVariables &fluxDat, - const ElementVolumeVariables &vDat, - const Vector &tempGrad, + const ElementVolumeVariables &elemVolVars, + const DimVector &tempGrad, const Element &element, - const FVElementGeometry &fvElemGeom, - int scvfIdx) const + const FVElementGeometry &fvGeomtry, + const int faceIdx) const { static const Scalar ldry = 0.35; static const Scalar lSw1 = 1.8; static const Scalar lSn1 = 0.65; // arithmetic mean of the liquid saturation and the porosity - const int i = fvElemGeom.subContVolFace[scvfIdx].i; - const int j = fvElemGeom.subContVolFace[scvfIdx].j; - Scalar Sw = std::max(0.0, (vDat[i].saturation(wPhaseIdx) + - vDat[j].saturation(wPhaseIdx)) / 2); - Scalar Sn = std::max(0.0, (vDat[i].saturation(nPhaseIdx) + - vDat[j].saturation(nPhaseIdx)) / 2); + const int i = fvGeomtry.subContVolFace[faceIdx].i; + const int j = fvGeomtry.subContVolFace[faceIdx].j; + Scalar Sw = std::max(0.0, (elemVolVars[i].saturation(wPhaseIdx) + + elemVolVars[j].saturation(wPhaseIdx)) / 2); + Scalar Sn = std::max(0.0, (elemVolVars[i].saturation(nPhaseIdx) + + elemVolVars[j].saturation(nPhaseIdx)) / 2); // the heat conductivity of the matrix. in general this is a // tensorial value, but we assume isotropic heat conductivity. diff --git a/test/boxmodels/3p3cni/test_3p3cni.cc b/test/boxmodels/3p3cni/test_3p3cni.cc index dbcc17fdf4..9e1ce544a0 100644 --- a/test/boxmodels/3p3cni/test_3p3cni.cc +++ b/test/boxmodels/3p3cni/test_3p3cni.cc @@ -29,8 +29,8 @@ * \brief test for the 3p3cni box model */ #include "config.h" -#include "kuevetteproblem.hh" -//#include "columnxylolproblem.hh" +//#include "kuevetteproblem.hh" +#include "columnxylolproblem.hh" #include <dumux/common/start.hh> @@ -62,7 +62,7 @@ void usage(const char *progName, const std::string &errorMsg) int main(int argc, char** argv) { - typedef TTAG(KuevetteProblem) ProblemTypeTag; -// typedef TTAG(ColumnProblem) ProblemTypeTag; +// typedef TTAG(KuevetteProblem) ProblemTypeTag; + typedef TTAG(ColumnProblem) ProblemTypeTag; return Dumux::start<ProblemTypeTag>(argc, argv, usage); } -- GitLab