diff --git a/dumux/freeflow/navierstokes/model.hh b/dumux/freeflow/navierstokes/model.hh
index 06f618f894d322dcb4300aacc9559407e14fb1be..6e58d4a18e9fac34b4cc8dc9d2f91882f4e8e6b6 100644
--- a/dumux/freeflow/navierstokes/model.hh
+++ b/dumux/freeflow/navierstokes/model.hh
@@ -18,8 +18,10 @@
  *****************************************************************************/
 /*!
  * \file
+ * \ingroup NavierStokesModel
  *
- * \brief Isothermal Navier-Stokes model
+ * \brief A single-phase, isothermal Navier-Stokes model
+ * TODO: doc me!
  */
 
 #ifndef DUMUX_NAVIERSTOKES_MODEL_HH
@@ -39,120 +41,108 @@
 #include <dumux/material/fluidstates/immiscible.hh>
 #include <dumux/discretization/methods.hh>
 
+namespace Dumux
+{
+
+// \{
+///////////////////////////////////////////////////////////////////////////
+// properties for the single-phase, isothermal Navier-Stokes model
+///////////////////////////////////////////////////////////////////////////
+namespace Properties {
+
+//////////////////////////////////////////////////////////////////
+// Type tags
+//////////////////////////////////////////////////////////////////
+
+//! The type tag for the single-phase, isothermal Navier-Stokes model
+NEW_TYPE_TAG(NavierStokes, INHERITS_FROM(FreeFlow));
+
+//! The type tag for the corresponding non-isothermal model
+NEW_TYPE_TAG(NavierStokesNI, INHERITS_FROM(NavierStokes, NavierStokesNonIsothermal));
+
+//////////////////////////////////////////////////////////////////
+// Property tags
+//////////////////////////////////////////////////////////////////
+
+NEW_PROP_TAG(EnableInertiaTerms); //!< Returns whether to include inertia terms in the momentum balance eq or not (Stokes / Navier-Stokes)
+NEW_PROP_TAG(NormalizePressure); //!<  Returns whether to normalize the pressure term in the momentum balance or not
+
+///////////////////////////////////////////////////////////////////////////
+// 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_BOOL_PROP(NavierStokes, EnableAdvection, true); //!< Enable advection
+SET_BOOL_PROP(NavierStokes, EnableMolecularDiffusion, false); //!< The one-phase model has no molecular diffusion
+SET_BOOL_PROP(NavierStokes, EnableEnergyBalance, false); //!< The model is isothermal
+SET_BOOL_PROP(NavierStokes, EnableInertiaTerms, true); //!< Consider inertia terms by default
+SET_BOOL_PROP(NavierStokes, NormalizePressure, true); //!< Normalize the pressure term in the momentum balance by default
+
+//! The number of equations
+SET_PROP(NavierStokes, NumEq)
+{
+private:
+    using GridView = typename GET_PROP_TYPE(TypeTag, GridView);
+    static constexpr auto dim = GridView::dimension;
+public:
+    static constexpr int value = dim + 1;
+};
+
 /*!
- * \ingroup NavierStokesModel
- * \brief A single-phase, isothermal isothermal Navier-Stokes model
- * TODO: doc me!
+ * \brief The fluid state which is used by the volume variables to
+ *        store the thermodynamic state. This should be chosen
+ *        appropriately for the model ((non-)isothermal, equilibrium, ...).
+ *        This can be done in the problem.
  */
-
- namespace Dumux
- {
-
- // \{
- ///////////////////////////////////////////////////////////////////////////
- // properties for the isothermal Navier-Stokes model
- ///////////////////////////////////////////////////////////////////////////
- namespace Properties {
-
- //////////////////////////////////////////////////////////////////
- // Type tags
- //////////////////////////////////////////////////////////////////
-
- //! The type tags for the implicit single-phase problems
- NEW_TYPE_TAG(NavierStokes, INHERITS_FROM(FreeFlow));
-
- //! The type tags for the corresponding non-isothermal problems
- NEW_TYPE_TAG(NavierStokesNI, INHERITS_FROM(NavierStokes, NavierStokesNonIsothermal));
-
- //////////////////////////////////////////////////////////////////
- // Property tags
- //////////////////////////////////////////////////////////////////
-
- NEW_PROP_TAG(EnableInertiaTerms); //!< Returns whether to include inertia terms in the momentum balance eq or not (Stokes / Navier-Stokes)
- NEW_PROP_TAG(NormalizePressure); //!<  Returns whether to normalize the pressure term in the momentum balance or not
-
- ///////////////////////////////////////////////////////////////////////////
- // 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
-
- //! The number of equations
- SET_PROP(NavierStokes, NumEq)
- {
- private:
-     using GridView = typename GET_PROP_TYPE(TypeTag, GridView);
-     static constexpr auto dim = GridView::dimension;
- public:
-     static constexpr int value = dim + 1;
- };
-
- /*!
-  * \brief The fluid state which is used by the volume variables to
-  *        store the thermodynamic state. This should be chosen
-  *        appropriately for the model ((non-)isothermal, equilibrium, ...).
-  *        This can be done in the problem.
-  */
- SET_PROP(NavierStokes, FluidState){
-     private:
-         using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar);
-         using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem);
-     public:
-         using type = Dumux::ImmiscibleFluidState<Scalar, FluidSystem>;
- };
-
- //! The local residual function
- SET_TYPE_PROP(NavierStokes, LocalResidual, NavierStokesResidual<TypeTag>);
-
- //! the VolumeVariables property
- SET_TYPE_PROP(NavierStokes, VolumeVariables, NavierStokesVolumeVariables<TypeTag>);
-
- //! The NavierStokes FluxVariables
- SET_TYPE_PROP(NavierStokes, FluxVariables, NavierStokesFluxVariables<TypeTag>);
-
- //! The flux variables cache class, by default the one for porous media
- SET_TYPE_PROP(NavierStokes, FluxVariablesCache, FreeFlowFluxVariablesCache<TypeTag>);
-
- //! Enable advection
- SET_BOOL_PROP(NavierStokes, EnableAdvection, true);
-
- //! The one-phase model has no molecular diffusion
- SET_BOOL_PROP(NavierStokes, EnableMolecularDiffusion, false);
-
- //! The indices required by the isothermal single-phase model
- SET_TYPE_PROP(NavierStokes, Indices, NavierStokesCommonIndices<TypeTag>);
-
- SET_BOOL_PROP(NavierStokes, EnableEnergyBalance, false);
-
- SET_TYPE_PROP(NavierStokes, VtkOutputFields, NavierStokesVtkOutputFields<TypeTag>);
-
- SET_BOOL_PROP(NavierStokes, EnableInertiaTerms, true);
-
- //! Normalize the pressure term in the momentum balance or not
- SET_BOOL_PROP(NavierStokes, NormalizePressure, true);
-
- //////////////////////////////////////////////////////////////////
- // Property values for isothermal model required for the general non-isothermal model
- //////////////////////////////////////////////////////////////////
-
- //set isothermal Indices
- SET_TYPE_PROP(NavierStokesNI, IsothermalIndices, NavierStokesCommonIndices<TypeTag>);
- SET_TYPE_PROP(NavierStokesNI, IsothermalVtkOutputFields, NavierStokesVtkOutputFields<TypeTag>);
-
- //set isothermal NumEq
- SET_PROP(NavierStokesNI, IsothermalNumEq)
- {
- private:
-     using GridView = typename GET_PROP_TYPE(TypeTag, GridView);
-     static constexpr auto dim = GridView::dimension;
- public:
-     static constexpr int value = dim + 1;
- };
-
+SET_PROP(NavierStokes, FluidState){
+private:
+    using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar);
+    using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem);
+public:
+    using type = Dumux::ImmiscibleFluidState<Scalar, FluidSystem>;
+};
+
+//! The local residual
+SET_TYPE_PROP(NavierStokes, LocalResidual, NavierStokesResidual<TypeTag>);
+
+//! The volume variables
+SET_TYPE_PROP(NavierStokes, VolumeVariables, NavierStokesVolumeVariables<TypeTag>);
+
+//! The flux variables
+SET_TYPE_PROP(NavierStokes, FluxVariables, NavierStokesFluxVariables<TypeTag>);
+
+//! The flux variables cache class, by default the one for free flow
+SET_TYPE_PROP(NavierStokes, FluxVariablesCache, FreeFlowFluxVariablesCache<TypeTag>);
+
+//! The indices required by the isothermal single-phase model
+SET_TYPE_PROP(NavierStokes, Indices, NavierStokesCommonIndices<TypeTag>);
+
+//! The specific vtk output fields
+SET_TYPE_PROP(NavierStokes, VtkOutputFields, NavierStokesVtkOutputFields<TypeTag>);
+
+//////////////////////////////////////////////////////////////////
+// Property values for isothermal model required for the general non-isothermal model
+//////////////////////////////////////////////////////////////////
+//! The indices required by the isothermal single-phase model
+SET_TYPE_PROP(NavierStokesNI, IsothermalIndices, NavierStokesCommonIndices<TypeTag>);
+
+//! The specific isothermal vtk output fields
+SET_TYPE_PROP(NavierStokesNI, IsothermalVtkOutputFields, NavierStokesVtkOutputFields<TypeTag>);
+
+//! The number of equations for the isothermal model
+SET_PROP(NavierStokesNI, IsothermalNumEq)
+{
+private:
+    using GridView = typename GET_PROP_TYPE(TypeTag, GridView);
+    static constexpr auto dim = GridView::dimension;
+public:
+    static constexpr int value = dim + 1;
+};
  // \}
- }
+}
 
- } // end namespace
+} // end namespace
 
 #endif // DUMUX_NAVIERSTOKES_MODEL_HH