diff --git a/dumux/material/binarycoefficients/brine_co2.hh b/dumux/material/binarycoefficients/brine_co2.hh
index 375b2da2f87a53d4a9558c34a4d79e04951b3f37..de2065a253eb622f2855d34df4bbdb8a5f231865 100644
--- a/dumux/material/binarycoefficients/brine_co2.hh
+++ b/dumux/material/binarycoefficients/brine_co2.hh
@@ -47,7 +47,7 @@ public:
     /*!
      * \brief Binary diffusion coefficient \f$\mathrm{[m^2/s]}\f$ of water in the CO2 phase.
      *
-     * According to "Diffusion of Water in Liquid and Supercritical Carbon 
+     * According to "Diffusion of Water in Liquid and Supercritical Carbon
      * Dioxide: An NMR Study", Bin Xu et al., 2002.
      * \param temperature the temperature \f$\mathrm{[K]}\f$
      * \param pressure the phase pressure \f$\mathrm{[Pa]}\f$
@@ -95,10 +95,10 @@ public:
      */
 
     static void calculateMoleFractions(const Scalar temperature,
-                                       const Scalar pg, 
+                                       const Scalar pg,
                                        const Scalar salinity,
                                        const int knownPhaseIdx,
-                                       Scalar &xlCO2, 
+                                       Scalar &xlCO2,
                                        Scalar &ygH2O) {
 
         Scalar A = computeA_(temperature, pg);
@@ -521,7 +521,7 @@ private:
         // CO2 because the mole fraction of CO2 in brine can be
         // considerable
         return pg - Brine::vaporPressure(temperature);
-    };
+    }
 
     /*!
      * \brief The fugacity coefficent of CO2 for a CO2-H2O mixture.
diff --git a/dumux/material/binarycoefficients/henryiapws.hh b/dumux/material/binarycoefficients/henryiapws.hh
index 30e96e0c08cc0405cf35f41eff655f958e56b6a1..01f04dc2d695a785ca234487e6a7b9178754dbf8 100644
--- a/dumux/material/binarycoefficients/henryiapws.hh
+++ b/dumux/material/binarycoefficients/henryiapws.hh
@@ -61,8 +61,8 @@ inline Scalar henryIAPWS(Scalar E,
 
     // regularizing temperature helps for stability.
     // Results are unphysical!
-    if (temperature > H2O::criticalTemperature()  )
-    	temperature = H2O::criticalTemperature()  ;
+    if (temperature > H2O::criticalTemperature())
+        temperature = H2O::criticalTemperature();
 
     Scalar Tr = temperature/H2O::criticalTemperature();
     Scalar tau = 1 - Tr;
diff --git a/dumux/material/components/air.hh b/dumux/material/components/air.hh
index 57e1b05655e34425d91e9c0b569e00afdf552c63..8556d07b71b77fd2ff791a29a8421480dde5c2a0 100644
--- a/dumux/material/components/air.hh
+++ b/dumux/material/components/air.hh
@@ -164,7 +164,7 @@ public:
         r = 1.496*1.E-6*pow(temperature,1.5)/(temperature+120.);
         return (r);
 
-    };
+    }
 
     /*!
      * \brief Specific enthalpy of air \f$\mathrm{[J/kg]}\f$
@@ -243,17 +243,17 @@ public:
     }
 
     /*!
-     * 	\brief Thermal conductivity \f$\mathrm{[[W/(m*K)]}\f$ of air.
-     * 	Isobaric Properties for Nitrogen in: NIST Standard
-     * 	see http://webbook.nist.gov/chemistry/fluid/
-     * 	evaluated at p=.1 MPa, T=20°C
-     * 	Nitrogen: 0.025398
-     * 	Oxygen: 0.026105
-     * 	lambda_air is approximately 0.78*lambda_N2+0.22*lambda_O2
+     * \brief Thermal conductivity \f$\mathrm{[[W/(m*K)]}\f$ of air.
+     * Isobaric Properties for Nitrogen in: NIST Standard
+     * see http://webbook.nist.gov/chemistry/fluid/
+     * evaluated at p=.1 MPa, T=20°C
+     * Nitrogen: 0.025398
+     * Oxygen: 0.026105
+     * lambda_air is approximately 0.78*lambda_N2+0.22*lambda_O2
      */
     static Scalar gasThermalConductivity(Scalar temperature, Scalar pressure)
     {
-    	return 0.0255535; // conductivity of pure air [W/(m K)]
+        return 0.0255535; // conductivity of pure air [W/(m K)]
     }
 };
 
diff --git a/dumux/material/components/benzene.hh b/dumux/material/components/benzene.hh
index 875258308ca1f95646759262a3aea8e741d56baa..61f29bfd71e4d6eda9716453b165af255f7b5692 100644
--- a/dumux/material/components/benzene.hh
+++ b/dumux/material/components/benzene.hh
@@ -54,7 +54,7 @@ public:
     static Scalar molarMass()
     {
         DUNE_THROW(Dune::NotImplemented, "molar mass for benzene");
-    };
+    }
 
     /*!
      * \brief Returns the critical temperature \f$\mathrm{[K]}\f$ of benzene.
@@ -62,7 +62,7 @@ public:
     static Scalar criticalTemperature()
     {
         DUNE_THROW(Dune::NotImplemented, "criticalTemperature for benzene");
-    };
+    }
 
     /*!
      * \brief Returns the critical pressure \f$\mathrm{[Pa]}\f$ of benzene.
@@ -70,7 +70,7 @@ public:
     static Scalar criticalPressure()
     {
         DUNE_THROW(Dune::NotImplemented, "criticalPressure for benzene");
-    };
+    }
 
     /*!
      * \brief Returns the temperature \f$\mathrm{[K]}\f$ at benzene's triple point.
@@ -78,7 +78,7 @@ public:
     static Scalar tripleTemperature()
     {
         DUNE_THROW(Dune::NotImplemented, "tripleTemperature for benzene");
-    };
+    }
 
     /*!
      * \brief Returns the pressure \f$\mathrm{[Pa]}\f$ at benzene's triple point.
@@ -86,7 +86,7 @@ public:
     static Scalar triplePressure()
     {
         DUNE_THROW(Dune::NotImplemented, "triplePressure for benzene");
-    };
+    }
 
     /*!
      * \brief The vapor pressure in \f$\mathrm{[Pa]}\f$ of pure benzene
@@ -97,7 +97,8 @@ public:
     static Scalar vaporPressure(Scalar T)
     {
         DUNE_THROW(Dune::NotImplemented, "vaporPressure for benzene");
-    };
+    }
+
     /*!
      * \brief Specific enthalpy of benzene steam \f$\mathrm{[J/kg]}\f$.
      *
@@ -108,7 +109,7 @@ public:
                                     Scalar pressure)
     {
         DUNE_THROW(Dune::NotImplemented, "gasEnthalpy for benzene");
-    };
+    }
 
     /*!
      * \brief Specific enthalpy of liquid benzene \f$\mathrm{[J/kg]}\f$.
@@ -120,7 +121,7 @@ public:
                                        Scalar pressure)
     {
         DUNE_THROW(Dune::NotImplemented, "liquidEnthalpy for benzene");
-    };
+    }
 
     /*!
      * \brief The density of steam at a given pressure and temperature \f$\mathrm{[kg/m^3]}\f$.
@@ -133,7 +134,7 @@ public:
         return IdealGas<Scalar>::density(molarMass(),
                                          temperature,
                                          pressure);
-    };
+    }
 
     /*!
      * \brief The density of pure benzene at a given pressure and temperature \f$\mathrm{[kg/m^3]}\f$.
@@ -156,7 +157,7 @@ public:
     static Scalar gasViscosity(Scalar temperature, Scalar pressure, bool regularize=true)
     {
         DUNE_THROW(Dune::NotImplemented, "gasViscosity for benzene");
-    };
+    }
 
     /*!
      * \brief The dynamic viscosity \f$\mathrm{[Pa*s]}\f$ of pure benzene.
@@ -167,7 +168,7 @@ public:
     static Scalar liquidViscosity(Scalar temperature, Scalar pressure)
     {
         return 1.12e-3;//[Pa s]
-    };
+    }
 };
 
 } // end namespace
diff --git a/dumux/material/components/brine.hh b/dumux/material/components/brine.hh
index de6214a15dd9a0e8b8b01ff6a85e23b5b5874692..64ce401a5eff591605583e963e22936e4837384a 100644
--- a/dumux/material/components/brine.hh
+++ b/dumux/material/components/brine.hh
@@ -66,7 +66,7 @@ public:
         const Scalar M2 = 58e-3; // molar mass of NaCl [kg/mol]
         const Scalar X2 = salinity; // mass fraction of salt in brine
         return M1*M2/(M2 + X2*(M1 - M2));
-    };
+    }
 
     /*!
      * \brief Returns the critical temperature \f$\mathrm{[K]}\f$ of brine.
@@ -199,7 +199,7 @@ public:
     {
         Scalar eps = temperature*1e-8;
         return (liquidEnthalpy(temperature + eps, pressure) - liquidEnthalpy(temperature, pressure))/eps;
-    };
+    }
 
     /*!
      * \brief Specific isobaric heat capacity of water steam \f$\mathrm{[J/kg]}\f$.
@@ -217,7 +217,7 @@ public:
                                         Scalar pressure)
     {
         return H2O::gasHeatCapacity(temperature, pressure);
-    };
+    }
 
     /*!
      * \brief Specific internal energy of steam \f$\mathrm{[J/kg]}\f$.
@@ -354,7 +354,7 @@ public:
      * \param pressure pressure of component
      */
     static Scalar gasViscosity(Scalar temperature, Scalar pressure)
-    { return H2O::gasViscosity(temperature, pressure); };
+    { return H2O::gasViscosity(temperature, pressure); }
 
     /*!
      * \brief The dynamic viscosity \f$\mathrm{[Pa*s]}\f$ of pure brine.
diff --git a/dumux/material/components/co2.hh b/dumux/material/components/co2.hh
index 875db19f344beca8d848e3f30da848fea2c38e1e..74200ca6431c2e92b5c38b79a8ecfa769e3159a8 100644
--- a/dumux/material/components/co2.hh
+++ b/dumux/material/components/co2.hh
@@ -48,7 +48,7 @@ class CO2 : public Component<Scalar, CO2<Scalar, CO2Tables> >
 {
     static const Scalar R;
     typedef typename Dumux::IdealGas<Scalar> IdealGas;
-    
+
     static bool warningThrown;
 
 public:
@@ -125,10 +125,10 @@ public:
      * 1996
      */
     static Scalar vaporPressure(Scalar T)
-    { 
-        static const Scalar a[4] = 
+    {
+        static const Scalar a[4] =
             { -7.0602087, 1.9391218, -1.6463597, -3.2995634 };
-        static const Scalar t[4] = 
+        static const Scalar t[4] =
             { 1.0, 1.5, 2.0, 4.0 };
 
         // this is on page 1524 of the reference
@@ -138,7 +138,7 @@ public:
             exponent += a[i]*std::pow(1 - Tred, t[i]);
         }
         exponent *= 1.0/Tred;
-        
+
         return std::exp(exponent)*criticalPressure();
     }
 
@@ -336,7 +336,7 @@ public:
         visco_CO2 = (mu0 + dmu)/1.0E6;   /* conversion to [Pa s] */
 
         return visco_CO2;
-    };
+    }
 
     /*!
      * \brief The dynamic viscosity \f$\mathrm{[Pa*s]}\f$ of pure CO2.
@@ -347,7 +347,7 @@ public:
     {
         // no difference for supercritical CO2
         return gasViscosity(temperature, pressure);
-    };
+    }
 };
 
 template <class Scalar, class CO2Tables>
diff --git a/dumux/material/components/co2tablereader.hh b/dumux/material/components/co2tablereader.hh
index e19ace939811bfa0bdc7dd70074b742dfe465d56..6ab56802152eaba2c45a609a994dfeed7ee5a4dc 100644
--- a/dumux/material/components/co2tablereader.hh
+++ b/dumux/material/components/co2tablereader.hh
@@ -42,10 +42,6 @@ class TabulatedCO2Properties
     enum { numTempSteps = Traits::numTempSteps, numPressSteps = Traits::numPressSteps };
 
 public:
-    TabulatedCO2Properties()
-    {
-    };
-
     Scalar minTemp() const
     { return Traits::minTemp; }
 
@@ -76,7 +72,7 @@ public:
                 pressure=minPress();
             if(pressure>maxPress())
                 pressure=maxPress();
-        };
+        }
 
         int i = findTempIdx_(temperature);
         int j = findPressIdx_(pressure);
@@ -99,7 +95,7 @@ public:
         // return the weighted sum of the low- and high-resolution
         // values
         return lowresValue;
-    };
+    }
 
     Scalar val(int i, int j) const
     {
@@ -112,10 +108,10 @@ public:
                        << ") on a " << Traits::name << " table of size ("
                        << Traits::numTempSteps << ", " << Traits::numPressSteps
                        << ")\n");
-        };
+        }
 #endif
         return Traits::vals[i][j];
-    };
+    }
 
 protected:
     int findTempIdx_(Scalar temperature) const
@@ -124,7 +120,7 @@ protected:
             return numTempSteps - 2;
         const int result = static_cast<int>((temperature - minTemp())/(maxTemp() - minTemp())*(numTempSteps - 1));
         return std::max(0, std::min(result, numTempSteps - 2));
-    };
+    }
 
     int findPressIdx_(Scalar pressure) const
     {
@@ -132,13 +128,13 @@ protected:
             return numPressSteps - 2;
         const int result = static_cast<int>((pressure - minPress())/(maxPress() - minPress())*(numPressSteps - 1));
         return std::max(0, std::min(result, numPressSteps - 2));
-    };
+    }
 
     Scalar temperatureAt_(int i) const
     { return i*(maxTemp() - minTemp())/(numTempSteps - 1) + minTemp(); }
     Scalar pressureAt_(int j) const
     { return j*(maxPress() - minPress())/(numPressSteps - 1) + minPress(); }
 };
-}
+} // end namespace Dumux
 
 #endif
diff --git a/dumux/material/components/dnapl.hh b/dumux/material/components/dnapl.hh
index 7e5423e257fa4341006b86eef98d2a41ce56f84e..57126aec160555b42d9f49ef740c024b491a6d08 100644
--- a/dumux/material/components/dnapl.hh
+++ b/dumux/material/components/dnapl.hh
@@ -53,7 +53,7 @@ public:
     static Scalar molarMass()
     {
         return 131.39e-3; // [kg/mol]
-    };
+    }
 
     /*!
      * \brief Returns the critical temperature \f$\mathrm{[K]}\f$ of TCE.
@@ -61,7 +61,7 @@ public:
     static Scalar criticalTemperature()
     {
         DUNE_THROW(Dune::NotImplemented, "criticalTemperature for TCE");
-    };
+    }
 
     /*!
      * \brief Returns the critical pressure \f$\mathrm{[Pa]}\f$ of TCE.
@@ -69,7 +69,7 @@ public:
     static Scalar criticalPressure()
     {
         DUNE_THROW(Dune::NotImplemented, "criticalPressure for TCE");
-    };
+    }
 
     /*!
      * \brief Returns the temperature \f$\mathrm{[K]}\f$ at TCE's triple point.
@@ -77,7 +77,7 @@ public:
     static Scalar tripleTemperature()
     {
         DUNE_THROW(Dune::NotImplemented, "tripleTemperature for TCE");
-    };
+    }
 
     /*!
      * \brief Returns the pressure \f$\mathrm{[Pa]}\f$ at TCE's triple point.
@@ -85,7 +85,7 @@ public:
     static Scalar triplePressure()
     {
         DUNE_THROW(Dune::NotImplemented, "triplePressure for TCE");
-    };
+    }
 
     /*!
      * \brief The vapor pressure in \f$\mathrm{[Pa]}\f$ of pure TCE
@@ -96,7 +96,7 @@ public:
     static Scalar vaporPressure(Scalar T)
     {
         return 3900; // [Pa] (at 20C)
-    };
+    }
 
     /*!
      * \brief Returns true if the gas phase is assumed to be compressible
@@ -121,7 +121,7 @@ public:
         return IdealGas<Scalar>::density(molarMass(),
                                          temperature,
                                          pressure);
-    };
+    }
 
     /*!
      * \brief Returns true if the gas phase is assumed to be ideal
@@ -149,7 +149,7 @@ public:
     static Scalar liquidViscosity(Scalar temperature, Scalar pressure)
     {
         return 5.7e-4;// [Pa*s]
-    };
+    }
 };
 
 } // end namespace
diff --git a/dumux/material/components/lnapl.hh b/dumux/material/components/lnapl.hh
index a9ff00157e856f2244fbea31f4c84528ab28f52d..53eb32238c34f988818fed065d8bf36357d1147a 100644
--- a/dumux/material/components/lnapl.hh
+++ b/dumux/material/components/lnapl.hh
@@ -73,7 +73,7 @@ public:
     static Scalar liquidViscosity(Scalar temperature, Scalar pressure)
     {
         return 8e-3;
-    };
+    }
 
 };
 
diff --git a/dumux/material/components/mesitylene.hh b/dumux/material/components/mesitylene.hh
index 5fdbeebb52eda4f4f08970d9fbfea7195f072ac9..19f042e283ead46f73059a965707d694cf1297c1 100644
--- a/dumux/material/components/mesitylene.hh
+++ b/dumux/material/components/mesitylene.hh
@@ -18,11 +18,11 @@
  *****************************************************************************/
 /*!
  * \file
- * 
+ *
  * \ingroup Components
- * 
+ *
  * \brief Properties of mesitylene.
- * 
+ *
  */
 #ifndef DUMUX_MESITYLENE_HH
 #define DUMUX_MESITYLENE_HH
diff --git a/dumux/material/components/simpleh2o.hh b/dumux/material/components/simpleh2o.hh
index e2ac15cf2d5d16018688d13adaa079bc1a6bb125..da5db24bea4a87008b683cc8b011e84235f2f18c 100644
--- a/dumux/material/components/simpleh2o.hh
+++ b/dumux/material/components/simpleh2o.hh
@@ -280,7 +280,7 @@ public:
     {
         return 4.2e3;
     }
-    
+
      /*!
      * \brief Thermal conductivity \f$\mathrm{[[W/(m*K)]}\f$ of water.
      *        source: http://webbook.nist.gov/cgi/fluid.cgi?ID=C7732185&Action=Page
@@ -290,7 +290,7 @@ public:
     {
        return 0.679;
     }
-    
+
      /*!
      * \brief Thermal conductivity \f$\mathrm{[[W/(m*K)]}\f$ of steam.
      *        source: http://webbook.nist.gov/cgi/fluid.cgi?ID=C7732185&Action=Page
@@ -300,8 +300,8 @@ public:
     {
        return 0.025;
     }
-    
-    
+
+
 };
 
 template <class Scalar>
diff --git a/dumux/material/components/tabulatedcomponent.hh b/dumux/material/components/tabulatedcomponent.hh
index 3f62dc9c486becd06bf8330abf976e2bc2c25dc5..9dd76f759c146635029ea1415f473ca0f3534fd6 100644
--- a/dumux/material/components/tabulatedcomponent.hh
+++ b/dumux/material/components/tabulatedcomponent.hh
@@ -114,7 +114,7 @@ public:
 
             try { vaporPressure_[iT] = RawComponent::vaporPressure(temperature); }
             catch (Dune::NotImplemented) { vaporPressure_[iT] = NaN; }
-            catch (NumericalProblem e) { vaporPressure_[iT] = NaN; };
+            catch (NumericalProblem e) { vaporPressure_[iT] = NaN; }
 
             Scalar pgMax = maxGasPressure_(iT);
             Scalar pgMin = minGasPressure_(iT);
@@ -127,23 +127,23 @@ public:
 
                 try { gasEnthalpy_[i] = RawComponent::gasEnthalpy(temperature, pressure); }
                 catch (Dune::NotImplemented) { gasEnthalpy_[i] = NaN; }
-                catch (NumericalProblem) { gasEnthalpy_[i] = NaN; };
+                catch (NumericalProblem) { gasEnthalpy_[i] = NaN; }
 
                 try { gasHeatCapacity_[i] = RawComponent::gasHeatCapacity(temperature, pressure); }
                 catch (Dune::NotImplemented) { gasHeatCapacity_[i] = NaN; }
-                catch (NumericalProblem) { gasHeatCapacity_[i] = NaN; };
+                catch (NumericalProblem) { gasHeatCapacity_[i] = NaN; }
 
                 try { gasDensity_[i] = RawComponent::gasDensity(temperature, pressure); }
                 catch (Dune::NotImplemented) { gasDensity_[i] = NaN; }
-                catch (NumericalProblem) { gasDensity_[i] = NaN; };
+                catch (NumericalProblem) { gasDensity_[i] = NaN; }
 
                 try { gasViscosity_[i] = RawComponent::gasViscosity(temperature, pressure); }
                 catch (Dune::NotImplemented) { gasViscosity_[i] = NaN; }
-                catch (NumericalProblem) { gasViscosity_[i] = NaN; };
+                catch (NumericalProblem) { gasViscosity_[i] = NaN; }
 
                 try { gasThermalConductivity_[i] = RawComponent::gasThermalConductivity(temperature, pressure); }
                 catch (Dune::NotImplemented) { gasThermalConductivity_[i] = NaN; }
-                catch (NumericalProblem) { gasThermalConductivity_[i] = NaN; };
+                catch (NumericalProblem) { gasThermalConductivity_[i] = NaN; }
             }
 
             Scalar plMin = minLiquidPressure_(iT);
@@ -155,23 +155,23 @@ public:
 
                 try { liquidEnthalpy_[i] = RawComponent::liquidEnthalpy(temperature, pressure); }
                 catch (Dune::NotImplemented) { liquidEnthalpy_[i] = NaN; }
-                catch (NumericalProblem) { liquidEnthalpy_[i] = NaN; };
+                catch (NumericalProblem) { liquidEnthalpy_[i] = NaN; }
 
                 try { liquidHeatCapacity_[i] = RawComponent::liquidHeatCapacity(temperature, pressure); }
                 catch (Dune::NotImplemented) { liquidHeatCapacity_[i] = NaN; }
-                catch (NumericalProblem) { liquidHeatCapacity_[i] = NaN; };
+                catch (NumericalProblem) { liquidHeatCapacity_[i] = NaN; }
 
                 try { liquidDensity_[i] = RawComponent::liquidDensity(temperature, pressure); }
                 catch (Dune::NotImplemented) { liquidDensity_[i] = NaN; }
-                catch (NumericalProblem) { liquidDensity_[i] = NaN; };
+                catch (NumericalProblem) { liquidDensity_[i] = NaN; }
 
                 try { liquidViscosity_[i] = RawComponent::liquidViscosity(temperature, pressure); }
                 catch (Dune::NotImplemented) { liquidViscosity_[i] = NaN; }
-                catch (NumericalProblem) { liquidViscosity_[i] = NaN; };
+                catch (NumericalProblem) { liquidViscosity_[i] = NaN; }
 
                 try { liquidThermalConductivity_[i] = RawComponent::liquidThermalConductivity(temperature, pressure); }
                 catch (Dune::NotImplemented) { liquidThermalConductivity_[i] = NaN; }
-                catch (NumericalProblem) { liquidThermalConductivity_[i] = NaN; };
+                catch (NumericalProblem) { liquidThermalConductivity_[i] = NaN; }
             }
         }
 
@@ -198,7 +198,7 @@ public:
                 unsigned i = iT + iRho*nTemp_;
 
                 try { gasPressure_[i] = RawComponent::gasPressure(temperature, density); }
-                catch (NumericalProblem) { gasPressure_[i] = NaN; };
+                catch (NumericalProblem) { gasPressure_[i] = NaN; }
             }
 
             // calculate the minimum and maximum values for the liquid
@@ -220,7 +220,7 @@ public:
                 unsigned i = iT + iRho*nTemp_;
 
                 try { liquidPressure_[i] = RawComponent::liquidPressure(temperature, density); }
-                catch (NumericalProblem) { liquidPressure_[i] = NaN; };
+                catch (NumericalProblem) { liquidPressure_[i] = NaN; }
             }
         }
     }
@@ -274,7 +274,7 @@ public:
             return RawComponent::vaporPressure(T);
         }
         return result;
-    };
+    }
 
     /*!
      * \brief The vapor pressure in \f$\mathrm{[Pa]}\f$ of the component at a given
@@ -286,7 +286,7 @@ public:
     static Scalar vaporTemperature(Scalar pressure)
     {
             return RawComponent::vaporTemperature(pressure);
-    };
+    }
 
     /*!
      * \brief Specific enthalpy of the gas \f$\mathrm{[J/kg]}\f$.
@@ -403,7 +403,7 @@ public:
                                              density);
         }
         return result;
-    };
+    }
 
     /*!
      * \brief The pressure of liquid in \f$\mathrm{[Pa]}\f$ at a given density and temperature.
@@ -422,7 +422,7 @@ public:
                                                 density);
         }
         return result;
-    };
+    }
 
     /*!
      * \brief Returns true iff the gas phase is assumed to be compressible
@@ -497,7 +497,7 @@ public:
             return RawComponent::gasViscosity(temperature, pressure);
         }
         return result;
-    };
+    }
 
     /*!
      * \brief The dynamic viscosity \f$\mathrm{[Pa*s]}\f$ of liquid.
@@ -515,7 +515,7 @@ public:
             return RawComponent::liquidViscosity(temperature, pressure);
         }
         return result;
-    };
+    }
 
     /*!
      * \brief The thermal conductivity of gaseous water \f$\mathrm{[W/(m*K)]}\f$.
@@ -533,7 +533,7 @@ public:
             return RawComponent::gasThermalConductivity(temperature, pressure);
         }
         return result;
-    };
+    }
 
     /*!
      * \brief The thermal conductivity of liquid water \f$\mathrm{[W/(m*K)]}\f$.
@@ -551,7 +551,7 @@ public:
             return RawComponent::liquidThermalConductivity(temperature, pressure);
         }
         return result;
-    };
+    }
 
 
 private:
diff --git a/dumux/material/components/xylene.hh b/dumux/material/components/xylene.hh
index 6cefa1e5887c7311f1f667389b2706ec54196d0a..260a3f11c66a9dd784f0aa2af380136c17ca70af 100644
--- a/dumux/material/components/xylene.hh
+++ b/dumux/material/components/xylene.hh
@@ -18,9 +18,9 @@
  *****************************************************************************/
 /*!
  * \file
- * 
+ *
  * \ingroup Components
- * 
+ *
  * \brief Properties of xylene.
  */
 #ifndef DUMUX_XYLENE_HH
@@ -127,25 +127,25 @@ public:
         // Xylene: C9H12  : 3* CH3 ; 1* C6H5 (phenyl-ring) ; -2* H (this was too much!)
         // linear interpolation between table values [J/(mol K)]
 
-        if(temp < 298.0){                          	// take care: extrapolation for Temp<273
-            H = 13.4 + 1.2*(temp - 273.0)/25.0;		// 13.4 + 1.2 = 14.6 = H(T=298K) i.e. interpolation of table values 273<T<298
-            CH3 = 40.0 + 1.6*(temp - 273.0)/25.0;	// 40 + 1.6 = 41.6 = CH3(T=298K)
+        if(temp < 298.0){                              // take care: extrapolation for Temp<273
+            H = 13.4 + 1.2*(temp - 273.0)/25.0;        // 13.4 + 1.2 = 14.6 = H(T=298K) i.e. interpolation of table values 273<T<298
+            CH3 = 40.0 + 1.6*(temp - 273.0)/25.0;    // 40 + 1.6 = 41.6 = CH3(T=298K)
             C6H5 = 113.0 + 4.2*(temp - 273.0)/25.0; // 113 + 4.2 = 117.2 = C6H5(T=298K)
         }
         else if(temp < 323.0){
-            H = 14.6 + 0.9*(temp - 298.0)/25.0;		// i.e. interpolation of table values 298<T<323
+            H = 14.6 + 0.9*(temp - 298.0)/25.0;        // i.e. interpolation of table values 298<T<323
             CH3 = 41.6 + 1.9*(temp - 298.0)/25.0;
             C6H5 = 117.2 + 6.2*(temp - 298.0)/25.0;
         }
         else if(temp < 348.0){
-            H = 15.5 + 1.2*(temp - 323.0)/25.0;		// i.e. interpolation of table values 323<T<348
+            H = 15.5 + 1.2*(temp - 323.0)/25.0;        // i.e. interpolation of table values 323<T<348
             CH3 = 43.5 + 2.3*(temp - 323.0)/25.0;
             C6H5 = 123.4 + 6.3*(temp - 323.0)/25.0;
         }
         else {
             H = 16.7 + 2.1*(temp - 348.0)/25.0;         // i.e. interpolation of table values 348<T<373
-            CH3 = 45.8 + 2.5*(temp - 348.0)/25.0;		// take care: extrapolation for Temp>373
-            C6H5 = 129.7 + 6.3*(temp - 348.0)/25.0;		// most likely leads to underestimation
+            CH3 = 45.8 + 2.5*(temp - 348.0)/25.0;        // take care: extrapolation for Temp>373
+            C6H5 = 129.7 + 6.3*(temp - 348.0)/25.0;        // most likely leads to underestimation
         }
 
         return (C6H5 + 2*CH3 - H)/molarMass();// J/(mol K) -> J/(kg K)
diff --git a/dumux/material/constraintsolvers/compositionalflash.hh b/dumux/material/constraintsolvers/compositionalflash.hh
index 8a1f1e047b0e5e239221c1fdd738aeb6f52e761d..ab043e7fbf8c3d16bd91cf0e71f5d96652f26063 100644
--- a/dumux/material/constraintsolvers/compositionalflash.hh
+++ b/dumux/material/constraintsolvers/compositionalflash.hh
@@ -175,7 +175,7 @@ public:
         sw /= (fluidState.phaseMassFraction(wPhaseIdx)/fluidState.density(wPhaseIdx)
                     + fluidState.phaseMassFraction(nPhaseIdx)/fluidState.density(nPhaseIdx));
         fluidState.setSaturation(wPhaseIdx, sw);
-    };
+    }
 
     //! The simplest possible update routine for 1p2c "flash" calculations
     /*!
@@ -241,8 +241,6 @@ public:
                 +fluidState.massFraction(presentPhaseIdx, nCompIdx)*FluidSystem::molarMass(nCompIdx));
 
         fluidState.setDensity(presentPhaseIdx, FluidSystem::density(fluidState, presentPhaseIdx));
-
-        return;
     }
 //@}
 
diff --git a/dumux/material/constraintsolvers/compositionfromfugacities.hh b/dumux/material/constraintsolvers/compositionfromfugacities.hh
index 81c4cef72069a8f0e242587844022a4a7a99fbf6..8c256fafbbabe44ffc865058def2fd4b28a622d8 100644
--- a/dumux/material/constraintsolvers/compositionfromfugacities.hh
+++ b/dumux/material/constraintsolvers/compositionfromfugacities.hh
@@ -48,7 +48,7 @@ public:
     typedef Dune::FieldVector<Scalar, numComponents> ComponentVector;
 
     /*!
-     * \brief Guess an initial value for the composition of the phase. 
+     * \brief Guess an initial value for the composition of the phase.
      * \param fluidState Thermodynamic state of the fluids
      * \param paramCache  Container for cache parameters
      * \param phaseIdx The phase index
@@ -74,7 +74,7 @@ public:
 
     /*!
      * \brief Calculates the chemical equilibrium from the component
-     *        fugacities in a phase. 
+     *        fugacities in a phase.
      * \param fluidState Thermodynamic state of the fluids
      * \param paramCache  Container for cache parameters
      * \param phaseIdx The phase index
diff --git a/dumux/material/constraintsolvers/immiscibleflash.hh b/dumux/material/constraintsolvers/immiscibleflash.hh
index 0d15711409987b1c3f6724a161e66790dc06f935..d6047f9e893178ef5ef99d0239ca50ab37cd4906 100644
--- a/dumux/material/constraintsolvers/immiscibleflash.hh
+++ b/dumux/material/constraintsolvers/immiscibleflash.hh
@@ -82,7 +82,7 @@ public:
      * \brief Guess initial values for all quantities.
      * \param fluidState Thermodynamic state of the fluids
      * \param paramCache  Container for cache parameters
-     * \param globalMolarities 
+     * \param globalMolarities
      */
     template <class FluidState>
     static void guessInitial(FluidState &fluidState,
@@ -108,8 +108,8 @@ public:
      *        fugacities in a phase.
      * \param fluidState Thermodynamic state of the fluids
      * \param paramCache  Container for cache parameters
-     * \param globalMolarities 
-     * \param matParams The material law object  
+     * \param globalMolarities
+     * \param matParams The material law object
      *
      * The phase's fugacities must already be set.
      */
diff --git a/dumux/material/constraintsolvers/ncpflash.hh b/dumux/material/constraintsolvers/ncpflash.hh
index 647d9de071d497b9e43ef0f8cd46813dc9f4d1fc..bb455f32d6371c9740a54654da9f60a11ef7a39f 100644
--- a/dumux/material/constraintsolvers/ncpflash.hh
+++ b/dumux/material/constraintsolvers/ncpflash.hh
@@ -93,8 +93,8 @@ public:
      * \brief Guess initial values for all quantities.
      * \param fluidState Thermodynamic state of the fluids
      * \param paramCache  Container for cache parameters
-     * \param globalMolarities 
-     * 
+     * \param globalMolarities
+     *
      */
     template <class FluidState>
     static void guessInitial(FluidState &fluidState,
@@ -112,7 +112,7 @@ public:
                 fluidState.setMoleFraction(phaseIdx,
                                            compIdx,
                                            globalMolarities[compIdx]/sumMoles);
-            
+
             // pressure. use atmospheric pressure as initial guess
             fluidState.setPressure(phaseIdx, 1.0135e5);
 
@@ -135,9 +135,9 @@ public:
      *        fugacities in a phase.
      * \param fluidState Thermodynamic state of the fluids
      * \param paramCache  Container for cache parameters
-     * \param globalMolarities 
-     * \param matParams The material law object  
-     * 
+     * \param globalMolarities
+     * \param matParams The material law object
+     *
      * The phase's fugacities must already be set.
      */
     template <class MaterialLaw, class FluidState>
diff --git a/dumux/material/eos/pengrobinson.hh b/dumux/material/eos/pengrobinson.hh
index 734ff0ffe034eabde4708f37c2d45a8dab8de5b3..533884b40f8be143f27571d25782bddc0ff98ba2 100644
--- a/dumux/material/eos/pengrobinson.hh
+++ b/dumux/material/eos/pengrobinson.hh
@@ -95,7 +95,7 @@ public:
      *        setTP().
      * \param T temperature in \f$\mathrm{[K]}\f$
      * \param params Parameters
-     * 
+     *
      * Initially, the vapor pressure is roughly estimated by using the
      * Ambrose-Walton method, then the Newton method is used to make
      * difference between the gas and liquid phase fugacity zero.
@@ -139,7 +139,7 @@ public:
 
     /*!
      * \brief Computes molar volumes \f$\mathrm{[m^3 / mol]}\f$ where the Peng-Robinson EOS is
-     *        true. 
+     *        true.
      * \param fs Thermodynamic state of the fluids
      * \param params Parameters
      * \param phaseIdx The phase index
diff --git a/dumux/material/eos/pengrobinsonmixture.hh b/dumux/material/eos/pengrobinsonmixture.hh
index 86ea880d9fae21be065f05db280643bbb1526bf3..777374dce6fc9c10e0e82da7c99dacb5438de48d 100644
--- a/dumux/material/eos/pengrobinsonmixture.hh
+++ b/dumux/material/eos/pengrobinsonmixture.hh
@@ -75,7 +75,7 @@ public:
      * \param params Parameters
      * \param phaseIdx The phase index
      * \param compIdx The index of the component
-     * 
+     *
      * The fugacity coefficient \f$\phi_i\f$ of a component \f$i\f$ is
      * defined as
      * \f[
diff --git a/dumux/material/eos/pengrobinsonparamsmixture.hh b/dumux/material/eos/pengrobinsonparamsmixture.hh
index b650f631179712c73788433d0958d829455804ee..608806efdcd3faf2a4f2ecf598dd364aeee6bbfc 100644
--- a/dumux/material/eos/pengrobinsonparamsmixture.hh
+++ b/dumux/material/eos/pengrobinsonparamsmixture.hh
@@ -76,7 +76,7 @@ public:
     /*!
      * \brief Update Peng-Robinson parameters for the pure components.
      * \param fluidState Thermodynamic state of the fluids
-     * 
+     *
      */
     template <class FluidState>
     void updatePure(const FluidState &fluidState)
diff --git a/dumux/material/fluidmatrixinteractions/2p/heatpipelaw.hh b/dumux/material/fluidmatrixinteractions/2p/heatpipelaw.hh
index b5dbfc3eb9c6233baac0590b0450109f17f21824..efc71a86632676948d4096e03c680769933def55 100644
--- a/dumux/material/fluidmatrixinteractions/2p/heatpipelaw.hh
+++ b/dumux/material/fluidmatrixinteractions/2p/heatpipelaw.hh
@@ -125,7 +125,7 @@ public:
     static Scalar krw(const Params &params, Scalar Sw)
     {
         return kr_(Sw);
-    };
+    }
 
     /*!
      * \brief The relative permeability for the non-wetting phase.
diff --git a/dumux/material/fluidmatrixinteractions/2p/heatpipelawparams.hh b/dumux/material/fluidmatrixinteractions/2p/heatpipelawparams.hh
index e55b5c4147e015399ab0295913c7e49528fe9590..f83d33d3a29f410223f837d230ac65e78e0a2ffc 100644
--- a/dumux/material/fluidmatrixinteractions/2p/heatpipelawparams.hh
+++ b/dumux/material/fluidmatrixinteractions/2p/heatpipelawparams.hh
@@ -44,7 +44,7 @@ public:
     {
         setP0(p0);
         setGamma(gamma);
-    };
+    }
 
     /*!
      * \brief Return the \f$\gamma\f$ shape parameter.
diff --git a/dumux/material/fluidmatrixinteractions/2p/linearmaterialparams.hh b/dumux/material/fluidmatrixinteractions/2p/linearmaterialparams.hh
index 56d7209769126023fedb482e20e8343db8286922..7bb970c23a1ab161dceba0afc54282b797eeb504 100644
--- a/dumux/material/fluidmatrixinteractions/2p/linearmaterialparams.hh
+++ b/dumux/material/fluidmatrixinteractions/2p/linearmaterialparams.hh
@@ -46,7 +46,7 @@ public:
     {
         setEntryPc(entryPc);
         setMaxPc(maxPc);
-    };
+    }
 
 
     /*!
diff --git a/dumux/material/fluidmatrixinteractions/2p/thermalconductivitysimplefluidlumping.hh b/dumux/material/fluidmatrixinteractions/2p/thermalconductivitysimplefluidlumping.hh
index 5128e984d41328814b77d5ef6029035b65c80bb5..771f6665b5aa59b6b9fcf377c200af52a7fdd72b 100644
--- a/dumux/material/fluidmatrixinteractions/2p/thermalconductivitysimplefluidlumping.hh
+++ b/dumux/material/fluidmatrixinteractions/2p/thermalconductivitysimplefluidlumping.hh
@@ -79,7 +79,7 @@ public:
      * \param lambdaSolid The thermal conductivity of the solid phase
      * \param porosity The porosity
      * \param rhoSolid The density of the solid phase
-     * 
+     *
      * \return Effective thermal conductivity of the fluid phases
      */
     static Scalar effectiveThermalConductivity(const Scalar sw,
diff --git a/dumux/material/fluidmatrixinteractions/2p/vangenuchtenparams.hh b/dumux/material/fluidmatrixinteractions/2p/vangenuchtenparams.hh
index 8c70f2fac63854c8294bbde4eae928ed2984ced2..295c7195d05d628162261fbc646556b2183bb53e 100644
--- a/dumux/material/fluidmatrixinteractions/2p/vangenuchtenparams.hh
+++ b/dumux/material/fluidmatrixinteractions/2p/vangenuchtenparams.hh
@@ -50,7 +50,7 @@ public:
     {
         setVgAlpha(vgAlpha);
         setVgn(vgn);
-    };
+    }
 
     /*!
      * \brief Return the \f$\alpha\f$ shape parameter [1/Pa] of van Genuchten's
diff --git a/dumux/material/fluidmatrixinteractions/3p/parkervangen3p.hh b/dumux/material/fluidmatrixinteractions/3p/parkervangen3p.hh
index b7dcc89a9b392b5ebc701d14af1248fac77453c3..1bb1897076f82b023daa77f9a79dd723d31dc284 100644
--- a/dumux/material/fluidmatrixinteractions/3p/parkervangen3p.hh
+++ b/dumux/material/fluidmatrixinteractions/3p/parkervangen3p.hh
@@ -17,10 +17,10 @@
  *   along with this program.  If not, see <http://www.gnu.org/licenses/>.   *
  *****************************************************************************/
 /*!
- * \file 
- * 
+ * \file
+ *
  * \brief Implementation of van Genuchten's capillary pressure-saturation relation.
- * 
+ *
  */
 #ifndef PARKERVANGEN_3P_HH
 #define PARKERVANGEN_3P_HH
diff --git a/dumux/material/fluidmatrixinteractions/3p/parkervangen3pparams.hh b/dumux/material/fluidmatrixinteractions/3p/parkervangen3pparams.hh
index 9070a516a7226f366d7cc0a68a6b5915f5d7eb3e..978e50952116041675b55bba48c2d00b30b63107 100644
--- a/dumux/material/fluidmatrixinteractions/3p/parkervangen3pparams.hh
+++ b/dumux/material/fluidmatrixinteractions/3p/parkervangen3pparams.hh
@@ -17,9 +17,9 @@
  *   along with this program.  If not, see <http://www.gnu.org/licenses/>.   *
  *****************************************************************************/
 /*!
- * \file 
- * 
- * \brief Specification of the material params for the van Genuchten 
+ * \file
+ *
+ * \brief Specification of the material params for the van Genuchten
  *        capillary pressure model.
  *
  * In comparison to the 2p version, this parameter container also includes
@@ -60,7 +60,7 @@ public:
         setBetaGn(betaGn);
         setBetaGw(betaGw);
         setRhoBulk(rhoBulk);
-    };
+    }
 
     /*!
      * \brief Return the \f$\alpha\f$ shape parameter of van Genuchten's
diff --git a/dumux/material/fluidmatrixinteractions/diffusivityconstanttau.hh b/dumux/material/fluidmatrixinteractions/diffusivityconstanttau.hh
index 9a6073431b48340d378e7801dfe40b6b85c824fc..ab7a120f41821519c66d74d1fb224da36c9f4628 100644
--- a/dumux/material/fluidmatrixinteractions/diffusivityconstanttau.hh
+++ b/dumux/material/fluidmatrixinteractions/diffusivityconstanttau.hh
@@ -55,12 +55,12 @@ public:
      */
     static Scalar effectiveDiffusivity(const Scalar porosity,
                                                const Scalar saturation,
-                                               const Scalar diffCoeff) 
+                                               const Scalar diffCoeff)
 
     {
         Scalar tau = GET_RUNTIME_PARAM(TypeTag, Scalar, tau);
-        
-    	return porosity * saturation * tau * diffCoeff;
+
+        return porosity * saturation * tau * diffCoeff;
     }
 };
 }
diff --git a/dumux/material/fluidmatrixinteractions/diffusivitymillingtonquirk.hh b/dumux/material/fluidmatrixinteractions/diffusivitymillingtonquirk.hh
index dbdbeb347738708c56a21607443b605a641a531d..3ae992fe3afb0615ef13376d2af007e19761147c 100644
--- a/dumux/material/fluidmatrixinteractions/diffusivitymillingtonquirk.hh
+++ b/dumux/material/fluidmatrixinteractions/diffusivitymillingtonquirk.hh
@@ -61,10 +61,10 @@ public:
                                                const Scalar diffCoeff)
 
     {
-    	Scalar tau = 1.0/(porosity * porosity) *
-    				pow(porosity * saturation, 7.0/3);
+        Scalar tau = 1.0/(porosity * porosity) *
+                    pow(porosity * saturation, 7.0/3);
 
-    	return porosity * saturation * tau * diffCoeff;
+        return porosity * saturation * tau * diffCoeff;
     }
 };
 }
diff --git a/dumux/material/fluidmatrixinteractions/mp/2padapter.hh b/dumux/material/fluidmatrixinteractions/mp/2padapter.hh
index d58d5dee98e70885a4abc27efaa145f954f7cd02..e6e6e6be9b45efb0b659f6e5743d13c1bd1820be 100644
--- a/dumux/material/fluidmatrixinteractions/mp/2padapter.hh
+++ b/dumux/material/fluidmatrixinteractions/mp/2padapter.hh
@@ -20,7 +20,7 @@
  * \file 2padapter.hh
  *
  * \brief Makes the twophase capillary pressure-saturation relations available under the M-phase API for material laws
- * 
+ *
  * Makes the twophase capillary pressure-saturation relations
  * available under the M-phase API for material laws
  */
diff --git a/dumux/material/fluidmatrixinteractions/mp/2poftadapter.hh b/dumux/material/fluidmatrixinteractions/mp/2poftadapter.hh
index 1edf88644f69f311de474714964a1b29f898a911..ddac48c0b12184d346a95f8c1f1919d6d451be56 100644
--- a/dumux/material/fluidmatrixinteractions/mp/2poftadapter.hh
+++ b/dumux/material/fluidmatrixinteractions/mp/2poftadapter.hh
@@ -53,7 +53,7 @@ public:
      */
     template <class pcContainerT, class FluidState>
     static void capillaryPressures(pcContainerT &pc,
-                   const Params &params, 
+                   const Params &params,
                    const FluidState &fluidState)
     {
         // non-wetting phase gets the capillary pressure added
@@ -68,7 +68,7 @@ public:
      */
     template <class krContainerT, class FluidState>
     static void relativePermeabilities(krContainerT &kr,
-                   const Params &params, 
+                   const Params &params,
                    const FluidState &fluidState)
     {
         kr[wPhaseIdx] = TwoPLaw::krw(params, fluidState.saturation(wPhaseIdx));
diff --git a/dumux/material/fluidmatrixinteractions/mp/mplinearmaterial.hh b/dumux/material/fluidmatrixinteractions/mp/mplinearmaterial.hh
index fb2a8ec4a15075cb964349924dde56c5bf6c9513..c56a5840e5b96979ba3bd89b76647ef21d37b2e3 100644
--- a/dumux/material/fluidmatrixinteractions/mp/mplinearmaterial.hh
+++ b/dumux/material/fluidmatrixinteractions/mp/mplinearmaterial.hh
@@ -18,9 +18,9 @@
  *****************************************************************************/
 /*!
  * \file
- * 
+ *
  * \brief Implements a linear saturation-capillary pressure relation
- * 
+ *
  * Implements a linear saturation-capillary pressure relation for
  * M-phase fluid systems.
  */
diff --git a/dumux/material/fluidstates/compositionalfluidstate.hh b/dumux/material/fluidstates/compositionalfluidstate.hh
index 101e1603097bb63f72164d9c326c618d28416396..41d921dfc3d300aebbaf6413115f5644296f831e 100644
--- a/dumux/material/fluidstates/compositionalfluidstate.hh
+++ b/dumux/material/fluidstates/compositionalfluidstate.hh
@@ -272,15 +272,15 @@ public:
         Valgrind::SetDefined(averageMolarMass_[phaseIdx]);
         Valgrind::SetDefined(moleFraction_[phaseIdx][compIdx]);
 
-		moleFraction_[phaseIdx][compIdx] = value;
-
-		// re-calculate the mean molar mass
-		sumMoleFractions_[phaseIdx] = 0.0;
-		averageMolarMass_[phaseIdx] = 0.0;
-		for (int compJIdx = 0; compJIdx < numComponents; ++compJIdx) {
-			sumMoleFractions_[phaseIdx] += moleFraction_[phaseIdx][compJIdx];
-			averageMolarMass_[phaseIdx] += moleFraction_[phaseIdx][compJIdx]*FluidSystem::molarMass(compJIdx);
-		}
+        moleFraction_[phaseIdx][compIdx] = value;
+
+        // re-calculate the mean molar mass
+        sumMoleFractions_[phaseIdx] = 0.0;
+        averageMolarMass_[phaseIdx] = 0.0;
+        for (int compJIdx = 0; compJIdx < numComponents; ++compJIdx) {
+            sumMoleFractions_[phaseIdx] += moleFraction_[phaseIdx][compJIdx];
+            averageMolarMass_[phaseIdx] += moleFraction_[phaseIdx][compJIdx]*FluidSystem::molarMass(compJIdx);
+        }
     }
 
     /*!
diff --git a/dumux/material/fluidstates/immisciblefluidstate.hh b/dumux/material/fluidstates/immisciblefluidstate.hh
index 2f34795fece50af0ab2b767bcd3b18589198680f..61441b12c096f31f16ee70dd55d1479700b1e5fe 100644
--- a/dumux/material/fluidstates/immisciblefluidstate.hh
+++ b/dumux/material/fluidstates/immisciblefluidstate.hh
@@ -109,7 +109,7 @@ public:
             return pressure(phaseIdx);
         else
             return 0;
-    };
+    }
 
     /*!
      * \brief The fugacity coefficient of a component in a phase [-]
diff --git a/dumux/material/fluidstates/isothermalimmisciblefluidstate.hh b/dumux/material/fluidstates/isothermalimmisciblefluidstate.hh
index 4c55baf401aee4a59f95cc9ef41af21fa5315e73..576025a912de937c61ba7fac2c0e77cae9bf51b7 100644
--- a/dumux/material/fluidstates/isothermalimmisciblefluidstate.hh
+++ b/dumux/material/fluidstates/isothermalimmisciblefluidstate.hh
@@ -105,7 +105,7 @@ public:
             return pressure(phaseIdx);
         else
             return 0;
-    };
+    }
 
     /*!
      * \brief The fugacity coefficient of a component in a phase [-]
diff --git a/dumux/material/fluidsystems/2pimmisciblefluidsystem.hh b/dumux/material/fluidsystems/2pimmisciblefluidsystem.hh
index e7f58ed841ba88a16220b6f14995833e33e0d135..a92144734003c6aedcc2778315ae104d3d452bf8 100644
--- a/dumux/material/fluidsystems/2pimmisciblefluidsystem.hh
+++ b/dumux/material/fluidsystems/2pimmisciblefluidsystem.hh
@@ -211,7 +211,7 @@ public:
         if (compIdx == wCompIdx)
             return WettingPhase::criticalTemperature();
         return NonwettingPhase::criticalTemperature();
-    };
+    }
 
     /*!
      * \brief Critical pressure of a component [Pa].
@@ -223,7 +223,7 @@ public:
         if (compIdx == wCompIdx)
             return WettingPhase::criticalPressure();
         return NonwettingPhase::criticalPressure();
-    };
+    }
 
     /*!
      * \brief The acentric factor of a component [].
diff --git a/dumux/material/fluidsystems/brineco2fluidsystem.hh b/dumux/material/fluidsystems/brineco2fluidsystem.hh
index 221252037b1f9df3e182e811b13670245f7871ef..218869505484ab954f07b902295197b78b3ea843 100644
--- a/dumux/material/fluidsystems/brineco2fluidsystem.hh
+++ b/dumux/material/fluidsystems/brineco2fluidsystem.hh
@@ -109,6 +109,7 @@ public:
         assert(0 <= phaseIdx && phaseIdx < numPhases);
         return name[phaseIdx];
     }
+
     /*!
      * \brief Return whether a phase is liquid
      *
@@ -250,7 +251,7 @@ public:
             Scalar sumx = xlBrine + xlCO2;
             xlBrine /= sumx;
             xlCO2 /= sumx;
-       
+
             Scalar result = liquidDensity_(temperature,
                                            pressure,
                                            xlBrine,
@@ -270,7 +271,7 @@ public:
             Scalar sumx = xgBrine + xgCO2;
             xgBrine /= sumx;
             xgCO2 /= sumx;
-       
+
             Scalar result = gasDensity_(temperature,
                                         pressure,
                                         xgBrine,
@@ -302,10 +303,10 @@ public:
             // assume pure brine for the liquid phase. TODO: viscosity
             // of mixture
             result = Brine::liquidViscosity(temperature, pressure);
-        	}
-        else 
-        	result = CO2::gasViscosity(temperature, pressure);
-        
+            }
+        else
+            result = CO2::gasViscosity(temperature, pressure);
+
         Valgrind::CheckDefined(result);
         return result;
     }
@@ -361,8 +362,8 @@ public:
         // could use some cleanup.
         Scalar xlH2O, xgH2O;
         Scalar xlCO2, xgCO2;
-        Brine_CO2::calculateMoleFractions(temperature, 
-                                          pressure, 
+        Brine_CO2::calculateMoleFractions(temperature,
+                                          pressure,
                                           BrineRawComponent::salinity,
                                           /*knownPhaseIdx=*/-1,
                                           xlCO2,
@@ -379,12 +380,11 @@ public:
             Scalar phigH2O = 1.0;
             return phigH2O * xgH2O / xlH2O;
         }
-        else {
-            assert(compIdx == CO2Idx);
 
-            Scalar phigCO2 = 1.0;
-            return phigCO2 * xgCO2 / xlCO2;
-        };
+        assert(compIdx == CO2Idx);
+
+        Scalar phigCO2 = 1.0;
+        return phigCO2 * xgCO2 / xlCO2;
     }
 
     /*!
@@ -517,7 +517,7 @@ public:
 
         if (phaseIdx == lPhaseIdx) {
             Scalar XlCO2 = fluidState.massFraction(phaseIdx, CO2Idx);
-            
+
             Scalar result = liquidEnthalpyBrineCO2_(temperature,
                                                     pressure,
                                                     BrineRawComponent::salinity,
@@ -560,7 +560,7 @@ public:
 
     /*!
      * \copydoc BaseFluidSystem::heatCapacity
-     * 
+     *
      * We employ the heat capacity of the pure phases.
      * Todo: Include compositional effects.
      *
@@ -722,7 +722,7 @@ private:
         h_ls = (h_ls1 - X_CO2_w*hw + hg*X_CO2_w)*1E3; /*J/kg*/
 
         return (h_ls);
-    };
+    }
 };
 } // end namespace FluidSystems
 
@@ -762,10 +762,10 @@ SET_SCALAR_PROP(NumericModel, ProblemSalinity, 1e-3);
                 //    typedef Dumux::TabulatedComponent<Scalar,BrineRawComponent > Brine;
 
             // Apply the following component classes:
-            typedef Dumux::H2O<Scalar> H2O; 
+            typedef Dumux::H2O<Scalar> H2O;
             typedef Dumux::Brine<Scalar, H2O> BrineRawComponent;
             typedef typename BrineRawComponent Brine;// all components have to be redefined,
-            													//the applied H2O and Brine implemementations.
+                                                     // the applied H2O and Brine implemementations.
         };
     \endverbatim.
      Also remember to initialize all tabulated components (FluidSystem::init()), while this
diff --git a/dumux/material/fluidsystems/gasphase.hh b/dumux/material/fluidsystems/gasphase.hh
index 7fed2903f486decd9ab8fea22fd1552836081754..4b929ab6b2f91fc0f871c7e3829b56566bcdaee0 100644
--- a/dumux/material/fluidsystems/gasphase.hh
+++ b/dumux/material/fluidsystems/gasphase.hh
@@ -45,7 +45,7 @@ public:
      * \brief Returs whether the fluid is a liquid
      */
     static bool isLiquid()
-    { return false; };
+    { return false; }
 
     /*!
      * \brief Returns true iff the fluid is assumed to be compressible
diff --git a/dumux/material/fluidsystems/h2oairfluidsystem.hh b/dumux/material/fluidsystems/h2oairfluidsystem.hh
index 7a231c40da4670011be9917273646fcf0fa9d2b9..e67719fa71f4da83279169683db734c99d5962df 100644
--- a/dumux/material/fluidsystems/h2oairfluidsystem.hh
+++ b/dumux/material/fluidsystems/h2oairfluidsystem.hh
@@ -116,7 +116,7 @@ public:
         switch (phaseIdx) {
         case wPhaseIdx: return "liquid";
         case nPhaseIdx: return "gas";
-        };
+        }
         DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx);
     }
 
@@ -210,7 +210,7 @@ public:
         {
         case H2OIdx: return H2O::name();
         case AirIdx: return Air::name();
-        };
+        }
         DUNE_THROW(Dune::InvalidStateException, "Invalid component index " << compIdx);
     }
 
@@ -225,7 +225,7 @@ public:
         {
         case H2OIdx: return H2O::molarMass();
         case AirIdx: return Air::molarMass();
-        };
+        }
         DUNE_THROW(Dune::InvalidStateException, "Invalid component index " << compIdx);
     }
 
@@ -244,7 +244,7 @@ public:
 
         assert(0 <= compIdx && compIdx < numComponents);
         return Tcrit[compIdx];
-    };
+    }
 
     /*!
      * \brief Critical pressure of a component [Pa].
@@ -260,7 +260,7 @@ public:
 
         assert(0 <= compIdx && compIdx < numComponents);
         return pcrit[compIdx];
-    };
+    }
 
     /*!
      * \brief Molar volume of a component at the critical point [m^3/mol].
@@ -271,8 +271,7 @@ public:
     {
         DUNE_THROW(Dune::NotImplemented,
                    "H2OAirFluidSystem::criticalMolarVolume()");
-        return 0;
-    };
+    }
 
     /*!
      * \brief The acentric factor of a component [].
@@ -288,7 +287,7 @@ public:
 
         assert(0 <= compIdx && compIdx < numComponents);
         return accFac[compIdx];
-    };
+    }
 
     /****************************************
      * thermodynamic relations
@@ -696,7 +695,7 @@ public:
     static Scalar thermalConductivity(const FluidState &fluidState,
                                       int phaseIdx)
     {
-		// PRELIMINARY, values for 293.15 K - has to be generalized
+        // PRELIMINARY, values for 293.15 K - has to be generalized
         assert(0 <= phaseIdx  && phaseIdx < numPhases);
 
         if (phaseIdx == wPhaseIdx){// liquid phase
diff --git a/dumux/material/fluidsystems/h2oairmesitylenefluidsystem.hh b/dumux/material/fluidsystems/h2oairmesitylenefluidsystem.hh
index 0b151da2f463673d9fd061a42d7ce50aafcbd637..3ad2078e55d30ce3fce1d31e30c419ae4d134ee6 100644
--- a/dumux/material/fluidsystems/h2oairmesitylenefluidsystem.hh
+++ b/dumux/material/fluidsystems/h2oairmesitylenefluidsystem.hh
@@ -72,9 +72,9 @@ public:
     static const int H2OIdx = 0;
     static const int NAPLIdx = 1;
     static const int airIdx = 2;
-    
-    // export component indices to indicate the main component 
-    // of the corresponding phase at atmospheric pressure 1 bar 
+
+    // export component indices to indicate the main component
+    // of the corresponding phase at atmospheric pressure 1 bar
     // and room temperature 20°C:
     static const int wCompIdx = H2OIdx;
     static const int nCompIdx = NAPLIdx;
@@ -190,7 +190,7 @@ public:
         case wPhaseIdx: return "w";
         case nPhaseIdx: return "n";
         case gPhaseIdx: return "g";
-        };
+        }
         DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx);
     }
 
@@ -203,7 +203,7 @@ public:
         case H2OIdx: return H2O::name();
         case airIdx: return Air::name();
         case NAPLIdx: return NAPL::name();
-        };
+        }
         DUNE_THROW(Dune::InvalidStateException, "Invalid component index " << compIdx);
     }
 
@@ -216,7 +216,7 @@ public:
         case H2OIdx: return H2O::molarMass();
         case airIdx: return Air::molarMass();
         case NAPLIdx: return NAPL::molarMass();
-        };
+        }
         DUNE_THROW(Dune::InvalidStateException, "Invalid component index " << compIdx);
     }
 
@@ -547,7 +547,7 @@ private:
     static Scalar gasPhaseDensity_(Scalar T, Scalar pg, Scalar xgw, Scalar xga, Scalar xgc)
     {
         return H2O::gasDensity(T, pg*xgw) + Air::gasDensity(T, pg*xga) + NAPL::gasDensity(T, pg*xgc);
-    };
+    }
 
     static Scalar NAPLPhaseDensity_(Scalar T, Scalar pn)
     {
@@ -581,10 +581,10 @@ namespace Properties {
  *        SET_PROP(myApplicationProperty, Components) : public GET_PROP(TypeTag, DefaultComponents)
  *        {
  *            typedef typename GET_PROP_TYPE(TypeTag, Scalar) Scalar;
- * 
+ *
  *        // Do not use the defaults !
  *        //    typedef Dumux::TabulatedComponent<Scalar, Dumux::H2O<Scalar> > H2O;
- * 
+ *
  *        // Apply e.g. untabulated water:
  *        typedef Dumux::H2O<Scalar> H2O;
  *        };
diff --git a/dumux/material/fluidsystems/h2oairxylenefluidsystem.hh b/dumux/material/fluidsystems/h2oairxylenefluidsystem.hh
index e75a2ec85a7f029ee435f68c5b6acee782ef815b..84f74815dbcf6e829a9717a78a7d5857fef1f665 100644
--- a/dumux/material/fluidsystems/h2oairxylenefluidsystem.hh
+++ b/dumux/material/fluidsystems/h2oairxylenefluidsystem.hh
@@ -70,8 +70,8 @@ public:
     static const int NAPLIdx = 1;
     static const int airIdx = 2;
 
-    // export component indices to indicate the main component 
-    // of the corresponding phase at atmospheric pressure 1 bar 
+    // export component indices to indicate the main component
+    // of the corresponding phase at atmospheric pressure 1 bar
     // and room temperature 20°C:
     static const int wCompIdx = H2OIdx;
     static const int nCompIdx = NAPLIdx;
@@ -92,7 +92,7 @@ public:
              /*pMax=*/20e6,
              /*numP=*/200);
     }
-    
+
     /*!
      * \brief Initialize the fluid system's static parameters using
      *        problem specific temperature and pressure ranges
@@ -111,7 +111,7 @@ public:
             std::cout << "Initializing tables for the H2O fluid properties ("
             << nTemp*nPress
             << " entries).\n";
-            
+
             H2O::init(tempMin, tempMax, nTemp,
                       pressMin, pressMax, nPress);
         }
@@ -186,7 +186,7 @@ public:
         case wPhaseIdx: return "w";
         case nPhaseIdx: return "n";
         case gPhaseIdx: return "g";
-        };
+        }
         DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx);
     }
 
@@ -199,7 +199,7 @@ public:
         case H2OIdx: return H2O::name();
         case airIdx: return Air::name();
         case NAPLIdx: return NAPL::name();
-        };
+        }
         DUNE_THROW(Dune::InvalidStateException, "Invalid component index " << compIdx);
     }
 
@@ -212,7 +212,7 @@ public:
         case H2OIdx: return H2O::molarMass();
         case airIdx: return Air::molarMass();
         case NAPLIdx: return NAPL::molarMass();
-        };
+        }
         DUNE_THROW(Dune::InvalidStateException, "Invalid component index " << compIdx);
     }
 
@@ -546,7 +546,7 @@ private:
     static Scalar gasPhaseDensity_(Scalar T, Scalar pg, Scalar xgw, Scalar xga, Scalar xgc)
     {
         return H2O::gasDensity(T, pg*xgw) + Air::gasDensity(T, pg*xga) + NAPL::gasDensity(T, pg*xgc);
-    };
+    }
 
     static Scalar NAPLPhaseDensity_(Scalar T, Scalar pn)
     {
@@ -580,10 +580,10 @@ namespace Properties {
  *        SET_PROP(myApplicationProperty, Components) : public GET_PROP(TypeTag, DefaultComponents)
  *        {
  *            typedef typename GET_PROP_TYPE(TypeTag, Scalar) Scalar;
- * 
+ *
  *        // Do not use the defaults !
  *        //    typedef Dumux::TabulatedComponent<Scalar, Dumux::H2O<Scalar> > H2O;
- * 
+ *
  *        // Apply e.g. untabulated water:
  *        typedef Dumux::H2O<Scalar> H2O;
  *        };
@@ -597,7 +597,7 @@ class H2OAirXyleneFluidSystem
                                     typename GET_PROP(TypeTag, Components)::H2O>
 {};
 #endif
-    
+
 } // end namespace Dumux
 
 #endif
diff --git a/dumux/material/fluidsystems/h2on2fluidsystem.hh b/dumux/material/fluidsystems/h2on2fluidsystem.hh
index b006925787956f2d2e032a023877676d49b3104c..e712aed06e618f004b8ec58fe38290f40c32228d 100644
--- a/dumux/material/fluidsystems/h2on2fluidsystem.hh
+++ b/dumux/material/fluidsystems/h2on2fluidsystem.hh
@@ -83,13 +83,13 @@ public:
 
     static constexpr int wPhaseIdx = 0; // index of the wetting phase
     static constexpr int nPhaseIdx = 1; // index of the non-wetting phase
-    
-    // export component indices to indicate the main component 
-    // of the corresponding phase at atmospheric pressure 1 bar 
+
+    // export component indices to indicate the main component
+    // of the corresponding phase at atmospheric pressure 1 bar
     // and room temperature 20°C:
     static const int wCompIdx = wPhaseIdx;
     static const int nCompIdx = nPhaseIdx;
-    
+
     /*!
      * \brief Return the human readable name of a fluid phase
      *
diff --git a/dumux/material/fluidsystems/h2on2fluidsystemkinetic.hh b/dumux/material/fluidsystems/h2on2fluidsystemkinetic.hh
index e2c4546cb3134ca8b4f9b84d15efaa0280c8f104..5ee893dd31ec8db893aa4403747040de78d3e6af 100644
--- a/dumux/material/fluidsystems/h2on2fluidsystemkinetic.hh
+++ b/dumux/material/fluidsystems/h2on2fluidsystemkinetic.hh
@@ -66,7 +66,7 @@ public:
 //     * \brief Initialize the fluid system's static parameters
 //     */
 //    static void init(Scalar tempMin, Scalar tempMax, unsigned nTemp,
-//    				 Scalar pressMin, Scalar pressMax, unsigned nPress)
+//                     Scalar pressMin, Scalar pressMax, unsigned nPress)
 //    {
 //        ParentType::init(tempMin, tempMax, nTemp,
 //                         pressMin, pressMax, nPress);
@@ -187,7 +187,6 @@ public:
                 Valgrind::CheckDefined(xnw);
                 fluidState.setMoleFraction(otherPhaseIdx, calcCompIdx, xnw) ;
                 return;
-                break;
             }
 
             case nCompIdx :
@@ -198,7 +197,7 @@ public:
                 const Scalar xnn    = H / pn * xwn; // mole fraction in the other phase
                 Valgrind::CheckDefined(xnn);
                 fluidState.setMoleFraction(otherPhaseIdx, calcCompIdx, xnn) ;
-                return ;
+                return;
             }
 
             default: DUNE_THROW(Dune::NotImplemented, "wrong index");
@@ -217,8 +216,7 @@ public:
                 const Scalar xww = pn / pv * xnw ; // mole fraction in the other phase
                 Valgrind::CheckDefined(xww);
                 fluidState.setMoleFraction(otherPhaseIdx, calcCompIdx, xww) ;
-                return ;
-                break ;
+                return;
             }
 
             case nCompIdx :
@@ -232,12 +230,11 @@ public:
                 return ;
             }
 
-            default: DUNE_THROW(Dune::NotImplemented, "wrong index");
-            break;
+            default:
+                DUNE_THROW(Dune::NotImplemented, "wrong index");
             }
 
             DUNE_THROW(Dune::NotImplemented, "wrong index");
-            break;
         }
     }
 
@@ -298,14 +295,11 @@ public:
                 fluidState.setMoleFraction(phaseIdx, compIdx, x[phaseIdx][compIdx]) ;
             }
     }
-    
-    
-    
-    
-        /*!
+
+    /*!
      * \brief Give the Henry constant for a component in a phase.
      */
-    static Scalar henry(Scalar temperature) 
+    static Scalar henry(Scalar temperature)
     {
         return Dumux::BinaryCoeff::H2O_N2::henry(temperature) ; // Pa
     }
@@ -317,16 +311,8 @@ public:
     {
         return ParentType::H2O::vaporPressure(temperature); // Pa // 1e-20 ; //
     }
-    
-    
-    
-    
-    
-    
 };
-
 }// end namespace Fluidsystem
-
 } // end namespace Dumux
 
 #endif
diff --git a/dumux/material/fluidsystems/liquidphase.hh b/dumux/material/fluidsystems/liquidphase.hh
index d36dec5712bb1df684b21de858fbf0bfd382ab3a..5bf48a9703afe31a321bce4652acde20bdad3afb 100644
--- a/dumux/material/fluidsystems/liquidphase.hh
+++ b/dumux/material/fluidsystems/liquidphase.hh
@@ -46,7 +46,7 @@ public:
      * \brief Returs whether the fluid is a liquid
      */
     static bool isLiquid()
-    { return true; };
+    { return true; }
 
     /*!
      * \brief Returns true iff the fluid is assumed to be compressible
diff --git a/dumux/material/fluidsystems/purewatersimplefluidsystem.hh b/dumux/material/fluidsystems/purewatersimplefluidsystem.hh
index 00182da50bfaa78525af4949a489e338f47e7166..28dba4c17a0dcf1e66c6ed4740d8fbe0a611c7ad 100644
--- a/dumux/material/fluidsystems/purewatersimplefluidsystem.hh
+++ b/dumux/material/fluidsystems/purewatersimplefluidsystem.hh
@@ -53,7 +53,7 @@ namespace FluidSystems
  * \ingroup Fluidsystems
  *
  * \brief A two-phase fluid system with water as sole component.
- * 		  Values are taken from Shi & Wang, A numerical investigation of transpiration cooling with liquid coolant phase change, Transport in Porous Media, 2011
+ *           Values are taken from Shi & Wang, A numerical investigation of transpiration cooling with liquid coolant phase change, Transport in Porous Media, 2011
  *
  * This FluidSystem can be used without the PropertySystem that is applied in Dumux,
  * as all Parameters are defined via template parameters. Hence it is in an
@@ -84,13 +84,13 @@ public:
     static constexpr int wPhaseIdx = 0; // index of the wetting phase
     static constexpr int nPhaseIdx = 1; // index of the non-wetting phase
     static constexpr int sPhaseIdx = 2; // Index of the solid phase
-    
-    // export component indices to indicate the main component 
-    // of the corresponding phase at atmospheric pressure 1 bar 
+
+    // export component indices to indicate the main component
+    // of the corresponding phase at atmospheric pressure 1 bar
     // and room temperature 20°C:
     static const int wCompIdx = wPhaseIdx;
     static const int nCompIdx = nPhaseIdx;
-    
+
     /*!
      * \brief Return the human readable name of a fluid phase
      *
@@ -319,7 +319,7 @@ public:
     static void init(Scalar tempMin, Scalar tempMax, unsigned nTemp,
                      Scalar pressMin, Scalar pressMax, unsigned nPress)
     {
-    	std::cout << "Using very simple pure water fluid system\n";
+        std::cout << "Using very simple pure water fluid system\n";
     }
 
     /*!
@@ -341,8 +341,8 @@ public:
         }
         else if (phaseIdx == nPhaseIdx)// gas phase
         {
-        	return
-					1.679 ;
+            return
+                    1.679 ;
         }
         else DUNE_THROW(Dune::NotImplemented,
                    "wrong index");
@@ -367,7 +367,7 @@ public:
         }
         else if (phaseIdx == nPhaseIdx) // gas phase
         {
-        	return 7.16e-6 * density(fluidState, phaseIdx) ;
+            return 7.16e-6 * density(fluidState, phaseIdx) ;
         }
         else DUNE_THROW(Dune::NotImplemented,
                    "wrong index");
@@ -381,7 +381,7 @@ public:
      */
     template <class FluidState>
     static Scalar vaporTemperature(const FluidState &fluidState,
-    							   const unsigned int phaseIdx)
+                                   const unsigned int phaseIdx)
     {
         assert(0 <= phaseIdx  && phaseIdx < numPhases);
         Scalar pressure = fluidState.pressure(nPhaseIdx) ;
@@ -498,11 +498,11 @@ public:
 
         // liquid phase
         if (phaseIdx == wPhaseIdx) {
-        	return cp * (temperature -  373.15);
+            return cp * (temperature -  373.15);
         }
         else if (phaseIdx == nPhaseIdx) // gas phase
         {
-        	return cp * (temperature - 373.15) + 2.257e6;
+            return cp * (temperature - 373.15) + 2.257e6;
         }
         else DUNE_THROW(Dune::NotImplemented,
                    "wrong index");
@@ -528,7 +528,7 @@ public:
         }
         else if (phaseIdx == nPhaseIdx) // gas phase
         {
-        	return 0.0248;
+            return 0.0248;
         }
         else DUNE_THROW(Dune::NotImplemented,
                    "wrong index");
@@ -553,7 +553,7 @@ public:
         }
         else if (phaseIdx == nPhaseIdx) // gas phase
         {
-        	return 2.029e3;
+            return 2.029e3;
         }
         else DUNE_THROW(Dune::NotImplemented,
                    "wrong index");
diff --git a/dumux/material/fluidsystems/spe5fluidsystem.hh b/dumux/material/fluidsystems/spe5fluidsystem.hh
index 0e4cec5337a6cce53434f378ea42e70f8033416f..6f3f2f6ad2cd1f717bb3721f5664786331a849fe 100644
--- a/dumux/material/fluidsystems/spe5fluidsystem.hh
+++ b/dumux/material/fluidsystems/spe5fluidsystem.hh
@@ -219,7 +219,7 @@ public:
 
         assert(0 <= compIdx && compIdx < numComponents);
         return Tcrit[compIdx];
-    };
+    }
 
     /*!
      * \brief Critical pressure of a component [Pa].
@@ -238,7 +238,7 @@ public:
 
         assert(0 <= compIdx && compIdx < numComponents);
         return pcrit[compIdx];
-    };
+    }
 
     /*!
      * \brief Molar volume of a component at the critical point [m^3/mol].
@@ -258,7 +258,7 @@ public:
 
         assert(0 <= compIdx && compIdx < numComponents);
         return vcrit[compIdx];
-    };
+    }
 
     /*!
      * \brief The acentric factor of a component [].
@@ -277,7 +277,7 @@ public:
 
         assert(0 <= compIdx && compIdx < numComponents);
         return accFac[compIdx];
-    };
+    }
 
     /*!
      * \brief Returns the interaction coefficient for two components.
@@ -517,7 +517,7 @@ private:
         case C20Idx: return 1e10;
         default: DUNE_THROW(Dune::InvalidStateException, "Unknown component index " << compIdx);
         }
-    };
+    }
 };
 
 } // end namespace
diff --git a/dumux/material/spatialparams/implicitspatialparams.hh b/dumux/material/spatialparams/implicitspatialparams.hh
index ebc2a686c5632192bdc7dca6cf7ba74b1c19ab75..712f19b03d33bcb24bc12c0f6ebc3e7d5ff2862f 100644
--- a/dumux/material/spatialparams/implicitspatialparams.hh
+++ b/dumux/material/spatialparams/implicitspatialparams.hh
@@ -20,7 +20,7 @@
  * \file
  *
  * \ingroup SpatialParameters
- * \brief The base class for spatial parameters of multi-phase problems 
+ * \brief The base class for spatial parameters of multi-phase problems
  * using a fully implicit discretization method.
  */
 #ifndef DUMUX_IMPLICIT_SPATIAL_PARAMS_HH
@@ -41,7 +41,7 @@ NEW_PROP_TAG(MaterialLawParams);
 
 
 /**
- * \brief The base class for spatial parameters of multi-phase problems 
+ * \brief The base class for spatial parameters of multi-phase problems
  * using a fully implicit discretization method.
  */
 template<class TypeTag>
diff --git a/dumux/material/spatialparams/implicitspatialparams1p.hh b/dumux/material/spatialparams/implicitspatialparams1p.hh
index 178d97327c3d1e2c09f026ec56c5d92b3248f1ee..53b892295ea72dce3fa22e5893697a9805cbf9ef 100644
--- a/dumux/material/spatialparams/implicitspatialparams1p.hh
+++ b/dumux/material/spatialparams/implicitspatialparams1p.hh
@@ -20,7 +20,7 @@
  * \file
  *
  * \ingroup SpatialParameters
- * \brief The base class for spatial parameters of one-phase problems 
+ * \brief The base class for spatial parameters of one-phase problems
  * using a fully implicit discretization method.
  */
 #ifndef DUMUX_IMPLICIT_SPATIAL_PARAMS_ONE_P_HH
@@ -46,7 +46,7 @@ NEW_PROP_TAG(SpatialParamsForchCoeff);
 
 
 /**
- * \brief The base class for spatial parameters of one-phase problems 
+ * \brief The base class for spatial parameters of one-phase problems
  * using a fully implicit discretization method.
  */
 template<class TypeTag>