diff --git a/dumux/boxmodels/MpNc/diffusion/fluxvariables.hh b/dumux/boxmodels/MpNc/diffusion/fluxvariables.hh
index 35570f037cc9d4e8333de9c60142aef106b8be58..1d805f6fb41c4d21e1f65cabec8b74ef3704aafc 100644
--- a/dumux/boxmodels/MpNc/diffusion/fluxvariables.hh
+++ b/dumux/boxmodels/MpNc/diffusion/fluxvariables.hh
@@ -234,6 +234,6 @@ public:
     };
 };
 
-};
+}
 
 #endif // DUMUX_MPNC_DIFFUSION_FLUX_VARIABLES_HH
diff --git a/dumux/boxmodels/MpNc/diffusion/volumevariables.hh b/dumux/boxmodels/MpNc/diffusion/volumevariables.hh
index 42d61c3d60dda1b7f02c633c55e5ad6c26731e30..5683743860e36cd751af03ac2e24108a2698890e 100644
--- a/dumux/boxmodels/MpNc/diffusion/volumevariables.hh
+++ b/dumux/boxmodels/MpNc/diffusion/volumevariables.hh
@@ -88,7 +88,7 @@ public:
             }
         }
         Valgrind::CheckDefined(diffCoeffG_);
-    };
+    }
 
 
     Scalar diffCoeff(int phaseIdx, int compIIdx, int compJIdx) const
@@ -102,7 +102,7 @@ public:
         if (i != 0)
             return 0;
         return diffCoeffL_[j];
-    };
+    }
 
     /*!
      * \brief If running under valgrind this produces an error message
@@ -142,13 +142,13 @@ public:
                 ParameterCache &paramCache,
                 const VolumeVariables &volVars,
                 const Problem &problem)
-    { };
+    { }
 
     Scalar diffCoeffL(int compIdx) const
-    { return 0; };
+    { return 0; }
 
     Scalar diffCoeffG(int compIIdx, int compJIdx) const
-    { return 0; };
+    { return 0; }
 
     /*!
      * \brief If running under valgrind this produces an error message
diff --git a/dumux/boxmodels/MpNc/energy/MpNclocalresidualenergy.hh b/dumux/boxmodels/MpNc/energy/MpNclocalresidualenergy.hh
index 6a29a7cf22460c68c5a5c1d038a04a2e913090f1..f5df71603fcabe322c5090119ef0c7098cbfb738 100644
--- a/dumux/boxmodels/MpNc/energy/MpNclocalresidualenergy.hh
+++ b/dumux/boxmodels/MpNc/energy/MpNclocalresidualenergy.hh
@@ -61,7 +61,7 @@ public:
                                const VolumeVariables &volVars)
     {
         // do nothing, we're isothermal!
-    };
+    }
 
 
     static void addPhaseStorage(PrimaryVariables &storage,
@@ -69,7 +69,7 @@ public:
                                 int phaseIdx)
     {
         // do nothing, we're isothermal!
-    };
+    }
 
     static void phaseEnthalpyFlux(PrimaryVariables &result,
                                   int phaseIdx,
@@ -78,14 +78,14 @@ public:
                                   const FluxVariables &fluxVars)
     {
         // do nothing, we're isothermal!
-    };
+    }
 
     static void heatConduction(PrimaryVariables &result,
                                const ElementVolumeVariables &volVars,
                                const FluxVariables &fluxVars)
     {
         // do nothing, we're isothermal!
-    };
+    }
 
 
     static void computeFlux(PrimaryVariables & flux,
@@ -233,6 +233,6 @@ public:
 
 
 
-};
+}
 
 #endif // DUMUX_MPNC_ENERGY_HH
diff --git a/dumux/boxmodels/richards/richardslocalresidual.hh b/dumux/boxmodels/richards/richardslocalresidual.hh
index caf6ce3e86eedb10c616bcec60c299f39f465a10..be094928bb7256840d48c649af0e19d6827f7d22 100644
--- a/dumux/boxmodels/richards/richardslocalresidual.hh
+++ b/dumux/boxmodels/richards/richardslocalresidual.hh
@@ -169,6 +169,6 @@ private:
     Scalar massUpwindWeight_;
 };
 
-};
+}
 
 #endif
diff --git a/dumux/boxmodels/richards/richardsproperties.hh b/dumux/boxmodels/richards/richardsproperties.hh
index 2c1bdbce6c9c051f062dd10893851905d320db6a..80b793fd53756e002116132bdf778240adcd3bbf 100644
--- a/dumux/boxmodels/richards/richardsproperties.hh
+++ b/dumux/boxmodels/richards/richardsproperties.hh
@@ -63,7 +63,7 @@ NEW_PROP_TAG(NonwettingPhase); //!< Fluid which represents the non-wetting phase
 NEW_PROP_TAG(EnableGravity); //!< Returns whether gravity is considered in the problem
 NEW_PROP_TAG(MassUpwindWeight); //!< The value of the weight of the upwind direction in the mass conservation equations
 // \}
-};
+}
 
 } // end namepace
 
diff --git a/dumux/boxmodels/richards/richardspropertydefaults.hh b/dumux/boxmodels/richards/richardspropertydefaults.hh
index 5fc78d5aa7c25c9b457c9c7599b8f5be019c109d..c0e04a16fb17c745d2491a472b134e9e03eccb74 100644
--- a/dumux/boxmodels/richards/richardspropertydefaults.hh
+++ b/dumux/boxmodels/richards/richardspropertydefaults.hh
@@ -148,7 +148,7 @@ public:
 };
 
 // \}
-};
+}
 
 } // end namepace
 
diff --git a/dumux/common/splinecommon_.hh b/dumux/common/splinecommon_.hh
index 33abc4f60667033b9ace812f7ba3396ae497f84a..b895d49f2b7d17e1639310ecc07d973d8473b2c8 100644
--- a/dumux/common/splinecommon_.hh
+++ b/dumux/common/splinecommon_.hh
@@ -325,7 +325,7 @@ protected:
             destX[i] = srcX[idx];
             destY[i] = srcY[idx];
         }
-    };
+    }
 
     template <class DestVector, class ListIterator>
     void assignFromArrayList_(DestVector &destX,
@@ -352,7 +352,7 @@ protected:
             destX[i] = (*it)[0];
             destY[i] = (*it)[1];
         }
-    };
+    }
 
     /*!
      * \brief Set the sampling points.
@@ -389,7 +389,7 @@ protected:
             destX[i] = std::tr1::get<0>(*it);
             destY[i] = std::tr1::get<1>(*it);
         }
-    };
+    }
 
 
     /*!
@@ -587,7 +587,7 @@ protected:
         x0 = (x0 + x1)/2; // pick point in the middle of the interval
                           // to avoid extrema on the boundaries
         return (x0*(x0*3*a + 2*b) + c > 0) ? 1 : -1;
-    };
+    }
 
     /*!
      * \brief Find all the intersections of a segment of the spline
@@ -633,7 +633,7 @@ protected:
                 iLow = i;
         };
         return iLow;
-    };
+    }
 
     /*!
      * \brief Returns x[i] - x[i - 1]
@@ -642,7 +642,8 @@ protected:
     {
         assert(x_(i) > x_(i-1)); // the sampling points must be given
                                  // in ascending order
-        return x_(i) - x_(i - 1); }
+        return x_(i) - x_(i - 1); 
+    }
 
     /*!
      * \brief Returns the y coordinate of the i-th sampling point.
diff --git a/dumux/decoupled/2p/transport/fv/fvsaturation2p.hh b/dumux/decoupled/2p/transport/fv/fvsaturation2p.hh
index 5688f7720b099db307d9657a0792b2165f1f70cd..fcd6e0e9ba8b630dc93524ec2b146e6a38b9a711 100644
--- a/dumux/decoupled/2p/transport/fv/fvsaturation2p.hh
+++ b/dumux/decoupled/2p/transport/fv/fvsaturation2p.hh
@@ -314,7 +314,6 @@ private:
     EvalCflFluxFunction* evalCflFluxFunction_;
 
     static const bool compressibility_ = GET_PROP_VALUE(TypeTag, PTAG(EnableCompressibility));
-    ;
     static const int saturationType_ = GET_PROP_VALUE(TypeTag, PTAG(SaturationFormulation));
     static const int velocityType_ = GET_PROP_VALUE(TypeTag, PTAG(VelocityFormulation));
     static const int pressureType_ = GET_PROP_VALUE(TypeTag, PTAG(PressureFormulation));
diff --git a/dumux/linear/elementborderlistfromgrid.hh b/dumux/linear/elementborderlistfromgrid.hh
index 0a30c3b78aadb69f3dd243bc2557d2aa4d1a5bd7..54054db9ea782a4bb923fc54b014001110927181 100644
--- a/dumux/linear/elementborderlistfromgrid.hh
+++ b/dumux/linear/elementborderlistfromgrid.hh
@@ -78,7 +78,7 @@ public:
         gv.communicate(*this,
                        Dune::InteriorBorder_All_Interface,
                        Dune::BackwardCommunication);
-    };
+    }
 
     // data handle methods
     bool contains (int dim, int codim) const
@@ -89,14 +89,14 @@ public:
 
     template<class EntityType>
     size_t size(const EntityType &e) const
-    { return 2; };
+    { return 2; }
 
     template<class MessageBufferImp, class EntityType>
     void gather(MessageBufferImp &buff, const EntityType &e) const
     {
         buff.write(gv_.comm().rank());
         buff.write(map_.map(e));
-    };
+    }
 
     template<class MessageBufferImp, class EntityType>
     void scatter(MessageBufferImp &buff, const EntityType &e, size_t n)
@@ -122,7 +122,7 @@ public:
             // intersecting with us.
             foreignBorderList_.push_back(bIdx);
         }
-    };
+    }
 
     // Access to the initial border list.
     const BorderList &foreignBorderList() const
diff --git a/dumux/material/binarycoefficients/h2o_n2.hh b/dumux/material/binarycoefficients/h2o_n2.hh
index ed64442eed7cae2a5471520fea805cb6480fa15d..fb28c5ebec502cf73ec2f83cf226eee3bde9379f 100644
--- a/dumux/material/binarycoefficients/h2o_n2.hh
+++ b/dumux/material/binarycoefficients/h2o_n2.hh
@@ -59,7 +59,7 @@ public:
         const Scalar H = -29.4396;
 
         return henryIAPWS(E, F, G, H, temperature);
-    };
+    }
 
     /*!
      * \brief Binary diffusion coefficent \f$\mathrm{[m^2/s]}\f$ for molecular water and nitrogen.
@@ -80,7 +80,7 @@ public:
         const Scalar M[2] = { H2O::molarMass()*Scalar(1e3), N2::molarMass()*Scalar(1e3) };
 
         return fullerMethod(M, SigmaNu, temperature, pressure);
-    };
+    }
 
     /*!
      * \brief Diffusion coefficent \f$\mathrm{[m^2/s]}\f$ for molecular nitrogen in liquid water.
@@ -107,7 +107,7 @@ public:
         const Scalar Dexp = 2.01e-9; // [m^2/s]
 
         return Dexp * temperature/Texp;
-    };
+    }
 };
 
 }
diff --git a/dumux/material/binarycoefficients/henryiapws.hh b/dumux/material/binarycoefficients/henryiapws.hh
index 941da891182bb69f04024fef32f5a1a6a1bbdf7f..b7ccdb47065846e5cc270362132ef08334a80e29 100644
--- a/dumux/material/binarycoefficients/henryiapws.hh
+++ b/dumux/material/binarycoefficients/henryiapws.hh
@@ -81,7 +81,7 @@ inline Scalar henryIAPWS(Scalar E,
     // multiply it with the vapor pressure of water in order to get
     // derivative of the partial pressure.
     return exp(exponent)*H2O::vaporPressure(temperature);
-};
-};
+}
+}
 
 #endif // DUMUX_HENRY_IAPWS_HH
diff --git a/dumux/material/constraintsolvers/compositionfromfugacities.hh b/dumux/material/constraintsolvers/compositionfromfugacities.hh
index a1283733896f235c230de4ceeb01221e89662487..ee47da3ddfada6fa6df3f0763a5d8c00e83893c3 100644
--- a/dumux/material/constraintsolvers/compositionfromfugacities.hh
+++ b/dumux/material/constraintsolvers/compositionfromfugacities.hh
@@ -70,7 +70,7 @@ public:
                                    i,
                                    1.0/numComponents);
         }
-    };
+    }
 
     /*!
      * \brief Calculates the chemical equilibrium from the component
@@ -97,7 +97,7 @@ public:
         Dune::FieldVector<Scalar, numComponents> xInit;
         for (int i = 0; i < numComponents; ++i) {
             xInit[i] = fluidState.moleFraction(phaseIdx, i);
-        };
+        }
 
         /////////////////////////
         // Newton method
@@ -176,7 +176,7 @@ public:
                    << xInit
                    << "}, {fug_t} = {" << targetFug << "}, p = " << fluidState.pressure(phaseIdx)
                    << ", T = " << fluidState.temperature(phaseIdx));
-    };
+    }
 
 
 protected:
@@ -204,7 +204,7 @@ protected:
         Scalar rho = FluidSystem::density(fluidState, paramCache, phaseIdx);
         fluidState.setDensity(phaseIdx, rho);
         return;
-    };
+    }
 
     template <class FluidState>
     static void linearize_(Dune::FieldMatrix<Scalar, numComponents, numComponents> &J,
@@ -294,7 +294,7 @@ protected:
 
             sumx += std::abs(fluidState.moleFraction(phaseIdx, i));
             sumDelta += std::abs(x[i]);
-        };
+        }
 
 #if 1
         // chop update to at most 20% change in composition
diff --git a/dumux/material/constraintsolvers/computefromreferencephase.hh b/dumux/material/constraintsolvers/computefromreferencephase.hh
index 8799011e6e7be3153bb8c96ba3c0cfcda665c292..4178b0b412c9cb4e625e71d323fba36a29d63894 100644
--- a/dumux/material/constraintsolvers/computefromreferencephase.hh
+++ b/dumux/material/constraintsolvers/computefromreferencephase.hh
@@ -169,7 +169,7 @@ public:
                                                              paramCache,
                                                              phaseIdx));
         }
-    };
+    }
 };
 
 } // end namespace Dumux
diff --git a/dumux/material/constraintsolvers/misciblemultiphasecomposition.hh b/dumux/material/constraintsolvers/misciblemultiphasecomposition.hh
index 5cda9c0ae10b27eb52909203ca63cba56522d90f..0d6faeb190211670ec1ae6c3e8f9bf1d4a3233e1 100644
--- a/dumux/material/constraintsolvers/misciblemultiphasecomposition.hh
+++ b/dumux/material/constraintsolvers/misciblemultiphasecomposition.hh
@@ -190,7 +190,7 @@ public:
                 fluidState.setEnthalpy(phaseIdx, value);
             }
         }
-    };
+    }
 };
 
 } // end namespace Dumux
diff --git a/dumux/material/constraintsolvers/ncpflash.hh b/dumux/material/constraintsolvers/ncpflash.hh
index 556e55f76c1bf954105d411fdeac41a348ab7770..e762db421e0f70b613d0cfe54afb73d85f23627d 100644
--- a/dumux/material/constraintsolvers/ncpflash.hh
+++ b/dumux/material/constraintsolvers/ncpflash.hh
@@ -126,7 +126,7 @@ public:
                 fluidState.setFugacityCoefficient(phaseIdx, compIdx, phi);
             }
         }
-    };
+    }
 
     /*!
      * \brief Calculates the chemical equilibrium from the component
@@ -232,7 +232,7 @@ public:
                    "Flash calculation failed."
                    " {c_alpha^kappa} = {" << globalMolarities << "}, T = " 
                    << fluidState.temperature(/*phaseIdx=*/0));
-    };
+    }
 
 
 protected:
@@ -526,7 +526,7 @@ protected:
             int compIdx = (pvIdx - numPhases)%numComponents;
             return fs.moleFraction(phaseIdx, compIdx);
         }
-    };
+    }
 
     // set a quantity in the fluid state
     template <class MaterialLaw, class FluidState>
@@ -612,7 +612,7 @@ protected:
         else {
             assert(false);
         }
-    };
+    }
 
     // set a quantity in the fluid state
     template <class FluidState>
@@ -637,7 +637,7 @@ protected:
             int compIdx = (pvIdx - numPhases)%numComponents;
             fs.setMoleFraction(phaseIdx, compIdx, value);
         }
-    };
+    }
 
     template <class FluidState>
     static Scalar quantityWeight_(const FluidState &fs, int pvIdx)
@@ -651,7 +651,7 @@ protected:
         // mole fractions
         else // if (pvIdx < numPhases + numPhases*numComponents) 
             return 1.0;
-    };
+    }
 };
 
 } // end namespace Dumux
diff --git a/dumux/material/fluidmatrixinteractions/2p/brookscoreyparams.hh b/dumux/material/fluidmatrixinteractions/2p/brookscoreyparams.hh
index fd809657a2f1c939c59cf14416f02876cd74e1ad..1f5e276c35bf222ec3a3dbe800cb21c725490a14 100644
--- a/dumux/material/fluidmatrixinteractions/2p/brookscoreyparams.hh
+++ b/dumux/material/fluidmatrixinteractions/2p/brookscoreyparams.hh
@@ -87,6 +87,6 @@ private:
     Scalar pe_;
     Scalar lambda_;
 };
-}; // namespace Dumux
+} // namespace Dumux
 
 #endif
diff --git a/dumux/material/fluidmatrixinteractions/2p/regularizedbrookscoreyparams.hh b/dumux/material/fluidmatrixinteractions/2p/regularizedbrookscoreyparams.hh
index 5f71dea291460e8a58f45f5c45aa64e58da87260..369e6cd47d0ae8a5a6f06812fa6a0fe8fa88e854 100644
--- a/dumux/material/fluidmatrixinteractions/2p/regularizedbrookscoreyparams.hh
+++ b/dumux/material/fluidmatrixinteractions/2p/regularizedbrookscoreyparams.hh
@@ -78,6 +78,6 @@ public:
     }
 
 };
-}; // namespace Dumux
+} // namespace Dumux
 
 #endif
diff --git a/dumux/material/fluidmatrixinteractions/2p/regularizedvangenuchtenparams.hh b/dumux/material/fluidmatrixinteractions/2p/regularizedvangenuchtenparams.hh
index b67c832aeacc82d4d8f9bc13bdfaac800a01d28b..af78efe3454f66e82905d8ab61a00bdd4fd8d2bc 100644
--- a/dumux/material/fluidmatrixinteractions/2p/regularizedvangenuchtenparams.hh
+++ b/dumux/material/fluidmatrixinteractions/2p/regularizedvangenuchtenparams.hh
@@ -120,6 +120,6 @@ public:
     { return 0.90; }
 
 };
-}; // namespace Dumux
+} // namespace Dumux
 
 #endif
diff --git a/dumux/material/fluidmatrixinteractions/Mp/2padapter.hh b/dumux/material/fluidmatrixinteractions/Mp/2padapter.hh
index d46e0fa00f73887c5e7d0949c6111997c8c523b3..97299ac145d08f1a05adb1ee610e4885f44a161b 100644
--- a/dumux/material/fluidmatrixinteractions/Mp/2padapter.hh
+++ b/dumux/material/fluidmatrixinteractions/Mp/2padapter.hh
@@ -77,7 +77,7 @@ public:
     {
         values[wPhaseIdx] = TwoPLaw::krw(params, state.saturation(wPhaseIdx));
         values[nPhaseIdx] = TwoPLaw::krn(params, state.saturation(wPhaseIdx));
-    };
+    }
 };
 }
 
diff --git a/dumux/material/fluidmatrixinteractions/Mp/Mplinearmaterial.hh b/dumux/material/fluidmatrixinteractions/Mp/Mplinearmaterial.hh
index 223e1f0cd7ecb7ef35d2c9fb91988a18fc37ccbb..cef7e9d8f1e967272b8332e680e1ace8a07b543e 100644
--- a/dumux/material/fluidmatrixinteractions/Mp/Mplinearmaterial.hh
+++ b/dumux/material/fluidmatrixinteractions/Mp/Mplinearmaterial.hh
@@ -115,7 +115,7 @@ public:
     {
         for (int phaseIdx = 0; phaseIdx < numPhases; ++phaseIdx)
             values[phaseIdx] = std::max(std::min(state.saturation(phaseIdx),1.0),0.0);
-    };
+    }
 };
 }
 
diff --git a/dumux/material/fluidstates/compositionalfluidstate.hh b/dumux/material/fluidstates/compositionalfluidstate.hh
index 61fea1cfe0129c2e786ba5dff295a663a5e0aa14..3ed14338ceef164db6b6735df0928eda91cbb9d2 100644
--- a/dumux/material/fluidstates/compositionalfluidstate.hh
+++ b/dumux/material/fluidstates/compositionalfluidstate.hh
@@ -231,7 +231,7 @@ public:
             viscosity_[phaseIdx] = fs.viscosity(phaseIdx);
         }
         temperature_ = fs.temperature(0);
-    };
+    }
 
     /*!
      * \brief Set the temperature [K] of a fluid phase
@@ -282,7 +282,7 @@ public:
         
         Valgrind::SetDefined(sumMoleFractions_[phaseIdx]);
         Valgrind::SetDefined(averageMolarMass_[phaseIdx]);
-    };
+    }
 
     /*!
      * \brief Set the fugacity of a component in a phase []
diff --git a/dumux/material/fluidstates/isoimmisciblefluidstate.hh b/dumux/material/fluidstates/isoimmisciblefluidstate.hh
index 0f6327f2d26e0110078af4830f8f72207ec4abc4..095913e32f4bf0ba85cabced6535b9a4a3a8e4af 100644
--- a/dumux/material/fluidstates/isoimmisciblefluidstate.hh
+++ b/dumux/material/fluidstates/isoimmisciblefluidstate.hh
@@ -112,7 +112,7 @@ public:
             viscosity_[phaseIdx] = fs.viscosity(phaseIdx);
         }
         temperature_ = fs.temperature(0);
-    };
+    }
 
     /*!
      * \brief Set the temperature [K] of a fluid phase
diff --git a/dumux/material/fluidstates/nonequilibriumfluidstate.hh b/dumux/material/fluidstates/nonequilibriumfluidstate.hh
index 1866ba12ac84977d8d4f59c96dfcf5496d76e5d6..bc0086578929b4bb5faa50a24c10ef7499abfbfb 100644
--- a/dumux/material/fluidstates/nonequilibriumfluidstate.hh
+++ b/dumux/material/fluidstates/nonequilibriumfluidstate.hh
@@ -156,7 +156,7 @@ public:
      * \brief The pressure of a fluid phase [Pa]
      */
     Scalar pressure(int phaseIdx) const
-    { return pressure_[phaseIdx]; };
+    { return pressure_[phaseIdx]; }
     /*!
      * \brief The specific enthalpy of a fluid phase [J/kg]
      */
@@ -173,7 +173,7 @@ public:
      * \brief The dynamic viscosity of a fluid phase [Pa s]
      */
     Scalar viscosity(int phaseIdx) const
-    { return viscosity_[phaseIdx]; };
+    { return viscosity_[phaseIdx]; }
 
     /*****************************************************
      * Setter methods. Note that these are not part of the
@@ -277,7 +277,7 @@ public:
             viscosity_[phaseIdx] = fs.viscosity(phaseIdx);
             temperature_[phaseIdx] = fs.temperature(phaseIdx);
         }
-    };
+    }
 
     /*!
      * \brief Make sure that all attributes are defined.
diff --git a/dumux/material/fluidsystems/2pimmisciblefluidsystem.hh b/dumux/material/fluidsystems/2pimmisciblefluidsystem.hh
index 0d6c76e91f057b036c738b681d957701cd623e5e..8fbb9f2f7d573bace5cfe79d1a4e8395cdb91ad3 100644
--- a/dumux/material/fluidsystems/2pimmisciblefluidsystem.hh
+++ b/dumux/material/fluidsystems/2pimmisciblefluidsystem.hh
@@ -224,7 +224,7 @@ public:
         if (compIdx == wCompIdx)
             return WettingPhase::acentricFactor();
         return NonwettingPhase::acentricFactor();
-    };
+    }
 
     /****************************************
      * thermodynamic relations
@@ -336,7 +336,7 @@ public:
         DUNE_THROW(Dune::InvalidStateException,
                    "Diffusion coefficients of components are meaningless if"
                    " immiscibility is assumed");
-    };
+    }
 
     /*!
      * \brief Given a phase's composition, temperature and pressure,
@@ -354,7 +354,7 @@ public:
         DUNE_THROW(Dune::InvalidStateException,
                    "Binary diffusion coefficients of components are meaningless if"
                    " immiscibility is assumed");
-    };
+    }
 
     /*!
      * \brief Return the specific enthalpy of a fluid phase [J/kg].
@@ -420,7 +420,7 @@ namespace Properties {
 NEW_PROP_TAG(Scalar);
 NEW_PROP_TAG(WettingPhase);
 NEW_PROP_TAG(NonwettingPhase);
-};
+}
 /*!
  * \brief A non-compositional twophase fluid system.
  *
diff --git a/dumux/material/fluidsystems/h2on2fluidsystem.hh b/dumux/material/fluidsystems/h2on2fluidsystem.hh
index daedcbb77a69388455809736cd33980206be5e8b..b39bb66a2ceaaef23c3d0e9bd323abe8007cc8e2 100644
--- a/dumux/material/fluidsystems/h2on2fluidsystem.hh
+++ b/dumux/material/fluidsystems/h2on2fluidsystem.hh
@@ -226,7 +226,7 @@ public:
 
         assert(0 <= compIdx && compIdx < numComponents);
         return Tcrit[compIdx];
-    };
+    }
 
     /*!
      * \brief Critical pressure of a component [Pa].
@@ -242,7 +242,7 @@ public:
 
         assert(0 <= compIdx && compIdx < numComponents);
         return pcrit[compIdx];
-    };
+    }
 
     /*!
      * \brief Molar volume of a component at the critical point [m^3/mol].
@@ -254,7 +254,7 @@ public:
         DUNE_THROW(Dune::NotImplemented,
                    "H2ON2FluidSystem::criticalMolarVolume()");
         return 0;
-    };
+    }
 
     /*!
      * \brief The acentric factor of a component [].
@@ -270,7 +270,7 @@ public:
 
         assert(0 <= compIdx && compIdx < numComponents);
         return accFac[compIdx];
-    };
+    }
 
     /****************************************
      * thermodynamic relations
@@ -382,7 +382,7 @@ public:
         Scalar rho_gH2O = H2O::gasDensity(T, p*fluidState.moleFraction(gPhaseIdx, H2OIdx));
         Scalar rho_gN2 = N2::gasDensity(T, p*fluidState.moleFraction(gPhaseIdx, N2Idx));
         return (rho_gH2O + rho_gN2) / std::max(1e-5, sumMoleFrac);
-    };
+    }
 
     /*!
      * \brief Calculate the dynamic viscosity of a fluid phase [Pa*s]
@@ -443,7 +443,7 @@ public:
             }
             return muResult;
         }
-    };
+    }
 
     /*!
      * \brief Calculate the fugacity coefficient [Pa] of an individual
@@ -528,7 +528,7 @@ public:
     {
         // TODO!
         DUNE_THROW(Dune::NotImplemented, "Diffusion coefficients");
-    };
+    }
 
     /*!
      * \brief Given a phase's composition, temperature and pressure,
@@ -580,7 +580,7 @@ public:
         if (compIIdx == H2OIdx && compJIdx == N2Idx)
             return BinaryCoeff::H2O_N2::gasDiffCoeff(T, p);
         return undefined;
-    };
+    }
 
     /*!
      * \brief Given a phase's composition, temperature, pressure and
diff --git a/dumux/material/spatialparameters/boxspatialparameters.hh b/dumux/material/spatialparameters/boxspatialparameters.hh
index 3753787626b8f94311e7c70f4453f385887ab568..ad3da63c34e8ef5f384f3d8832677a99811ddaf2 100644
--- a/dumux/material/spatialparameters/boxspatialparameters.hh
+++ b/dumux/material/spatialparameters/boxspatialparameters.hh
@@ -35,7 +35,7 @@ namespace Dumux {
 // forward declation of property tags
 namespace Properties {
 NEW_PROP_TAG(SpatialParameters);
-};
+}
 
 /*!
  * \ingroup SpatialParameters
diff --git a/dumux/material/spatialparameters/fvspatialparameters1p.hh b/dumux/material/spatialparameters/fvspatialparameters1p.hh
index 907d9d71e339a03e4f8f3b638da57fbbf29e1cd7..1a2d7afd1d781ba5ae305dfb6a2a0c4130b49777 100644
--- a/dumux/material/spatialparameters/fvspatialparameters1p.hh
+++ b/dumux/material/spatialparameters/fvspatialparameters1p.hh
@@ -43,7 +43,7 @@ namespace Properties
 {
 NEW_PROP_TAG( SpatialParameters);
 }
-;
+
 
 /*!
  * \ingroup SpatialParameters
diff --git a/test/boxmodels/1p2c/interstitialfluidtrailfluidsystem.hh b/test/boxmodels/1p2c/interstitialfluidtrailfluidsystem.hh
index f40169a71e3933a51704d2b47ef417ed122784ee..f7415e855fc55d8b51d3d30074eb77f87d13dc2c 100644
--- a/test/boxmodels/1p2c/interstitialfluidtrailfluidsystem.hh
+++ b/test/boxmodels/1p2c/interstitialfluidtrailfluidsystem.hh
@@ -136,7 +136,7 @@ public:
     {
         assert(0 <= phaseIdx && phaseIdx < numPhases);
         return false;
-    };
+    }
 
     /****************************************
      * Component related static parameters
@@ -283,7 +283,7 @@ public:
     {
         // TODO!
         DUNE_THROW(Dune::NotImplemented, "Diffusion coefficients");
-    };
+    }
 
 
     /*!
@@ -327,7 +327,7 @@ public:
         assert(0 <= phaseIdx && phaseIdx < numPhases);
 
         DUNE_THROW(Dune::NotImplemented, "Enthalpies");
-    };
+    }
 
     /*!
      * \brief Thermal conductivity of a fluid phase [W/(m^2 K/m)].
@@ -343,7 +343,7 @@ public:
         assert(0 <= phaseIdx && phaseIdx < numPhases);
 
         DUNE_THROW(Dune::NotImplemented, "Thermal conductivities.");
-    };
+    }
 
     /*!
      * \brief Specific isobaric heat capacity of a fluid phase.
@@ -360,7 +360,7 @@ public:
         assert(0 <= phaseIdx && phaseIdx < numPhases);
 
         DUNE_THROW(Dune::NotImplemented, "Heat capacities.");
-    };
+    }
 };
 
 } // end namepace
diff --git a/test/material/fluidsystems/checkfluidsystem.hh b/test/material/fluidsystems/checkfluidsystem.hh
index 06fb71e4df062536071cc9c618f99f0a80021985..0afe5519f472de05150278ec57a2f5274fc423e0 100644
--- a/test/material/fluidsystems/checkfluidsystem.hh
+++ b/test/material/fluidsystems/checkfluidsystem.hh
@@ -316,6 +316,6 @@ void checkFluidSystem()
     }
 
     std::cout << "----------------------------------\n";
-};
+}
 
 #endif
diff --git a/test/material/ncpflash/test_ncpflash.cc b/test/material/ncpflash/test_ncpflash.cc
index 87c17ac1d1b7ed908905b440f14395ddbece813d..bf751ecd83a09e9d87f5e0ed91c3229e186b6210 100644
--- a/test/material/ncpflash/test_ncpflash.cc
+++ b/test/material/ncpflash/test_ncpflash.cc
@@ -80,7 +80,7 @@ void checkSame(const FluidState &fsRef, const FluidState &fsFlash)
                           << fsFlash.moleFraction(phaseIdx, compIdx) << " flash vs "
                           << fsRef.moleFraction(phaseIdx, compIdx) << " reference"
                           << " error=" << error << "\n";
-        };
+        }
     }
 }
 
@@ -115,7 +115,7 @@ void checkNcpFlash(const FluidState &fsRef,
 
     // compare the "flashed" fluid state with the reference one
     checkSame<Scalar>(fsRef, fsFlash);
-};
+}
 
 
 template <class Scalar, class FluidSystem, class MaterialLaw, class FluidState>
diff --git a/tutorial/tutorial_coupled.cc b/tutorial/tutorial_coupled.cc
index 35ff6159b4877c4204bccb9a7cebd4e3cd0c4014..998c340db3016f3f6a24e03c4a10c15c23d6b035 100644
--- a/tutorial/tutorial_coupled.cc
+++ b/tutorial/tutorial_coupled.cc
@@ -36,7 +36,7 @@ void usage(const char *progname)
 {
     std::cout << "usage: " << progname << " [--restart restartTime] tEnd dt\n";
     exit(1);
-};
+}
 
 int main(int argc, char** argv)
 {