diff --git a/dumux/boxmodels/1p/1pfluxvariables.hh b/dumux/boxmodels/1p/1pfluxvariables.hh index f6a72fbff4862e9b6ec46d3c5d0f8c63d1747ae8..53e770b048cd6d70f0e1a40bd996f8f37f5b2c0c 100644 --- a/dumux/boxmodels/1p/1pfluxvariables.hh +++ b/dumux/boxmodels/1p/1pfluxvariables.hh @@ -1,35 +1,35 @@ // -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- // vi: set et ts=4 sw=4 sts=4: /***************************************************************************** - * Copyright (C) 2011 by Katherina Baber - * Copyright (C) 2008-2009 by Onur Dogan * - * Copyright (C) 2008-2009 by Andreas Lauser * - * Institute for Modelling Hydraulic and Environmental Systems * - * University of Stuttgart, Germany * - * email: <givenname>.<name>@iws.uni-stuttgart.de * - * * - * 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/>. * - *****************************************************************************/ +* Copyright (C) 2011 by Katherina Baber +* Copyright (C) 2008-2009 by Onur Dogan * +* Copyright (C) 2008-2009 by Andreas Lauser * +* Institute for Modelling Hydraulic and Environmental Systems * +* University of Stuttgart, Germany * +* email: <givenname>.<name>@iws.uni-stuttgart.de * +* * +* 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 This file contains the data which is required to calculate - * the flux of the fluid over a face of a finite volume for the one-phase model. - * - * This means pressure and temperature gradients, phase densities at - * the integration point, etc. - */ +* \file +* +* \brief This file contains the data which is required to calculate +* the flux of the fluid over a face of a finite volume for the one-phase model. +* +* This means pressure and temperature gradients, phase densities at +* the integration point, etc. +*/ #ifndef DUMUX_1P_FLUX_VARIABLES_HH #define DUMUX_1P_FLUX_VARIABLES_HH @@ -41,68 +41,68 @@ namespace Dumux { /*! - * \ingroup OnePBoxModel - * \ingroup BoxFluxVariables - * \brief This template class contains the data which is required to - * calculate the flux of the fluid over a face of a - * finite volume for the one-phase model. - */ +* \ingroup OnePBoxModel +* \ingroup BoxFluxVariables +* \brief This template class contains the data which is required to +* calculate the flux of the fluid over a face of a +* finite volume for the one-phase model. +*/ template <class TypeTag> class OnePFluxVariables { - typedef typename GET_PROP_TYPE(TypeTag, Scalar) Scalar; - typedef typename GET_PROP_TYPE(TypeTag, Problem) Problem; - typedef typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables) ElementVolumeVariables; - typedef typename GET_PROP_TYPE(TypeTag, SpatialParameters) SpatialParameters; +typedef typename GET_PROP_TYPE(TypeTag, Scalar) Scalar; +typedef typename GET_PROP_TYPE(TypeTag, Problem) Problem; +typedef typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables) ElementVolumeVariables; +typedef typename GET_PROP_TYPE(TypeTag, SpatialParams) SpatialParams; - typedef typename GET_PROP_TYPE(TypeTag, GridView) GridView; - typedef typename GridView::template Codim<0>::Entity Element; - enum { dim = GridView::dimension }; - typedef Dune::FieldVector<Scalar, dim> Vector; - typedef Dune::FieldMatrix<Scalar, dim, dim> Tensor; +typedef typename GET_PROP_TYPE(TypeTag, GridView) GridView; +typedef typename GridView::template Codim<0>::Entity Element; +enum { dim = GridView::dimension }; +typedef Dune::FieldVector<Scalar, dim> DimVector; +typedef Dune::FieldMatrix<Scalar, dim, dim> DimMatrix; - typedef typename GET_PROP_TYPE(TypeTag, FVElementGeometry) FVElementGeometry; - typedef typename FVElementGeometry::SubControlVolumeFace SCVFace; +typedef typename GET_PROP_TYPE(TypeTag, FVElementGeometry) FVElementGeometry; +typedef typename FVElementGeometry::SubControlVolumeFace SCVFace; public: - /* - * \brief The constructor. - * - * \param problem The problem - * \param element The finite element - * \param fvGeometry The finite-volume geometry in the box scheme - * \param faceIdx The local index of the SCV (sub-control-volume) face - * \param elemDat The volume variables of the current element - */ - OnePFluxVariables(const Problem &problem, - const Element &element, - const FVElementGeometry &fvGeometry, - int faceIdx, - const ElementVolumeVariables &elemDat) +/* +* \brief The constructor. +* +* \param problem The problem +* \param element The finite element +* \param fvGeometry The finite-volume geometry in the box scheme +* \param faceIdx The local index of the SCV (sub-control-volume) face +* \param elemVolVars The volume variables of the current element +*/ +OnePFluxVariables(const Problem &problem, + const Element &element, + const FVElementGeometry &fvGeometry, + const int faceIdx, + const ElementVolumeVariables &elemVolVars) : fvGeometry_(fvGeometry) { - scvfIdx_ = faceIdx; + faceIdx_ = faceIdx; calculateK_(problem, element); - calculateGradients_(problem, element, elemDat); + calculateGradients_(problem, element, elemVolVars); }; /*! * \brief The face of the current sub-control volume. */ const SCVFace &face() const - { return fvGeometry_.subContVolFace[scvfIdx_]; } + { return fvGeometry_.subContVolFace[faceIdx_]; } /*! * \brief Return the intrinsic permeability \f$\mathrm{[m^2]}\f$. */ - const Tensor &intrinsicPermeability() const + const DimMatrix &intrinsicPermeability() const { return K_; } /*! * \brief Return the pressure potential gradient \f$\mathrm{[Pa/m]}\f$. */ - const Vector &potentialGrad() const + const DimVector &potentialGrad() const { return potentialGrad_; } /*! @@ -111,7 +111,7 @@ public: * return the local index of the upstream control volume * for a given phase. * - * \param normalFlux The normal flux i.e. the given intrinsic permeability + * \param normalFlux The normal flux i.e. the given intrinsic permeability * times the pressure potential gradient and SCV face normal. * */ @@ -124,7 +124,7 @@ public: * return the local index of the downstream control volume * for a given phase. * - * \param normalFlux The normal flux i.e. the given intrinsic permeability + * \param normalFlux The normal flux i.e. the given intrinsic permeability * times the pressure potential gradient and SCV face normal. * */ @@ -144,10 +144,10 @@ private: idx++) // loop over adjacent vertices { // FE gradient at vertex idx - const Vector &feGrad = face().grad[idx]; + const DimVector &feGrad = face().grad[idx]; // the pressure gradient - Vector tmp(feGrad); + DimVector tmp(feGrad); tmp *= elemVolVars[idx].pressure(); potentialGrad_ += tmp; } @@ -158,7 +158,7 @@ private: if (GET_PARAM(TypeTag, bool, EnableGravity)) { // estimate the gravitational acceleration at a given SCV face // using the arithmetic mean - Vector g(problem.boxGravity(element, fvGeometry_, face().i)); + DimVector g(problem.boxGravity(element, fvGeometry_, face().i)); g += problem.boxGravity(element, fvGeometry_, face().j); g /= 2; @@ -169,7 +169,7 @@ private: Scalar density = (rhoI + rhoJ)/2; // make it a force - Vector f(g); + DimVector f(g); f *= density; // calculate the final potential gradient @@ -180,7 +180,7 @@ private: void calculateK_(const Problem &problem, const Element &element) { - const SpatialParameters &spatialParams = problem.spatialParameters(); + const SpatialParams &spatialParams = problem.spatialParams(); spatialParams.meanK(K_, spatialParams.intrinsicPermeability(element, fvGeometry_, @@ -192,13 +192,13 @@ private: protected: const FVElementGeometry &fvGeometry_; - int scvfIdx_; + int faceIdx_; // gradients - Vector potentialGrad_; + DimVector potentialGrad_; // intrinsic permeability - Tensor K_; + DimMatrix K_; // local index of the upwind vertex int upstreamIdx_; diff --git a/dumux/boxmodels/1p/1plocalresidual.hh b/dumux/boxmodels/1p/1plocalresidual.hh index 28bffdf372cf8ab3410b8f974c5f08520fb421c2..3b9e8c316470a3c1eea735eb375801c1420bef97 100644 --- a/dumux/boxmodels/1p/1plocalresidual.hh +++ b/dumux/boxmodels/1p/1plocalresidual.hh @@ -55,8 +55,8 @@ class OnePLocalResidual : public BoxLocalResidual<TypeTag> typedef typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables) ElementVolumeVariables; typedef typename GET_PROP_TYPE(TypeTag, GridView) GridView; - enum { dimWorld = GridView::dimensionworld }; - typedef Dune::FieldVector<Scalar, dimWorld> Vector; + enum { dim = GridView::dimension }; + typedef Dune::FieldVector<Scalar, dim> DimVector; typedef typename GET_PROP_TYPE(TypeTag, Indices) Indices; enum { pressureIdx = Indices::pressureIdx }; @@ -81,22 +81,22 @@ public: * model. * * This function should not include the source and sink terms. - * \param result The phase mass within the sub-control volume + * \param storage The phase mass within the sub-control volume * \param scvIdx The SCV (sub-control-volume) index * \param usePrevSol Evaluate function with solution of current or previous time step */ - void computeStorage(PrimaryVariables &result, int scvIdx, bool usePrevSol) const + void computeStorage(PrimaryVariables &storage, const int scvIdx, const bool usePrevSol) const { // if flag usePrevSol is set, the solution from the previous // time step is used, otherwise the current solution is // used. The secondary variables are used accordingly. This // is required to compute the derivative of the storage term // using the implicit euler method. - const ElementVolumeVariables &elemVars = usePrevSol ? this->prevVolVars_() : this->curVolVars_(); - const VolumeVariables &volVars = elemVars[scvIdx]; + const ElementVolumeVariables &elemVolVars = usePrevSol ? this->prevVolVars_() : this->curVolVars_(); + const VolumeVariables &volVars = elemVolVars[scvIdx]; // partial time derivative of the wetting phase mass - result[pressureIdx] = volVars.density() * volVars.porosity(); + storage[pressureIdx] = volVars.density() * volVars.porosity(); } @@ -107,14 +107,14 @@ public: * \param flux The flux over the SCV (sub-control-volume) face * \param faceIdx The index of the SCV face */ - void computeFlux(PrimaryVariables &flux, int faceIdx) const + void computeFlux(PrimaryVariables &flux, const int faceIdx) const { FluxVariables fluxVars(this->problem_(), - this->elem_(), - this->fvElemGeom_(), + this->element_(), + this->fvGeometry_(), faceIdx, this->curVolVars_()); - Vector tmpVec; + DimVector tmpVec; fluxVars.intrinsicPermeability().mv(fluxVars.potentialGrad(), tmpVec); @@ -133,16 +133,16 @@ public: /*! * \brief Calculate the source term of the equation. * - * \param q The source/sink in the SCV - * \param localVertexIdx The index of the SCV + * \param source The source/sink in the SCV + * \param scvIdx The index of the SCV * */ - void computeSource(PrimaryVariables &q, int localVertexIdx) + void computeSource(PrimaryVariables &source, const int scvIdx) { - this->problem_().boxSDSource(q, - this->elem_(), - this->fvElemGeom_(), - localVertexIdx, + this->problem_().boxSDSource(source, + this->element_(), + this->fvGeometry_(), + scvIdx, this->curVolVars_()); } diff --git a/dumux/boxmodels/1p/1pmodel.hh b/dumux/boxmodels/1p/1pmodel.hh index 5634957c24f503cfbfd26e13bb3f88972b89695a..c622a59bc8fb492ff7222e9a51e063efbb30e2dd 100644 --- a/dumux/boxmodels/1p/1pmodel.hh +++ b/dumux/boxmodels/1p/1pmodel.hh @@ -56,7 +56,7 @@ class OnePBoxModel : public BoxModel<TypeTag> { typedef typename GET_PROP_TYPE(TypeTag, FVElementGeometry) FVElementGeometry; typedef typename GET_PROP_TYPE(TypeTag, VolumeVariables) VolumeVariables; - typedef typename GET_PROP_TYPE(TypeTag, SpatialParameters) SpatialParameters; + typedef typename GET_PROP_TYPE(TypeTag, SpatialParams) SpatialParams; typedef typename GET_PROP_TYPE(TypeTag, ElementBoundaryTypes) ElementBoundaryTypes; typedef typename GET_PROP_TYPE(TypeTag, SolutionVector) SolutionVector; @@ -85,7 +85,7 @@ public: unsigned numElements = this->gridView_().size(0); ScalarField *rank = writer.allocateManagedBuffer(numElements); - FVElementGeometry fvElemGeom; + FVElementGeometry fvGeometry; VolumeVariables volVars; ElementBoundaryTypes elemBcTypes; @@ -96,8 +96,8 @@ public: int idx = this->problem_().model().elementMapper().map(*elemIt); (*rank)[idx] = this->gridView_().comm().rank(); - fvElemGeom.update(this->gridView_(), *elemIt); - elemBcTypes.update(this->problem_(), *elemIt, fvElemGeom); + fvGeometry.update(this->gridView_(), *elemIt); + elemBcTypes.update(this->problem_(), *elemIt, fvGeometry); int numVerts = elemIt->template count<dim> (); for (int i = 0; i < numVerts; ++i) @@ -106,15 +106,15 @@ public: volVars.update(sol[globalIdx], this->problem_(), *elemIt, - fvElemGeom, + fvGeometry, i, false); - const SpatialParameters &spatialParams = this->problem_().spatialParameters(); + const SpatialParams &spatialParams = this->problem_().spatialParams(); (*p)[globalIdx] = volVars.pressure(); - (*K)[globalIdx] = spatialParams.intrinsicPermeability(*elemIt, - fvElemGeom, - i); + (*K)[globalIdx]= spatialParams.intrinsicPermeability(*elemIt, + fvGeometry, + i); }; } diff --git a/dumux/boxmodels/1p/1pproblem.hh b/dumux/boxmodels/1p/1pproblem.hh index 7b715be719c8db8597a2c586b56931224127fbde..9575e1393386607297b38a0ab4df5f8e1c24cfa0 100644 --- a/dumux/boxmodels/1p/1pproblem.hh +++ b/dumux/boxmodels/1p/1pproblem.hh @@ -47,7 +47,7 @@ class OnePBoxProblem : public PorousMediaBoxProblem<TypeTag> typedef typename GET_PROP_TYPE(TypeTag, TimeManager) TimeManager; typedef typename GET_PROP_TYPE(TypeTag, GridView) GridView; - typedef typename GET_PROP_TYPE(TypeTag, SpatialParameters) SpatialParameters; + typedef typename GET_PROP_TYPE(TypeTag, SpatialParams) SpatialParams; public: /*! @@ -69,13 +69,13 @@ public: * * \param timeManager The time manager * \param gridView The grid view - * \param spatialParameters The spatial parameters object + * \param spatialParams The spatial parameters object * \param verbose Turn verbosity on or off */ DUMUX_DEPRECATED_MSG("use PorousMediaBoxProblem instead") OnePBoxProblem(TimeManager &timeManager, const GridView &gridView, - SpatialParameters &spatialParameters, + SpatialParams &spatialParams, bool verbose = true) : ParentType(timeManager, gridView) {} diff --git a/dumux/boxmodels/1p/1pproperties.hh b/dumux/boxmodels/1p/1pproperties.hh index ae78717a4839f6c5d0fe1516ed40679eaf98bc17..2ee58468d8ecbff76b5e8b1128aa8e3c42097785 100644 --- a/dumux/boxmodels/1p/1pproperties.hh +++ b/dumux/boxmodels/1p/1pproperties.hh @@ -55,7 +55,8 @@ NEW_TYPE_TAG(BoxOneP, INHERITS_FROM(BoxModel)); NEW_PROP_TAG(NumPhases); //!< Number of fluid phases in the system NEW_PROP_TAG(OnePIndices); //!< DEPRECATED Enumerations for the 1p models NEW_PROP_TAG(Indices); //!< Enumerations for the model -NEW_PROP_TAG(SpatialParameters); //!< The type of the spatial parameters object +NEW_PROP_TAG(SpatialParams); //!< The type of the spatial parameters object +NEW_PROP_TAG(SpatialParameters); //!< DEPRECATED The type of the spatial parameters object NEW_PROP_TAG(FluidSystem); //!< The type of the fluid system to use NEW_PROP_TAG(Fluid); //!< The fluid used for the default fluid system NEW_PROP_TAG(EnableGravity); //!< Returns whether gravity is considered in the problem diff --git a/dumux/boxmodels/1p/1pvolumevariables.hh b/dumux/boxmodels/1p/1pvolumevariables.hh index 96b549556ca07e5b7d302584a60f4b385589744c..769d1a7650a40ed4637b54d1cf4924954131a61e 100644 --- a/dumux/boxmodels/1p/1pvolumevariables.hh +++ b/dumux/boxmodels/1p/1pvolumevariables.hh @@ -68,27 +68,27 @@ public: * \param priVars The local primary variable vector * \param problem The problem object * \param element The current element - * \param elemGeom The finite-volume geometry in the box scheme + * \param fvGeometry The finite-volume geometry in the box scheme * \param scvIdx The local index of the SCV (sub-control volume) * \param isOldSol Evaluate function with solution of current or previous time step */ void update(const PrimaryVariables &priVars, const Problem &problem, const Element &element, - const FVElementGeometry &elemGeom, - int scvIdx, + const FVElementGeometry &fvGeometry, + const int scvIdx, bool isOldSol) { - ParentType::update(priVars, problem, element, elemGeom, scvIdx, isOldSol); + ParentType::update(priVars, problem, element, fvGeometry, scvIdx, isOldSol); - completeFluidState(priVars, problem, element, elemGeom, scvIdx, fluidState_); + completeFluidState(priVars, problem, element, fvGeometry, scvIdx, fluidState_); // porosity - porosity_ = problem.spatialParameters().porosity(element, - elemGeom, + porosity_ = problem.spatialParams().porosity(element, + fvGeometry, scvIdx); // energy related quantities not contained in the fluid state - asImp_().updateEnergy_(priVars, problem, element, elemGeom, scvIdx, isOldSol); + asImp_().updateEnergy_(priVars, problem, element, fvGeometry, scvIdx, isOldSol); }; /*! @@ -97,12 +97,12 @@ public: static void completeFluidState(const PrimaryVariables& primaryVariables, const Problem& problem, const Element& element, - const FVElementGeometry& elementGeometry, - int scvIdx, + const FVElementGeometry& fvGeometry, + const int scvIdx, FluidState& fluidState) { Scalar t = Implementation::temperature_(primaryVariables, problem, element, - elementGeometry, scvIdx); + fvGeometry, scvIdx); fluidState.setTemperature(t); fluidState.setPressure(/*phaseIdx=*/0, primaryVariables[Indices::pressureIdx]); @@ -170,10 +170,10 @@ protected: static Scalar temperature_(const PrimaryVariables &priVars, const Problem& problem, const Element &element, - const FVElementGeometry &elemGeom, - int scvIdx) + const FVElementGeometry &fvGeometry, + const int scvIdx) { - return problem.boxTemperature(element, elemGeom, scvIdx); + return problem.boxTemperature(element, fvGeometry, scvIdx); } /*! @@ -182,8 +182,8 @@ protected: void updateEnergy_(const PrimaryVariables &sol, const Problem &problem, const Element &element, - const FVElementGeometry &elemGeom, - int vertIdx, + const FVElementGeometry &fvGeometry, + const int scvIdx, bool isOldSol) { } diff --git a/test/boxmodels/1p/1ptestproblem.hh b/test/boxmodels/1p/1ptestproblem.hh index ae0beb1f4330c00127e0ad48882a0b8802f914bd..8075563fb777aeb75288ffa5101d885840e215bf 100644 --- a/test/boxmodels/1p/1ptestproblem.hh +++ b/test/boxmodels/1p/1ptestproblem.hh @@ -227,12 +227,12 @@ public: using ParentType::neumann; void neumann(PrimaryVariables &values, const Element &element, - const FVElementGeometry &fvElemGeom, + const FVElementGeometry &fvGeometry, const Intersection &is, - int scvIdx, - int boundaryFaceIdx) const + const int scvIdx, + const int boundaryFaceIdx) const { - // const GlobalPosition &globalPos = fvElemGeom.boundaryFace[boundaryFaceIdx].ipGlobal; + // const GlobalPosition &globalPos = fvGeometry.boundaryFace[boundaryFaceIdx].ipGlobal; values[pressureIdx] = 0; } @@ -252,8 +252,8 @@ public: */ void initial(PrimaryVariables &values, const Element &element, - const FVElementGeometry &fvElemGeom, - int scvIdx) const + const FVElementGeometry &fvGeometry, + const int scvIdx) const { //const GlobalPosition &globalPos = element.geometry().corner(scvIdx); values[pressureIdx] = 1.0e+5;// + 9.81*1.23*(20-globalPos[dim-1]); diff --git a/test/boxmodels/1p/1ptestspatialparameters.hh b/test/boxmodels/1p/1ptestspatialparameters.hh index d5fd46d365b0ed781c022ebd9a9f6590337fd245..880c73dea4ab7b1d1508c0a6e0c81b94996cd50c 100644 --- a/test/boxmodels/1p/1ptestspatialparameters.hh +++ b/test/boxmodels/1p/1ptestspatialparameters.hh @@ -63,20 +63,20 @@ public: { try { - lensLowerLeft_[0] = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParameters.lensLowerLeftX); + lensLowerLeft_[0] = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParams.lensLowerLeftX); if (dim > 1) - lensLowerLeft_[1] = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParameters.lensLowerLeftY); + lensLowerLeft_[1] = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParams.lensLowerLeftY); if (dim > 2) - lensLowerLeft_[2] = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParameters.lensLowerLeftZ); + lensLowerLeft_[2] = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParams.lensLowerLeftZ); - lensUpperRight_[0] = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParameters.lensUpperRightX); + lensUpperRight_[0] = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParams.lensUpperRightX); if (dim > 1) - lensUpperRight_[1] = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParameters.lensUpperRightY); + lensUpperRight_[1] = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParams.lensUpperRightY); if (dim > 2) - lensUpperRight_[2] = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParameters.lensUpperRightZ); + lensUpperRight_[2] = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParams.lensUpperRightZ); - permeability_ = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParameters.permeability); - permeabilityLens_=GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParameters.permeabilityLens); + permeability_ = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParams.permeability); + permeabilityLens_=GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParams.permeabilityLens); } catch (Dumux::ParameterException &e) { std::cerr << e << ". Abort!\n"; @@ -92,15 +92,15 @@ public: * \brief Return the intrinsic permeability for the current sub-control volume. * * \param element The current finite element - * \param fvElemGeom The current finite volume geometry of the 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 Element &element, - const FVElementGeometry &fvElemGeom, - int scvIdx) const + const FVElementGeometry &fvGeometry, + const int scvIdx) const { - const GlobalPosition &globalPos = fvElemGeom.subContVol[scvIdx].global; + const GlobalPosition &globalPos = fvGeometry.subContVol[scvIdx].global; if (isInLens_(globalPos)) return permeabilityLens_; @@ -111,12 +111,12 @@ public: /*! \brief Define the porosity. * * \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 */ Scalar porosity(const Element &element, - const FVElementGeometry &fvElemGeom, - int scvIdx) const + const FVElementGeometry &fvGeometry, + const int scvIdx) const { return 0.4; } private: diff --git a/test/boxmodels/1p/test_1p.input b/test/boxmodels/1p/test_1p.input index 7c7d05c2d485da0d3a3accac6f4f70cf1ae49e73..aa516228325db0cd97976300910bd662cf1a0860 100644 --- a/test/boxmodels/1p/test_1p.input +++ b/test/boxmodels/1p/test_1p.input @@ -24,9 +24,9 @@ gridFile = ./grids/test_1p_2d.dgf # restart = ... #################################################################### -# SpatialParameters +# SpatialParams #################################################################### -[SpatialParameters] +[SpatialParams] #lens from (0.25|0.25) to (0.75|0.75) box-wise definition of permability lensLowerLeftX = 0.25 lensLowerLeftY = 0.25