diff --git a/dumux/assembly/fclocalresidual.hh b/dumux/assembly/fclocalresidual.hh index 9cb3a237c896212a83e702107ffdfb67051252d5..5e3fca07c947d61e7c9fa6ced7c769a68aa05da6 100644 --- a/dumux/assembly/fclocalresidual.hh +++ b/dumux/assembly/fclocalresidual.hh @@ -51,7 +51,10 @@ public: using ElementResidualVector = typename ParentType::ElementResidualVector; using ParentType::ParentType; - //! evaluate flux residuals for one sub control volume face and add to residual + /*! + * \brief evaluate flux residuals for one sub control volume face and add to residual + * + */ void evalFlux(ElementResidualVector& residual, const Problem& problem, const Element& element, diff --git a/dumux/freeflow/navierstokes/mass/1p/fluxvariables.hh b/dumux/freeflow/navierstokes/mass/1p/fluxvariables.hh index 41090fb6131358ee46170d6b7e6f2594308ec20a..3e9d903712e2f96791d62fdf5ac46ef2a407d937 100644 --- a/dumux/freeflow/navierstokes/mass/1p/fluxvariables.hh +++ b/dumux/freeflow/navierstokes/mass/1p/fluxvariables.hh @@ -50,7 +50,8 @@ class NavierStokesMassOnePFluxVariables public: /*! - * \brief Returns the advective mass flux in kg/s. + * \brief Returns the advective mass flux in kg/s + * or the advective mole flux in mole/s. */ NumEqVector advectiveFlux(int phaseIdx = 0) const { @@ -62,8 +63,10 @@ public: } /*! - * \brief Returns all fluxes for the single-phase flow Navier-Stokes model: the - * advective mass flux in kg/s and the energy flux in J/s (for nonisothermal models). + * \brief Returns all fluxes for the single-phase flow, multi-component + * Navier-Stokes model: the advective mass flux in kg/s + * or the advective mole flux in mole/s and the energy flux + * in J/s (for nonisothermal models). */ NumEqVector flux(int phaseIdx = 0) const { diff --git a/dumux/freeflow/navierstokes/mass/1p/model.hh b/dumux/freeflow/navierstokes/mass/1p/model.hh index 37cb0a205c49e4f7076c628219fa3e67d6f4efc6..ea76285f23e82f1850e2f23bc8dee83c7e8c9c55 100644 --- a/dumux/freeflow/navierstokes/mass/1p/model.hh +++ b/dumux/freeflow/navierstokes/mass/1p/model.hh @@ -73,7 +73,7 @@ struct NavierStokesMassOnePModelTraits //! Enable advection static constexpr bool enableAdvection() { return true; } - //! The one-phase model has no molecular diffusion + //! The one-phase one-component model has no molecular diffusion static constexpr bool enableMolecularDiffusion() { return false; } //! The model is isothermal diff --git a/dumux/freeflow/navierstokes/mass/1p/volumevariables.hh b/dumux/freeflow/navierstokes/mass/1p/volumevariables.hh index 35a2384741b941d0e2da34e8339b64c8fcc330bc..3671f5fc692ac0127ba43290bbb7980c86cdf499 100644 --- a/dumux/freeflow/navierstokes/mass/1p/volumevariables.hh +++ b/dumux/freeflow/navierstokes/mass/1p/volumevariables.hh @@ -137,9 +137,6 @@ public: /*! * \brief Returns the temperature \f$\mathrm{[K]}\f$ inside the sub-control volume. * - * Note that we assume thermodynamic equilibrium, i.e. the - * temperatures of the rock matrix and of all fluid phases are - * identical. */ Scalar temperature() const { return fluidState_.temperature(); } diff --git a/dumux/freeflow/navierstokes/mass/1pnc/advectiveflux.hh b/dumux/freeflow/navierstokes/mass/1pnc/advectiveflux.hh index bf0ad44fd6981733e02d2048fcc89cf631afcbca..f9cb65bb331cb0e0634d841f0bab1f02617e6953 100644 --- a/dumux/freeflow/navierstokes/mass/1pnc/advectiveflux.hh +++ b/dumux/freeflow/navierstokes/mass/1pnc/advectiveflux.hh @@ -65,7 +65,7 @@ struct AdvectiveFlux<NavierStokesMassOnePNCModelTraits<nComp, useM, repCompEqIdx flux[eqIdx] += upwind(upwindTerm); } - // in case one balance is substituted by the total mole balance + // in case one balance is substituted by the total mass balance if constexpr(useTotalMassBalance) { auto upwindTerm = [&]() diff --git a/dumux/freeflow/navierstokes/mass/1pnc/localresidual.hh b/dumux/freeflow/navierstokes/mass/1pnc/localresidual.hh index 3b95c494ed8ad5b42296c2c861689c4c998c1a9d..d1476335d1c19f6e2af72bf5e8ac56f4db62c81a 100644 --- a/dumux/freeflow/navierstokes/mass/1pnc/localresidual.hh +++ b/dumux/freeflow/navierstokes/mass/1pnc/localresidual.hh @@ -93,7 +93,7 @@ public: } /*! - * \brief Evaluatex the mass or mole flux over a face of a sub control volume. + * \brief Evaluates the mass or mole flux over a face of a sub control volume. * * \param problem The problem * \param element The element diff --git a/dumux/freeflow/navierstokes/mass/1pnc/model.hh b/dumux/freeflow/navierstokes/mass/1pnc/model.hh index 34eb915401cd233df275fec0ef100e1c599d5349..251ff8b3ed00aa551c5ccab810ba619637163cb3 100644 --- a/dumux/freeflow/navierstokes/mass/1pnc/model.hh +++ b/dumux/freeflow/navierstokes/mass/1pnc/model.hh @@ -61,7 +61,6 @@ namespace Dumux { * \ingroup NavierStokesModel * \brief Traits for the Navier-Stokes model * - * \tparam dimension The dimension of the problem */ template<int nComp, bool useM, int repCompEqIdx = nComp> struct NavierStokesMassOnePNCModelTraits @@ -73,7 +72,7 @@ struct NavierStokesMassOnePNCModelTraits //! The number of phases is 1 static constexpr int numFluidPhases() { return 1; } - //! The number of components is 1 + //! The number of components can be freely chosen static constexpr int numFluidComponents() { return nComp; } //! Use moles or not diff --git a/dumux/freeflow/navierstokes/mass/1pnc/volumevariables.hh b/dumux/freeflow/navierstokes/mass/1pnc/volumevariables.hh index 9195dd605415430cd28c996a1aead80ce9309c09..20bff1a79dcd939868dd7c72d6c4be7adc19dfa9 100644 --- a/dumux/freeflow/navierstokes/mass/1pnc/volumevariables.hh +++ b/dumux/freeflow/navierstokes/mass/1pnc/volumevariables.hh @@ -158,9 +158,6 @@ public: /*! * \brief Return temperature \f$\mathrm{[K]}\f$ inside the sub-control volume. * - * Note that we assume thermodynamic equilibrium, i.e. the - * temperatures of the rock matrix and of all fluid phases are - * identical. */ Scalar temperature() const { return fluidState_.temperature(); } diff --git a/dumux/freeflow/navierstokes/model.hh b/dumux/freeflow/navierstokes/model.hh index 442a342ae9ffe68ba8197cf47fd25074d9c6dcdd..f0a30d1c50fbebd7ba2b4a8d407a543a087a9b01 100644 --- a/dumux/freeflow/navierstokes/model.hh +++ b/dumux/freeflow/navierstokes/model.hh @@ -77,7 +77,7 @@ struct NavierStokesModelTraits //! Enable advection static constexpr bool enableAdvection() { return true; } - //! The one-phase model has no molecular diffusion + //! The one-phase one-component model has no molecular diffusion static constexpr bool enableMolecularDiffusion() { return false; } //! The model is isothermal diff --git a/dumux/freeflow/navierstokes/momentum/brinkman.hh b/dumux/freeflow/navierstokes/momentum/brinkman.hh index 7cdb3fc020a5b5aa3ec9dda5d7be3c5318658330..784615553278d7f6331a4c15af24bc1ba441e933 100644 --- a/dumux/freeflow/navierstokes/momentum/brinkman.hh +++ b/dumux/freeflow/navierstokes/momentum/brinkman.hh @@ -27,7 +27,7 @@ namespace Dumux { /*! * \file * \ingroup NavierStokesModel - * \brief A helper function to add Brinkman term to the momentum balance + * \brief A helper function to add the Brinkman term to the momentum balance * \addtogroup NavierStokesModel * @{ * The Navier-Stokes model can be extended to a Darcy-Brinkman model by adding @@ -36,7 +36,7 @@ namespace Dumux { + \epsilon_B \mu \mathbf{K}^{-1} \mathbf{v} * \f] * to the momentum balance. This can be achieved with the helper function \ref addBrinkmanTerm. - * The function relies on the spatial parameters class being based on <code>BrinkmanSpatialParams</code> + * This function relies on the spatial parameters class being based on <code>BrinkmanSpatialParams</code> * or providing the `brinkmanEpsilon` and `inversePermeability` interfaces. * These interface functions provide the * weighting factor \f$ \epsilon_B \f$ and the permeability tensor \f$ \mathbf{K} \f$. diff --git a/dumux/freeflow/navierstokes/momentum/cvfe/indices.hh b/dumux/freeflow/navierstokes/momentum/cvfe/indices.hh index 2af3e95f4f5c0ba60ac950994572b9ec0016601f..447d6f674574331adb21662cf14037659d200612 100644 --- a/dumux/freeflow/navierstokes/momentum/cvfe/indices.hh +++ b/dumux/freeflow/navierstokes/momentum/cvfe/indices.hh @@ -29,13 +29,13 @@ struct NavierStokesMomentumCVFEIndices static constexpr auto dim = dimension; - static constexpr int momentumXBalanceIdx = 0; //!< Index of the momentum balance equation - static constexpr int momentumYBalanceIdx = 1; //!< Index of the momentum balance equation - static constexpr int momentumZBalanceIdx = 2; //!< Index of the momentum balance equation + static constexpr int momentumXBalanceIdx = 0; //!< Index of the momentum balance equation x-component + static constexpr int momentumYBalanceIdx = 1; //!< Index of the momentum balance equation y-component + static constexpr int momentumZBalanceIdx = 2; //!< Index of the momentum balance equation z-component - static constexpr int velocityXIdx = 0; //!< Index of the velocity in a solution vector - static constexpr int velocityYIdx = 1; //!< Index of the velocity in a solution vector - static constexpr int velocityZIdx = 2; //!< Index of the velocity in a solution vector + static constexpr int velocityXIdx = 0; //!< Index of the velocity in a solution vector x-component + static constexpr int velocityYIdx = 1; //!< Index of the velocity in a solution vector y-component + static constexpr int velocityZIdx = 2; //!< Index of the velocity in a solution vector z-component /*! * \brief Index of the velocity in a solution vector given a certain direction. diff --git a/dumux/freeflow/navierstokes/momentum/cvfe/localresidual.hh b/dumux/freeflow/navierstokes/momentum/cvfe/localresidual.hh index 77545e408eca53be96df8f6012e750cfd3f1ae2d..721391795e1282d22654e5ee6f44900827b31e62 100644 --- a/dumux/freeflow/navierstokes/momentum/cvfe/localresidual.hh +++ b/dumux/freeflow/navierstokes/momentum/cvfe/localresidual.hh @@ -27,7 +27,7 @@ namespace Dumux { /*! * \ingroup NavierStokesModel - * \brief Element-wise calculation of the Navier-Stokes residual for models using the CVFE discretizations + * \brief Element-wise calculation of the Navier-Stokes residual for models using CVFE discretizations */ template<class TypeTag> class NavierStokesMomentumCVFELocalResidual @@ -72,7 +72,7 @@ public: using ParentType::ParentType; /*! - * \brief Calculate the source term of the equation + * \brief Calculate the storage term of the equation * * \param problem The problem to solve * \param fvGeometry The finite-volume geometry of the element @@ -112,7 +112,7 @@ public: // add rho*g (note that gravity might be zero in case it's disabled in the problem) source += problem.density(element, fvGeometry, scv) * problem.gravity(); - // Axisymmetric problems in 2D feature an extra source terms arising from the transformation to cylindrical coordinates. + // Axisymmetric problems in 2D feature an extra source term arising from the transformation to cylindrical coordinates. // See Ferziger/Peric: Computational methods for Fluid Dynamics (2020) // https://doi.org/10.1007/978-3-319-99693-6 // Chapter 9.9 and Eq. (9.81) and comment on finite volume methods @@ -122,7 +122,7 @@ public: const auto r = scv.center()[Extrusion::radialAxis] - fvGeometry.gridGeometry().bBoxMin()[Extrusion::radialAxis]; // The velocity term is new with respect to Cartesian coordinates and handled below as a source term - // it only enters the balance of the momentum balance in radial direction + // It only enters the balance of the momentum balance in radial direction source[Extrusion::radialAxis] += -2.0*problem.effectiveViscosity(element, fvGeometry, scv) * elemVolVars[scv].velocity(Extrusion::radialAxis) / (r*r); diff --git a/dumux/freeflow/navierstokes/momentum/localresidual.hh b/dumux/freeflow/navierstokes/momentum/localresidual.hh index 8c1f7784a414ebfb2f0acee860006bed6a5dd777..a05ddb7525d7c277921fa5ca1313fc8ba741056b 100644 --- a/dumux/freeflow/navierstokes/momentum/localresidual.hh +++ b/dumux/freeflow/navierstokes/momentum/localresidual.hh @@ -130,7 +130,7 @@ public: } /*! - * \brief Evaluates the mass flux over a face of a sub control volume. + * \brief Evaluates the momentum flux over a face of a sub control volume. * * \param problem The problem * \param element The element diff --git a/dumux/freeflow/navierstokes/momentum/problem.hh b/dumux/freeflow/navierstokes/momentum/problem.hh index 3df164689440324574c54359478b6974014d0f25..914b31eaec81c061bb3611099e24386a959c8b0e 100644 --- a/dumux/freeflow/navierstokes/momentum/problem.hh +++ b/dumux/freeflow/navierstokes/momentum/problem.hh @@ -365,7 +365,7 @@ public: } /*! - * \brief Evaluate the initial value at an sub control volume + * \brief Evaluate the initial value at a sub control volume */ InitialValues initial(const SubControlVolume& scv) const { @@ -395,7 +395,7 @@ public: * Here, \f$h\f$ corresponds to the extruded height that is * bounded by the imaginary walls. See Flekkoy et al. (1995) \cite flekkoy1995a<BR> * A value of 8.0 is used as a default factor, corresponding - * to the velocity profile at the center plane + * to the velocity profile at the center plane * of the virtual height (maximum velocity). Setting this value to 12.0 corresponds * to an depth-averaged velocity (Venturoli and Boek, 2006) \cite venturoli2006a. */ @@ -472,7 +472,7 @@ public: /*! * \brief Returns the slip velocity at a porous boundary based on the Beavers-Joseph(-Saffman) condition. - * \note This only returns a vector filled with one component of the slip velocity (corresponding to the dof axis of the scv the svf belongs to) + * \note This only returns a vector filled with one component of the slip velocity (corresponding to the dof axis of the scv the scvf belongs to) */ [[deprecated("Will be removed after release 3.9.")]] const VelocityVector beaversJosephVelocity(const FVElementGeometry& fvGeometry, @@ -640,8 +640,7 @@ public: } /*! - * \brief Evaluate the source term for all phases within a given - * sub-control-volume. + * \brief Evaluate the source term for all phases at a given position * * \param globalPos The position of the center of the finite volume * for which the source term ought to be diff --git a/dumux/freeflow/navierstokes/scalarfluxhelper.hh b/dumux/freeflow/navierstokes/scalarfluxhelper.hh index 9215573b4a936f5225a8fdb4dce43fa7aa0fb269..224f2ec5db8a0f77056e164f788388d677ef05c0 100644 --- a/dumux/freeflow/navierstokes/scalarfluxhelper.hh +++ b/dumux/freeflow/navierstokes/scalarfluxhelper.hh @@ -128,7 +128,7 @@ struct NavierStokesScalarBoundaryFluxHelper /*! * \brief Return the area-specific outflow fluxes for all scalar balance equations. - * This should only be used of flow reversal does never occur. + * This should only be used if flow reversal never occurs. * A (deactivable) warning is emitted otherwise. */ template<class Problem, class Element, class FVElementGeometry, class ElementVolumeVariables> @@ -157,7 +157,7 @@ struct NavierStokesScalarBoundaryFluxHelper std::cout << "\n ********** WARNING ********** \n\n" "Outflow condition set at " << scvf.center() << " might be invalid due to flow reversal. " "Consider using \n" - "outflowFlux(problem, element, fvGeometry, scvf, elemVolVars, outsideBoundaryPriVars, upwindWeight) \n" + "scalarOutflowFlux(problem, element, fvGeometry, scvf, elemVolVars, outsideBoundaryPriVars, upwindWeight) \n" "instead where you can specify primary variables for inflow situations.\n" "\n ***************************** \n" << std::endl; } diff --git a/dumux/freeflow/navierstokes/scalarfluxvariablescachefiller.hh b/dumux/freeflow/navierstokes/scalarfluxvariablescachefiller.hh index 169188629fc5a59af2173edd34a43a2dcee29c88..8bc55bda4e87a2be2f7bdb9e5f39a1529a1e3842 100644 --- a/dumux/freeflow/navierstokes/scalarfluxvariablescachefiller.hh +++ b/dumux/freeflow/navierstokes/scalarfluxvariablescachefiller.hh @@ -30,7 +30,7 @@ class FreeFlowScalarFluxVariablesCacheFillerImplementation; * \ingroup NavierStokesModel * \brief The flux variables cache filler class for free flow * - * Helps filling the flux variables cache depending several policies + * Helps filling the flux variables cache depending on several policies */ template<class Problem, class ModelTraits, bool diffusionIsSolDependent, bool heatConductionIsSolDependent> using FreeFlowScalarFluxVariablesCacheFiller = FreeFlowScalarFluxVariablesCacheFillerImplementation<Problem, ModelTraits, diffusionIsSolDependent, heatConductionIsSolDependent, typename ProblemTraits<Problem>::GridGeometry::DiscretizationMethod>; diff --git a/dumux/freeflow/navierstokes/staggered/fluxvariables.hh b/dumux/freeflow/navierstokes/staggered/fluxvariables.hh index c5caf13bbb9f826cd1043f328591af7aff04c2cf..78e2fd35e5d364dedc5f551fa634c662fafd6c57 100644 --- a/dumux/freeflow/navierstokes/staggered/fluxvariables.hh +++ b/dumux/freeflow/navierstokes/staggered/fluxvariables.hh @@ -99,7 +99,7 @@ public: * \param elemVolVars All volume variables for the element * \param elemFaceVars The face variables * \param scvf The sub control volume face - * \param upwindTerm The uwind term (i.e. the advectively transported quantity) + * \param upwindTerm The upwind term (i.e. the advectively transported quantity) */ template<class UpwindTerm> static Scalar advectiveFluxForCellCenter(const Problem& problem, diff --git a/dumux/freeflow/navierstokes/volumevariables.hh b/dumux/freeflow/navierstokes/volumevariables.hh index b534e5273415a24c464d508e15125779df5900a5..5d9a0036c67732ff71720ad7847b3bb3af242d46 100644 --- a/dumux/freeflow/navierstokes/volumevariables.hh +++ b/dumux/freeflow/navierstokes/volumevariables.hh @@ -107,9 +107,6 @@ public: /*! * \brief Return temperature \f$\mathrm{[K]}\f$ inside the sub-control volume. * - * Note that we assume thermodynamic equilibrium, i.e. the - * temperatures of the rock matrix and of all fluid phases are - * identical. */ Scalar temperature() const { return fluidState_.temperature(); } diff --git a/dumux/freeflow/shallowwater/indices.hh b/dumux/freeflow/shallowwater/indices.hh index 521f4e8f2b554613530259d6a841f4fdf397a5c3..f8f0fe97e30e74d72e33c3e20964047fca77d85c 100644 --- a/dumux/freeflow/shallowwater/indices.hh +++ b/dumux/freeflow/shallowwater/indices.hh @@ -29,8 +29,8 @@ struct ShallowWaterIndices static constexpr int momentumYBalanceIdx = 2; //!< Index of the y momentum balance equation static constexpr int waterdepthIdx = massBalanceIdx; //!< Index of the velocity in a solution vector - static constexpr int velocityXIdx = momentumXBalanceIdx; //!< Index of the velocity in a solution vector - static constexpr int velocityYIdx = momentumYBalanceIdx; //!< Index of the velocity in a solution vector + static constexpr int velocityXIdx = momentumXBalanceIdx; //!< Index of the x velocity in a solution vector + static constexpr int velocityYIdx = momentumYBalanceIdx; //!< Index of the y velocity in a solution vector static constexpr int velocityOffset = velocityXIdx; //!< Offset for the velocity index }; diff --git a/test/freeflow/navierstokesnc/channel/main.cc b/test/freeflow/navierstokesnc/channel/main.cc index f313120b59c3db6240c362516d324d65feac825e..787190203049c721be5277903a3cd382565f5251 100644 --- a/test/freeflow/navierstokesnc/channel/main.cc +++ b/test/freeflow/navierstokesnc/channel/main.cc @@ -35,11 +35,6 @@ #include <dumux/io/vtkoutputmodule.hh> #include <dumux/freeflow/navierstokes/velocityoutput.hh> - -#include <dumux/multidomain/fvassembler.hh> -#include <dumux/multidomain/traits.hh> -#include <dumux/multidomain/newtonsolver.hh> - #include "properties.hh" int main(int argc, char** argv) diff --git a/test/freeflow/navierstokesnc/channel/problem.hh b/test/freeflow/navierstokesnc/channel/problem.hh index 485749e1d3817634e9b3704992fa4c275e867dac..af2786f5adcd91adeef3feebf9f0ef3d502994fa 100644 --- a/test/freeflow/navierstokesnc/channel/problem.hh +++ b/test/freeflow/navierstokesnc/channel/problem.hh @@ -130,11 +130,15 @@ public: const auto& globalPos = scvf.ipGlobal(); DirichletValues values = initialAtPos(globalPos); - if constexpr (!ParentType::isMomentumProblem()) + if constexpr (!ParentType::isMomentumProblem()) // mass problem { // give the system some time so that the pressure can equilibrate, then start the injection of the tracer if (isInlet_(globalPos)) { + // With respect to implementation, pressure is treated as if it were a dirichlet condition. + // As we want to prescribe the velocity profile in the inlet, we cannot fix the pressure at the same time. + // Therefore, the coupling manager is used to get the pressure from the momentum problem and use it as + // entry for the dirichlet condition in the mass problem. values[Indices::pressureIdx] = this->couplingManager().cellPressure(element, scvf); if (time() >= 10.0 || inletVelocity_ < eps_) diff --git a/test/freeflow/navierstokesnc/channel/properties.hh b/test/freeflow/navierstokesnc/channel/properties.hh index 60e537702ed02feaf8f6826cb524bb0e09f745c0..3645f3c04c77baa6ee053f0b763c7cfa0a32dc5c 100644 --- a/test/freeflow/navierstokesnc/channel/properties.hh +++ b/test/freeflow/navierstokesnc/channel/properties.hh @@ -93,7 +93,7 @@ struct EnableGridFaceVariablesCache<TypeTag, TTag::ChannelNCTest> { static const template<class TypeTag> struct UseMoles<TypeTag, TTag::ChannelNCTest> { static constexpr bool value = USEMOLES; }; -// Set the problem property +// Set the coupling manager template<class TypeTag> struct CouplingManager<TypeTag, TTag::ChannelNCTest> { diff --git a/test/freeflow/navierstokesnc/maxwellstefan/properties.hh b/test/freeflow/navierstokesnc/maxwellstefan/properties.hh index 55469cf76ce595abc8c36a403f81fbec6c6b91c7..909d0abffe90db1421e1001df868846dd260b0e9 100644 --- a/test/freeflow/navierstokesnc/maxwellstefan/properties.hh +++ b/test/freeflow/navierstokesnc/maxwellstefan/properties.hh @@ -197,6 +197,7 @@ public: template<class TypeTag> struct FluidSystem<TypeTag, TTag::MaxwellStefanNCTest> { using type = MaxwellStefanFluidSystem<TypeTag>; }; +// Set the coupling manager template<class TypeTag> struct CouplingManager<TypeTag, TTag::MaxwellStefanNCTest> { diff --git a/test/freeflow/rans/problem.hh b/test/freeflow/rans/problem.hh index 278cc850d58df52b6f106d0750344475ffc5a5c1..c276b07ced21027f37acedd5c2369a2725ca1bc1 100644 --- a/test/freeflow/rans/problem.hh +++ b/test/freeflow/rans/problem.hh @@ -135,7 +135,7 @@ public: } /*! - * \brief Returns whether a fixed Dirichlet value shall be used at a given cell. + * \brief Returns whether a fixed Dirichlet value shall be used inside a given cell. * * \param element The finite element * \param fvGeometry The finite-volume geometry @@ -150,7 +150,7 @@ public: { return isDirichletCell_(element, fvGeometry, scv, pvIdx); } /*! - * \brief Evaluate the boundary conditions for a dirichlet values at the boundary. + * \brief Evaluate the boundary conditions for dirichlet values at the given boundary. * * \param element The finite element * \param scvf the sub control volume face @@ -190,7 +190,7 @@ public: } /*! - * \brief Evaluate the initial value for a control volume. + * \brief Evaluate the initial value at the given global position. * * \param globalPos The global position */ diff --git a/test/freeflow/ransnc/problem.hh b/test/freeflow/ransnc/problem.hh index 2e3aafe1084d02eacd397eca7a01dc8a25ebc8c8..ef92302e5a2213c538c825170516af38d9888d3d 100644 --- a/test/freeflow/ransnc/problem.hh +++ b/test/freeflow/ransnc/problem.hh @@ -145,7 +145,7 @@ public: } /*! - * \brief Returns whether a fixed Dirichlet value shall be used at a given cell. + * \brief Returns whether a fixed Dirichlet value shall be used inside a given cell. * * \param element The finite element * \param fvGeometry The finite-volume geometry @@ -160,7 +160,7 @@ public: { return isDirichletCell_(element, fvGeometry, scv, pvIdx); } /*! - * \brief Evaluate the boundary conditions for a dirichlet values at the boundary. + * \brief Evaluate the boundary conditions for dirichlet values at the given boundary. * * \param element The finite element * \param scvf the sub control volume face @@ -207,7 +207,7 @@ public: } /*! - * \brief Evaluates the initial value for a control volume. + * \brief Evaluates the initial value for a given position. * * \param globalPos The global position */ diff --git a/test/freeflow/shallowwater/bowl/main.cc b/test/freeflow/shallowwater/bowl/main.cc index 9ac533f8d6aa0b86241efa6d3dc1bb181fd365b9..9e93a59d7000c67a9d9b7d59a8dc64519c124565 100644 --- a/test/freeflow/shallowwater/bowl/main.cc +++ b/test/freeflow/shallowwater/bowl/main.cc @@ -167,7 +167,7 @@ int main(int argc, char** argv) const auto maxDt = getParam<Scalar>("TimeLoop.MaxTimeStepSize"); auto dt = getParam<Scalar>("TimeLoop.DtInitial"); - // initialize the vtk output module and analytical solution + // initialize the vtk output module and the analytical solution VtkOutputModule<GridVariables, SolutionVector> vtkWriter(*gridVariables,x, problem->name()); auto exactSolution = computeAnalyticalSolution<SolutionVector>(0.0, *problem); const auto exactWaterDepth = SolutionComponent<SolutionVector, 0>(exactSolution);