From 625d794eddf4afd86bfbf02f0596d04033395eeb Mon Sep 17 00:00:00 2001
From: Bernd Flemisch <bernd@iws.uni-stuttgart.de>
Date: Tue, 19 Dec 2017 11:55:41 +0100
Subject: [PATCH] [doc] fix Doxygen comments in code lines

The Doxygen comment `//!` refers to the line after the comment. If
the comment should refer to the same line, `//!<` has to be used.
---
 dumux/adaptive/initializationindicator.hh     |  32 ++--
 dumux/common/pointsource.hh                   |   6 +-
 dumux/common/properties.hh                    | 180 +++++++++---------
 dumux/discretization/box/boxgeometryhelper.hh |  46 ++---
 .../cellcentered/mpfa/helper.hh               |   8 +-
 .../mpfa/interactionvolumebase.hh             |  12 +-
 .../mpfa/interactionvolumedatahandle.hh       |  24 +--
 .../mpfa/omethod/interactionvolume.hh         |   2 +-
 dumux/discretization/fluxvariablesbase.hh     |  12 +-
 .../freeflow/staggeredgeometryhelper.hh       |   8 +-
 .../staggered/subcontrolvolumeface.hh         |   4 +-
 dumux/freeflow/navierstokes/model.hh          |   6 +-
 dumux/freeflow/navierstokesnc/model.hh        |   6 +-
 dumux/io/vtkoutputmodule.hh                   |   4 +-
 dumux/linear/amgparallelhelpers.hh            |  12 +-
 dumux/porousmediumflow/1pnc/model.hh          |  30 +--
 dumux/porousmediumflow/2p/model.hh            |  32 ++--
 dumux/porousmediumflow/2p1c/model.hh          |   6 +-
 .../2p2c/sequential/adaptiveproperties.hh     |   2 +-
 .../2p2c/sequential/fvpressure.hh             |   4 +-
 .../sequential/fvpressurecompositional.hh     |   2 +-
 .../2p2c/sequential/fvpressuremultiphysics.hh |   2 +-
 dumux/porousmediumflow/2pnc/model.hh          |  44 ++---
 dumux/porousmediumflow/2pncmin/model.hh       |   8 +-
 .../porousmediumflow/3pwateroil/properties.hh |   6 +-
 .../porousmediumflow/nonisothermal/indices.hh |   4 +-
 dumux/porousmediumflow/richards/model.hh      |   2 +-
 .../richards/volumevariables.hh               |  16 +-
 dumux/porousmediumflow/richardsnc/model.hh    |   2 +-
 .../richardsnc/volumevariables.hh             |  12 +-
 test/freeflow/staggered/test_angeli.cc        |   2 +-
 test/freeflow/staggered/test_channel.cc       |   2 +-
 test/freeflow/staggered/test_closedsystem.cc  |   2 +-
 test/freeflow/staggered/test_donea.cc         |   2 +-
 test/freeflow/staggered/test_kovasznay.cc     |   2 +-
 test/freeflow/staggerednc/test_channel.cc     |   2 +-
 .../staggerednc/test_densitydrivenflow.cc     |   2 +-
 .../1p/implicit/compressible/test_1p.cc       |   2 +-
 .../compressible/test_1p_stationary.cc        |   2 +-
 .../1p/implicit/incompressible/test_1pfv.cc   |   2 +-
 .../pointsources/test_1pfv_pointsources.cc    |   2 +-
 .../test_1pfv_pointsources_timedependent.cc   |   2 +-
 .../porousmediumflow/1p/implicit/test_1pfv.cc |   2 +-
 .../1p/implicit/test_1pfv_fracture2d3d.cc     |   2 +-
 .../1p/implicit/test_1pfv_network1d3d.cc      |   2 +-
 .../1p/implicit/test_1pnifv.cc                |   2 +-
 .../1pnc/implicit/test_1p2c_fv.cc             |   2 +-
 .../implicit/test_1p2cni_conduction_fv.cc     |   2 +-
 .../implicit/test_1p2cni_convection_fv.cc     |   2 +-
 .../implicit/adaptive/test_2p_adaptive_fv.cc  |  24 +--
 .../implicit/fracture/test_2p_fracture_fv.cc  |   2 +-
 .../2p/implicit/incompressible/test_2p_fv.cc  |   2 +-
 .../2p/implicit/nonisothermal/test_2pni_fv.cc |   2 +-
 .../2p1c/implicit/test_2p1c_fv.cc             |   2 +-
 .../2p2c/implicit/test_2p2c_fv.cc             |   2 +-
 .../2pnc/implicit/test_2pnc_fv.cc             |   4 +-
 .../2pncmin/implicit/dissolutionproblem.hh    |   2 +-
 .../2pncmin/implicit/test_2pncmin_fv.cc       |   2 +-
 .../3p/implicit/test_3p_fv.cc                 |   2 +-
 .../3p/implicit/test_3pni_fv_conduction.cc    |   2 +-
 .../3p/implicit/test_3pni_fv_convection.cc    |   2 +-
 .../3p3c/implicit/test_3p3c_fv.cc             |   2 +-
 .../co2/implicit/test_co2_fv.cc               |   4 +-
 .../implicit/test_ccrichardsanalytical.cc     |   2 +-
 .../richards/implicit/test_richardslens_fv.cc |   2 +-
 .../implicit/test_richardsniconduction_fv.cc  |   2 +-
 .../implicit/test_richardsniconvection_fv.cc  |   2 +-
 .../richardsnc/implicit/test_richardsnc_fv.cc |   2 +-
 .../tracer/1ptracer/test_cctracer.cc          |   2 +-
 .../tracer/constvel/test_tracer.cc            |   2 +-
 70 files changed, 320 insertions(+), 320 deletions(-)

diff --git a/dumux/adaptive/initializationindicator.hh b/dumux/adaptive/initializationindicator.hh
index 3571568892..7539d74b90 100644
--- a/dumux/adaptive/initializationindicator.hh
+++ b/dumux/adaptive/initializationindicator.hh
@@ -148,7 +148,7 @@ public:
             if (element.level() < minLevel_)
             {
                 indicatorVector_[eIdx] = true;
-                continue; //! proceed to the next element
+                continue; //!< proceed to the next element
             }
 
             //! If refinement at sources/BCs etc is deactivated, skip the rest
@@ -175,7 +175,7 @@ public:
                     if (source.infinity_norm() > eps_)
                     {
                         indicatorVector_[eIdx] = true;
-                        break; //! element is marked, escape scv loop
+                        break; //!< element is marked, escape scv loop
                     }
                 }
             }
@@ -199,7 +199,7 @@ public:
                         if(bcTypes.hasOnlyDirichlet() && refineAtDirichletBC_)
                         {
                             indicatorVector_[eIdx] = true;
-                            break; //! element is marked, escape scvf loop
+                            break; //!< element is marked, escape scvf loop
                         }
 
                         //! we are on a pure Neumann boundary
@@ -209,7 +209,7 @@ public:
                             if (fluxes.infinity_norm() > eps_)
                             {
                                 indicatorVector_[eIdx] = true;
-                                break; //! element is marked, escape scvf loop
+                                break; //!< element is marked, escape scvf loop
                             }
                         }
                     }
@@ -227,7 +227,7 @@ public:
                         if (refineAtDirichletBC_ && bcTypes[scv.indexInElement()].hasDirichlet())
                         {
                             indicatorVector_[eIdx] = true;
-                            break; //! element is marked, escape scv loop
+                            break; //!< element is marked, escape scv loop
                         }
                     }
 
@@ -243,7 +243,7 @@ public:
                                 if (fluxes.infinity_norm() > eps_)
                                 {
                                     indicatorVector_[eIdx] = true;
-                                    break; //! element is marked, escape scvf loop
+                                    break; //!< element is marked, escape scvf loop
                                 }
                             }
                         }
@@ -272,17 +272,17 @@ public:
     }
 
 private:
-    std::shared_ptr<const Problem> problem_;               //! The problem to be solved
-    std::shared_ptr<const FVGridGeometry> fvGridGeometry_; //! The finite volume grid geometry
-    std::shared_ptr<const GridVariables> gridVariables_;   //! The secondary variables on the grid
-    std::vector<bool> indicatorVector_;                    //! Indicator for BCs/sources
+    std::shared_ptr<const Problem> problem_;               //!< The problem to be solved
+    std::shared_ptr<const FVGridGeometry> fvGridGeometry_; //!< The finite volume grid geometry
+    std::shared_ptr<const GridVariables> gridVariables_;   //!< The secondary variables on the grid
+    std::vector<bool> indicatorVector_;                    //!< Indicator for BCs/sources
 
-    int minLevel_;             //! The minimum allowed level
-    int maxLevel_;             //! The maximum allowed level
-    bool refineAtDirichletBC_; //! Specifies if it should be refined at Dirichlet BCs
-    bool refineAtFluxBC_;      //! Specifies if it should be refined at non-zero Neumann BCs
-    bool refineAtSource_;      //! Specifies if it should be refined at sources
-    Scalar eps_;               //! Threshold for refinement at sources/BCS
+    int minLevel_;             //!< The minimum allowed level
+    int maxLevel_;             //!< The maximum allowed level
+    bool refineAtDirichletBC_; //!< Specifies if it should be refined at Dirichlet BCs
+    bool refineAtFluxBC_;      //!< Specifies if it should be refined at non-zero Neumann BCs
+    bool refineAtSource_;      //!< Specifies if it should be refined at sources
+    Scalar eps_;               //!< Threshold for refinement at sources/BCS
 };
 
 }
diff --git a/dumux/common/pointsource.hh b/dumux/common/pointsource.hh
index bcda706a4d..b2ed400a45 100644
--- a/dumux/common/pointsource.hh
+++ b/dumux/common/pointsource.hh
@@ -150,10 +150,10 @@ public:
     }
 
 protected:
-    PrimaryVariables values_; //! value of the point source for each equation
+    PrimaryVariables values_; //!< value of the point source for each equation
 private:
-    GlobalPosition pos_; //! position of the point source
-    std::size_t embeddings_; //! how many SCVs the point source is associated with
+    GlobalPosition pos_; //!< position of the point source
+    std::size_t embeddings_; //!< how many SCVs the point source is associated with
 };
 
 /*!
diff --git a/dumux/common/properties.hh b/dumux/common/properties.hh
index c2d7c37f55..def2fb54f8 100644
--- a/dumux/common/properties.hh
+++ b/dumux/common/properties.hh
@@ -38,27 +38,27 @@ namespace Properties
 ///////////////////////////////////////
 // Basic properties of numeric models:
 ///////////////////////////////////////
-NEW_PROP_TAG(Scalar);                 //! Property to specify the type of scalar values.
-NEW_PROP_TAG(ModelParameterGroup);    //! Property which defines the group that is queried for parameters by default
-NEW_PROP_TAG(ModelDefaultParameters); //! Property which defines the group that is queried for parameters by default
-NEW_PROP_TAG(GridCreator);            //! Property which provides a GridCreator (manages grids)
-NEW_PROP_TAG(Grid);                   //! The DUNE grid type
-NEW_PROP_TAG(NumEq);                  //! The number of equations to solve (equal to number of primary variables)
-NEW_PROP_TAG(Indices);                //! Enumerations for the numeric model
-NEW_PROP_TAG(PrimaryVariables);       //! A vector of primary variables
-NEW_PROP_TAG(NumEqVector);            //! A vector of size number equations that can be used for Neumann fluxes, sources, residuals, ...
-NEW_PROP_TAG(GridView);               //! The type of the grid view according to the grid type
-NEW_PROP_TAG(Problem);                //! Property to specify the type of a problem which has to be solved
-NEW_PROP_TAG(PointSource);            //! Property defining the type of point source used
-NEW_PROP_TAG(PointSourceHelper);      //! Property defining the class that computes which sub control volume point sources belong to
-NEW_PROP_TAG(VtkOutputFields);        //! A class helping models to define default vtk output parameters
-NEW_PROP_TAG(BaseLocalResidual);      //! The type of the base class of the local residual (specific to a discretization scheme)
-NEW_PROP_TAG(JacobianMatrix);         //! Type of the global jacobian matrix
-NEW_PROP_TAG(SolutionVector);         //! Vector containing all primary variable vector of the grid
-NEW_PROP_TAG(BoundaryTypes);          //! Stores the boundary types of a single degree of freedom
-NEW_PROP_TAG(DiscretizationMethod);   //! Property for the used discretization method
-NEW_PROP_TAG(VertexMapper);           //! mapper for vertices
-NEW_PROP_TAG(ElementMapper);          //! mapper for elements
+NEW_PROP_TAG(Scalar);                 //!< Property to specify the type of scalar values.
+NEW_PROP_TAG(ModelParameterGroup);    //!< Property which defines the group that is queried for parameters by default
+NEW_PROP_TAG(ModelDefaultParameters); //!< Property which defines the group that is queried for parameters by default
+NEW_PROP_TAG(GridCreator);            //!< Property which provides a GridCreator (manages grids)
+NEW_PROP_TAG(Grid);                   //!< The DUNE grid type
+NEW_PROP_TAG(NumEq);                  //!< The number of equations to solve (equal to number of primary variables)
+NEW_PROP_TAG(Indices);                //!< Enumerations for the numeric model
+NEW_PROP_TAG(PrimaryVariables);       //!< A vector of primary variables
+NEW_PROP_TAG(NumEqVector);            //!< A vector of size number equations that can be used for Neumann fluxes, sources, residuals, ...
+NEW_PROP_TAG(GridView);               //!< The type of the grid view according to the grid type
+NEW_PROP_TAG(Problem);                //!< Property to specify the type of a problem which has to be solved
+NEW_PROP_TAG(PointSource);            //!< Property defining the type of point source used
+NEW_PROP_TAG(PointSourceHelper);      //!< Property defining the class that computes which sub control volume point sources belong to
+NEW_PROP_TAG(VtkOutputFields);        //!< A class helping models to define default vtk output parameters
+NEW_PROP_TAG(BaseLocalResidual);      //!< The type of the base class of the local residual (specific to a discretization scheme)
+NEW_PROP_TAG(JacobianMatrix);         //!< Type of the global jacobian matrix
+NEW_PROP_TAG(SolutionVector);         //!< Vector containing all primary variable vector of the grid
+NEW_PROP_TAG(BoundaryTypes);          //!< Stores the boundary types of a single degree of freedom
+NEW_PROP_TAG(DiscretizationMethod);   //!< Property for the used discretization method
+NEW_PROP_TAG(VertexMapper);           //!< mapper for vertices
+NEW_PROP_TAG(ElementMapper);          //!< mapper for elements
 
 //! The type of the local residual function, i.e. the equation to be solved. Must inherit
 //! from the BaseLocalResidual property and fulfill its interfaces.
@@ -66,79 +66,79 @@ NEW_PROP_TAG(LocalResidual);
 
 //! TODO: Remove this property as soon as the decoupled models are integrated
 NEW_PROP_TAG(LinearSolver);
-NEW_PROP_TAG(LinearSolverPreconditionerBlockLevel); //! Block level depth for the preconditioner
+NEW_PROP_TAG(LinearSolverPreconditionerBlockLevel); //!< Block level depth for the preconditioner
 
 ////////////////////////////////////////////////
 // Basic properties regarding balance equations
 /////////////////////////////////////////////////
 // TODO: Integrate UseMoles into BalanceEqOpts
-NEW_PROP_TAG(UseMoles);               //! Property whether to use moles or kg as amount unit for balance equations
-NEW_PROP_TAG(ReplaceCompEqIdx);       //! The component balance index that should be replaced by the total mass/mole balance
-NEW_PROP_TAG(BalanceEqOpts);          //! A class that collects options for the evaluation of the balance equations
+NEW_PROP_TAG(UseMoles);               //!< Property whether to use moles or kg as amount unit for balance equations
+NEW_PROP_TAG(ReplaceCompEqIdx);       //!< The component balance index that should be replaced by the total mass/mole balance
+NEW_PROP_TAG(BalanceEqOpts);          //!< A class that collects options for the evaluation of the balance equations
 
 /////////////////////////////////////////////
 // Properties used by finite volume schemes:
 /////////////////////////////////////////////
-NEW_PROP_TAG(ElementBoundaryTypes);                //! Stores the boundary types on an element
-NEW_PROP_TAG(ElementSolutionVector);               //! A vector of primary variables within an element
-NEW_PROP_TAG(AssemblyMap);                         //! Connectivity map (transposed) used for assembling the Jacobian matrix entries
-
-NEW_PROP_TAG(SubControlVolume);                    //! The type of the sub control volume
-NEW_PROP_TAG(SubControlVolumeFace);                //! The type of the sub control volume face
-NEW_PROP_TAG(FVElementGeometry);                   //! The type of the local finite volume geometry (iterators over scvs, scvfs)
-NEW_PROP_TAG(FVGridGeometry);                      //! The type of the global finite volume geometry
-NEW_PROP_TAG(EnableFVGridGeometryCache);           //! specifies if geometric data is saved (faster, but more memory consuming)
-
-NEW_PROP_TAG(VolumeVariables);                     //! The secondary variables within a sub-control volume
-NEW_PROP_TAG(ElementVolumeVariables);              //! The type for a local (element/stencil) container for the volume variables
-NEW_PROP_TAG(GridVolumeVariables);                 //! The type for a global container for the volume variables
-NEW_PROP_TAG(EnableGridVolumeVariablesCache);      //! If disabled, the volume variables are not stored (reduces memory, but is slower)
-NEW_PROP_TAG(FluxVariables);                       //! Container storing the different types of flux variables
-NEW_PROP_TAG(FluxVariablesCache);                  //! Stores data associated with flux vars
-NEW_PROP_TAG(ElementFluxVariablesCache);           //! A local vector of flux variable caches per element
-NEW_PROP_TAG(GridFluxVariablesCache);              //! The global vector of flux variable containers
-NEW_PROP_TAG(EnableGridFluxVariablesCache);        //! specifies if data on flux vars should be saved (faster, but more memory consuming)
-NEW_PROP_TAG(GridVariables);                       //! The grid variables object managing variable data on the grid (volvars/fluxvars cache)
+NEW_PROP_TAG(ElementBoundaryTypes);                //!< Stores the boundary types on an element
+NEW_PROP_TAG(ElementSolutionVector);               //!< A vector of primary variables within an element
+NEW_PROP_TAG(AssemblyMap);                         //!< Connectivity map (transposed) used for assembling the Jacobian matrix entries
+
+NEW_PROP_TAG(SubControlVolume);                    //!< The type of the sub control volume
+NEW_PROP_TAG(SubControlVolumeFace);                //!< The type of the sub control volume face
+NEW_PROP_TAG(FVElementGeometry);                   //!< The type of the local finite volume geometry (iterators over scvs, scvfs)
+NEW_PROP_TAG(FVGridGeometry);                      //!< The type of the global finite volume geometry
+NEW_PROP_TAG(EnableFVGridGeometryCache);           //!< specifies if geometric data is saved (faster, but more memory consuming)
+
+NEW_PROP_TAG(VolumeVariables);                     //!< The secondary variables within a sub-control volume
+NEW_PROP_TAG(ElementVolumeVariables);              //!< The type for a local (element/stencil) container for the volume variables
+NEW_PROP_TAG(GridVolumeVariables);                 //!< The type for a global container for the volume variables
+NEW_PROP_TAG(EnableGridVolumeVariablesCache);      //!< If disabled, the volume variables are not stored (reduces memory, but is slower)
+NEW_PROP_TAG(FluxVariables);                       //!< Container storing the different types of flux variables
+NEW_PROP_TAG(FluxVariablesCache);                  //!< Stores data associated with flux vars
+NEW_PROP_TAG(ElementFluxVariablesCache);           //!< A local vector of flux variable caches per element
+NEW_PROP_TAG(GridFluxVariablesCache);              //!< The global vector of flux variable containers
+NEW_PROP_TAG(EnableGridFluxVariablesCache);        //!< specifies if data on flux vars should be saved (faster, but more memory consuming)
+NEW_PROP_TAG(GridVariables);                       //!< The grid variables object managing variable data on the grid (volvars/fluxvars cache)
 
 /////////////////////////////////////////////////////////////////
 // Additional properties used by the cell-centered mpfa schemes:
 /////////////////////////////////////////////////////////////////
-NEW_PROP_TAG(MpfaMethod);                          //! Specifies the mpfa method to be used
-NEW_PROP_TAG(MpfaHelper);                          //! A Helper class depending on the mpfa method and grid dimension
-NEW_PROP_TAG(PrimaryInteractionVolume);            //! The primary interaction volume type
-NEW_PROP_TAG(SecondaryInteractionVolume);          //! The secondary interaction volume type used e.g. on the boundaries
+NEW_PROP_TAG(MpfaMethod);                          //!< Specifies the mpfa method to be used
+NEW_PROP_TAG(MpfaHelper);                          //!< A Helper class depending on the mpfa method and grid dimension
+NEW_PROP_TAG(PrimaryInteractionVolume);            //!< The primary interaction volume type
+NEW_PROP_TAG(SecondaryInteractionVolume);          //!< The secondary interaction volume type used e.g. on the boundaries
 
 
 /////////////////////////////////////////////////////////////
 // Properties used by models involving flow in porous media:
 /////////////////////////////////////////////////////////////
-NEW_PROP_TAG(EnergyLocalResidual);                 //! The local residual of the energy equation
-NEW_PROP_TAG(EnableAdvection);                     //! specifies if advection is considered in the model
-NEW_PROP_TAG(AdvectionType);                       //! The type for the calculation the advective fluxes
-NEW_PROP_TAG(SolutionDependentAdvection);          //! specifies if the parameters for the advective fluxes depend on the solution
-NEW_PROP_TAG(EnableMolecularDiffusion);            //! specifies if molecular diffusive fluxes are considered in the model
-NEW_PROP_TAG(MolecularDiffusionType);              //! The type for the calculation of the molecular diffusion fluxes
-NEW_PROP_TAG(SolutionDependentMolecularDiffusion); //! specifies if the parameters for the diffusive fluxes depend on the solution
-NEW_PROP_TAG(EnableEnergyBalance);                 //! Specifies if the model solves an energy equation
-NEW_PROP_TAG(HeatConductionType);                  //! The type for the calculation of the heat conduction fluxes
-NEW_PROP_TAG(SolutionDependentHeatConduction);     //! specifies if the parameters for the heat conduction fluxes depend on the solution
-
-NEW_PROP_TAG(NumPhases);                           //! Number of fluid phases in the system
-NEW_PROP_TAG(PhaseIdx);                            //! A phase index to allow using a two-phase fluidsystem for one-phase models
-NEW_PROP_TAG(NumComponents);                       //! Number of fluid phases in the system
-NEW_PROP_TAG(SpatialParams);                       //! The type of the spatial parameters object
-NEW_PROP_TAG(FluidSystem);                         //! The type of the fluid system to use
-NEW_PROP_TAG(FluidState);                          //! The type of the fluid state to use
-NEW_PROP_TAG(PrimaryVariableSwitch);               //! The primary variable switch needed for compositional models
-NEW_PROP_TAG(EffectiveDiffusivityModel);           //! The employed model for the computation of the effective diffusivity
-NEW_PROP_TAG(ThermalConductivityModel);            //! Model to be used for the calculation of the effective conductivity
-NEW_PROP_TAG(VelocityOutput);                      //! specifies the velocity calculation module to be used
-
-NEW_PROP_TAG(MaterialLaw);                         //! The material law which ought to be used (extracted from the spatial parameters)
-NEW_PROP_TAG(Formulation);                         //! The formulation of the model
+NEW_PROP_TAG(EnergyLocalResidual);                 //!< The local residual of the energy equation
+NEW_PROP_TAG(EnableAdvection);                     //!< specifies if advection is considered in the model
+NEW_PROP_TAG(AdvectionType);                       //!< The type for the calculation the advective fluxes
+NEW_PROP_TAG(SolutionDependentAdvection);          //!< specifies if the parameters for the advective fluxes depend on the solution
+NEW_PROP_TAG(EnableMolecularDiffusion);            //!< specifies if molecular diffusive fluxes are considered in the model
+NEW_PROP_TAG(MolecularDiffusionType);              //!< The type for the calculation of the molecular diffusion fluxes
+NEW_PROP_TAG(SolutionDependentMolecularDiffusion); //!< specifies if the parameters for the diffusive fluxes depend on the solution
+NEW_PROP_TAG(EnableEnergyBalance);                 //!< Specifies if the model solves an energy equation
+NEW_PROP_TAG(HeatConductionType);                  //!< The type for the calculation of the heat conduction fluxes
+NEW_PROP_TAG(SolutionDependentHeatConduction);     //!< specifies if the parameters for the heat conduction fluxes depend on the solution
+
+NEW_PROP_TAG(NumPhases);                           //!< Number of fluid phases in the system
+NEW_PROP_TAG(PhaseIdx);                            //!< A phase index to allow using a two-phase fluidsystem for one-phase models
+NEW_PROP_TAG(NumComponents);                       //!< Number of fluid phases in the system
+NEW_PROP_TAG(SpatialParams);                       //!< The type of the spatial parameters object
+NEW_PROP_TAG(FluidSystem);                         //!< The type of the fluid system to use
+NEW_PROP_TAG(FluidState);                          //!< The type of the fluid state to use
+NEW_PROP_TAG(PrimaryVariableSwitch);               //!< The primary variable switch needed for compositional models
+NEW_PROP_TAG(EffectiveDiffusivityModel);           //!< The employed model for the computation of the effective diffusivity
+NEW_PROP_TAG(ThermalConductivityModel);            //!< Model to be used for the calculation of the effective conductivity
+NEW_PROP_TAG(VelocityOutput);                      //!< specifies the velocity calculation module to be used
+
+NEW_PROP_TAG(MaterialLaw);                         //!< The material law which ought to be used (extracted from the spatial parameters)
+NEW_PROP_TAG(Formulation);                         //!< The formulation of the model
 // TODO: is this useful? -> everything is a constraint solver just a different type
-NEW_PROP_TAG(UseConstraintSolver);                 //! Whether to use a contraint solver for computing the secondary variables
-NEW_PROP_TAG(UseKelvinEquation);                   //! If we use Kelvin equation to lower the vapor pressure as a function of capillary pressure, temperature
+NEW_PROP_TAG(UseConstraintSolver);                 //!< Whether to use a contraint solver for computing the secondary variables
+NEW_PROP_TAG(UseKelvinEquation);                   //!< If we use Kelvin equation to lower the vapor pressure as a function of capillary pressure, temperature
 
 ////////////////////////////////////////////////////////////////////////////////
 // Properties used by models involving mineralization:
@@ -147,7 +147,7 @@ NEW_PROP_TAG(NumSPhases);
 NEW_PROP_TAG(NonMineralizationVtkOutputFields);
 NEW_PROP_TAG(NonMineralizationVolumeVariables);
 
-NEW_PROP_TAG(UseConstraintSolver);                 //! Determines whether the constraint solver should be used#
+NEW_PROP_TAG(UseConstraintSolver);                 //!< Determines whether the constraint solver should be used#
 
 /////////////////////////////////////////////////////////////
 // non-isothermal porous medium flow models
@@ -177,20 +177,20 @@ NEW_PROP_TAG(EnableWaterDiffusionInAir); //!< Property for turning Richards into
 /////////////////////////////////////////////////////////////
 // Properties used by the staggered-grid discretization method
 /////////////////////////////////////////////////////////////
-NEW_PROP_TAG(NumEqCellCenter);                     //! The number of equations for cell-centered dofs
-NEW_PROP_TAG(NumEqFace);                           //! The number of equations for face dofs
-NEW_PROP_TAG(CellCenterSolutionVector);            //! The solution vector type for cell-centered dofs
-NEW_PROP_TAG(FaceSolutionVector);                  //! The solution vector type for face dofs
-NEW_PROP_TAG(GlobalFaceVars);                      //! Class containing face-related data
-NEW_PROP_TAG(CellCenterPrimaryVariables);          //! The primary variables container type for cell-centered dofs
-NEW_PROP_TAG(FacePrimaryVariables);                //! The primary variables container type for face dofs
-NEW_PROP_TAG(IntersectionMapper);                  //! Specifies the intersection mapper
-NEW_PROP_TAG(DofTypeIndices);                      //! Specifies index types for accessing the multi type block vectors/matrices
-NEW_PROP_TAG(StaggeredGeometryHelper);             //! Specifies a helper class for the staggered grid geometry
-NEW_PROP_TAG(StaggeredPrimaryVariables);           //! The hybrid primary variables container type
-NEW_PROP_TAG(BaseEpsilon);                         //! A base epsilon for numerical differentiation, can contain multiple values
-NEW_PROP_TAG(FaceVariables);                       //! Class containing local face-related data
-NEW_PROP_TAG(BoundaryValues);                      //! Class containing local boundary data
+NEW_PROP_TAG(NumEqCellCenter);                     //!< The number of equations for cell-centered dofs
+NEW_PROP_TAG(NumEqFace);                           //!< The number of equations for face dofs
+NEW_PROP_TAG(CellCenterSolutionVector);            //!< The solution vector type for cell-centered dofs
+NEW_PROP_TAG(FaceSolutionVector);                  //!< The solution vector type for face dofs
+NEW_PROP_TAG(GlobalFaceVars);                      //!< Class containing face-related data
+NEW_PROP_TAG(CellCenterPrimaryVariables);          //!< The primary variables container type for cell-centered dofs
+NEW_PROP_TAG(FacePrimaryVariables);                //!< The primary variables container type for face dofs
+NEW_PROP_TAG(IntersectionMapper);                  //!< Specifies the intersection mapper
+NEW_PROP_TAG(DofTypeIndices);                      //!< Specifies index types for accessing the multi type block vectors/matrices
+NEW_PROP_TAG(StaggeredGeometryHelper);             //!< Specifies a helper class for the staggered grid geometry
+NEW_PROP_TAG(StaggeredPrimaryVariables);           //!< The hybrid primary variables container type
+NEW_PROP_TAG(BaseEpsilon);                         //!< A base epsilon for numerical differentiation, can contain multiple values
+NEW_PROP_TAG(FaceVariables);                       //!< Class containing local face-related data
+NEW_PROP_TAG(BoundaryValues);                      //!< Class containing local boundary data
 
 } // end namespace Properties
 } // end namespace Dumux
diff --git a/dumux/discretization/box/boxgeometryhelper.hh b/dumux/discretization/box/boxgeometryhelper.hh
index ce5e31cac9..f10e052383 100644
--- a/dumux/discretization/box/boxgeometryhelper.hh
+++ b/dumux/discretization/box/boxgeometryhelper.hh
@@ -108,7 +108,7 @@ public:
     }
 
 private:
-    const typename Element::Geometry& elementGeometry_; //! Reference to the element geometry
+    const typename Element::Geometry& elementGeometry_; //!< Reference to the element geometry
     std::size_t corners_; // number of element corners
     GlobalPosition p[maxPoints]; // the points needed for construction of the geometries
 };
@@ -161,8 +161,8 @@ public:
         case 3: // triangle
         {
             //! Only build the maps the first time we encounter a triangle
-            static const std::uint8_t vo = 1; //! vertex offset in point vector p
-            static const std::uint8_t fo = 4; //! face offset in point vector p
+            static const std::uint8_t vo = 1; //!< vertex offset in point vector p
+            static const std::uint8_t fo = 4; //!< face offset in point vector p
             static const std::uint8_t map[3][4] =
             {
                 {vo+0, fo+0, fo+1, 0},
@@ -178,8 +178,8 @@ public:
         case 4: // quadrilateral
         {
             //! Only build the maps the first time we encounter a quadrilateral
-            static const std::uint8_t vo = 1; //! vertex offset in point vector p
-            static const std::uint8_t fo = 5; //! face offset in point vector p
+            static const std::uint8_t vo = 1; //!< vertex offset in point vector p
+            static const std::uint8_t fo = 5; //!< face offset in point vector p
             static const std::uint8_t map[4][4] =
             {
                 {vo+0, fo+2, fo+0, 0},
@@ -210,7 +210,7 @@ public:
         case 3: // triangle
         {
             //! Only build the maps the first time we encounter a triangle
-            static const std::uint8_t fo = 4; //! face offset in point vector p
+            static const std::uint8_t fo = 4; //!< face offset in point vector p
             static const std::uint8_t map[3][2] =
             {
                 {0, fo+0},
@@ -224,7 +224,7 @@ public:
         case 4: // quadrilateral
         {
             //! Only build the maps the first time we encounter a quadrilateral
-            static const std::uint8_t fo = 5; //! face offset in point vector p
+            static const std::uint8_t fo = 5; //!< face offset in point vector p
             static const std::uint8_t map[4][2] =
             {
                 {fo+0, 0},
@@ -323,7 +323,7 @@ public:
     }
 
 private:
-    const typename Element::Geometry& elementGeometry_; //! Reference to the element geometry
+    const typename Element::Geometry& elementGeometry_; //!< Reference to the element geometry
     std::size_t corners_; // number of element corners
     GlobalPosition p[maxPoints]; // the points needed for construction of the geometries
 };
@@ -380,9 +380,9 @@ public:
         case 4: // tetrahedron
         {
             //! Only build the maps the first time we encounter a tetrahedron
-            static const std::uint8_t vo = 1; //! vertex offset in point vector p
-            static const std::uint8_t eo = 5; //! edge offset in point vector p
-            static const std::uint8_t fo = 11; //! face offset in point vector p
+            static const std::uint8_t vo = 1; //!< vertex offset in point vector p
+            static const std::uint8_t eo = 5; //!< edge offset in point vector p
+            static const std::uint8_t fo = 11; //!< face offset in point vector p
             static const std::uint8_t map[4][8] =
             {
                 {vo+0, eo+0, eo+1, fo+0, eo+3, fo+1, fo+2,    0},
@@ -403,9 +403,9 @@ public:
         case 8: // hexahedron
         {
             //! Only build the maps the first time we encounter a quadrilateral
-            static const std::uint8_t vo = 1; //! vertex offset in point vector p
-            static const std::uint8_t eo = 9; //! edge offset in point vector p
-            static const std::uint8_t fo = 21; //! face offset in point vector p
+            static const std::uint8_t vo = 1; //!< vertex offset in point vector p
+            static const std::uint8_t eo = 9; //!< edge offset in point vector p
+            static const std::uint8_t fo = 21; //!< face offset in point vector p
             static const std::uint8_t map[8][8] =
             {
                 {vo+0, eo+6, eo+4, fo+4, eo+0, fo+2, fo+0,    0},
@@ -443,8 +443,8 @@ public:
         case 4: // tetrahedron
         {
             //! Only build the maps the first time we encounter a triangle
-            static const std::uint8_t eo = 5; //! edge offset in point vector p
-            static const std::uint8_t fo = 11; //! face offset in point vector p
+            static const std::uint8_t eo = 5; //!< edge offset in point vector p
+            static const std::uint8_t fo = 11; //!< face offset in point vector p
             static const std::uint8_t map[6][4] =
             {
                 {eo+0, fo+0, fo+1,    0},
@@ -463,8 +463,8 @@ public:
         case 8: // hexahedron
         {
             //! Only build the maps the first time we encounter a quadrilateral
-            static const std::uint8_t eo = 9; //! edge offset in point vector p
-            static const std::uint8_t fo = 21; //! face offset in point vector p
+            static const std::uint8_t eo = 9; //!< edge offset in point vector p
+            static const std::uint8_t fo = 21; //!< face offset in point vector p
             static const std::uint8_t map[12][4] =
             {
                 {fo+0, eo+0,    0, fo+2},
@@ -520,8 +520,8 @@ public:
         case 3: // triangle
         {
             //! Only build the maps the first time we encounter a triangle
-            static const std::uint8_t vo = 1; //! vertex offset in point vector p
-            static const std::uint8_t fo = 4; //! face offset in point vector p
+            static const std::uint8_t vo = 1; //!< vertex offset in point vector p
+            static const std::uint8_t fo = 4; //!< face offset in point vector p
             static const std::uint8_t map[3][4] =
             {
                 {vo+0, fo+0, fo+1, 0},
@@ -537,8 +537,8 @@ public:
         case 4: // quadrilateral
         {
             //! Only build the maps the first time we encounter a quadrilateral
-            static const std::uint8_t vo = 1; //! vertex offset in point vector p
-            static const std::uint8_t fo = 5; //! face offset in point vector p
+            static const std::uint8_t vo = 1; //!< vertex offset in point vector p
+            static const std::uint8_t fo = 5; //!< face offset in point vector p
             static const std::uint8_t map[4][4] =
             {
                 {vo+0, fo+2, fo+0, 0},
@@ -592,7 +592,7 @@ public:
     }
 
 private:
-    const typename Element::Geometry& elementGeometry_; //! Reference to the element geometry
+    const typename Element::Geometry& elementGeometry_; //!< Reference to the element geometry
     std::size_t corners_; // number of element corners
     GlobalPosition p[maxPoints]; // the points needed for construction of the scv/scvf geometries
 };
diff --git a/dumux/discretization/cellcentered/mpfa/helper.hh b/dumux/discretization/cellcentered/mpfa/helper.hh
index 84e0248bab..fc0054aecd 100644
--- a/dumux/discretization/cellcentered/mpfa/helper.hh
+++ b/dumux/discretization/cellcentered/mpfa/helper.hh
@@ -466,8 +466,8 @@ public:
             case 3: // triangle
             {
                 //! Only build the maps the first time we encounter a triangle
-                static const std::uint8_t vo = 1; //! vertex offset in point vector p
-                static const std::uint8_t eo = 4; //! edge offset in point vector p
+                static const std::uint8_t vo = 1; //!< vertex offset in point vector p
+                static const std::uint8_t eo = 4; //!< edge offset in point vector p
                 static const std::uint8_t map[3][4] =
                 {
                     {0, eo+1, eo+0, vo+0},
@@ -483,8 +483,8 @@ public:
             case 4: // quadrilateral
             {
                 //! Only build the maps the first time we encounter a quadrilateral
-                static const std::uint8_t vo = 1; //! vertex offset in point vector p
-                static const std::uint8_t eo = 5; //! face offset in point vector p
+                static const std::uint8_t vo = 1; //!< vertex offset in point vector p
+                static const std::uint8_t eo = 5; //!< face offset in point vector p
                 static const std::uint8_t map[4][4] =
                 {
                     {0, eo+0, eo+2, vo+0},
diff --git a/dumux/discretization/cellcentered/mpfa/interactionvolumebase.hh b/dumux/discretization/cellcentered/mpfa/interactionvolumebase.hh
index c92afa9bf3..acc01de45c 100644
--- a/dumux/discretization/cellcentered/mpfa/interactionvolumebase.hh
+++ b/dumux/discretization/cellcentered/mpfa/interactionvolumebase.hh
@@ -111,12 +111,12 @@ public:
 
     class LocalFaceData
     {
-        LocalIndexType ivLocalScvfIndex_;          //! the iv-local scvf index this scvf maps to
-        LocalIndexType ivLocalInsideScvIndex_;     //! the iv-local index of the scvfs' inside scv
-        LocalIndexType ivLocalOutsideScvfIndex_;   //! the index of this scvf in the iv-local outside faces
-        LocalIndexType scvfLocalOutsideScvfIndex_; //! the index of this scvf in the scvf-local outside faces
-        GlobalIndexType globalScvfIndex_;          //! the index of the corresponding global scvf
-        bool isOutside_;                           //! indicates if this face maps to the iv-local index from "outside"
+        LocalIndexType ivLocalScvfIndex_;          //!< the iv-local scvf index this scvf maps to
+        LocalIndexType ivLocalInsideScvIndex_;     //!< the iv-local index of the scvfs' inside scv
+        LocalIndexType ivLocalOutsideScvfIndex_;   //!< the index of this scvf in the iv-local outside faces
+        LocalIndexType scvfLocalOutsideScvfIndex_; //!< the index of this scvf in the scvf-local outside faces
+        GlobalIndexType globalScvfIndex_;          //!< the index of the corresponding global scvf
+        bool isOutside_;                           //!< indicates if this face maps to the iv-local index from "outside"
 
       public:
         //! Constructor for "inside" faces
diff --git a/dumux/discretization/cellcentered/mpfa/interactionvolumedatahandle.hh b/dumux/discretization/cellcentered/mpfa/interactionvolumedatahandle.hh
index 20e11e14f2..bc547e83bf 100644
--- a/dumux/discretization/cellcentered/mpfa/interactionvolumedatahandle.hh
+++ b/dumux/discretization/cellcentered/mpfa/interactionvolumedatahandle.hh
@@ -103,10 +103,10 @@ namespace Dumux
 
     private:
         // advection-related variables
-        const GlobalIndexContainer* advectionVolVarsStencil_;  //! Pointer to the global volvar indices (stored in the interaction volume)
-        Matrix advectionT_;                                    //! The transmissibilities
-        Matrix advectionAB_;                                   //! Coefficients for gradient reconstruction
-        Matrix advectionTout_;                                 //! The transmissibilities associated with "outside" faces (only necessary on surface grids)
+        const GlobalIndexContainer* advectionVolVarsStencil_;  //!< Pointer to the global volvar indices (stored in the interaction volume)
+        Matrix advectionT_;                                    //!< The transmissibilities
+        Matrix advectionAB_;                                   //!< Coefficients for gradient reconstruction
+        Matrix advectionTout_;                                 //!< The transmissibilities associated with "outside" faces (only necessary on surface grids)
     };
 
     //! Data handle for quantities related to diffusion
@@ -174,8 +174,8 @@ namespace Dumux
 
     private:
         // diffusion-related variables (see comments in AdvectionDataHandle)
-        unsigned int contextPhaseIdx_;                         //! The phase index set for the context
-        unsigned int contextCompIdx_;                          //! The component index set for the context
+        unsigned int contextPhaseIdx_;                         //!< The phase index set for the context
+        unsigned int contextCompIdx_;                          //!< The component index set for the context
         std::array<std::array<const GlobalIndexContainer*, numComponents>, numPhases> diffusionVolVarsStencil_;
         std::array<std::array<Matrix, numComponents>, numPhases> diffusionT_;
         std::array<std::array<Matrix, numComponents>, numPhases> diffusionAB_;
@@ -216,10 +216,10 @@ namespace Dumux
 
     private:
         // heat conduction-related variables
-        const GlobalIndexContainer* heatConductionVolVarsStencil_;  //! Pointer to the global volvar indices (stored in the interaction volume)
-        Matrix heatConductionT_;                                    //! The transmissibilities
-        Matrix heatConductionAB_;                                   //! Coefficients for gradient reconstruction
-        Matrix heatConductionTout_;                                 //! The transmissibilities associated with "outside" faces (only necessary on surface grids)
+        const GlobalIndexContainer* heatConductionVolVarsStencil_;  //!< Pointer to the global volvar indices (stored in the interaction volume)
+        Matrix heatConductionT_;                                    //!< The transmissibilities
+        Matrix heatConductionAB_;                                   //!< Coefficients for gradient reconstruction
+        Matrix heatConductionTout_;                                 //!< The transmissibilities associated with "outside" faces (only necessary on surface grids)
     };
 
     //! Process-dependet data handle when related process is disabled
@@ -397,8 +397,8 @@ namespace Dumux
         }
 
     private:
-        Contexts context_;                     //! The context variable
-        DirichletDataContainer dirichletData_; //! The dirichlet data container of this iv
+        Contexts context_;                     //!< The context variable
+        DirichletDataContainer dirichletData_; //!< The dirichlet data container of this iv
     };
 
 } // end namespace Dumux
diff --git a/dumux/discretization/cellcentered/mpfa/omethod/interactionvolume.hh b/dumux/discretization/cellcentered/mpfa/omethod/interactionvolume.hh
index 42b427741b..02cf2ec7ac 100644
--- a/dumux/discretization/cellcentered/mpfa/omethod/interactionvolume.hh
+++ b/dumux/discretization/cellcentered/mpfa/omethod/interactionvolume.hh
@@ -206,7 +206,7 @@ public:
                                                         outsideLocalScvIdx, //! iv-local scv index
                                                         numOutsideFaces_++, //! iv-local index in outside faces
                                                         i-1,                //! scvf-local index in outside faces
-                                                        flipScvf.index());  //! global scvf index
+                                                        flipScvf.index());  //!< global scvf index
                         }
                     }
                 }
diff --git a/dumux/discretization/fluxvariablesbase.hh b/dumux/discretization/fluxvariablesbase.hh
index f0ecac1fef..5df9c1dfd8 100644
--- a/dumux/discretization/fluxvariablesbase.hh
+++ b/dumux/discretization/fluxvariablesbase.hh
@@ -104,12 +104,12 @@ public:
     }
 
 private:
-    const Problem* problemPtr_;                             //! Pointer to the problem
-    const Element* elementPtr_;                             //! Pointer to the element at hand
-    const FVElementGeometry* fvGeometryPtr_;                //! Pointer to the current FVElementGeometry
-    const SubControlVolumeFace* scvFacePtr_;                //! Pointer to the sub control volume face for which the flux variables are created
-    const ElementVolumeVariables* elemVolVarsPtr_;          //! Pointer to the current element volume variables
-    const ElementFluxVariablesCache* elemFluxVarsCachePtr_; //! Pointer to the current element flux variables cache
+    const Problem* problemPtr_;                             //!< Pointer to the problem
+    const Element* elementPtr_;                             //!< Pointer to the element at hand
+    const FVElementGeometry* fvGeometryPtr_;                //!< Pointer to the current FVElementGeometry
+    const SubControlVolumeFace* scvFacePtr_;                //!< Pointer to the sub control volume face for which the flux variables are created
+    const ElementVolumeVariables* elemVolVarsPtr_;          //!< Pointer to the current element volume variables
+    const ElementFluxVariablesCache* elemFluxVarsCachePtr_; //!< Pointer to the current element flux variables cache
 };
 
 } // end namespace Dumux
diff --git a/dumux/discretization/staggered/freeflow/staggeredgeometryhelper.hh b/dumux/discretization/staggered/freeflow/staggeredgeometryhelper.hh
index 700b594fe3..9fbadc94a7 100644
--- a/dumux/discretization/staggered/freeflow/staggeredgeometryhelper.hh
+++ b/dumux/discretization/staggered/freeflow/staggeredgeometryhelper.hh
@@ -451,11 +451,11 @@ private:
     }
 
     // TODO: check whether to use references here or not
-    Intersection intersection_; //! The intersection of interest
-    const Element element_; //! The respective element
-    const typename Element::Geometry elementGeometry_; //! Reference to the element geometry
+    Intersection intersection_; //!< The intersection of interest
+    const Element element_; //!< The respective element
+    const typename Element::Geometry elementGeometry_; //!< Reference to the element geometry
     const GridView gridView_;
-    std::array<PairData<Scalar, GlobalPosition>, numPairs> pairData_; //! collection of pair information
+    std::array<PairData<Scalar, GlobalPosition>, numPairs> pairData_; //!< collection of pair information
     std::vector<GlobalPosition> innerNormalFacePos_;
 };
 
diff --git a/dumux/discretization/staggered/subcontrolvolumeface.hh b/dumux/discretization/staggered/subcontrolvolumeface.hh
index 44291a0d8b..ba2e20e0a2 100644
--- a/dumux/discretization/staggered/subcontrolvolumeface.hh
+++ b/dumux/discretization/staggered/subcontrolvolumeface.hh
@@ -77,8 +77,8 @@ public:
    }
 
 private:
-   Intersection intersection_; //! The intersection of interest
-   const Element element_; //! The respective element
+   Intersection intersection_; //!< The intersection of interest
+   const Element element_; //!< The respective element
    const GridView gridView_;
 };
 
diff --git a/dumux/freeflow/navierstokes/model.hh b/dumux/freeflow/navierstokes/model.hh
index ffe11b1610..88e792f0a0 100644
--- a/dumux/freeflow/navierstokes/model.hh
+++ b/dumux/freeflow/navierstokes/model.hh
@@ -76,9 +76,9 @@
  ///////////////////////////////////////////////////////////////////////////
  // default property values for the isothermal single phase model
  ///////////////////////////////////////////////////////////////////////////
- SET_INT_PROP(NavierStokes, NumPhases, 1); //! The number of phases in the 1p model is 1
- SET_INT_PROP(NavierStokes, NumComponents, 1); //! The number of components in the 1p model is 1
- SET_INT_PROP(NavierStokes, PhaseIdx, 0); //! The default phase index
+ SET_INT_PROP(NavierStokes, NumPhases, 1); //!< The number of phases in the 1p model is 1
+ SET_INT_PROP(NavierStokes, NumComponents, 1); //!< The number of components in the 1p model is 1
+ SET_INT_PROP(NavierStokes, PhaseIdx, 0); //!< The default phase index
 
  //! The number of equations
  SET_PROP(NavierStokes, NumEq)
diff --git a/dumux/freeflow/navierstokesnc/model.hh b/dumux/freeflow/navierstokesnc/model.hh
index 6ead117b84..a0efc408e4 100644
--- a/dumux/freeflow/navierstokesnc/model.hh
+++ b/dumux/freeflow/navierstokesnc/model.hh
@@ -148,11 +148,11 @@
 
  SET_INT_PROP(NavierStokesNC, PhaseIdx, 0); //!< Defines the phaseIdx
 
- SET_TYPE_PROP(NavierStokesNC, VtkOutputFields, NavierStokesNCVtkOutputFields<TypeTag>); //! the vtk output fields
+ SET_TYPE_PROP(NavierStokesNC, VtkOutputFields, NavierStokesNCVtkOutputFields<TypeTag>); //!< the vtk output fields
 
  // non-isothermal properties
- SET_TYPE_PROP(NavierStokesNCNI, IsothermalIndices, NavierStokesNCIndices<TypeTag>); //! the isothermal indices
- SET_TYPE_PROP(NavierStokesNCNI, IsothermalVtkOutputFields, NavierStokesNCVtkOutputFields<TypeTag>); //! the isothermal vtk output fields
+ SET_TYPE_PROP(NavierStokesNCNI, IsothermalIndices, NavierStokesNCIndices<TypeTag>); //!< the isothermal indices
+ SET_TYPE_PROP(NavierStokesNCNI, IsothermalVtkOutputFields, NavierStokesNCVtkOutputFields<TypeTag>); //!< the isothermal vtk output fields
 
  //! The number of equations
  SET_PROP(NavierStokesNCNI, IsothermalNumEq)
diff --git a/dumux/io/vtkoutputmodule.hh b/dumux/io/vtkoutputmodule.hh
index be8bab380e..a606804bff 100644
--- a/dumux/io/vtkoutputmodule.hh
+++ b/dumux/io/vtkoutputmodule.hh
@@ -544,8 +544,8 @@ private:
     std::shared_ptr<Dune::VTKWriter<GridView>> writer_;
     Dune::VTKSequenceWriter<GridView> sequenceWriter_;
 
-    std::vector<VolVarScalarDataInfo> volVarScalarDataInfo_; //! Registered volume variables
-    std::vector<Field> fields_; //! Registered scalar and vector fields
+    std::vector<VolVarScalarDataInfo> volVarScalarDataInfo_; //!< Registered volume variables
+    std::vector<Field> fields_; //!< Registered scalar and vector fields
 };
 
 } // end namespace Dumux
diff --git a/dumux/linear/amgparallelhelpers.hh b/dumux/linear/amgparallelhelpers.hh
index 1ac54762f5..27c67626ea 100644
--- a/dumux/linear/amgparallelhelpers.hh
+++ b/dumux/linear/amgparallelhelpers.hh
@@ -462,12 +462,12 @@ public:
 #endif
 
 private:
-    const GridView gridView_; //! the grid view
-    const DofMapper& mapper_; //! the dof mapper
-    std::vector<std::size_t> owner_; //! vector to identify unique decomposition
-    std::vector<std::size_t> isGhost_; //! vector to identify ghost dofs
-    int verbose_; //! verbosity
-    bool initialized_; //! whether isGhost and owner arrays are initialized
+    const GridView gridView_; //!< the grid view
+    const DofMapper& mapper_; //!< the dof mapper
+    std::vector<std::size_t> owner_; //!< vector to identify unique decomposition
+    std::vector<std::size_t> isGhost_; //!< vector to identify ghost dofs
+    int verbose_; //!< verbosity
+    bool initialized_; //!< whether isGhost and owner arrays are initialized
 
 }; // class ParallelISTLHelper
 
diff --git a/dumux/porousmediumflow/1pnc/model.hh b/dumux/porousmediumflow/1pnc/model.hh
index b270389cfc..0bc4d273e7 100644
--- a/dumux/porousmediumflow/1pnc/model.hh
+++ b/dumux/porousmediumflow/1pnc/model.hh
@@ -150,15 +150,15 @@ SET_TYPE_PROP(OnePNC, EffectiveDiffusivityModel,
              DiffusivityMillingtonQuirk<typename GET_PROP_TYPE(TypeTag, Scalar)>);
 
 
-SET_INT_PROP(OnePNC, NumPhases, 1); //! The number of phases in the 1pnc model is 1
-SET_INT_PROP(OnePNC, PhaseIdx, 0); //! The default phase index
-SET_TYPE_PROP(OnePNC, LocalResidual, CompositionalLocalResidual<TypeTag>); //! The local residual function
-SET_TYPE_PROP(OnePNC, VolumeVariables, OnePNCVolumeVariables<TypeTag>);   //! the VolumeVariables property
-SET_BOOL_PROP(OnePNC, EnableAdvection, true);                           //! The one-phase model considers advection
-SET_BOOL_PROP(OnePNC, EnableMolecularDiffusion, true);                 //! The one-phase model has no molecular diffusion
-SET_BOOL_PROP(OnePNC, EnableEnergyBalance, false);                      //! Isothermal model by default
-SET_TYPE_PROP(OnePNC, Indices, OnePNCIndices <TypeTag, /*PVOffset=*/0>);                            //! The indices required by the isothermal single-phase model
-SET_TYPE_PROP(OnePNC, VtkOutputFields, OnePNCVtkOutputFields<TypeTag>);   //! Set the vtk output fields specific to this model
+SET_INT_PROP(OnePNC, NumPhases, 1); //!< The number of phases in the 1pnc model is 1
+SET_INT_PROP(OnePNC, PhaseIdx, 0); //!< The default phase index
+SET_TYPE_PROP(OnePNC, LocalResidual, CompositionalLocalResidual<TypeTag>); //!< The local residual function
+SET_TYPE_PROP(OnePNC, VolumeVariables, OnePNCVolumeVariables<TypeTag>);   //!< the VolumeVariables property
+SET_BOOL_PROP(OnePNC, EnableAdvection, true);                           //!< The one-phase model considers advection
+SET_BOOL_PROP(OnePNC, EnableMolecularDiffusion, true);                 //!< The one-phase model has no molecular diffusion
+SET_BOOL_PROP(OnePNC, EnableEnergyBalance, false);                      //!< Isothermal model by default
+SET_TYPE_PROP(OnePNC, Indices, OnePNCIndices <TypeTag, /*PVOffset=*/0>);                            //!< The indices required by the isothermal single-phase model
+SET_TYPE_PROP(OnePNC, VtkOutputFields, OnePNCVtkOutputFields<TypeTag>);   //!< Set the vtk output fields specific to this model
 
 
 ///////////////////////////////////////////////////////////////////////////
@@ -175,14 +175,14 @@ private:
 public:
     static constexpr auto value = FluidSystem::numComponents;
 };
-SET_BOOL_PROP(OnePNCNI, EnableEnergyBalance, true);                                   //! we do solve for the energy balance here
-SET_TYPE_PROP(OnePNCNI, IsothermalVtkOutputFields, OnePNCVtkOutputFields<TypeTag>);     //! the isothermal vtk output fields
-SET_TYPE_PROP(OnePNCNI, IsothermalVolumeVariables, OnePNCVolumeVariables<TypeTag>);     //! Vol vars of the isothermal model
-SET_TYPE_PROP(OnePNCNI, IsothermalLocalResidual, CompositionalLocalResidual<TypeTag>);   //! Local residual of the isothermal model
-SET_TYPE_PROP(OnePNCNI, IsothermalIndices, OnePNCIndices <TypeTag, /*PVOffset=*/0>);                              //! Indices of the isothermal model
+SET_BOOL_PROP(OnePNCNI, EnableEnergyBalance, true);                                   //!< we do solve for the energy balance here
+SET_TYPE_PROP(OnePNCNI, IsothermalVtkOutputFields, OnePNCVtkOutputFields<TypeTag>);     //!< the isothermal vtk output fields
+SET_TYPE_PROP(OnePNCNI, IsothermalVolumeVariables, OnePNCVolumeVariables<TypeTag>);     //!< Vol vars of the isothermal model
+SET_TYPE_PROP(OnePNCNI, IsothermalLocalResidual, CompositionalLocalResidual<TypeTag>);   //!< Local residual of the isothermal model
+SET_TYPE_PROP(OnePNCNI, IsothermalIndices, OnePNCIndices <TypeTag, /*PVOffset=*/0>);                              //!< Indices of the isothermal model
 SET_TYPE_PROP(OnePNCNI,
               ThermalConductivityModel,
-              ThermalConductivityAverage<typename GET_PROP_TYPE(TypeTag, Scalar)>); //! Use the average for effective conductivities
+              ThermalConductivityAverage<typename GET_PROP_TYPE(TypeTag, Scalar)>); //!< Use the average for effective conductivities
 
 } // end namespace Properties
 } // end namespace Dumux
diff --git a/dumux/porousmediumflow/2p/model.hh b/dumux/porousmediumflow/2p/model.hh
index c9afaef2fb..e261e448a7 100644
--- a/dumux/porousmediumflow/2p/model.hh
+++ b/dumux/porousmediumflow/2p/model.hh
@@ -92,21 +92,21 @@ NEW_TYPE_TAG(TwoPNI, INHERITS_FROM(TwoP, NonIsothermal));
 ///////////////////////////////////////////////////////////////////////////
 // properties for the isothermal two-phase model
 ///////////////////////////////////////////////////////////////////////////
-SET_INT_PROP(TwoP, NumEq, 2);                                                 //! Set the number of equations to 2
-SET_INT_PROP(TwoP, NumPhases, 2);                                             //! The number of phases in the 2p model is 2
-SET_INT_PROP(TwoP, NumComponents, 2);                                         //! The number of components in the 2p model is 2
-SET_INT_PROP(TwoP, Formulation, TwoPFormulation::pwsn);                       //! Set the default formulation to pWsN
-SET_BOOL_PROP(TwoP, EnableAdvection, true);                                   //! Enable advection
-SET_BOOL_PROP(TwoP, EnableMolecularDiffusion, false);                         //! The two-phase model has no molecular diffusion
-SET_BOOL_PROP(TwoP, EnableEnergyBalance, false);                              //! Isothermal model (non-isothermal type tag is below)
-SET_TYPE_PROP(TwoP, LocalResidual, ImmiscibleLocalResidual<TypeTag>);         //! Use the immiscible local residual operator for the 2p model
-SET_TYPE_PROP(TwoP, VolumeVariables, TwoPVolumeVariables<TypeTag>);           //! the VolumeVariables property
-SET_TYPE_PROP(TwoP, SpatialParams, FVSpatialParams<TypeTag>);           //! The spatial parameters. Use FVSpatialParams by default.
-SET_TYPE_PROP(TwoP, VtkOutputFields, TwoPVtkOutputFields<TypeTag>);           //! Set the vtk output fields specific to the twop model
+SET_INT_PROP(TwoP, NumEq, 2);                                                 //!< Set the number of equations to 2
+SET_INT_PROP(TwoP, NumPhases, 2);                                             //!< The number of phases in the 2p model is 2
+SET_INT_PROP(TwoP, NumComponents, 2);                                         //!< The number of components in the 2p model is 2
+SET_INT_PROP(TwoP, Formulation, TwoPFormulation::pwsn);                       //!< Set the default formulation to pWsN
+SET_BOOL_PROP(TwoP, EnableAdvection, true);                                   //!< Enable advection
+SET_BOOL_PROP(TwoP, EnableMolecularDiffusion, false);                         //!< The two-phase model has no molecular diffusion
+SET_BOOL_PROP(TwoP, EnableEnergyBalance, false);                              //!< Isothermal model (non-isothermal type tag is below)
+SET_TYPE_PROP(TwoP, LocalResidual, ImmiscibleLocalResidual<TypeTag>);         //!< Use the immiscible local residual operator for the 2p model
+SET_TYPE_PROP(TwoP, VolumeVariables, TwoPVolumeVariables<TypeTag>);           //!< the VolumeVariables property
+SET_TYPE_PROP(TwoP, SpatialParams, FVSpatialParams<TypeTag>);           //!< The spatial parameters. Use FVSpatialParams by default.
+SET_TYPE_PROP(TwoP, VtkOutputFields, TwoPVtkOutputFields<TypeTag>);           //!< Set the vtk output fields specific to the twop model
 
 SET_TYPE_PROP(TwoP,
               Indices,
-              TwoPIndices<TypeTag, GET_PROP_VALUE(TypeTag, Formulation), 0>); //! The indices required by the isothermal 2p model
+              TwoPIndices<TypeTag, GET_PROP_VALUE(TypeTag, Formulation), 0>); //!< The indices required by the isothermal 2p model
 
 //! The two-phase model uses the immiscible fluid state
 SET_PROP(TwoP, FluidState)
@@ -121,10 +121,10 @@ public:
 ////////////////////////////////////////////////////////
 // properties for the non-isothermal two-phase model
 ////////////////////////////////////////////////////////
-SET_INT_PROP(TwoPNI, IsothermalNumEq, 2);                                         //! set isothermal NumEq
-SET_TYPE_PROP(TwoPNI, IsothermalVolumeVariables, TwoPVolumeVariables<TypeTag>);   //! set isothermal VolumeVariables
-SET_TYPE_PROP(TwoPNI, IsothermalLocalResidual, ImmiscibleLocalResidual<TypeTag>); //! set isothermal LocalResidual
-SET_TYPE_PROP(TwoPNI, IsothermalVtkOutputFields, TwoPVtkOutputFields<TypeTag>);   //! set isothermal output fields
+SET_INT_PROP(TwoPNI, IsothermalNumEq, 2);                                         //!< set isothermal NumEq
+SET_TYPE_PROP(TwoPNI, IsothermalVolumeVariables, TwoPVolumeVariables<TypeTag>);   //!< set isothermal VolumeVariables
+SET_TYPE_PROP(TwoPNI, IsothermalLocalResidual, ImmiscibleLocalResidual<TypeTag>); //!< set isothermal LocalResidual
+SET_TYPE_PROP(TwoPNI, IsothermalVtkOutputFields, TwoPVtkOutputFields<TypeTag>);   //!< set isothermal output fields
 
 //! set isothermal Indices
 SET_PROP(TwoPNI, IsothermalIndices)
diff --git a/dumux/porousmediumflow/2p1c/model.hh b/dumux/porousmediumflow/2p1c/model.hh
index 4774dd47c3..8d66b082bf 100644
--- a/dumux/porousmediumflow/2p1c/model.hh
+++ b/dumux/porousmediumflow/2p1c/model.hh
@@ -133,10 +133,10 @@ namespace Properties
                    "Only fluid systems with 2 phases are supported by the 2p1cni model!");
  };
 
-SET_TYPE_PROP(TwoPOneCNI, LocalResidual, TwoPOneCLocalResidual<TypeTag>); //! The local residual function
+SET_TYPE_PROP(TwoPOneCNI, LocalResidual, TwoPOneCLocalResidual<TypeTag>); //!< The local residual function
 
-SET_BOOL_PROP(TwoPOneCNI, EnableAdvection, true);                           //! The one-phase model considers advection
-SET_BOOL_PROP(TwoPOneCNI, EnableMolecularDiffusion, false);                 //! The one-phase model has no molecular diffusion
+SET_BOOL_PROP(TwoPOneCNI, EnableAdvection, true);                           //!< The one-phase model considers advection
+SET_BOOL_PROP(TwoPOneCNI, EnableMolecularDiffusion, false);                 //!< The one-phase model has no molecular diffusion
 
  /*!
   * \brief The fluid state which is used by the volume variables to
diff --git a/dumux/porousmediumflow/2p2c/sequential/adaptiveproperties.hh b/dumux/porousmediumflow/2p2c/sequential/adaptiveproperties.hh
index fe8cac328e..25cc3b1edc 100644
--- a/dumux/porousmediumflow/2p2c/sequential/adaptiveproperties.hh
+++ b/dumux/porousmediumflow/2p2c/sequential/adaptiveproperties.hh
@@ -77,7 +77,7 @@ namespace Properties {
 // Properties
 //////////////////////////////////////////////////////////////////
 SET_BOOL_PROP(SequentialTwoPTwoCAdaptive, AdaptiveGrid, true);
-SET_TYPE_PROP(SequentialTwoPTwoCAdaptive, GridTypeIndices, GridTypes); //! Property not used but default necessary for mpfa2p
+SET_TYPE_PROP(SequentialTwoPTwoCAdaptive, GridTypeIndices, GridTypes); //!< Property not used but default necessary for mpfa2p
 SET_BOOL_PROP(SequentialTwoPTwoCAdaptive, GridAdaptEnableMultiPointFluxApproximation, true); //!< applies an mpfa method around hanging nodes
 SET_INT_PROP(SequentialTwoPTwoCAdaptive, GridAdaptMaxInteractionVolumes, 4); //!< Uses up to 4 interaction regions as default
 
diff --git a/dumux/porousmediumflow/2p2c/sequential/fvpressure.hh b/dumux/porousmediumflow/2p2c/sequential/fvpressure.hh
index 3b9473ae41..6cb44d2d6b 100644
--- a/dumux/porousmediumflow/2p2c/sequential/fvpressure.hh
+++ b/dumux/porousmediumflow/2p2c/sequential/fvpressure.hh
@@ -179,8 +179,8 @@ public:
 protected:
     Problem& problem_;
     bool enableVolumeIntegral; //!< Enables the volume integral of the pressure equation
-    bool regulateBoundaryPermeability; //! Enables regulation of permeability in the direction of a Dirichlet Boundary Condition
-    Scalar minimalBoundaryPermeability; //! Minimal limit for the boundary permeability
+    bool regulateBoundaryPermeability; //!< Enables regulation of permeability in the direction of a Dirichlet Boundary Condition
+    Scalar minimalBoundaryPermeability; //!< Minimal limit for the boundary permeability
     Scalar ErrorTermFactor_; //!< Handling of error term: relaxation factor
     Scalar ErrorTermLowerBound_; //!< Handling of error term: lower bound for error dampening
     Scalar ErrorTermUpperBound_; //!< Handling of error term: upper bound for error dampening
diff --git a/dumux/porousmediumflow/2p2c/sequential/fvpressurecompositional.hh b/dumux/porousmediumflow/2p2c/sequential/fvpressurecompositional.hh
index ff73988ed9..7d73f3c137 100644
--- a/dumux/porousmediumflow/2p2c/sequential/fvpressurecompositional.hh
+++ b/dumux/porousmediumflow/2p2c/sequential/fvpressurecompositional.hh
@@ -384,7 +384,7 @@ public:
         }
     }
 protected:
-    TransportSolutionType updateEstimate_; //! Update estimate for changes in volume for the pressure equation
+    TransportSolutionType updateEstimate_; //!< Update estimate for changes in volume for the pressure equation
     Problem& problem_;
 
     //! output for the initialization procedure
diff --git a/dumux/porousmediumflow/2p2c/sequential/fvpressuremultiphysics.hh b/dumux/porousmediumflow/2p2c/sequential/fvpressuremultiphysics.hh
index 5b7ef2fa49..f788b480a8 100644
--- a/dumux/porousmediumflow/2p2c/sequential/fvpressuremultiphysics.hh
+++ b/dumux/porousmediumflow/2p2c/sequential/fvpressuremultiphysics.hh
@@ -220,7 +220,7 @@ protected:
     #endif
 
     // subdomain map
-    Dune::BlockVector<Dune::FieldVector<int,1> > nextSubdomain;  //! vector holding next subdomain
+    Dune::BlockVector<Dune::FieldVector<int,1> > nextSubdomain;  //!< vector holding next subdomain
     const GlobalPosition& gravity_; //!< vector including the gravity constant
     //! gives kind of pressure used (\f$ 0 = p_w \f$, \f$ 1 = p_n \f$, \f$ 2 = p_{global} \f$)
     static constexpr int pressureType = GET_PROP_VALUE(TypeTag, PressureFormulation);
diff --git a/dumux/porousmediumflow/2pnc/model.hh b/dumux/porousmediumflow/2pnc/model.hh
index 6de3a09371..6124c7ce13 100644
--- a/dumux/porousmediumflow/2pnc/model.hh
+++ b/dumux/porousmediumflow/2pnc/model.hh
@@ -116,24 +116,24 @@ NEW_TYPE_TAG(TwoPNCNI, INHERITS_FROM(TwoPNC, NonIsothermal));
 //////////////////////////////////////////////////////////////////
 // Properties for the isothermal 2pnc model
 //////////////////////////////////////////////////////////////////
-SET_TYPE_PROP(TwoPNC, PrimaryVariables, SwitchablePrimaryVariables<TypeTag, int>);          //! The primary variables vector for the 2pnc model
-SET_TYPE_PROP(TwoPNC, PrimaryVariableSwitch, TwoPNCPrimaryVariableSwitch<TypeTag>);         //! The primary variable switch for the 2pnc model
-SET_TYPE_PROP(TwoPNC, VolumeVariables, TwoPNCVolumeVariables<TypeTag>);                     //! the VolumeVariables property
-SET_TYPE_PROP(TwoPNC, Indices, TwoPNCIndices <TypeTag, /*PVOffset=*/0>);                    //! The indices required by the isothermal 2pnc model
-SET_TYPE_PROP(TwoPNC, SpatialParams, FVSpatialParams<TypeTag>);                       //! Use the FVSpatialParams by default
-SET_TYPE_PROP(TwoPNC, VtkOutputFields, TwoPNCVtkOutputFields<TypeTag>);                     //! Set the vtk output fields specific to the TwoPNC model
-SET_TYPE_PROP(TwoPNC, LocalResidual, CompositionalLocalResidual<TypeTag>);                  //! Use the compositional local residual
-
-SET_INT_PROP(TwoPNC, NumComponents, GET_PROP_TYPE(TypeTag, FluidSystem)::numComponents);    //! Use the number of components of the fluid system
-SET_INT_PROP(TwoPNC, ReplaceCompEqIdx, GET_PROP_TYPE(TypeTag, FluidSystem)::numComponents); //! Per default, no component mass balance is replaced
-SET_INT_PROP(TwoPNC, NumEq, GET_PROP_TYPE(TypeTag, FluidSystem)::numComponents);            //! We solve one equation per component
-SET_INT_PROP(TwoPNC, Formulation, TwoPNCFormulation::pwsn);                                 //! Default formulation is pw-Sn, overwrite if necessary
-
-SET_BOOL_PROP(TwoPNC, SetMoleFractionsForWettingPhase, true);  //! Set the primary variables mole fractions for the wetting or non-wetting phase
-SET_BOOL_PROP(TwoPNC, EnableAdvection, true);                  //! Enable advection
-SET_BOOL_PROP(TwoPNC, EnableMolecularDiffusion, true);         //! Enable molecular diffusion
-SET_BOOL_PROP(TwoPNC, EnableEnergyBalance, false);             //! This is the isothermal variant of the model
-SET_BOOL_PROP(TwoPNC, UseMoles, true);                         //! Use mole fractions in the balance equations by default
+SET_TYPE_PROP(TwoPNC, PrimaryVariables, SwitchablePrimaryVariables<TypeTag, int>);          //!< The primary variables vector for the 2pnc model
+SET_TYPE_PROP(TwoPNC, PrimaryVariableSwitch, TwoPNCPrimaryVariableSwitch<TypeTag>);         //!< The primary variable switch for the 2pnc model
+SET_TYPE_PROP(TwoPNC, VolumeVariables, TwoPNCVolumeVariables<TypeTag>);                     //!< the VolumeVariables property
+SET_TYPE_PROP(TwoPNC, Indices, TwoPNCIndices <TypeTag, /*PVOffset=*/0>);                    //!< The indices required by the isothermal 2pnc model
+SET_TYPE_PROP(TwoPNC, SpatialParams, FVSpatialParams<TypeTag>);                       //!< Use the FVSpatialParams by default
+SET_TYPE_PROP(TwoPNC, VtkOutputFields, TwoPNCVtkOutputFields<TypeTag>);                     //!< Set the vtk output fields specific to the TwoPNC model
+SET_TYPE_PROP(TwoPNC, LocalResidual, CompositionalLocalResidual<TypeTag>);                  //!< Use the compositional local residual
+
+SET_INT_PROP(TwoPNC, NumComponents, GET_PROP_TYPE(TypeTag, FluidSystem)::numComponents);    //!< Use the number of components of the fluid system
+SET_INT_PROP(TwoPNC, ReplaceCompEqIdx, GET_PROP_TYPE(TypeTag, FluidSystem)::numComponents); //!< Per default, no component mass balance is replaced
+SET_INT_PROP(TwoPNC, NumEq, GET_PROP_TYPE(TypeTag, FluidSystem)::numComponents);            //!< We solve one equation per component
+SET_INT_PROP(TwoPNC, Formulation, TwoPNCFormulation::pwsn);                                 //!< Default formulation is pw-Sn, overwrite if necessary
+
+SET_BOOL_PROP(TwoPNC, SetMoleFractionsForWettingPhase, true);  //!< Set the primary variables mole fractions for the wetting or non-wetting phase
+SET_BOOL_PROP(TwoPNC, EnableAdvection, true);                  //!< Enable advection
+SET_BOOL_PROP(TwoPNC, EnableMolecularDiffusion, true);         //!< Enable molecular diffusion
+SET_BOOL_PROP(TwoPNC, EnableEnergyBalance, false);             //!< This is the isothermal variant of the model
+SET_BOOL_PROP(TwoPNC, UseMoles, true);                         //!< Use mole fractions in the balance equations by default
 
 
 //! Use the model after Millington (1961) for the effective diffusivity
@@ -174,10 +174,10 @@ public:
 /////////////////////////////////////////////////
 // Properties for the non-isothermal 2pnc model
 /////////////////////////////////////////////////
-SET_TYPE_PROP(TwoPNCNI, IsothermalVolumeVariables, TwoPNCVolumeVariables<TypeTag>);     //! set isothermal VolumeVariables
-SET_TYPE_PROP(TwoPNCNI, IsothermalLocalResidual, CompositionalLocalResidual<TypeTag>);  //! set isothermal LocalResidual
-SET_TYPE_PROP(TwoPNCNI, IsothermalIndices, TwoPNCIndices<TypeTag, /*PVOffset=*/0>);     //! set isothermal Indices
-SET_TYPE_PROP(TwoPNCNI, IsothermalVtkOutputFields, TwoPNCVtkOutputFields<TypeTag>);     //! set isothermal output fields
+SET_TYPE_PROP(TwoPNCNI, IsothermalVolumeVariables, TwoPNCVolumeVariables<TypeTag>);     //!< set isothermal VolumeVariables
+SET_TYPE_PROP(TwoPNCNI, IsothermalLocalResidual, CompositionalLocalResidual<TypeTag>);  //!< set isothermal LocalResidual
+SET_TYPE_PROP(TwoPNCNI, IsothermalIndices, TwoPNCIndices<TypeTag, /*PVOffset=*/0>);     //!< set isothermal Indices
+SET_TYPE_PROP(TwoPNCNI, IsothermalVtkOutputFields, TwoPNCVtkOutputFields<TypeTag>);     //!< set isothermal output fields
 
 //! Somerton is used as default model to compute the effective thermal heat conductivity
 SET_PROP(TwoPNCNI, ThermalConductivityModel)
diff --git a/dumux/porousmediumflow/2pncmin/model.hh b/dumux/porousmediumflow/2pncmin/model.hh
index 3086a9cd10..9ada6881dc 100644
--- a/dumux/porousmediumflow/2pncmin/model.hh
+++ b/dumux/porousmediumflow/2pncmin/model.hh
@@ -108,14 +108,14 @@ NEW_TYPE_TAG(TwoPNCMinNI, INHERITS_FROM(TwoPNCMin, NonIsothermal));
 //////////////////////////////////////////////////////////////////
 // Property tags for the isothermal 2pncmin model
 //////////////////////////////////////////////////////////////////
-SET_TYPE_PROP(TwoPNCMin, NonMineralizationVolumeVariables, TwoPNCVolumeVariables<TypeTag>);     //! the VolumeVariables property
-SET_TYPE_PROP(TwoPNCMin, NonMineralizationVtkOutputFields, TwoPNCVtkOutputFields<TypeTag>);     //! Set the vtk output fields specific to the TwoPNCMin model
+SET_TYPE_PROP(TwoPNCMin, NonMineralizationVolumeVariables, TwoPNCVolumeVariables<TypeTag>);     //!< the VolumeVariables property
+SET_TYPE_PROP(TwoPNCMin, NonMineralizationVtkOutputFields, TwoPNCVtkOutputFields<TypeTag>);     //!< Set the vtk output fields specific to the TwoPNCMin model
 
 //////////////////////////////////////////////////////////////////
 // Properties for the non-isothermal 2pncmin model
 //////////////////////////////////////////////////////////////////
-SET_TYPE_PROP(TwoPNCMinNI, IsothermalVolumeVariables, MineralizationVolumeVariables<TypeTag>);  //! set isothermal VolumeVariables
-SET_TYPE_PROP(TwoPNCMinNI, IsothermalVtkOutputFields, MineralizationVtkOutputFields<TypeTag>);  //! set isothermal output fields
+SET_TYPE_PROP(TwoPNCMinNI, IsothermalVolumeVariables, MineralizationVolumeVariables<TypeTag>);  //!< set isothermal VolumeVariables
+SET_TYPE_PROP(TwoPNCMinNI, IsothermalVtkOutputFields, MineralizationVtkOutputFields<TypeTag>);  //!< set isothermal output fields
 } // end namespace Properties
 } // end namespace Dumux
 
diff --git a/dumux/porousmediumflow/3pwateroil/properties.hh b/dumux/porousmediumflow/3pwateroil/properties.hh
index 2f235ed929..2ba4bc7e38 100644
--- a/dumux/porousmediumflow/3pwateroil/properties.hh
+++ b/dumux/porousmediumflow/3pwateroil/properties.hh
@@ -59,15 +59,15 @@ NEW_PROP_TAG(MaterialLaw);   //!< The material law which ought to be used (extra
 
 NEW_PROP_TAG(ProblemEnableGravity); //!< Returns whether gravity is considered in the problem
 
-NEW_PROP_TAG(UseMoles); //!Defines whether mole (true) or mass (false) fractions are used
+NEW_PROP_TAG(UseMoles); //!< Defines whether mole (true) or mass (false) fractions are used
 
-NEW_PROP_TAG(UseMassOutput); //!Defines whether mole or mass are used for phaseStorage output
+NEW_PROP_TAG(UseMassOutput); //!< Defines whether mole or mass are used for phaseStorage output
 NEW_PROP_TAG(EffectiveDiffusivityModel); //!< The employed model for the computation of the effective diffusivity
 
 NEW_PROP_TAG(ImplicitMassUpwindWeight); //!< The value of the upwind parameter for the mobility
 NEW_PROP_TAG(ImplicitMobilityUpwindWeight); //!< Weight for the upwind mobility in the velocity calculation
 NEW_PROP_TAG(UseSimpleModel); //!< Determines whether a simple model with only two phase states (wng) and (wn) should be used
-NEW_PROP_TAG(BaseFluxVariables); //! The base flux variables
+NEW_PROP_TAG(BaseFluxVariables); //!< The base flux variables
 NEW_PROP_TAG(SpatialParamsForchCoeff); //!< Property for the forchheimer coefficient
 }
 }
diff --git a/dumux/porousmediumflow/nonisothermal/indices.hh b/dumux/porousmediumflow/nonisothermal/indices.hh
index 42ebd4c8c3..2c77c7af92 100644
--- a/dumux/porousmediumflow/nonisothermal/indices.hh
+++ b/dumux/porousmediumflow/nonisothermal/indices.hh
@@ -40,8 +40,8 @@ class EnergyIndices : public GET_PROP_TYPE(TypeTag, IsothermalIndices)
 {
 public:
     static const int numEq = GET_PROP_VALUE(TypeTag, NumEq);
-    static const int temperatureIdx = PVOffset + numEq -1; //! The index for temperature in primary variable vectors.
-    static const int energyEqIdx = PVOffset + numEq -1; //! The index for energy in equation vectors.
+    static const int temperatureIdx = PVOffset + numEq -1; //!< The index for temperature in primary variable vectors.
+    static const int energyEqIdx = PVOffset + numEq -1; //!< The index for energy in equation vectors.
 
 };
 
diff --git a/dumux/porousmediumflow/richards/model.hh b/dumux/porousmediumflow/richards/model.hh
index 0ecedffa1a..601e22abe1 100644
--- a/dumux/porousmediumflow/richards/model.hh
+++ b/dumux/porousmediumflow/richards/model.hh
@@ -144,7 +144,7 @@ SET_INT_PROP(Richards, NumComponents, 1);
 //! The local residual operator
 SET_TYPE_PROP(Richards, LocalResidual, RichardsLocalResidual<TypeTag>);
 
-SET_TYPE_PROP(Richards, VtkOutputFields, RichardsVtkOutputFields<TypeTag>);           //! Set the vtk output fields specific to the twop model
+SET_TYPE_PROP(Richards, VtkOutputFields, RichardsVtkOutputFields<TypeTag>);           //!< Set the vtk output fields specific to the twop model
 
 //! The class for the volume averaged quantities
 SET_TYPE_PROP(Richards, VolumeVariables, RichardsVolumeVariables<TypeTag>);
diff --git a/dumux/porousmediumflow/richards/volumevariables.hh b/dumux/porousmediumflow/richards/volumevariables.hh
index 4e23e719b7..4d5c871f2f 100644
--- a/dumux/porousmediumflow/richards/volumevariables.hh
+++ b/dumux/porousmediumflow/richards/volumevariables.hh
@@ -405,14 +405,14 @@ public:
     }
 
 protected:
-    FluidState fluidState_; //! the fluid state
-    Scalar relativePermeabilityWetting_; //! the relative permeability of the wetting phase
-    Scalar porosity_; //! the porosity
-    PermeabilityType permeability_; //! the instrinsic permeability
-    Scalar minPc_; //! the minimum capillary pressure (entry pressure)
-    Scalar moleFraction_[numPhases]; //! The water mole fractions in water and air
-    Scalar molarDensity_[numPhases]; //! The molar density of water and air
-    Scalar diffCoeff_; //! The binary diffusion coefficient of water in air
+    FluidState fluidState_; //!< the fluid state
+    Scalar relativePermeabilityWetting_; //!< the relative permeability of the wetting phase
+    Scalar porosity_; //!< the porosity
+    PermeabilityType permeability_; //!< the instrinsic permeability
+    Scalar minPc_; //!< the minimum capillary pressure (entry pressure)
+    Scalar moleFraction_[numPhases]; //!< The water mole fractions in water and air
+    Scalar molarDensity_[numPhases]; //!< The molar density of water and air
+    Scalar diffCoeff_; //!< The binary diffusion coefficient of water in air
 };
 
 } // end namespace Dumux
diff --git a/dumux/porousmediumflow/richardsnc/model.hh b/dumux/porousmediumflow/richardsnc/model.hh
index 64055776a2..f1e5eef63c 100644
--- a/dumux/porousmediumflow/richardsnc/model.hh
+++ b/dumux/porousmediumflow/richardsnc/model.hh
@@ -118,7 +118,7 @@ SET_PROP(RichardsNC, FluidState)
     using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem);
     using type = CompositionalFluidState<Scalar, FluidSystem>;
 };
-SET_TYPE_PROP(RichardsNC, VtkOutputFields, RichardsNCVtkOutputFields<TypeTag>);           //! Set the vtk output fields specific to the twop model
+SET_TYPE_PROP(RichardsNC, VtkOutputFields, RichardsNCVtkOutputFields<TypeTag>);           //!< Set the vtk output fields specific to the twop model
 
 //! Set the indices used
 SET_TYPE_PROP(RichardsNC, Indices, RichardsNCIndices<TypeTag>);
diff --git a/dumux/porousmediumflow/richardsnc/volumevariables.hh b/dumux/porousmediumflow/richardsnc/volumevariables.hh
index 6553b29e3f..497292e9d5 100644
--- a/dumux/porousmediumflow/richardsnc/volumevariables.hh
+++ b/dumux/porousmediumflow/richardsnc/volumevariables.hh
@@ -268,12 +268,12 @@ public:
     { return saturation(phaseIdx) * porosity_; }
 
 protected:
-    FluidState fluidState_; //! the fluid state
-    Scalar relativePermeabilityWetting_; //! the relative permeability of the wetting phase
-    Scalar porosity_; //! the porosity
-    PermeabilityType permeability_; //! the instrinsic permeability
-    Scalar pn_; //! the reference non-wetting pressure
-    Scalar minPc_; //! the minimum capillary pressure (entry pressure)
+    FluidState fluidState_; //!< the fluid state
+    Scalar relativePermeabilityWetting_; //!< the relative permeability of the wetting phase
+    Scalar porosity_; //!< the porosity
+    PermeabilityType permeability_; //!< the instrinsic permeability
+    Scalar pn_; //!< the reference non-wetting pressure
+    Scalar minPc_; //!< the minimum capillary pressure (entry pressure)
 };
 
 /*!
diff --git a/test/freeflow/staggered/test_angeli.cc b/test/freeflow/staggered/test_angeli.cc
index 6b7f620176..237c477396 100644
--- a/test/freeflow/staggered/test_angeli.cc
+++ b/test/freeflow/staggered/test_angeli.cc
@@ -161,7 +161,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     StaggeredVtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.addField(problem->getAnalyticalPressureSolution(), "pressureExact");
     vtkWriter.addField(problem->getAnalyticalVelocitySolution(), "velocityExact");
     vtkWriter.addFaceField(problem->getAnalyticalVelocitySolutionOnFace(), "faceVelocityExact");
diff --git a/test/freeflow/staggered/test_channel.cc b/test/freeflow/staggered/test_channel.cc
index 6c0a54e108..edee5e1a0a 100644
--- a/test/freeflow/staggered/test_channel.cc
+++ b/test/freeflow/staggered/test_channel.cc
@@ -160,7 +160,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     StaggeredVtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     // the assembler with time loop for instationary problem
diff --git a/test/freeflow/staggered/test_closedsystem.cc b/test/freeflow/staggered/test_closedsystem.cc
index 61169100ab..d264159c6a 100644
--- a/test/freeflow/staggered/test_closedsystem.cc
+++ b/test/freeflow/staggered/test_closedsystem.cc
@@ -155,7 +155,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     StaggeredVtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     // instantiate time loop
diff --git a/test/freeflow/staggered/test_donea.cc b/test/freeflow/staggered/test_donea.cc
index 4ef7f924d9..0ae1ff2297 100644
--- a/test/freeflow/staggered/test_donea.cc
+++ b/test/freeflow/staggered/test_donea.cc
@@ -143,7 +143,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     StaggeredVtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.addField(problem->getAnalyticalPressureSolution(), "pressureExact");
     vtkWriter.addField(problem->getAnalyticalVelocitySolution(), "velocityExact");
     vtkWriter.addFaceField(problem->getAnalyticalVelocitySolutionOnFace(), "faceVelocityExact");
diff --git a/test/freeflow/staggered/test_kovasznay.cc b/test/freeflow/staggered/test_kovasznay.cc
index 50afa4e0a8..21ffd30708 100644
--- a/test/freeflow/staggered/test_kovasznay.cc
+++ b/test/freeflow/staggered/test_kovasznay.cc
@@ -142,7 +142,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     StaggeredVtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.addField(problem->getAnalyticalPressureSolution(), "pressureExact");
     vtkWriter.addField(problem->getAnalyticalVelocitySolution(), "velocityExact");
     vtkWriter.addFaceField(problem->getAnalyticalVelocitySolutionOnFace(), "faceVelocityExact");
diff --git a/test/freeflow/staggerednc/test_channel.cc b/test/freeflow/staggerednc/test_channel.cc
index 92139af762..53ac33e9d2 100644
--- a/test/freeflow/staggerednc/test_channel.cc
+++ b/test/freeflow/staggerednc/test_channel.cc
@@ -160,7 +160,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     StaggeredVtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.addField(problem->getDeltaP(), "deltaP");
     vtkWriter.write(0.0);
 
diff --git a/test/freeflow/staggerednc/test_densitydrivenflow.cc b/test/freeflow/staggerednc/test_densitydrivenflow.cc
index 58b1f06942..3b90fe85fd 100644
--- a/test/freeflow/staggerednc/test_densitydrivenflow.cc
+++ b/test/freeflow/staggerednc/test_densitydrivenflow.cc
@@ -159,7 +159,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     StaggeredVtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.addField(problem->getDeltaRho(), "deltaRho");
     vtkWriter.write(0.0);
 
diff --git a/test/porousmediumflow/1p/implicit/compressible/test_1p.cc b/test/porousmediumflow/1p/implicit/compressible/test_1p.cc
index bf6ef42198..6f213b0406 100644
--- a/test/porousmediumflow/1p/implicit/compressible/test_1p.cc
+++ b/test/porousmediumflow/1p/implicit/compressible/test_1p.cc
@@ -114,7 +114,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     // instantiate time loop
diff --git a/test/porousmediumflow/1p/implicit/compressible/test_1p_stationary.cc b/test/porousmediumflow/1p/implicit/compressible/test_1p_stationary.cc
index 69bd17d006..712b2dc570 100644
--- a/test/porousmediumflow/1p/implicit/compressible/test_1p_stationary.cc
+++ b/test/porousmediumflow/1p/implicit/compressible/test_1p_stationary.cc
@@ -103,7 +103,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     // the assembler with time loop for instationary problem
diff --git a/test/porousmediumflow/1p/implicit/incompressible/test_1pfv.cc b/test/porousmediumflow/1p/implicit/incompressible/test_1pfv.cc
index bbb75716af..3d488de44a 100644
--- a/test/porousmediumflow/1p/implicit/incompressible/test_1pfv.cc
+++ b/test/porousmediumflow/1p/implicit/incompressible/test_1pfv.cc
@@ -96,7 +96,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     // make assemble and attach linear system
diff --git a/test/porousmediumflow/1p/implicit/pointsources/test_1pfv_pointsources.cc b/test/porousmediumflow/1p/implicit/pointsources/test_1pfv_pointsources.cc
index e541556e9d..917f4da90d 100644
--- a/test/porousmediumflow/1p/implicit/pointsources/test_1pfv_pointsources.cc
+++ b/test/porousmediumflow/1p/implicit/pointsources/test_1pfv_pointsources.cc
@@ -115,7 +115,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     // instantiate time loop
diff --git a/test/porousmediumflow/1p/implicit/pointsources/test_1pfv_pointsources_timedependent.cc b/test/porousmediumflow/1p/implicit/pointsources/test_1pfv_pointsources_timedependent.cc
index 2ee38fd5bf..e07f665b92 100644
--- a/test/porousmediumflow/1p/implicit/pointsources/test_1pfv_pointsources_timedependent.cc
+++ b/test/porousmediumflow/1p/implicit/pointsources/test_1pfv_pointsources_timedependent.cc
@@ -115,7 +115,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     // instantiate time loop
diff --git a/test/porousmediumflow/1p/implicit/test_1pfv.cc b/test/porousmediumflow/1p/implicit/test_1pfv.cc
index f6a3c02d0d..39052a1121 100644
--- a/test/porousmediumflow/1p/implicit/test_1pfv.cc
+++ b/test/porousmediumflow/1p/implicit/test_1pfv.cc
@@ -146,7 +146,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
 
     // if we are using a random permeability field with gstat
     bool isRandomField = getParam<bool>("SpatialParams.RandomField", false);
diff --git a/test/porousmediumflow/1p/implicit/test_1pfv_fracture2d3d.cc b/test/porousmediumflow/1p/implicit/test_1pfv_fracture2d3d.cc
index 0a4bb5c0f1..51da32020b 100644
--- a/test/porousmediumflow/1p/implicit/test_1pfv_fracture2d3d.cc
+++ b/test/porousmediumflow/1p/implicit/test_1pfv_fracture2d3d.cc
@@ -140,7 +140,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     // instantiate time loop
diff --git a/test/porousmediumflow/1p/implicit/test_1pfv_network1d3d.cc b/test/porousmediumflow/1p/implicit/test_1pfv_network1d3d.cc
index 816bdc9ecf..f258f7228b 100644
--- a/test/porousmediumflow/1p/implicit/test_1pfv_network1d3d.cc
+++ b/test/porousmediumflow/1p/implicit/test_1pfv_network1d3d.cc
@@ -140,7 +140,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     // instantiate time loop
diff --git a/test/porousmediumflow/1p/implicit/test_1pnifv.cc b/test/porousmediumflow/1p/implicit/test_1pnifv.cc
index 51dc2e67a3..98b6563d55 100644
--- a/test/porousmediumflow/1p/implicit/test_1pnifv.cc
+++ b/test/porousmediumflow/1p/implicit/test_1pnifv.cc
@@ -142,7 +142,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.addField(problem->getExactTemperature(), "temperatureExact");
     vtkWriter.write(0.0);
 
diff --git a/test/porousmediumflow/1pnc/implicit/test_1p2c_fv.cc b/test/porousmediumflow/1pnc/implicit/test_1p2c_fv.cc
index 998eebadf2..ec5573e01e 100644
--- a/test/porousmediumflow/1pnc/implicit/test_1p2c_fv.cc
+++ b/test/porousmediumflow/1pnc/implicit/test_1p2c_fv.cc
@@ -114,7 +114,7 @@
      // intialize the vtk output module
      VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
      using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
-     VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+     VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
      vtkWriter.write(0.0);
 
      // instantiate time loop
diff --git a/test/porousmediumflow/1pnc/implicit/test_1p2cni_conduction_fv.cc b/test/porousmediumflow/1pnc/implicit/test_1p2cni_conduction_fv.cc
index 68808be8fe..3d1a250599 100644
--- a/test/porousmediumflow/1pnc/implicit/test_1p2cni_conduction_fv.cc
+++ b/test/porousmediumflow/1pnc/implicit/test_1p2cni_conduction_fv.cc
@@ -114,7 +114,7 @@
      // intialize the vtk output module
      VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
      using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
-     VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+     VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
      vtkWriter.addField(problem->getExactTemperature(), "temperatureExact");
      vtkWriter.write(0.0);
      // output every vtkOutputInterval time step
diff --git a/test/porousmediumflow/1pnc/implicit/test_1p2cni_convection_fv.cc b/test/porousmediumflow/1pnc/implicit/test_1p2cni_convection_fv.cc
index a2736a7a69..78e1b7a462 100644
--- a/test/porousmediumflow/1pnc/implicit/test_1p2cni_convection_fv.cc
+++ b/test/porousmediumflow/1pnc/implicit/test_1p2cni_convection_fv.cc
@@ -114,7 +114,7 @@
      // intialize the vtk output module
      VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
      using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
-     VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+     VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
      vtkWriter.addField(problem->getExactTemperature(), "temperatureExact");
      vtkWriter.write(0.0);
      // output every vtkOutputInterval time step
diff --git a/test/porousmediumflow/2p/implicit/adaptive/test_2p_adaptive_fv.cc b/test/porousmediumflow/2p/implicit/adaptive/test_2p_adaptive_fv.cc
index 647253bb60..3ee56a5758 100644
--- a/test/porousmediumflow/2p/implicit/adaptive/test_2p_adaptive_fv.cc
+++ b/test/porousmediumflow/2p/implicit/adaptive/test_2p_adaptive_fv.cc
@@ -147,9 +147,9 @@ int main(int argc, char** argv) try
         // update grid data after adaption
         if (wasAdapted)
         {
-            xOld = x;                         //! Overwrite the old solution with the new (resized & interpolated) one
-            gridVariables->init(x, xOld);     //! Initialize the secondary variables to the new (and "new old") solution
-            problem->computePointSourceMap(); //! Update the point source map
+            xOld = x;                         //!< Overwrite the old solution with the new (resized & interpolated) one
+            gridVariables->init(x, xOld);     //!< Initialize the secondary variables to the new (and "new old") solution
+            problem->computePointSourceMap(); //!< Update the point source map
         }
     }
 
@@ -164,9 +164,9 @@ int main(int argc, char** argv) try
     // update grid data after adaption
     if (wasAdapted)
     {
-        xOld = x;                         //! Overwrite the old solution with the new (resized & interpolated) one
-        gridVariables->init(x, xOld);     //! Initialize the secondary variables to the new (and "new old") solution
-        problem->computePointSourceMap(); //! Update the point source map
+        xOld = x;                         //!< Overwrite the old solution with the new (resized & interpolated) one
+        gridVariables->init(x, xOld);     //!< Initialize the secondary variables to the new (and "new old") solution
+        problem->computePointSourceMap(); //!< Update the point source map
     }
 
     // get some time loop parameters
@@ -184,7 +184,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     // instantiate time loop
@@ -222,11 +222,11 @@ int main(int argc, char** argv) try
             if (wasAdapted)
             {
                 // Note that if we were using point sources, we would have to update the map here as well
-                xOld = x;                         //! Overwrite the old solution with the new (resized & interpolated) one
-                assembler->setJacobianPattern();  //! Tell the assembler to resize the matrix and set pattern
-                assembler->setResidualSize();     //! Tell the assembler to resize the residual
-                gridVariables->init(x, xOld);     //! Initialize the secondary variables to the new (and "new old") solution
-                problem->computePointSourceMap(); //! Update the point source map
+                xOld = x;                         //!< Overwrite the old solution with the new (resized & interpolated) one
+                assembler->setJacobianPattern();  //!< Tell the assembler to resize the matrix and set pattern
+                assembler->setResidualSize();     //!< Tell the assembler to resize the residual
+                gridVariables->init(x, xOld);     //!< Initialize the secondary variables to the new (and "new old") solution
+                problem->computePointSourceMap(); //!< Update the point source map
             }
         }
 
diff --git a/test/porousmediumflow/2p/implicit/fracture/test_2p_fracture_fv.cc b/test/porousmediumflow/2p/implicit/fracture/test_2p_fracture_fv.cc
index fa9b06a96e..fedc3d2d92 100644
--- a/test/porousmediumflow/2p/implicit/fracture/test_2p_fracture_fv.cc
+++ b/test/porousmediumflow/2p/implicit/fracture/test_2p_fracture_fv.cc
@@ -129,7 +129,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     // instantiate time loop
diff --git a/test/porousmediumflow/2p/implicit/incompressible/test_2p_fv.cc b/test/porousmediumflow/2p/implicit/incompressible/test_2p_fv.cc
index 3d33bdf9b1..2628abaa29 100644
--- a/test/porousmediumflow/2p/implicit/incompressible/test_2p_fv.cc
+++ b/test/porousmediumflow/2p/implicit/incompressible/test_2p_fv.cc
@@ -147,7 +147,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     // instantiate time loop
diff --git a/test/porousmediumflow/2p/implicit/nonisothermal/test_2pni_fv.cc b/test/porousmediumflow/2p/implicit/nonisothermal/test_2pni_fv.cc
index c6f63d9a42..0c184ca26c 100644
--- a/test/porousmediumflow/2p/implicit/nonisothermal/test_2pni_fv.cc
+++ b/test/porousmediumflow/2p/implicit/nonisothermal/test_2pni_fv.cc
@@ -140,7 +140,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     // instantiate time loop
diff --git a/test/porousmediumflow/2p1c/implicit/test_2p1c_fv.cc b/test/porousmediumflow/2p1c/implicit/test_2p1c_fv.cc
index 9f73c8d302..034d9b213c 100644
--- a/test/porousmediumflow/2p1c/implicit/test_2p1c_fv.cc
+++ b/test/porousmediumflow/2p1c/implicit/test_2p1c_fv.cc
@@ -114,7 +114,7 @@
      // intialize the vtk output module
      VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
      using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
-     VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+     VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
      vtkWriter.write(0.0);
 
      // instantiate time loop
diff --git a/test/porousmediumflow/2p2c/implicit/test_2p2c_fv.cc b/test/porousmediumflow/2p2c/implicit/test_2p2c_fv.cc
index f2e0cf96ac..1cfe2691f6 100644
--- a/test/porousmediumflow/2p2c/implicit/test_2p2c_fv.cc
+++ b/test/porousmediumflow/2p2c/implicit/test_2p2c_fv.cc
@@ -116,7 +116,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     // instantiate time loop
diff --git a/test/porousmediumflow/2pnc/implicit/test_2pnc_fv.cc b/test/porousmediumflow/2pnc/implicit/test_2pnc_fv.cc
index 85b68ee55d..760eb80e1f 100644
--- a/test/porousmediumflow/2pnc/implicit/test_2pnc_fv.cc
+++ b/test/porousmediumflow/2pnc/implicit/test_2pnc_fv.cc
@@ -140,8 +140,8 @@ int main(int argc, char** argv) try
     // initialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
-    problem->addVtkFields(vtkWriter); //! Add problem specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
+    problem->addVtkFields(vtkWriter); //!< Add problem specific output fields
     vtkWriter.write(0.0);
 
     // instantiate time loop
diff --git a/test/porousmediumflow/2pncmin/implicit/dissolutionproblem.hh b/test/porousmediumflow/2pncmin/implicit/dissolutionproblem.hh
index a901fe2fbe..ac6e0376a1 100644
--- a/test/porousmediumflow/2pncmin/implicit/dissolutionproblem.hh
+++ b/test/porousmediumflow/2pncmin/implicit/dissolutionproblem.hh
@@ -62,7 +62,7 @@ SET_PROP(DissolutionTypeTag, FluidSystem)
 SET_TYPE_PROP(DissolutionTypeTag, SpatialParams, DissolutionSpatialparams<TypeTag>);
 
 //Set properties here to override the default property settings
-SET_INT_PROP(DissolutionTypeTag, ReplaceCompEqIdx, 1); //! Replace gas balance by total mass balance
+SET_INT_PROP(DissolutionTypeTag, ReplaceCompEqIdx, 1); //!< Replace gas balance by total mass balance
 SET_INT_PROP(DissolutionTypeTag, Formulation, TwoPNCFormulation::pnsw);
 }
 
diff --git a/test/porousmediumflow/2pncmin/implicit/test_2pncmin_fv.cc b/test/porousmediumflow/2pncmin/implicit/test_2pncmin_fv.cc
index d5b313c23b..254e48935b 100644
--- a/test/porousmediumflow/2pncmin/implicit/test_2pncmin_fv.cc
+++ b/test/porousmediumflow/2pncmin/implicit/test_2pncmin_fv.cc
@@ -138,7 +138,7 @@ int main(int argc, char** argv) try
     // initialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     //add specific output
     vtkWriter.addField(problem->getKxx(), "Kxx");
     vtkWriter.addField(problem->getKyy(), "Kyy");
diff --git a/test/porousmediumflow/3p/implicit/test_3p_fv.cc b/test/porousmediumflow/3p/implicit/test_3p_fv.cc
index 86b28e07ad..90517031de 100644
--- a/test/porousmediumflow/3p/implicit/test_3p_fv.cc
+++ b/test/porousmediumflow/3p/implicit/test_3p_fv.cc
@@ -145,7 +145,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     // instantiate time loop
diff --git a/test/porousmediumflow/3p/implicit/test_3pni_fv_conduction.cc b/test/porousmediumflow/3p/implicit/test_3pni_fv_conduction.cc
index 7bef199e27..38ff031ed6 100644
--- a/test/porousmediumflow/3p/implicit/test_3pni_fv_conduction.cc
+++ b/test/porousmediumflow/3p/implicit/test_3pni_fv_conduction.cc
@@ -145,7 +145,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.addField(problem->getExactTemperature(), "temperatureExact");
     vtkWriter.write(0.0);
     // output every vtkOutputInterval time step
diff --git a/test/porousmediumflow/3p/implicit/test_3pni_fv_convection.cc b/test/porousmediumflow/3p/implicit/test_3pni_fv_convection.cc
index 83b4c614f8..0da9bcc0a5 100644
--- a/test/porousmediumflow/3p/implicit/test_3pni_fv_convection.cc
+++ b/test/porousmediumflow/3p/implicit/test_3pni_fv_convection.cc
@@ -145,7 +145,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.addField(problem->getExactTemperature(), "temperatureExact");
     vtkWriter.write(0.0);
     // output every vtkOutputInterval time step
diff --git a/test/porousmediumflow/3p3c/implicit/test_3p3c_fv.cc b/test/porousmediumflow/3p3c/implicit/test_3p3c_fv.cc
index 00f2252c59..9b68aacd92 100644
--- a/test/porousmediumflow/3p3c/implicit/test_3p3c_fv.cc
+++ b/test/porousmediumflow/3p3c/implicit/test_3p3c_fv.cc
@@ -145,7 +145,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     // instantiate time loop
diff --git a/test/porousmediumflow/co2/implicit/test_co2_fv.cc b/test/porousmediumflow/co2/implicit/test_co2_fv.cc
index 47b508d624..6192ed1bc5 100644
--- a/test/porousmediumflow/co2/implicit/test_co2_fv.cc
+++ b/test/porousmediumflow/co2/implicit/test_co2_fv.cc
@@ -115,8 +115,8 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
-    problem->addFieldsToWriter(vtkWriter); //! Add some more problem dependent fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
+    problem->addFieldsToWriter(vtkWriter); //!< Add some more problem dependent fields
     vtkWriter.write(0.0);
 
     // instantiate time loop
diff --git a/test/porousmediumflow/richards/implicit/test_ccrichardsanalytical.cc b/test/porousmediumflow/richards/implicit/test_ccrichardsanalytical.cc
index 84cd68a11f..41b6568b06 100644
--- a/test/porousmediumflow/richards/implicit/test_ccrichardsanalytical.cc
+++ b/test/porousmediumflow/richards/implicit/test_ccrichardsanalytical.cc
@@ -141,7 +141,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     // instantiate time loop
diff --git a/test/porousmediumflow/richards/implicit/test_richardslens_fv.cc b/test/porousmediumflow/richards/implicit/test_richardslens_fv.cc
index 786d5c8b65..61234f44ab 100644
--- a/test/porousmediumflow/richards/implicit/test_richardslens_fv.cc
+++ b/test/porousmediumflow/richards/implicit/test_richardslens_fv.cc
@@ -141,7 +141,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     // instantiate time loop
diff --git a/test/porousmediumflow/richards/implicit/test_richardsniconduction_fv.cc b/test/porousmediumflow/richards/implicit/test_richardsniconduction_fv.cc
index 8970db7557..0323d1b9ba 100644
--- a/test/porousmediumflow/richards/implicit/test_richardsniconduction_fv.cc
+++ b/test/porousmediumflow/richards/implicit/test_richardsniconduction_fv.cc
@@ -141,7 +141,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.addField(problem->getExactTemperature(), "temperatureExact");
     vtkWriter.write(0.0);
 
diff --git a/test/porousmediumflow/richards/implicit/test_richardsniconvection_fv.cc b/test/porousmediumflow/richards/implicit/test_richardsniconvection_fv.cc
index 6f42130c79..38941e54e9 100644
--- a/test/porousmediumflow/richards/implicit/test_richardsniconvection_fv.cc
+++ b/test/porousmediumflow/richards/implicit/test_richardsniconvection_fv.cc
@@ -141,7 +141,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.addField(problem->getExactTemperature(), "temperatureExact");
     vtkWriter.write(0.0);
 
diff --git a/test/porousmediumflow/richardsnc/implicit/test_richardsnc_fv.cc b/test/porousmediumflow/richardsnc/implicit/test_richardsnc_fv.cc
index 505905c13c..915f4e27e6 100644
--- a/test/porousmediumflow/richardsnc/implicit/test_richardsnc_fv.cc
+++ b/test/porousmediumflow/richardsnc/implicit/test_richardsnc_fv.cc
@@ -141,7 +141,7 @@ int main(int argc, char** argv) try
     // intialize the vtk output module
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     // instantiate time loop
diff --git a/test/porousmediumflow/tracer/1ptracer/test_cctracer.cc b/test/porousmediumflow/tracer/1ptracer/test_cctracer.cc
index 62d093e0ea..179895a4e7 100644
--- a/test/porousmediumflow/tracer/1ptracer/test_cctracer.cc
+++ b/test/porousmediumflow/tracer/1ptracer/test_cctracer.cc
@@ -240,7 +240,7 @@ int main(int argc, char** argv)
     //! intialize the vtk output module
     VtkOutputModule<TracerTypeTag> vtkWriter(*tracerProblem, *fvGridGeometry, *gridVariables, x, tracerProblem->name());
     using VtkOutputFields = typename GET_PROP_TYPE(TracerTypeTag, VtkOutputFields);
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     /////////////////////////////////////////////////////////////////////////////////////////////////
diff --git a/test/porousmediumflow/tracer/constvel/test_tracer.cc b/test/porousmediumflow/tracer/constvel/test_tracer.cc
index 4c5156167f..7a789b011e 100644
--- a/test/porousmediumflow/tracer/constvel/test_tracer.cc
+++ b/test/porousmediumflow/tracer/constvel/test_tracer.cc
@@ -127,7 +127,7 @@ int main(int argc, char** argv) try
     //! intialize the vtk output module
     VtkOutputModule<TypeTag> vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name());
     using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields);
-    VtkOutputFields::init(vtkWriter); //! Add model specific output fields
+    VtkOutputFields::init(vtkWriter); //!< Add model specific output fields
     vtkWriter.write(0.0);
 
     /////////////////////////////////////////////////////////////////////////////////////////////////
-- 
GitLab