diff --git a/doc/doxygen/modules.txt b/doc/doxygen/modules.txt index b0c15db748d059fc72c9e1d9f0774bf323c8ba4f..13cde77a349278477248a6c9eb00428fd98661d9 100644 --- a/doc/doxygen/modules.txt +++ b/doc/doxygen/modules.txt @@ -112,7 +112,7 @@ /*! * \ingroup PorousmediumflowModels * \defgroup BoxDFMModel boxdfm - * \brief \todo + * \brief Vertex-centered, continuous-pressure, conforming lower-dimensional discrete-fracture model * \copydetails ./porousmediumflow/boxdfm/model.hh */ /*! @@ -182,7 +182,7 @@ /* ***************** FreeflowModels ******************/ /*! * \defgroup FreeflowModels Free Flow Models - * \brief Single-phase models basing on the Navier-Stokes equation + * \brief Single-phase models based on the Navier-Stokes equation */ /*! * \ingroup FreeflowModels @@ -251,7 +251,7 @@ */ /*! * \defgroup Geomechanics Geomechanics Models - * \brief Models for taking into account solid deformation + * \brief Models taking into account solid deformation */ /*! * \ingroup Geomechanics @@ -460,7 +460,7 @@ /* ***************** Flux ******************/ /*! * \defgroup Flux Flux - * \brief All flux related things available in DuMu<sup>x</sup> + * \brief Everything flux related in DuMu<sup>x</sup> */ /*! * \ingroup Flux @@ -495,7 +495,7 @@ /* ***************** Material ******************/ /*! * \defgroup Material Material and Fluid Framework - * \brief The DuMu<sup>x</sup> material and fluid framework with constitutive laws and physics + * \brief The material and fluid framework with constitutive laws and mixture physics * \par * Short description of the most important concepts of the material and fluid framework: * @@ -700,15 +700,15 @@ /* ***************** InputOutput ******************/ /*! * \defgroup InputOutput Input Output - * \brief Classes and functions dealing with input and output of data and grids + * \brief Input and output of data and grids */ /* ***************** MultiDomain ******************/ /*! * \defgroup MultiDomain Multidomain simulations - * \brief Classes to run problems with multiple domains + * \brief Coupling of several regular DuMu<sup>x</sup> problems * - * The multi domain module allows to couple regular DuMu<sup>x</sup> problems. + * The multi domain module allows coupling regular DuMu<sup>x</sup> problems. * Several coupling modes are currently available. */ /*! diff --git a/dumux/common/geometry/geometryintersection.hh b/dumux/common/geometry/geometryintersection.hh index 13f6a4923179dd061b6a049f45e8172a28560c58..cd702ac1c47c8eaff53a9f79b548f2cd0e7ac909 100644 --- a/dumux/common/geometry/geometryintersection.hh +++ b/dumux/common/geometry/geometryintersection.hh @@ -1008,7 +1008,7 @@ public: * \note Algorithm based on the one from "Real-Time Collision Detection" by Christer Ericson, * published by Morgan Kaufmann Publishers, (c) 2005 Elsevier Inc. (Chapter 5.3.6) * \param geo1/geo2 The geometries to intersect - * \param is If the geometries collide, is holds the corner points of + * \param intersection If the geometries collide, is holds the corner points of * the intersection object in global coordinates. * \note This overload is used when point-like intersections are seeked */ @@ -1080,9 +1080,9 @@ public: * \brief Colliding segment and convex polyhedron * \note Algorithm based on the one from "Real-Time Collision Detection" by Christer Ericson, * published by Morgan Kaufmann Publishers, (c) 2005 Elsevier Inc. (Chapter 5.3.6) - * \param geo1/geo2 The geometries to intersect * \param is If the geometries collide, is holds the corner points of * the intersection object in global coordinates. + * \param a/b/c/p/q \todo Doc me! * \note This overload is used when point-like intersections are seeked */ template<class P = Policy, std::enable_if_t<P::dimIntersection == 0, int> = 0> diff --git a/dumux/common/integrate.hh b/dumux/common/integrate.hh index 7b4fc483881ee2b76ba6391d4adf5862b262cb2c..f458f763655027d37d1d3e093c01d8ad33f482e4 100644 --- a/dumux/common/integrate.hh +++ b/dumux/common/integrate.hh @@ -97,7 +97,7 @@ using FieldType = typename FieldTypeImpl<T>::type; /*! * \brief Integrate a grid function over a grid view * \param gg the grid geometry - * \param f the grid function + * \param sol the solution vector * \param order the order of the quadrature rule */ template<class GridGeometry, class SolutionVector, @@ -127,9 +127,9 @@ auto integrateGridFunction(const GridGeometry& gg, /*! * \brief Integrate a function over a grid view - * \param gv the grid view - * \param f the first function - * \param g the second function + * \param gg the grid geometry + * \param sol1 the first function + * \param sol2 the second function * \param order the order of the quadrature rule * \note dune functions currently doesn't support composing two functions */ diff --git a/dumux/discretization/evalgradients.hh b/dumux/discretization/evalgradients.hh index 3e930a50a5cf6ed7bff7f19a534bd26adbfa46d2..090a0670b79499c357b05b3162b1e8aa842e4865 100644 --- a/dumux/discretization/evalgradients.hh +++ b/dumux/discretization/evalgradients.hh @@ -45,6 +45,7 @@ namespace Dumux { * \param fvGridGeometry 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 * * \return Dune::FieldVector with as many entries as dimension of * the PrimaryVariables object (i.e. numEq). Each entry is diff --git a/dumux/discretization/projection/projector.hh b/dumux/discretization/projection/projector.hh index fe9160393b0bc205b763590ad6cd5c8c4798f9f9..f9fad6e6a759b1a9e98bc1a321b8cc4d2d6c7432 100644 --- a/dumux/discretization/projection/projector.hh +++ b/dumux/discretization/projection/projector.hh @@ -125,6 +125,7 @@ public: /*! * \brief Project a solution u into up * \param u The solution living on the domain space + * \param params \todo Doc me! * \return The projection of u into the target space */ template< class BlockType, std::enable_if_t<std::is_convertible<BlockType, ScalarType>::value, int> = 0 > @@ -162,6 +163,7 @@ public: /*! * \brief Project a solution u into up * \param u The solution living on the domain space + * \param params \todo Doc me! * \return The projection of u into the target space */ template< class BlockType, std::enable_if_t<!std::is_convertible<BlockType, ScalarType>::value, int> = 0 > diff --git a/dumux/freeflow/navierstokes/staggered/staggeredupwindfluxvariables.hh b/dumux/freeflow/navierstokes/staggered/staggeredupwindfluxvariables.hh index d8485ec10c24ea6b7920385d022f578084e4befb..429aae4516b6f06fa49f21570cf86bc789eb799b 100644 --- a/dumux/freeflow/navierstokes/staggered/staggeredupwindfluxvariables.hh +++ b/dumux/freeflow/navierstokes/staggered/staggeredupwindfluxvariables.hh @@ -19,7 +19,7 @@ /*! * \file * \ingroup NavierStokesModel - * \copydoc Dumux::NavierStokesUpwindVariables + * \copydoc Dumux::StaggeredUpwindFluxVariables */ #ifndef DUMUX_NAVIERSTOKES_STAGGERED_UPWINDVARIABLES_HH #define DUMUX_NAVIERSTOKES_STAGGERED_UPWINDVARIABLES_HH diff --git a/dumux/freeflow/rans/oneeq/problem.hh b/dumux/freeflow/rans/oneeq/problem.hh index ab3ecd1b1b3554eb87952e52dc9e1fa4eca769ef..682f3830d997532590980bac1f2054828caaca83 100644 --- a/dumux/freeflow/rans/oneeq/problem.hh +++ b/dumux/freeflow/rans/oneeq/problem.hh @@ -19,7 +19,7 @@ /*! * \file * \ingroup OneEqModel - * \copydoc Dumux::OneEqProblem + * \brief One-equation turbulence problem base class. */ #ifndef DUMUX_ONEEQ_PROBLEM_HH #define DUMUX_ONEEQ_PROBLEM_HH diff --git a/dumux/freeflow/rans/problem.hh b/dumux/freeflow/rans/problem.hh index 00e6272cdbc287e9f6a8f8e6bd363d428ee898af..5c95e70eb5c44506827d9e399d37d6ff9ff69541 100644 --- a/dumux/freeflow/rans/problem.hh +++ b/dumux/freeflow/rans/problem.hh @@ -500,7 +500,7 @@ public: const Scalar karmanConstant() const { return 0.41; } - //! \brief Returns the \$f \beta_{\omega} \$f constant + //! \brief Returns the \f$ \beta_{\omega} \f$ constant const Scalar betaOmega() const { return 0.0708; diff --git a/dumux/freeflow/rans/twoeq/kepsilon/problem.hh b/dumux/freeflow/rans/twoeq/kepsilon/problem.hh index 81da26df026baf598242deb99cd0a58ee9efa3be..939fa207ce6b11ea75a3420808a495b0a2e0970e 100644 --- a/dumux/freeflow/rans/twoeq/kepsilon/problem.hh +++ b/dumux/freeflow/rans/twoeq/kepsilon/problem.hh @@ -19,7 +19,7 @@ /*! * \file * \ingroup KEpsilonModel - * \copydoc Dumux::KEpsilonProblem + * \brief K-epsilon turbulence problem base class. */ #ifndef DUMUX_KEPSILON_PROBLEM_HH #define DUMUX_KEPSILON_PROBLEM_HH diff --git a/dumux/freeflow/rans/twoeq/komega/problem.hh b/dumux/freeflow/rans/twoeq/komega/problem.hh index e6acf8e6417854a4e7e48ee18022c179a5318363..9d026e7aeee1aff78cf0591149b568a0182086a8 100644 --- a/dumux/freeflow/rans/twoeq/komega/problem.hh +++ b/dumux/freeflow/rans/twoeq/komega/problem.hh @@ -19,7 +19,7 @@ /*! * \file * \ingroup KOmegaModel - * \copydoc Dumux::KOmegaProblem + * \brief K-Omega turbulence model problem base class. */ #ifndef DUMUX_KOMEGA_PROBLEM_HH #define DUMUX_KOMEGA_PROBLEM_HH diff --git a/dumux/freeflow/rans/twoeq/lowrekepsilon/problem.hh b/dumux/freeflow/rans/twoeq/lowrekepsilon/problem.hh index 92c11329095f0da0b438c1c1ab1c70bd9b1e1d70..29200e009ae94fbe896829ed3c3da2fd0d4d8443 100644 --- a/dumux/freeflow/rans/twoeq/lowrekepsilon/problem.hh +++ b/dumux/freeflow/rans/twoeq/lowrekepsilon/problem.hh @@ -19,7 +19,7 @@ /*! * \file * \ingroup LowReKEpsilonModel - * \copydoc Dumux::LowReKEpsilonProblem + * \brief Low-Re k-epsilon turbulence problem base class. */ #ifndef DUMUX_LOWREKEPSILON_PROBLEM_HH #define DUMUX_LOWREKEPSILON_PROBLEM_HH diff --git a/dumux/freeflow/rans/zeroeq/problem.hh b/dumux/freeflow/rans/zeroeq/problem.hh index 843c4029cbfeab283f3cac7d44d770fd28c03df5..f4594ac4ee8b152a48ea04607aa7e0f0d70f6602 100644 --- a/dumux/freeflow/rans/zeroeq/problem.hh +++ b/dumux/freeflow/rans/zeroeq/problem.hh @@ -19,7 +19,7 @@ /*! * \file * \ingroup ZeroEqModel - * \copydoc Dumux::ZeroEqProblem + * \brief Zero-equation turbulence problem base class. */ #ifndef DUMUX_ZEROEQ_PROBLEM_HH #define DUMUX_ZEROEQ_PROBLEM_HH diff --git a/dumux/freeflow/staggeredupwindmethods.hh b/dumux/freeflow/staggeredupwindmethods.hh index 26754bff295067f88a2bf60bf6df7fa8a623f6cb..592208dba63786a2b0bb17d2536eb0539ed0a8a2 100644 --- a/dumux/freeflow/staggeredupwindmethods.hh +++ b/dumux/freeflow/staggeredupwindmethods.hh @@ -38,7 +38,7 @@ enum class TvdApproach none, uniform, li, hou }; -//! \biraf Available differencing schemes +//! \brief Available differencing schemes enum class DifferencingScheme { none, vanleer, vanalbada, minmod, superbee, umist, mclimiter, wahyd diff --git a/dumux/io/container.hh b/dumux/io/container.hh index 3c5a04a9157f10a09e6af3ba93c3ecb30b570a06..7799653c783a7de070492bf60931db55b1a2fedb 100644 --- a/dumux/io/container.hh +++ b/dumux/io/container.hh @@ -40,6 +40,7 @@ namespace Dumux { * \brief Writes a container to file * \param v The container, requires begin() and end() method * \param filename The filename to write to + * \param floatPrecision The total number of digits stored, including decimal * * usage: std::vector<double> v(5, 0.0); writeContainerToFile(v, "myvector.txt"); */ diff --git a/dumux/io/vtk/vtkreader.hh b/dumux/io/vtk/vtkreader.hh index 8cb862863b1d406361e1db70236ef25a7e2f4728..b69a3d9cc12e0b538e02cbb09208dd87c80f4c40 100644 --- a/dumux/io/vtk/vtkreader.hh +++ b/dumux/io/vtk/vtkreader.hh @@ -117,6 +117,7 @@ public: * \brief Read a grid from a vtk/vtu/vtp file, ignoring cell and point data * \note use this signature if the factory might be needed outside to interpret the data via the factory's insertion indices * \param verbose if the output should be verbose + * \param factory the (emtpy) grid factory */ template<class Grid> std::unique_ptr<Grid> readGrid(Dune::GridFactory<Grid>& factory, bool verbose = false) const diff --git a/dumux/material/components/simpleh2o.hh b/dumux/material/components/simpleh2o.hh index 4c15e8b9efd2a61381e86c33b97710f361efd15b..371b18026a11d7222b738f464d58742b63e95505 100644 --- a/dumux/material/components/simpleh2o.hh +++ b/dumux/material/components/simpleh2o.hh @@ -308,11 +308,8 @@ public: /*! * \brief Specific isobaric heat capacity of the component \f$\mathrm{[J/(kg*K)]}\f$ as a liquid. - * - * \param temperature temperature of component in \f$\mathrm{[K]}\f$ - * \param pressure pressure of component in \f$\mathrm{[Pa]}\f$ - * source: http://webbook.nist.gov/cgi/fluid.cgi?ID=C7732185&Action=Page - * @ T= 281.15K (8°C) , p=0.1MPa) + * source: http://webbook.nist.gov/cgi/fluid.cgi?ID=C7732185&Action=Page + * @ T= 281.15K (8°C) , p=0.1MPa) * \param temperature absolute temperature in \f$\mathrm{[K]}\f$ * \param pressure of the phase in \f$\mathrm{[Pa]}\f$ */ diff --git a/dumux/material/fluidsystems/brineair.hh b/dumux/material/fluidsystems/brineair.hh index 89d7908a67a9139e25951d5ae959a783f22095a3..e9f413edf4cf86cf5305e99bd87938a0e47b23f5 100644 --- a/dumux/material/fluidsystems/brineair.hh +++ b/dumux/material/fluidsystems/brineair.hh @@ -336,6 +336,7 @@ public: H2O::init(tempMin, tempMax, nTemp, pressMin, pressMax, nPress); } + using Base::density; /*! * \brief Given a phase's composition, temperature, pressure, and * the partial pressures of all components, return its @@ -349,7 +350,6 @@ public: * - cited by: Bachu & Adams (2002) * "Equations of State for basin geofluids" \cite adams2002 */ - using Base::density; template <class FluidState> static Scalar density(const FluidState &fluidState, int phaseIdx) { @@ -386,6 +386,7 @@ public: DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx); } + using Base::molarDensity; /*! * \brief The molar density \f$\rho_{mol,\alpha}\f$ * of a fluid phase \f$\alpha\f$ in \f$\mathrm{[mol/m^3]}\f$ @@ -395,7 +396,6 @@ public: * * \f[\rho_{mol,\alpha} = \frac{\rho_\alpha}{\overline M_\alpha} \;.\f] */ - using Base::molarDensity; template <class FluidState> static Scalar molarDensity(const FluidState& fluidState, int phaseIdx) { @@ -418,6 +418,7 @@ public: DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx); } + using Base::viscosity; /*! * \brief Calculate the dynamic viscosity of a fluid phase \f$\mathrm{[Pa*s]}\f$ * @@ -428,7 +429,6 @@ public: * component is neglected. This contribution is probably not big, but somebody * would have to find out its influence. */ - using Base::viscosity; template <class FluidState> static Scalar viscosity(const FluidState& fluidState, int phaseIdx) { @@ -440,6 +440,7 @@ public: return Air::gasViscosity(fluidState.temperature(phaseIdx), fluidState.pressure(phaseIdx)); } + using Base::fugacityCoefficient; /*! * \brief Returns the fugacity coefficient \f$\mathrm{[-]}\f$ of a component in a * phase. @@ -461,7 +462,6 @@ public: * Henry constant for the solutes and the saturated vapor pressure * both divided by phase pressure. */ - using Base::fugacityCoefficient; template <class FluidState> static Scalar fugacityCoefficient(const FluidState& fluidState, int phaseIdx, int compIdx) { @@ -505,6 +505,7 @@ public: DUNE_THROW(Dune::NotImplemented, "Diffusion coefficients"); } + using Base::binaryDiffusionCoefficient; /*! * \brief Given a phase's composition, temperature and pressure, * return the binary diffusion coefficient \f$\mathrm{[m^2/s]}\f$ for components @@ -515,7 +516,6 @@ public: * \param compIIdx The index of the first component to consider * \param compJIdx The index of the second component to consider */ - using Base::binaryDiffusionCoefficient; template <class FluidState> static Scalar binaryDiffusionCoefficient(const FluidState& fluidState, int phaseIdx, @@ -563,6 +563,7 @@ public: DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx); } + using Base::enthalpy; /*! * \brief Given a phase's composition, temperature and pressure, * return its specific enthalpy \f$\mathrm{[J/kg]}\f$. @@ -582,7 +583,6 @@ public: * is neglected. This contribution is probably not big. Somebody would have to * find out the enthalpy of solution for this system. ... */ - using Base::enthalpy; template <class FluidState> static Scalar enthalpy(const FluidState& fluidState, int phaseIdx) { @@ -637,6 +637,7 @@ public: DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx); } + using Base::thermalConductivity; /*! * \brief Thermal conductivity of a fluid phase \f$\mathrm{[W/(m K)]}\f$. * \param fluidState An abitrary fluid state @@ -646,7 +647,6 @@ public: * components is neglected. This contribution is probably not big, but somebody * would have to find out its influence. */ - using Base::thermalConductivity; template <class FluidState> static Scalar thermalConductivity(const FluidState& fluidState, int phaseIdx) { diff --git a/dumux/multidomain/facet/gridmanager.hh b/dumux/multidomain/facet/gridmanager.hh index 5f7d694f9e0a2054270a148d3eeb1f806cca3287..5e6fa82532ce76d58b0ad04e57963adf07fcd344 100644 --- a/dumux/multidomain/facet/gridmanager.hh +++ b/dumux/multidomain/facet/gridmanager.hh @@ -245,8 +245,8 @@ public: * \param gridFactoryPtr shared pointer to this (id-th) grid factory * \param embeddedEntityMap map containing the lower-dimensional entities for this grid's elements * \param adjoinedEntityMap map containing the (d+1)-dimensional elements in which this grid's elements are embedded in - * \param lowDimGridVertexIndices the hierachy's insertion indices that make up this grid - * (only necessary for lower-dimensional grids) + * \param gridVertexIndices \todo Doc me! + * \param numVerticesInHierarchy \todo Doc me! */ template<std::size_t id> void setData( std::shared_ptr<Grid<id>> gridPtr, diff --git a/dumux/nonlinear/newtonconvergencewriter.hh b/dumux/nonlinear/newtonconvergencewriter.hh index 6d06350ed547ac3f5c3b8c1e11fe6aa3f37dfb4e..ac5c7cd78337281afb0253a4ea1758e2bf112aab 100644 --- a/dumux/nonlinear/newtonconvergencewriter.hh +++ b/dumux/nonlinear/newtonconvergencewriter.hh @@ -62,9 +62,8 @@ class NewtonConvergenceWriter : public ConvergenceWriterInterface<SolutionVector public: /*! * \brief Constructor - * \param gridView the grid view we are solving on - * \param size the size of the solution data - * \param name base name of the vtk output + * \param fvGridGeometry The finite-volume grid geometry + * \param name Base name of the vtk output */ NewtonConvergenceWriter(const FVGridGeometry& fvGridGeometry, const std::string& name = "newton_convergence") diff --git a/dumux/porousmediumflow/2p2c/sequential/fvpressure.hh b/dumux/porousmediumflow/2p2c/sequential/fvpressure.hh index 10d8df265d560c8ad53e001c9b9370e7c640e077..cbe2b1b257e66cf85d789879a16ebd31ba1e5531 100644 --- a/dumux/porousmediumflow/2p2c/sequential/fvpressure.hh +++ b/dumux/porousmediumflow/2p2c/sequential/fvpressure.hh @@ -897,7 +897,7 @@ void FVPressure2P2C<TypeTag>::getFluxOnBoundary(Dune::FieldVector<Scalar, 2>& en * primary variables. In case the method is called after the Transport, * i.e. at the end / post time step, CellData2p2c.reset() resets the volume * derivatives for the next time step. - * \param elementI The element + * \param element The element * \param postTimeStep Flag indicating if we have just completed a time step */ template<class TypeTag> diff --git a/dumux/porousmediumflow/2pnc/model.hh b/dumux/porousmediumflow/2pnc/model.hh index f7b7ff12d85e3e4cf9df7d26f2e61b8c36359eef..e6cf04b26bf880587e616976ce892191d2e13de0 100644 --- a/dumux/porousmediumflow/2pnc/model.hh +++ b/dumux/porousmediumflow/2pnc/model.hh @@ -28,23 +28,23 @@ * The solid phases. The standard multiphase Darcy * approach is used as the equation for the conservation of momentum: * \f[ - v_\alpha = - \frac{k_{r\alpha}}{\mu_\alpha} \mbox{\bf K} - \left(\text{grad}\, p_\alpha - \varrho_{\alpha} \mbox{\bf g} \right) + * v_\alpha = - \frac{k_{r\alpha}}{\mu_\alpha} \mbox{\bf K} + * \left(\text{grad}\, p_\alpha - \varrho_{\alpha} \mbox{\bf g} \right) * \f] * * By inserting this into the equations for the conservation of the * components, one gets one transport equation for each component - * \f{eqnarray} - && \frac{\partial (\sum_\alpha \varrho_\alpha X_\alpha^\kappa \phi S_\alpha )} - {\partial t} - - \sum_\alpha \text{div} \left\{ \varrho_\alpha X_\alpha^\kappa - \frac{k_{r\alpha}}{\mu_\alpha} \mbox{\bf K} - (\text{grad}\, p_\alpha - \varrho_{\alpha} \mbox{\bf g}) \right\} - \nonumber \\ \nonumber \\ - &-& \sum_\alpha \text{div} \left\{{\bf D_{\alpha, pm}^\kappa} \varrho_{\alpha} \text{grad}\, X^\kappa_{\alpha} \right\} - - \sum_\alpha q_\alpha^\kappa = 0 \qquad \kappa \in \{w, a,\cdots \} \, , - \alpha \in \{w, g\} - \f} + * \f{eqnarray*}{ + * && \frac{\partial (\sum_\alpha \varrho_\alpha X_\alpha^\kappa \phi S_\alpha )} + * {\partial t} + * - \sum_\alpha \text{div} \left\{ \varrho_\alpha X_\alpha^\kappa + * \frac{k_{r\alpha}}{\mu_\alpha} \mbox{\bf K} + * (\text{grad}\, p_\alpha - \varrho_{\alpha} \mbox{\bf g}) \right\} + * \nonumber \\ \nonumber \\ + * &-& \sum_\alpha \text{div} \left\{{\bf D_{\alpha, pm}^\kappa} \varrho_{\alpha} \text{grad}\, X^\kappa_{\alpha} \right\} + * - \sum_\alpha q_\alpha^\kappa = 0 \qquad \kappa \in \{w, a,\cdots \} \, , + * \alpha \in \{w, g\} + * \f} * * The solid or mineral phases are assumed to consist of a single component. * Their mass balance consist only of a storage and a source term: diff --git a/dumux/porousmediumflow/2pncmin/model.hh b/dumux/porousmediumflow/2pncmin/model.hh index 98bf40124ffcc6f8e3ff9b97ca0d3ecafa09c34a..f958a723a6ecd63080b24d91a950c79a960ae88d 100644 --- a/dumux/porousmediumflow/2pncmin/model.hh +++ b/dumux/porousmediumflow/2pncmin/model.hh @@ -28,23 +28,23 @@ * The solid phases. The standard multiphase Darcy * approach is used as the equation for the conservation of momentum: * \f[ - v_\alpha = - \frac{k_{r\alpha}}{\mu_\alpha} \mbox{\bf K} - \left(\text{grad}\, p_\alpha - \varrho_{\alpha} \mbox{\bf g} \right) + * v_\alpha = - \frac{k_{r\alpha}}{\mu_\alpha} \mbox{\bf K} + * \left(\text{grad}\, p_\alpha - \varrho_{\alpha} \mbox{\bf g} \right) * \f] * * By inserting this into the equations for the conservation of the * components, one gets one transport equation for each component - * \f{eqnarray} - && \frac{\partial (\sum_\alpha \varrho_\alpha X_\alpha^\kappa \phi S_\alpha )} - {\partial t} - - \sum_\alpha \text{div} \left\{ \varrho_\alpha X_\alpha^\kappa - \frac{k_{r\alpha}}{\mu_\alpha} \mbox{\bf K} - (\text{grad}\, p_\alpha - \varrho_{\alpha} \mbox{\bf g}) \right\} - \nonumber \\ \nonumber \\ - &-& \sum_\alpha \text{div} \left\{{\bf D_{\alpha, pm}^\kappa} \varrho_{\alpha} \text{grad}\, X^\kappa_{\alpha} \right\} - - \sum_\alpha q_\alpha^\kappa = 0 \qquad \kappa \in \{w, a,\cdots \} \, , - \alpha \in \{w, g\} - \f} + * \f{eqnarray*}{ + * && \frac{\partial (\sum_\alpha \varrho_\alpha X_\alpha^\kappa \phi S_\alpha )} + * {\partial t} + * - \sum_\alpha \text{div} \left\{ \varrho_\alpha X_\alpha^\kappa + * \frac{k_{r\alpha}}{\mu_\alpha} \mbox{\bf K} + * (\text{grad}\, p_\alpha - \varrho_{\alpha} \mbox{\bf g}) \right\} + * \nonumber \\ \nonumber \\ + * &-& \sum_\alpha \text{div} \left\{{\bf D_{\alpha, pm}^\kappa} \varrho_{\alpha} \text{grad}\, X^\kappa_{\alpha} \right\} + * - \sum_\alpha q_\alpha^\kappa = 0 \qquad \kappa \in \{w, a,\cdots \} \, , + * \alpha \in \{w, g\} + * \f} * * The solid or mineral phases are assumed to consist of a single component. * Their mass balance consist only of a storage and a source term: diff --git a/test/freeflow/rans/problem.hh b/test/freeflow/rans/problem.hh index ddbbdbab1289ec2f2c3b46c4cd8922a4a9833617..0d17ceefee170157b2ccad3f88dfa4dd5e163b2e 100644 --- a/test/freeflow/rans/problem.hh +++ b/test/freeflow/rans/problem.hh @@ -252,6 +252,7 @@ public: * \param element The finite element * \param fvGeometry The finite-volume geometry * \param scv The sub control volume + * \param pvIdx The primary variable index in the solution vector */ template<class Element, class FVElementGeometry, class SubControlVolume> bool isDirichletCell(const Element& element, diff --git a/test/freeflow/ransnc/problem.hh b/test/freeflow/ransnc/problem.hh index 1cef2595a92717a636167d83a30ff3d1b74b857b..13df079f3f7e8387ef349ebc51e80b9f8ae730a2 100644 --- a/test/freeflow/ransnc/problem.hh +++ b/test/freeflow/ransnc/problem.hh @@ -264,6 +264,7 @@ public: * \param element The finite element * \param fvGeometry The finite-volume geometry * \param scv The sub control volume + * \param pvIdx The primary variable index in the solution vector */ template<class Element, class FVElementGeometry, class SubControlVolume> bool isDirichletCell(const Element& element, diff --git a/test/porousmediumflow/1p/implicit/convergence/problem.hh b/test/porousmediumflow/1p/implicit/convergence/problem.hh index f0bfd880a92b570db9e19b0b9e34b1edbb39198b..72b99d09f715f8d8718ca2ae02e3cb89e6a0c971 100644 --- a/test/porousmediumflow/1p/implicit/convergence/problem.hh +++ b/test/porousmediumflow/1p/implicit/convergence/problem.hh @@ -181,7 +181,6 @@ public: /*! * \brief Returns the temperature \f$\mathrm{[K]}\f$ for an isothermal problem. - * \param globalPos The center of the finite volume for which it is to be set. */ Scalar temperature() const { return 283.15; } diff --git a/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/convection/problem.hh b/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/convection/problem.hh index 8475502ad83c2519f6f8c79f56db9242f367706e..641744bedc2b87cafe1b1974c676b218262420d0 100644 --- a/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/convection/problem.hh +++ b/test/porousmediumflow/1pnc/implicit/1p2c/nonisothermal/convection/problem.hh @@ -300,6 +300,7 @@ public: * \param element The finite element * \param fvGeometry The finite-volume geometry * \param elemVolVars All volume variables for the element + * \param elemFluxVarsCache The cache related to flux computation * \param scvf The sub-control volume face * * For this method, the \a values parameter stores the flux