diff --git a/NumLib/Assembler/SerialExecutor.h b/NumLib/Assembler/SerialExecutor.h
index fc8b97f7190769bc1a59b7b9722a424fdaeb4fb0..b702c549dd90ae8a5f782c913f30dc6db7a3e7ff 100644
--- a/NumLib/Assembler/SerialExecutor.h
+++ b/NumLib/Assembler/SerialExecutor.h
@@ -45,8 +45,7 @@ struct SerialExecutor
     /// \param args additional arguments passed to \c f.
     ///
     template <typename F, typename C, typename... Args_>
-    static void
-    executeDereferenced(F const& f, C const& c, Args_&&... args)
+    static void executeDereferenced(F const& f, C const& c, Args_&&... args)
     {
         for (std::size_t i = 0; i < c.size(); i++)
         {
diff --git a/NumLib/DOF/ComponentGlobalIndexDict.h b/NumLib/DOF/ComponentGlobalIndexDict.h
index 07bc79c266dce5f7e46940566fa09fdf256d1d46..27bf8c7f4479047b30c061fb932095542dd0614c 100644
--- a/NumLib/DOF/ComponentGlobalIndexDict.h
+++ b/NumLib/DOF/ComponentGlobalIndexDict.h
@@ -12,12 +12,11 @@
 
 #pragma once
 
-#include <limits>
-
 #include <boost/multi_index/composite_key.hpp>
 #include <boost/multi_index/member.hpp>
 #include <boost/multi_index/ordered_index.hpp>
 #include <boost/multi_index_container.hpp>
+#include <limits>
 #include <utility>
 
 #include "MeshLib/Location.h"
@@ -25,11 +24,9 @@
 
 namespace NumLib
 {
-
 /// \internal
 namespace detail
 {
-
 struct Line
 {
     MeshLib::Location location;
@@ -42,19 +39,22 @@ struct Line
 
     Line(MeshLib::Location l, int c, GlobalIndexType i)
         : location(std::move(l)), comp_id(c), global_index(i)
-    {}
+    {
+    }
 
     Line(MeshLib::Location l, int c)
         : location(std::move(l)),
           comp_id(c),
           global_index(std::numeric_limits<GlobalIndexType>::max())
-    {}
+    {
+    }
 
     explicit Line(MeshLib::Location l)
         : location(std::move(l)),
           comp_id(std::numeric_limits<int>::max()),
           global_index(std::numeric_limits<GlobalIndexType>::max())
-    {}
+    {
+    }
 
     friend std::ostream& operator<<(std::ostream& os, Line const& l)
     {
@@ -88,10 +88,18 @@ struct LineByLocationAndComponentComparator
     }
 };
 
-struct ByLocation {};
-struct ByLocationAndComponent {};
-struct ByComponent {};
-struct ByGlobalIndex {};
+struct ByLocation
+{
+};
+struct ByLocationAndComponent
+{
+};
+struct ByComponent
+{
+};
+struct ByGlobalIndex
+{
+};
 
 using ComponentGlobalIndexDict = boost::multi_index::multi_index_container<
     Line, boost::multi_index::indexed_by<
@@ -110,5 +118,5 @@ using ComponentGlobalIndexDict = boost::multi_index::multi_index_container<
                   boost::multi_index::member<Line, GlobalIndexType,
                                              &Line::global_index>>>>;
 
-}    // namespace detail
-}    // namespace NumLib
+}  // namespace detail
+}  // namespace NumLib
diff --git a/NumLib/DOF/ComputeSparsityPattern.cpp b/NumLib/DOF/ComputeSparsityPattern.cpp
index dcc45b5cec1f6229eca29eb63e5e9798c0e91431..97e802a31fe03d55ad96cfe54902bf1d21ae5bb5 100644
--- a/NumLib/DOF/ComputeSparsityPattern.cpp
+++ b/NumLib/DOF/ComputeSparsityPattern.cpp
@@ -55,10 +55,10 @@ GlobalSparsityPattern computeSparsityPatternNonPETSc(
     for (std::size_t n = 0; n < mesh.getNumberOfNodes(); ++n)
     {
         auto const& an = node_adjacency_table.getAdjacentNodes(n);
-        auto const n_connected_dof = std::accumulate(
-            cbegin(an), cend(an), 0, [&](auto const result, auto const i) {
-                return result + global_idcs[i].size();
-            });
+        auto const n_connected_dof =
+            std::accumulate(cbegin(an), cend(an), 0,
+                            [&](auto const result, auto const i)
+                            { return result + global_idcs[i].size(); });
         for (auto global_index : global_idcs[n])
         {
             sparsity_pattern[global_index] = n_connected_dof;
diff --git a/NumLib/DOF/ComputeSparsityPattern.h b/NumLib/DOF/ComputeSparsityPattern.h
index 90b86303473b235467b3c8811830f05ae70cc6e4..b6ce9366442a9a950117ac1a6558bd2b82ddd185 100644
--- a/NumLib/DOF/ComputeSparsityPattern.h
+++ b/NumLib/DOF/ComputeSparsityPattern.h
@@ -27,7 +27,8 @@ class LocalToGlobalIndexMap;
  * @brief Computes a sparsity pattern for the given inputs.
  *
  * @param dof_table            maps mesh nodes to global indices
- * @param mesh                 mesh for which the two parameters above are defined
+ * @param mesh                 mesh for which the two parameters above are
+ * defined
  *
  * @return The computed sparsity pattern.
  */
diff --git a/NumLib/DOF/DOFTableUtil.cpp b/NumLib/DOF/DOFTableUtil.cpp
index 7879eb2c5c5f5b43e478d44e2acb40baeb87d85e..4c51a40f418653d2edc93c49fc6244eece9c74f3 100644
--- a/NumLib/DOF/DOFTableUtil.cpp
+++ b/NumLib/DOF/DOFTableUtil.cpp
@@ -75,9 +75,8 @@ double normInfinity(GlobalVector const& x, unsigned const global_component,
                     MeshLib::Mesh const& mesh)
 {
     double res = norm(x, global_component, dof_table, mesh,
-                      [](double res, double value) {
-                          return std::max(res, std::abs(value));
-                      });
+                      [](double res, double value)
+                      { return std::max(res, std::abs(value)); });
 
 #ifdef USE_PETSC
     double global_result = 0.0;
diff --git a/NumLib/DOF/DOFTableUtil.h b/NumLib/DOF/DOFTableUtil.h
index 313baea6e60fb27fb4c7db4de0f60a124e1e58d7..b7f37df51b68f7d0eab175c740a2672d81d2a819 100644
--- a/NumLib/DOF/DOFTableUtil.h
+++ b/NumLib/DOF/DOFTableUtil.h
@@ -43,10 +43,9 @@ LocalToGlobalIndexMap::RowColumnIndices getRowColumnIndices(
     NumLib::LocalToGlobalIndexMap const& dof_table,
     std::vector<GlobalIndexType>& indices);
 
-//! Computes the specified norm of the given global component of the given vector x.
-//! \remark
-//! \c x is typically the solution vector of a monolithically coupled process
-//! with several primary variables.
+//! Computes the specified norm of the given global component of the given
+//! vector x. \remark \c x is typically the solution vector of a monolithically
+//! coupled process with several primary variables.
 double norm(GlobalVector const& x, unsigned const global_component,
             MathLib::VecNormType norm_type,
             LocalToGlobalIndexMap const& dof_table, MeshLib::Mesh const& mesh);
diff --git a/NumLib/DOF/GlobalMatrixProviders.h b/NumLib/DOF/GlobalMatrixProviders.h
index 631ac9d26f47f9ec3d4ac3e2cdf8808e1c044d37..e386b459c1c579b4bf68e213734e6c2cf4c2f808 100644
--- a/NumLib/DOF/GlobalMatrixProviders.h
+++ b/NumLib/DOF/GlobalMatrixProviders.h
@@ -10,9 +10,8 @@
 
 #pragma once
 
-#include "numlib_export.h"
-
 #include "MatrixProviderUser.h"
+#include "numlib_export.h"
 
 namespace NumLib
 {
diff --git a/NumLib/DOF/LocalToGlobalIndexMap.cpp b/NumLib/DOF/LocalToGlobalIndexMap.cpp
index cd1c61e4d77036e137896affeb936f33c260c4f6..7277eb370a9b8d86ef7db6d189606faef62d9cfc 100644
--- a/NumLib/DOF/LocalToGlobalIndexMap.cpp
+++ b/NumLib/DOF/LocalToGlobalIndexMap.cpp
@@ -254,9 +254,8 @@ LocalToGlobalIndexMap* LocalToGlobalIndexMap::deriveBoundaryConstrainedMap(
 
     transform(cbegin(component_ids), cend(component_ids),
               back_inserter(global_component_ids),
-              [&](auto const component_id) {
-                  return getGlobalComponent(variable_id, component_id);
-              });
+              [&](auto const component_id)
+              { return getGlobalComponent(variable_id, component_id); });
 
     auto mesh_component_map = _mesh_component_map.getSubset(
         _mesh_subsets, new_mesh_subset, global_component_ids);
diff --git a/NumLib/DOF/LocalToGlobalIndexMap.h b/NumLib/DOF/LocalToGlobalIndexMap.h
index 2ec3b7abf04f43f777552a6a68be455a77cb810f..63ce1496734f48634f0f24d9668eddad47bf9cca 100644
--- a/NumLib/DOF/LocalToGlobalIndexMap.h
+++ b/NumLib/DOF/LocalToGlobalIndexMap.h
@@ -14,12 +14,10 @@
 #include <iosfwd>
 #endif  // NDEBUG
 
-#include <vector>
-
 #include <Eigen/Dense>
+#include <vector>
 
 #include "MathLib/LinAlg/RowColumnIndices.h"
-
 #include "MeshComponentMap.h"
 
 namespace MeshLib
@@ -30,7 +28,6 @@ class Element;
 
 namespace NumLib
 {
-
 /// Row and column indices in global linear algebra objects for each mesh item.
 ///
 /// The row and column indices in global matrix and rhs vector for example,
@@ -59,7 +56,8 @@ public:
     /// each mesh element of the given mesh_subsets.
     ///
     /// \attention This constructor assumes the number of the given mesh subsets
-    /// is equal to the number of variables, i.e. every variable has a single component.
+    /// is equal to the number of variables, i.e. every variable has a single
+    /// component.
     LocalToGlobalIndexMap(std::vector<MeshLib::MeshSubset>&& mesh_subsets,
                           NumLib::ComponentOrder const order);
 
@@ -67,10 +65,10 @@ public:
     /// each mesh element of the given mesh_subsets.
     ///
     /// \param mesh_subsets  a vector of components
-    /// \param vec_var_n_components  a vector of the number of variable components.
-    /// The size of the vector should be equal to the number of variables. Sum of the entries
-    /// should be equal to the size of the mesh_subsets.
-    /// \param order  type of ordering values in a vector
+    /// \param vec_var_n_components  a vector of the number of variable
+    /// components. The size of the vector should be equal to the number of
+    /// variables. Sum of the entries should be equal to the size of the
+    /// mesh_subsets. \param order  type of ordering values in a vector
     LocalToGlobalIndexMap(std::vector<MeshLib::MeshSubset>&& mesh_subsets,
                           std::vector<int> const& vec_var_n_components,
                           NumLib::ComponentOrder const order);
@@ -79,11 +77,11 @@ public:
     /// the given mesh elements
     ///
     /// \param mesh_subsets  a vector of components
-    /// \param vec_var_n_components  a vector of the number of variable components.
-    /// The size of the vector should be equal to the number of variables. Sum of the entries
-    /// should be equal to the size of the mesh_subsets.
-    /// \param vec_var_elements  a vector of active mesh elements for each variable.
-    /// \param order  type of ordering values in a vector
+    /// \param vec_var_n_components  a vector of the number of variable
+    /// components. The size of the vector should be equal to the number of
+    /// variables. Sum of the entries should be equal to the size of the
+    /// mesh_subsets. \param vec_var_elements  a vector of active mesh elements
+    /// for each variable. \param order  type of ordering values in a vector
     LocalToGlobalIndexMap(
         std::vector<MeshLib::MeshSubset>&& mesh_subsets,
         std::vector<int> const& vec_var_n_components,
@@ -128,7 +126,8 @@ public:
 
     std::size_t getNumberOfElementDOF(std::size_t const mesh_item_id) const;
 
-    std::size_t getNumberOfElementComponents(std::size_t const mesh_item_id) const;
+    std::size_t getNumberOfElementComponents(
+        std::size_t const mesh_item_id) const;
 
     std::vector<int> getElementVariableIDs(
         std::size_t const mesh_item_id) const;
@@ -195,10 +194,12 @@ private:
     std::vector<MeshLib::MeshSubset> _mesh_subsets;
     NumLib::MeshComponentMap _mesh_component_map;
 
-    using Table = Eigen::Matrix<LineIndex, Eigen::Dynamic, Eigen::Dynamic, Eigen::RowMajor>;
+    using Table = Eigen::Matrix<LineIndex, Eigen::Dynamic, Eigen::Dynamic,
+                                Eigen::RowMajor>;
 
-    /// Table contains for each element (first index) and each component (second index)
-    /// a vector (\c LineIndex) of indices in the global stiffness matrix or vector
+    /// Table contains for each element (first index) and each component (second
+    /// index) a vector (\c LineIndex) of indices in the global stiffness matrix
+    /// or vector
     Table _rows;
 
     /// \see _rows
@@ -207,9 +208,9 @@ private:
     std::vector<int> const _variable_component_offsets;
 #ifndef NDEBUG
     /// Prints first rows of the table, every line, and the mesh component map.
-    friend std::ostream& operator<<(std::ostream& os, LocalToGlobalIndexMap const& map);
+    friend std::ostream& operator<<(std::ostream& os,
+                                    LocalToGlobalIndexMap const& map);
 #endif  // NDEBUG
-
 };
 
-}   // namespace NumLib
+}  // namespace NumLib
diff --git a/NumLib/DOF/MatrixProviderUser.h b/NumLib/DOF/MatrixProviderUser.h
index 8a690ae8010349061623d67b9a5e047f0f8246dc..cf955affecf2bfe0815db353394a181d7686f217 100644
--- a/NumLib/DOF/MatrixProviderUser.h
+++ b/NumLib/DOF/MatrixProviderUser.h
@@ -16,7 +16,6 @@
 
 namespace NumLib
 {
-
 class MatrixSpecificationsProvider
 {
 public:
@@ -26,7 +25,6 @@ public:
     virtual ~MatrixSpecificationsProvider() = default;
 };
 
-
 /*! Manages storage for vectors.
  *
  * This interface provides storage management semantics for vectors, which
@@ -39,17 +37,17 @@ public:
  * later on. Thereby the implementation of this interface can decide, whether
  * the storage for the specific vector can be freed or reused in the meantime.
  *
- * All get-methods of this class come in two variants: One with an \c id argument,
- * and one without. The latter makes it possible to temporarily release a vector
- * during the program run and re-acquire it again. The former variant is intended
- * as a short-cut that simplifies vector acquisition for callers that will use
- * the same vector throughout all of their lifetime without releasing it
- * intermediately.
+ * All get-methods of this class come in two variants: One with an \c id
+ * argument, and one without. The latter makes it possible to temporarily
+ * release a vector during the program run and re-acquire it again. The former
+ * variant is intended as a short-cut that simplifies vector acquisition for
+ * callers that will use the same vector throughout all of their lifetime
+ * without releasing it intermediately.
  *
  * \attention
- * The first time a vector is acquired by a method with \c id argument, the \c id
- * has to be initialized with zero. The respective method then will set the \c id
- * to the specific \c id of the returned vector.
+ * The first time a vector is acquired by a method with \c id argument, the \c
+ * id has to be initialized with zero. The respective method then will set the
+ * \c id to the specific \c id of the returned vector.
  */
 class VectorProvider
 {
@@ -64,11 +62,13 @@ public:
     virtual GlobalVector& getVector(GlobalVector const& x, std::size_t& id) = 0;
 
     //! Get a vector according to the given specifications.
-    virtual GlobalVector& getVector(MathLib::MatrixSpecifications const& ms) = 0;
+    virtual GlobalVector& getVector(
+        MathLib::MatrixSpecifications const& ms) = 0;
 
     //! Get a vector according to the given specifications in the storage
     //! of the vector with the given \c id.
-    virtual GlobalVector& getVector(MathLib::MatrixSpecifications const& ms, std::size_t& id) = 0;
+    virtual GlobalVector& getVector(MathLib::MatrixSpecifications const& ms,
+                                    std::size_t& id) = 0;
 
     //! Release the given vector.
     //!
@@ -91,7 +91,8 @@ public:
 
     //! Get a matrix according to the given specifications in the storage
     //! of the matrix with the given \c id.
-    virtual GlobalMatrix& getMatrix(MathLib::MatrixSpecifications const& ms, std::size_t& id) = 0;
+    virtual GlobalMatrix& getMatrix(MathLib::MatrixSpecifications const& ms,
+                                    std::size_t& id) = 0;
 
     //! Release the given matrix.
     //!
@@ -102,4 +103,4 @@ public:
     virtual ~MatrixProvider() = default;
 };
 
-} // namespace NumLib
+}  // namespace NumLib
diff --git a/NumLib/DOF/MeshComponentMap.cpp b/NumLib/DOF/MeshComponentMap.cpp
index be6ffd2373d4a26154793fc4e985ab3c4c3d4971..14cc5cb03127923b0c4b7044996d83792cec92fb 100644
--- a/NumLib/DOF/MeshComponentMap.cpp
+++ b/NumLib/DOF/MeshComponentMap.cpp
@@ -61,9 +61,8 @@ MeshComponentMap MeshComponentMap::getSubset(
        // all the bulk_mesh_subsets are equal.
         auto const first_mismatch =
             std::adjacent_find(begin(bulk_mesh_subsets), end(bulk_mesh_subsets),
-                               [](auto const& a, auto const& b) {
-                                   return a.getMeshID() != b.getMeshID();
-                               });
+                               [](auto const& a, auto const& b)
+                               { return a.getMeshID() != b.getMeshID(); });
         if (first_mismatch != end(bulk_mesh_subsets))
         {
             OGS_FATAL(
@@ -234,9 +233,8 @@ std::vector<GlobalIndexType> MeshComponentMap::getGlobalIndicesByComponent(
         }
     }
 
-    auto CIPairLess = [](CIPair const& a, CIPair const& b) {
-        return a.first < b.first;
-    };
+    auto CIPairLess = [](CIPair const& a, CIPair const& b)
+    { return a.first < b.first; };
 
     // Create vector of global indices from sub dictionary sorting by component.
     if (!std::is_sorted(pairs.begin(), pairs.end(), CIPairLess))
diff --git a/NumLib/DOF/SimpleMatrixVectorProvider.h b/NumLib/DOF/SimpleMatrixVectorProvider.h
index 287781dde024e1d65d475a65e304c0f15eedc65a..293af10f08b89b258a47affdf5f77782a244a99c 100644
--- a/NumLib/DOF/SimpleMatrixVectorProvider.h
+++ b/NumLib/DOF/SimpleMatrixVectorProvider.h
@@ -17,24 +17,24 @@
 
 namespace NumLib
 {
-
 /*! Manages storage for matrices and vectors.
  *
- * This is a simple implementation of the MatrixProvider and VectorProvider interfaces.
+ * This is a simple implementation of the MatrixProvider and VectorProvider
+ * interfaces.
  *
- * It is simple insofar it does not reuse released matrices/vectors, but keeps them in
- * memory until they are acquired again by the user.
+ * It is simple insofar it does not reuse released matrices/vectors, but keeps
+ * them in memory until they are acquired again by the user.
  */
-class SimpleMatrixVectorProvider final
-        : public MatrixProvider
-        , public VectorProvider
+class SimpleMatrixVectorProvider final : public MatrixProvider,
+                                         public VectorProvider
 {
 public:
     SimpleMatrixVectorProvider() = default;
 
     // no copies
     SimpleMatrixVectorProvider(SimpleMatrixVectorProvider const&) = delete;
-    SimpleMatrixVectorProvider& operator=(SimpleMatrixVectorProvider const&) = delete;
+    SimpleMatrixVectorProvider& operator=(SimpleMatrixVectorProvider const&) =
+        delete;
 
     GlobalVector& getVector(std::size_t& id) override;
 
@@ -42,13 +42,15 @@ public:
     GlobalVector& getVector(GlobalVector const& x, std::size_t& id) override;
 
     GlobalVector& getVector(MathLib::MatrixSpecifications const& ms) override;
-    GlobalVector& getVector(MathLib::MatrixSpecifications const& ms, std::size_t& id) override;
+    GlobalVector& getVector(MathLib::MatrixSpecifications const& ms,
+                            std::size_t& id) override;
 
     void releaseVector(GlobalVector const& x) override;
 
     GlobalMatrix& getMatrix(std::size_t& id) override;
 
-    GlobalMatrix& getMatrix(MathLib::MatrixSpecifications const& ms, std::size_t& id) override;
+    GlobalMatrix& getMatrix(MathLib::MatrixSpecifications const& ms,
+                            std::size_t& id) override;
 
     void releaseMatrix(GlobalMatrix const& A) override;
 
@@ -62,7 +64,8 @@ private:
     std::pair<GlobalVector*, bool> getVector_(std::size_t& id, Args&&... args);
 
     // returns a pair with the pointer to the matrix/vector and
-    // a boolean indicating if a new object has been built (then true else false)
+    // a boolean indicating if a new object has been built (then true else
+    // false)
     template <typename MatVec, typename... Args>
     std::pair<MatVec*, bool> get_(std::size_t& id,
                                   std::map<MatVec*, std::size_t>& used_map,
@@ -75,4 +78,4 @@ private:
     std::map<GlobalVector*, std::size_t> _used_vectors;
 };
 
-} // namespace NumLib
+}  // namespace NumLib
diff --git a/NumLib/Extrapolation/ExtrapolatableElementCollection.h b/NumLib/Extrapolation/ExtrapolatableElementCollection.h
index ec14a203c22bd691630c327ca5f2fb5f2c170673..cf58d24d72b2660a996844018c16d79ac2616513 100644
--- a/NumLib/Extrapolation/ExtrapolatableElementCollection.h
+++ b/NumLib/Extrapolation/ExtrapolatableElementCollection.h
@@ -13,9 +13,8 @@
 #include <functional>
 #include <vector>
 
-#include "MathLib/LinAlg/GlobalMatrixVectorTypes.h"
-
 #include "ExtrapolatableElement.h"
+#include "MathLib/LinAlg/GlobalMatrixVectorTypes.h"
 
 namespace NumLib
 {
@@ -136,6 +135,7 @@ public:
     }
 
     std::size_t size() const override { return _local_assemblers.size(); }
+
 private:
     LocalAssemblerCollection const& _local_assemblers;
     IntegrationPointValuesMethod const _integration_point_values_method;
diff --git a/NumLib/Extrapolation/Extrapolator.h b/NumLib/Extrapolation/Extrapolator.h
index 3dc6b872c946de27b36e37f7baace7f26ce46974..1f5bc8a186db8e8b855c0afaea0eed5ff039ed8e 100644
--- a/NumLib/Extrapolation/Extrapolator.h
+++ b/NumLib/Extrapolation/Extrapolator.h
@@ -10,11 +10,11 @@
 
 #pragma once
 
+#include <Eigen/Eigen>
 #include <vector>
 
-#include <Eigen/Eigen>
-#include "NumLib/NumericsConfig.h"
 #include "ExtrapolatableElementCollection.h"
+#include "NumLib/NumericsConfig.h"
 
 namespace NumLib
 {
diff --git a/NumLib/Extrapolation/LocalLinearLeastSquaresExtrapolator.h b/NumLib/Extrapolation/LocalLinearLeastSquaresExtrapolator.h
index 55a9a904f8abd1a6d5f2623a6411217cc92e6a7a..fcc6094727a5a951e361eb96a7f5d15436b5a1e7 100644
--- a/NumLib/Extrapolation/LocalLinearLeastSquaresExtrapolator.h
+++ b/NumLib/Extrapolation/LocalLinearLeastSquaresExtrapolator.h
@@ -12,9 +12,9 @@
 
 #include <map>
 
-#include "NumLib/DOF/LocalToGlobalIndexMap.h"
-#include "NumLib/DOF/GlobalMatrixProviders.h"
 #include "Extrapolator.h"
+#include "NumLib/DOF/GlobalMatrixProviders.h"
+#include "NumLib/DOF/LocalToGlobalIndexMap.h"
 
 namespace NumLib
 {
diff --git a/NumLib/Fem/CoordinatesMapping/NaturalCoordinatesMapping.h b/NumLib/Fem/CoordinatesMapping/NaturalCoordinatesMapping.h
index b73ed4db4867471ac43f3c704df06ceb31b7a25b..48620e514337045318f04f515d80f1d04b341e0f 100644
--- a/NumLib/Fem/CoordinatesMapping/NaturalCoordinatesMapping.h
+++ b/NumLib/Fem/CoordinatesMapping/NaturalCoordinatesMapping.h
@@ -48,7 +48,8 @@ struct NaturalCoordinatesMapping
      *
      * @param ele               Mesh element object
      * @param natural_pt        Location in natural coordinates (r,s,t)
-     * @param shapemat          Shape matrix data where calculated shape functions are stored
+     * @param shapemat          Shape matrix data where calculated shape
+     * functions are stored
      * @param global_dim        Global dimension
      */
     static void computeShapeMatrices(const T_MESH_ELEMENT& ele,
@@ -56,7 +57,8 @@ struct NaturalCoordinatesMapping
                                      T_SHAPE_MATRICES& shapemat,
                                      const unsigned global_dim)
     {
-        computeShapeMatrices<ShapeMatrixType::ALL>(ele, natural_pt, shapemat, global_dim);
+        computeShapeMatrices<ShapeMatrixType::ALL>(
+            ele, natural_pt, shapemat, global_dim);
     }
 
     /**
diff --git a/NumLib/Fem/CoordinatesMapping/NaturalNodeCoordinates.h b/NumLib/Fem/CoordinatesMapping/NaturalNodeCoordinates.h
index 4e55a631147112a5d4fc76acc547223ae042eab8..31d436638eea6e0048ae7ef9410ef6441638cfeb 100644
--- a/NumLib/Fem/CoordinatesMapping/NaturalNodeCoordinates.h
+++ b/NumLib/Fem/CoordinatesMapping/NaturalNodeCoordinates.h
@@ -11,7 +11,6 @@
 #include <cassert>
 
 #include "MathLib/Point3d.h"
-
 #include "MeshLib/ElementCoordinatesMappingLocal.h"
 #include "MeshLib/Elements/HexRule20.h"
 #include "MeshLib/Elements/HexRule8.h"
@@ -30,7 +29,6 @@
 #include "MeshLib/Elements/TetRule4.h"
 #include "MeshLib/Elements/TriRule3.h"
 #include "MeshLib/Elements/TriRule6.h"
-
 #include "NumLib/Fem/ShapeFunction/ShapeHex20.h"
 #include "NumLib/Fem/ShapeFunction/ShapeHex8.h"
 #include "NumLib/Fem/ShapeFunction/ShapeLine2.h"
@@ -48,7 +46,6 @@
 #include "NumLib/Fem/ShapeFunction/ShapeTri3.h"
 #include "NumLib/Fem/ShapeFunction/ShapeTri6.h"
 #include "NumLib/Fem/ShapeMatrixPolicy.h"
-
 #include "ShapeMatrices.h"
 
 namespace NumLib
diff --git a/NumLib/Fem/CoordinatesMapping/ShapeMatrices-impl.h b/NumLib/Fem/CoordinatesMapping/ShapeMatrices-impl.h
index be1f2be1a534ee810ee47ed5c6e7fb3be7891a29..e672105842be87495259ac2f1d763b0c4062e0e1 100644
--- a/NumLib/Fem/CoordinatesMapping/ShapeMatrices-impl.h
+++ b/NumLib/Fem/CoordinatesMapping/ShapeMatrices-impl.h
@@ -12,17 +12,16 @@
 
 namespace NumLib
 {
-
 namespace detail
 {
 /*
  * zero reset functions for Eigen
  */
-template<class T>
-void setMatrixZero(T &mat)
+template <class T>
+void setMatrixZero(T& mat)
 {
-    //mat.setZero();
-    const std::size_t n = mat.rows()*mat.cols();
+    // mat.setZero();
+    const std::size_t n = mat.rows() * mat.cols();
     auto* v = mat.data();
     for (std::size_t i = 0; i < n; i++)
     {
@@ -30,10 +29,10 @@ void setMatrixZero(T &mat)
     }
 }
 
-template<class T>
-void setVectorZero(T &vec)
+template <class T>
+void setVectorZero(T& vec)
 {
-    //vec.setZero();
+    // vec.setZero();
     const std::size_t n = vec.size();
     auto* v = vec.data();
     for (std::size_t i = 0; i < n; i++)
@@ -46,7 +45,10 @@ void setVectorZero(T &vec)
  * "tag dispatching" technique is used below to emulate explicit specialization
  * of a template function in a template class
  */
-template <ShapeMatrixType FIELD_TYPE> struct ShapeDataFieldType {};
+template <ShapeMatrixType FIELD_TYPE>
+struct ShapeDataFieldType
+{
+};
 
 template <class T_N, class T_DNDR, class T_J, class T_DNDX>
 inline void setZero(ShapeMatrices<T_N, T_DNDR, T_J, T_DNDX>& shape,
@@ -124,9 +126,10 @@ void ShapeMatrices<T_N, T_DNDR, T_J, T_DNDX>::write(std::ostream& out) const
 }
 
 template <class T_N, class T_DNDR, class T_J, class T_DNDX>
-std::ostream& operator<< (std::ostream &os, const ShapeMatrices<T_N, T_DNDR, T_J, T_DNDX> &shape)
+std::ostream& operator<<(std::ostream& os,
+                         const ShapeMatrices<T_N, T_DNDR, T_J, T_DNDX>& shape)
 {
-    shape.write (os);
+    shape.write(os);
     return os;
 }
 
diff --git a/NumLib/Fem/CoordinatesMapping/ShapeMatrices.h b/NumLib/Fem/CoordinatesMapping/ShapeMatrices.h
index 0802d70909399d7fb4e7798b2461586f1b40e254..2c945f23ae9b89e17c5c12e66c3c9f8fcec1f67d 100644
--- a/NumLib/Fem/CoordinatesMapping/ShapeMatrices.h
+++ b/NumLib/Fem/CoordinatesMapping/ShapeMatrices.h
@@ -12,33 +12,31 @@
 
 #pragma once
 
-#include <ostream>
-
 #include <Eigen/Core>
+#include <ostream>
 
 namespace NumLib
 {
-
 /**
-  * \brief Shape matrix type to be calculated
-  */
+ * \brief Shape matrix type to be calculated
+ */
 enum class ShapeMatrixType
 {
-    N,      ///< calculates N
-    DNDR,   ///< calculates dNdr
-    N_J,    ///< calculates N, dNdr, J, and detJ
-    DNDR_J, ///< calculates dNdr, J, and detJ
-    DNDX,   ///< calculates dNdr, J, detJ, invJ, and dNdx
-    ALL     ///< calculates all
+    N,       ///< calculates N
+    DNDR,    ///< calculates dNdr
+    N_J,     ///< calculates N, dNdr, J, and detJ
+    DNDR_J,  ///< calculates dNdr, J, and detJ
+    DNDX,    ///< calculates dNdr, J, detJ, invJ, and dNdx
+    ALL      ///< calculates all
 };
 
 /**
  * \brief Coordinates mapping matrices at particular location
  *
  * \tparam T_N      Vector type for shape functions
- * \tparam T_DNDR   Matrix type for gradient of shape functions in natural coordinates
- * \tparam T_J      Jacobian matrix type
- * \tparam T_DNDX   Matrix type for gradient of shape functions in physical coordinates
+ * \tparam T_DNDR   Matrix type for gradient of shape functions in natural
+ * coordinates \tparam T_J      Jacobian matrix type \tparam T_DNDX   Matrix
+ * type for gradient of shape functions in physical coordinates
  */
 template <class T_N, class T_DNDR, class T_J, class T_DNDX>
 struct ShapeMatrices
@@ -49,11 +47,13 @@ struct ShapeMatrices
     using DxShapeType = T_DNDX;
 
     ShapeType N;        ///< Vector of shape functions, N(r)
-    DrShapeType dNdr;   ///< Matrix of gradient of shape functions in natural coordinates, dN(r)/dr
+    DrShapeType dNdr;   ///< Matrix of gradient of shape functions in natural
+                        ///< coordinates, dN(r)/dr
     JacobianType J;     ///< Jacobian matrix, J=dx/dr
     double detJ;        ///< Determinant of the Jacobian
     JacobianType invJ;  ///< Inverse matrix of the Jacobian
-    DxShapeType dNdx;   ///< Matrix of gradient of shape functions in physical coordinates, dN(r)/dx
+    DxShapeType dNdx;   ///< Matrix of gradient of shape functions in physical
+                        ///< coordinates, dN(r)/dx
     double integralMeasure;
 
     /** Not default constructible, dimensions always must be given.
@@ -102,10 +102,10 @@ struct ShapeMatrices
      * writes the matrix entries into the output stream
      * @param out the output stream
      */
-    void write (std::ostream& out) const;
+    void write(std::ostream& out) const;
 
     EIGEN_MAKE_ALIGNED_OPERATOR_NEW;
-}; // ShapeMatrices
+};  // ShapeMatrices
 
 }  // namespace NumLib
 
diff --git a/NumLib/Fem/FiniteElement/C0IsoparametricElements.h b/NumLib/Fem/FiniteElement/C0IsoparametricElements.h
index f3fe74cf1d3d63f626ce02bb4fa448ed25c3ef4d..77fcbcd6d8705f681a5ef5cb6261a0b34cf13fbc 100644
--- a/NumLib/Fem/FiniteElement/C0IsoparametricElements.h
+++ b/NumLib/Fem/FiniteElement/C0IsoparametricElements.h
@@ -12,23 +12,22 @@
 
 #pragma once
 
-#include "NumLib/Fem/ShapeFunction/ShapePoint1.h"
+#include "NumLib/Fem/ShapeFunction/ShapeHex20.h"
+#include "NumLib/Fem/ShapeFunction/ShapeHex8.h"
 #include "NumLib/Fem/ShapeFunction/ShapeLine2.h"
 #include "NumLib/Fem/ShapeFunction/ShapeLine3.h"
-#include "NumLib/Fem/ShapeFunction/ShapeTri3.h"
-#include "NumLib/Fem/ShapeFunction/ShapeTri6.h"
+#include "NumLib/Fem/ShapeFunction/ShapePoint1.h"
+#include "NumLib/Fem/ShapeFunction/ShapePrism15.h"
+#include "NumLib/Fem/ShapeFunction/ShapePrism6.h"
+#include "NumLib/Fem/ShapeFunction/ShapePyra13.h"
+#include "NumLib/Fem/ShapeFunction/ShapePyra5.h"
 #include "NumLib/Fem/ShapeFunction/ShapeQuad4.h"
 #include "NumLib/Fem/ShapeFunction/ShapeQuad8.h"
 #include "NumLib/Fem/ShapeFunction/ShapeQuad9.h"
-#include "NumLib/Fem/ShapeFunction/ShapeHex8.h"
-#include "NumLib/Fem/ShapeFunction/ShapeHex20.h"
-#include "NumLib/Fem/ShapeFunction/ShapeTet4.h"
 #include "NumLib/Fem/ShapeFunction/ShapeTet10.h"
-#include "NumLib/Fem/ShapeFunction/ShapePrism6.h"
-#include "NumLib/Fem/ShapeFunction/ShapePrism15.h"
-#include "NumLib/Fem/ShapeFunction/ShapePyra5.h"
-#include "NumLib/Fem/ShapeFunction/ShapePyra13.h"
-
+#include "NumLib/Fem/ShapeFunction/ShapeTet4.h"
+#include "NumLib/Fem/ShapeFunction/ShapeTri3.h"
+#include "NumLib/Fem/ShapeFunction/ShapeTri6.h"
 #include "TemplateIsoparametric.h"
 
 namespace NumLib
diff --git a/NumLib/Fem/Integration/GaussLegendreIntegrationPolicy.h b/NumLib/Fem/Integration/GaussLegendreIntegrationPolicy.h
index ff1be95c771bfad215b63ba5bc53cb41763fd533..6fa702d9e3b0c323140c01765e5167b020c8f3c7 100644
--- a/NumLib/Fem/Integration/GaussLegendreIntegrationPolicy.h
+++ b/NumLib/Fem/Integration/GaussLegendreIntegrationPolicy.h
@@ -15,7 +15,6 @@
 #include "MeshLib/Elements/Pyramid.h"
 #include "MeshLib/Elements/Tet.h"
 #include "MeshLib/Elements/Tri.h"
-
 #include "NumLib/Fem/Integration/IntegrationGaussLegendrePrism.h"
 #include "NumLib/Fem/Integration/IntegrationGaussLegendrePyramid.h"
 #include "NumLib/Fem/Integration/IntegrationGaussLegendreRegular.h"
diff --git a/NumLib/Fem/Integration/IntegrationGaussLegendrePrism.h b/NumLib/Fem/Integration/IntegrationGaussLegendrePrism.h
index 1c2319586553e50f951d560553459e74a20b1850..4c15226456842b8051eb754d2d417967c6234904 100644
--- a/NumLib/Fem/Integration/IntegrationGaussLegendrePrism.h
+++ b/NumLib/Fem/Integration/IntegrationGaussLegendrePrism.h
@@ -47,13 +47,17 @@ public:
     /// return the number of sampling points
     unsigned getNumberOfPoints() const { return _n_sampl_pt; }
 
-    /// \copydoc NumLib::IntegrationGaussLegendreRegular::getWeightedPoint(unsigned) const
+    /// \copydoc
+    /// NumLib::IntegrationGaussLegendreRegular::getWeightedPoint(unsigned)
+    /// const
     WeightedPoint getWeightedPoint(unsigned igp) const
     {
         return getWeightedPoint(getIntegrationOrder(), igp);
     }
 
-    /// \copydoc NumLib::IntegrationGaussLegendreRegular::getWeightedPoint(unsigned, unsigned)
+    /// \copydoc
+    /// NumLib::IntegrationGaussLegendreRegular::getWeightedPoint(unsigned,
+    /// unsigned)
     static WeightedPoint getWeightedPoint(unsigned order, unsigned igp)
     {
         (void)order;
diff --git a/NumLib/Fem/Integration/IntegrationPoint.h b/NumLib/Fem/Integration/IntegrationPoint.h
index a59a00366fb5dcffcfa5146862c10482645b9480..a331362b71b1e39b6f1b4508c1566ae3bf9ec6c8 100644
--- a/NumLib/Fem/Integration/IntegrationPoint.h
+++ b/NumLib/Fem/Integration/IntegrationPoint.h
@@ -24,9 +24,7 @@ public:
     using WeightedPoint = MathLib::TemplateWeightedPoint<double, double, 1>;
 
     /// IntegrationPoint constructor for given order.
-    explicit IntegrationPoint(unsigned /* order */)
-    {
-    }
+    explicit IntegrationPoint(unsigned /* order */) {}
 
     /// Change the integration order.
     static void setIntegrationOrder(unsigned /* order */) {}
@@ -37,13 +35,15 @@ public:
     /// Return the number of sampling points.
     static constexpr unsigned getNumberOfPoints() { return 1; }
 
-    /// \copydoc IntegrationGaussLegendreRegular::getWeightedPoint(unsigned) const
+    /// \copydoc IntegrationGaussLegendreRegular::getWeightedPoint(unsigned)
+    /// const
     static WeightedPoint getWeightedPoint(unsigned igp)
     {
         return getWeightedPoint(getIntegrationOrder(), igp);
     }
 
-    /// \copydoc IntegrationGaussLegendreRegular::getWeightedPoint(unsigned, unsigned)
+    /// \copydoc IntegrationGaussLegendreRegular::getWeightedPoint(unsigned,
+    /// unsigned)
     static WeightedPoint getWeightedPoint(unsigned order, unsigned igp)
     {
         (void)order;
diff --git a/NumLib/Fem/ShapeFunction/ShapeHex20-impl.h b/NumLib/Fem/ShapeFunction/ShapeHex20-impl.h
index 4abe0d15f72e6a43ab900c4809fc7945163d2e9f..a251680b209287df912254e79272008c74ad3cc3 100644
--- a/NumLib/Fem/ShapeFunction/ShapeHex20-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapeHex20-impl.h
@@ -10,41 +10,44 @@
 
 namespace
 {
-
-inline double ShapeFunctionHexHQ_Corner(const double r, const double s, const double t)
+inline double ShapeFunctionHexHQ_Corner(const double r, const double s,
+                                        const double t)
 {
     return 0.125 * (r - 1) * (s - 1) * (t - 1) * (r + s + t + 2.0);
 }
 
-inline double ShapeFunctionHexHQ_Middle(const double r, const double s, const double t)
+inline double ShapeFunctionHexHQ_Middle(const double r, const double s,
+                                        const double t)
 {
     return 0.25 * (1 - r * r) * (s - 1) * (t - 1);
 }
 
-inline double dShapeFunctionHexHQ_Corner(const double r, const double s, const double t, const int ty)
+inline double dShapeFunctionHexHQ_Corner(const double r, const double s,
+                                         const double t, const int ty)
 {
-    switch(ty)
+    switch (ty)
     {
-    case 0:
-        return 0.125 * (s - 1) * (t - 1) * (2.0 * r + s + t + 1.0);
-    case 1:
-        return 0.125 * (t - 1) * (r - 1) * (2.0 * s + r + t + 1.0);
-    case 2:
-        return 0.125 * (r - 1) * (s - 1) * (2.0 * t + s + r + 1.0);
+        case 0:
+            return 0.125 * (s - 1) * (t - 1) * (2.0 * r + s + t + 1.0);
+        case 1:
+            return 0.125 * (t - 1) * (r - 1) * (2.0 * s + r + t + 1.0);
+        case 2:
+            return 0.125 * (r - 1) * (s - 1) * (2.0 * t + s + r + 1.0);
     }
     return 0.0;
 }
 
-inline double dShapeFunctionHexHQ_Middle(const double r, const double s, const double t, const int ty)
+inline double dShapeFunctionHexHQ_Middle(const double r, const double s,
+                                         const double t, const int ty)
 {
-    switch(ty)
+    switch (ty)
     {
-    case 0:
-        return -0.5 * r * (s - 1) * (t - 1);
-    case 1:
-        return 0.25 * (1 - r * r) * (t - 1);
-    case 2:
-        return 0.25 * (1 - r * r) * (s - 1);
+        case 0:
+            return -0.5 * r * (s - 1) * (t - 1);
+        case 1:
+            return 0.25 * (1 - r * r) * (t - 1);
+        case 2:
+            return 0.25 * (1 - r * r) * (s - 1);
     }
     return 0.0;
 }
@@ -53,63 +56,67 @@ inline double dShapeFunctionHexHQ_Middle(const double r, const double s, const d
 
 namespace NumLib
 {
-
 template <class T_X, class T_N>
-void ShapeHex20::computeShapeFunction(const T_X &rst, T_N &N)
+void ShapeHex20::computeShapeFunction(const T_X& rst, T_N& N)
 {
     const double r = rst[0];
     const double s = rst[1];
     const double t = rst[2];
 
-    N[0] = ShapeFunctionHexHQ_Corner(r,s,t);
-    N[1] = ShapeFunctionHexHQ_Corner(-r,s,t);
-    N[2] = ShapeFunctionHexHQ_Corner(-r,-s,t);
-    N[3] = ShapeFunctionHexHQ_Corner(r,-s,t);
-    N[4] = ShapeFunctionHexHQ_Corner(r,s,-t);
-    N[5] = ShapeFunctionHexHQ_Corner(-r,s,-t);
-    N[6] = ShapeFunctionHexHQ_Corner(-r,-s,-t);
-    N[7] = ShapeFunctionHexHQ_Corner(r,-s,-t);
-
-    N[8] = ShapeFunctionHexHQ_Middle(r,s,t);
-    N[10] = ShapeFunctionHexHQ_Middle(r,-s,t);
-    N[14] = ShapeFunctionHexHQ_Middle(r,-s,-t);
-    N[12] = ShapeFunctionHexHQ_Middle(r,s,-t);
-
-    N[11] = ShapeFunctionHexHQ_Middle(s,t,r);
-    N[15] = ShapeFunctionHexHQ_Middle(s,-t,r);
-    N[13] = ShapeFunctionHexHQ_Middle(s,-t,-r);
-    N[9]  =  ShapeFunctionHexHQ_Middle(s,t,-r);
-
-    N[16] = ShapeFunctionHexHQ_Middle(t,r,s);
-    N[17] = ShapeFunctionHexHQ_Middle(t,-r,s);
-    N[18] = ShapeFunctionHexHQ_Middle(t,-r,-s);
-    N[19] = ShapeFunctionHexHQ_Middle(t,r,-s);
+    N[0] = ShapeFunctionHexHQ_Corner(r, s, t);
+    N[1] = ShapeFunctionHexHQ_Corner(-r, s, t);
+    N[2] = ShapeFunctionHexHQ_Corner(-r, -s, t);
+    N[3] = ShapeFunctionHexHQ_Corner(r, -s, t);
+    N[4] = ShapeFunctionHexHQ_Corner(r, s, -t);
+    N[5] = ShapeFunctionHexHQ_Corner(-r, s, -t);
+    N[6] = ShapeFunctionHexHQ_Corner(-r, -s, -t);
+    N[7] = ShapeFunctionHexHQ_Corner(r, -s, -t);
+
+    N[8] = ShapeFunctionHexHQ_Middle(r, s, t);
+    N[10] = ShapeFunctionHexHQ_Middle(r, -s, t);
+    N[14] = ShapeFunctionHexHQ_Middle(r, -s, -t);
+    N[12] = ShapeFunctionHexHQ_Middle(r, s, -t);
+
+    N[11] = ShapeFunctionHexHQ_Middle(s, t, r);
+    N[15] = ShapeFunctionHexHQ_Middle(s, -t, r);
+    N[13] = ShapeFunctionHexHQ_Middle(s, -t, -r);
+    N[9] = ShapeFunctionHexHQ_Middle(s, t, -r);
+
+    N[16] = ShapeFunctionHexHQ_Middle(t, r, s);
+    N[17] = ShapeFunctionHexHQ_Middle(t, -r, s);
+    N[18] = ShapeFunctionHexHQ_Middle(t, -r, -s);
+    N[19] = ShapeFunctionHexHQ_Middle(t, r, -s);
 }
 
 template <class T_X, class T_N>
-void ShapeHex20::computeGradShapeFunction(const T_X &rst, T_N &dNdr)
+void ShapeHex20::computeGradShapeFunction(const T_X& rst, T_N& dNdr)
 {
     const double r = rst[0];
     const double s = rst[1];
     const double t = rst[2];
-    const static double sign1[] = {-1.0, 1.0,1.0};
-    const static double sign2[] = { 1.0,-1.0,1.0};
-    const static double sign3[] = { 1.0, 1.0,-1.0};
-    for(int i = 0; i < 3; i++)
+    const static double sign1[] = {-1.0, 1.0, 1.0};
+    const static double sign2[] = {1.0, -1.0, 1.0};
+    const static double sign3[] = {1.0, 1.0, -1.0};
+    for (int i = 0; i < 3; i++)
     {
-        dNdr[20 * i + 0] = dShapeFunctionHexHQ_Corner(r,s,t,i);
-        dNdr[20 * i + 1] = sign1[i] * dShapeFunctionHexHQ_Corner(-r,s,t,i);
-        dNdr[20 * i + 2] = sign1[i] * sign2[i] * dShapeFunctionHexHQ_Corner(-r,-s,t,i);
-        dNdr[20 * i + 3] = sign2[i] * dShapeFunctionHexHQ_Corner(r,-s,t,i);
-        dNdr[20 * i + 4] = sign3[i] * dShapeFunctionHexHQ_Corner(r,s,-t,i);
-        dNdr[20 * i + 5] = sign1[i] * sign3[i] * dShapeFunctionHexHQ_Corner(-r,s,-t,i);
-        dNdr[20 * i + 6] = sign1[i] * sign2[i] * sign3[i] * dShapeFunctionHexHQ_Corner(-r,-s,-t,i);
-        dNdr[20 * i + 7] = sign2[i] * sign3[i] * dShapeFunctionHexHQ_Corner(r,-s,-t,i);
-
-        dNdr[20 * i + 8] =  dShapeFunctionHexHQ_Middle(r,s,t,i);
-        dNdr[20 * i + 10] = sign2[i] * dShapeFunctionHexHQ_Middle(r,-s,t,i);
-        dNdr[20 * i + 14] = sign2[i] * sign3[i] * dShapeFunctionHexHQ_Middle(r,-s,-t,i);
-        dNdr[20 * i + 12] = sign3[i] * dShapeFunctionHexHQ_Middle(r,s,-t,i);
+        dNdr[20 * i + 0] = dShapeFunctionHexHQ_Corner(r, s, t, i);
+        dNdr[20 * i + 1] = sign1[i] * dShapeFunctionHexHQ_Corner(-r, s, t, i);
+        dNdr[20 * i + 2] =
+            sign1[i] * sign2[i] * dShapeFunctionHexHQ_Corner(-r, -s, t, i);
+        dNdr[20 * i + 3] = sign2[i] * dShapeFunctionHexHQ_Corner(r, -s, t, i);
+        dNdr[20 * i + 4] = sign3[i] * dShapeFunctionHexHQ_Corner(r, s, -t, i);
+        dNdr[20 * i + 5] =
+            sign1[i] * sign3[i] * dShapeFunctionHexHQ_Corner(-r, s, -t, i);
+        dNdr[20 * i + 6] = sign1[i] * sign2[i] * sign3[i] *
+                           dShapeFunctionHexHQ_Corner(-r, -s, -t, i);
+        dNdr[20 * i + 7] =
+            sign2[i] * sign3[i] * dShapeFunctionHexHQ_Corner(r, -s, -t, i);
+
+        dNdr[20 * i + 8] = dShapeFunctionHexHQ_Middle(r, s, t, i);
+        dNdr[20 * i + 10] = sign2[i] * dShapeFunctionHexHQ_Middle(r, -s, t, i);
+        dNdr[20 * i + 14] =
+            sign2[i] * sign3[i] * dShapeFunctionHexHQ_Middle(r, -s, -t, i);
+        dNdr[20 * i + 12] = sign3[i] * dShapeFunctionHexHQ_Middle(r, s, -t, i);
 
         {
             int const co = (i + 2) % 3;
diff --git a/NumLib/Fem/ShapeFunction/ShapeHex20.h b/NumLib/Fem/ShapeFunction/ShapeHex20.h
index 64592b48d68ffa5c13ae5c298ffff2706607be48..222f6bcbb6e460493156c07d7a13a117564f3c57 100644
--- a/NumLib/Fem/ShapeFunction/ShapeHex20.h
+++ b/NumLib/Fem/ShapeFunction/ShapeHex20.h
@@ -14,7 +14,6 @@
 
 namespace NumLib
 {
-
 /**
  *  Shape function for a 20-nodes hex element in natural coordinates
  *
@@ -29,7 +28,7 @@ public:
      * @param [out] N   a vector of calculated shape functions
      */
     template <class T_X, class T_N>
-    static void computeShapeFunction(const T_X &r, T_N &N);
+    static void computeShapeFunction(const T_X& r, T_N& N);
 
     /**
      * Evaluate derivatives of the shape function at the given point
@@ -38,7 +37,7 @@ public:
      * @param [out] dN  a matrix of the derivatives
      */
     template <class T_X, class T_N>
-    static void computeGradShapeFunction(const T_X &r, T_N &dN);
+    static void computeGradShapeFunction(const T_X& r, T_N& dN);
 
     using MeshElement = MeshLib::Hex20;
     static const unsigned DIM = MeshElement::dimension;
diff --git a/NumLib/Fem/ShapeFunction/ShapeHex8-impl.h b/NumLib/Fem/ShapeFunction/ShapeHex8-impl.h
index 090c7e6f5448a5f1d0259b64d2655e3b9bcbfd81..1cb2571120a1629d1c1f5f33e579cbf6f6efffd4 100644
--- a/NumLib/Fem/ShapeFunction/ShapeHex8-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapeHex8-impl.h
@@ -10,9 +10,8 @@
 
 namespace NumLib
 {
-
 template <class T_X, class T_N>
-void ShapeHex8::computeShapeFunction(const T_X &r, T_N &N)
+void ShapeHex8::computeShapeFunction(const T_X& r, T_N& N)
 {
     N[0] = (1.0 - r[0]) * (1.0 - r[1]) * (1.0 - r[2]) * 0.125;
     N[1] = (1.0 + r[0]) * (1.0 - r[1]) * (1.0 - r[2]) * 0.125;
@@ -25,7 +24,7 @@ void ShapeHex8::computeShapeFunction(const T_X &r, T_N &N)
 }
 
 template <class T_X, class T_N>
-void ShapeHex8::computeGradShapeFunction(const T_X &r, T_N &dN)
+void ShapeHex8::computeGradShapeFunction(const T_X& r, T_N& dN)
 {
     // dN/dx
     dN[0] = -(1.0 - r[1]) * (1.0 - r[2]) * 0.125;
@@ -38,8 +37,8 @@ void ShapeHex8::computeGradShapeFunction(const T_X &r, T_N &dN)
     dN[7] = -dN[6];
 
     // dN/dy
-    dN[8]  = -(1.0 - r[0]) * (1.0 - r[2]) * 0.125;
-    dN[9]  = -(1.0 + r[0]) * (1.0 - r[2]) * 0.125;
+    dN[8] = -(1.0 - r[0]) * (1.0 - r[2]) * 0.125;
+    dN[9] = -(1.0 + r[0]) * (1.0 - r[2]) * 0.125;
     dN[10] = -dN[9];
     dN[11] = -dN[8];
     dN[12] = -(1.0 - r[0]) * (1.0 + r[2]) * 0.125;
diff --git a/NumLib/Fem/ShapeFunction/ShapeHex8.h b/NumLib/Fem/ShapeFunction/ShapeHex8.h
index befb2fe36949265f8ca14112f4271b7683d05d6d..18dfa55699772c60e81c422b1520acf6ea8973ad 100644
--- a/NumLib/Fem/ShapeFunction/ShapeHex8.h
+++ b/NumLib/Fem/ShapeFunction/ShapeHex8.h
@@ -14,7 +14,6 @@
 
 namespace NumLib
 {
-
 /**
  *  Shape function for a 8-nodes hex element in natural coordinates
  *
@@ -47,7 +46,7 @@ public:
      * @param [out] N   a vector of calculated shape functions
      */
     template <class T_X, class T_N>
-    static void computeShapeFunction(const T_X &r, T_N &N);
+    static void computeShapeFunction(const T_X& r, T_N& N);
 
     /**
      * Evaluate derivatives of the shape function at the given point
@@ -56,7 +55,7 @@ public:
      * @param [out] dN  a matrix of the derivatives
      */
     template <class T_X, class T_N>
-    static void computeGradShapeFunction(const T_X &r, T_N &dN);
+    static void computeGradShapeFunction(const T_X& r, T_N& dN);
 
     using MeshElement = MeshLib::Hex;
     static const unsigned DIM = MeshElement::dimension;
diff --git a/NumLib/Fem/ShapeFunction/ShapeLine2-impl.h b/NumLib/Fem/ShapeFunction/ShapeLine2-impl.h
index 60af48bc8c492d1bd7dd1af8b22446c5694a58ba..69afec1ed83f00c00ad5d65dd1b4c69995a38553 100644
--- a/NumLib/Fem/ShapeFunction/ShapeLine2-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapeLine2-impl.h
@@ -10,16 +10,15 @@
 
 namespace NumLib
 {
-
 template <class T_X, class T_N>
-void ShapeLine2::computeShapeFunction(const T_X &r, T_N &N)
+void ShapeLine2::computeShapeFunction(const T_X& r, T_N& N)
 {
     N[0] = (1.0 - r[0]) * 0.5;
     N[1] = (1.0 + r[0]) * 0.5;
 }
 
 template <class T_X, class T_N>
-void ShapeLine2::computeGradShapeFunction(const T_X &/*r*/, T_N &dN)
+void ShapeLine2::computeGradShapeFunction(const T_X& /*r*/, T_N& dN)
 {
     dN[0] = -0.5;
     dN[1] = 0.5;
diff --git a/NumLib/Fem/ShapeFunction/ShapeLine2.h b/NumLib/Fem/ShapeFunction/ShapeLine2.h
index ed5d1ed7c311a95200a8a6b1b20e197c26060b16..a9195085f58601c25e653e13d2908a533bb64e2a 100644
--- a/NumLib/Fem/ShapeFunction/ShapeLine2.h
+++ b/NumLib/Fem/ShapeFunction/ShapeLine2.h
@@ -14,7 +14,6 @@
 
 namespace NumLib
 {
-
 /**
  *  Shape function for a line element of two nodes in natural coordinates
  *
@@ -33,7 +32,7 @@ public:
      * @param [out] N   a vector of calculated shape function.
      */
     template <class T_X, class T_N>
-    static void computeShapeFunction(const T_X &r, T_N &N);
+    static void computeShapeFunction(const T_X& r, T_N& N);
 
     /**
      * Evaluate derivatives of the shape function at the given point
@@ -42,7 +41,7 @@ public:
      * @param [out] dN  a matrix of the derivatives
      */
     template <class T_X, class T_N>
-    static void computeGradShapeFunction(const T_X &r, T_N &dN);
+    static void computeGradShapeFunction(const T_X& r, T_N& dN);
 
     using MeshElement = MeshLib::Line;
     static const unsigned DIM = MeshElement::dimension;
diff --git a/NumLib/Fem/ShapeFunction/ShapeLine3-impl.h b/NumLib/Fem/ShapeFunction/ShapeLine3-impl.h
index 4eb2edb9a69b1e22ae413c432b92bcf5856cfbe5..0136966d2e59ad0e41c70066d6c9756e449166bd 100644
--- a/NumLib/Fem/ShapeFunction/ShapeLine3-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapeLine3-impl.h
@@ -10,9 +10,8 @@
 
 namespace NumLib
 {
-
 template <class T_X, class T_N>
-void ShapeLine3::computeShapeFunction(const T_X &r, T_N &N)
+void ShapeLine3::computeShapeFunction(const T_X& r, T_N& N)
 {
     N[0] = 0.5 * r[0] * (r[0] - 1.0);
     N[1] = 0.5 * r[0] * (r[0] + 1.0);
@@ -20,7 +19,7 @@ void ShapeLine3::computeShapeFunction(const T_X &r, T_N &N)
 }
 
 template <class T_X, class T_N>
-void ShapeLine3::computeGradShapeFunction(const T_X &r, T_N &dN)
+void ShapeLine3::computeGradShapeFunction(const T_X& r, T_N& dN)
 {
     dN[0] = r[0] - 0.5;
     dN[1] = r[0] + 0.5;
diff --git a/NumLib/Fem/ShapeFunction/ShapeLine3.h b/NumLib/Fem/ShapeFunction/ShapeLine3.h
index 55c9adab230151d840a06e9d2e05e376c7b258ac..e7bff7058f97e07fc1f69a69dab1883a7577da96 100644
--- a/NumLib/Fem/ShapeFunction/ShapeLine3.h
+++ b/NumLib/Fem/ShapeFunction/ShapeLine3.h
@@ -14,7 +14,6 @@
 
 namespace NumLib
 {
-
 /**
  *  Shape function for a 3-nodes line element
  */
@@ -28,7 +27,7 @@ public:
      * @param [out] N   a vector of calculated shape function.
      */
     template <class T_X, class T_N>
-    static void computeShapeFunction(const T_X &r, T_N &N);
+    static void computeShapeFunction(const T_X& r, T_N& N);
 
     /**
      * Evaluate derivatives of the shape function at the given point
@@ -37,7 +36,7 @@ public:
      * @param [out] dN  a matrix of the derivatives
      */
     template <class T_X, class T_N>
-    static void computeGradShapeFunction(const T_X &r, T_N &dN);
+    static void computeGradShapeFunction(const T_X& r, T_N& dN);
 
     using MeshElement = MeshLib::Line3;
     static const unsigned DIM = MeshElement::dimension;
diff --git a/NumLib/Fem/ShapeFunction/ShapePoint1-impl.h b/NumLib/Fem/ShapeFunction/ShapePoint1-impl.h
index 029231f70456c4afccb6752546993beec960519f..090ba51d0b5ca7cdb3bf182035a68d560f06d38b 100644
--- a/NumLib/Fem/ShapeFunction/ShapePoint1-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapePoint1-impl.h
@@ -10,11 +10,10 @@
 
 namespace NumLib
 {
-
 template <class T_X, class T_N>
 void ShapePoint1::computeShapeFunction(const T_X& /*r*/, T_N& N)
 {
     N[0] = 1;
 }
 
-}
+}  // namespace NumLib
diff --git a/NumLib/Fem/ShapeFunction/ShapePrism15-impl.h b/NumLib/Fem/ShapeFunction/ShapePrism15-impl.h
index f7cee6612456d56f84fb874a2b0c90106f7e85a1..e5ea962d27ec69b7731342825d54f9f217e1d41f 100644
--- a/NumLib/Fem/ShapeFunction/ShapePrism15-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapePrism15-impl.h
@@ -10,9 +10,8 @@
 
 namespace NumLib
 {
-
 template <class T_X, class T_N>
-void ShapePrism15::computeShapeFunction(const T_X &x, T_N &N)
+void ShapePrism15::computeShapeFunction(const T_X& x, T_N& N)
 {
     const double L1 = x[0];
     const double L2 = x[1];
@@ -50,7 +49,7 @@ void ShapePrism15::computeShapeFunction(const T_X &x, T_N &N)
 }
 
 template <class T_X, class T_N>
-void ShapePrism15::computeGradShapeFunction(const T_X &x, T_N &dN)
+void ShapePrism15::computeGradShapeFunction(const T_X& x, T_N& dN)
 {
     const double L1 = x[0];
     const double L2 = x[1];
@@ -63,48 +62,48 @@ void ShapePrism15::computeGradShapeFunction(const T_X &x, T_N &dN)
     double v2 = (4.0 * L1 - 1);
     // Vertex, bottom
     dN[0] = -0.5 * (v1 * (1.0 - t) - tt1);
-    dN[1] =  0.5 * (v2 * (1.0 - t) - tt1);
-    dN[2] =  0.0;
+    dN[1] = 0.5 * (v2 * (1.0 - t) - tt1);
+    dN[2] = 0.0;
     // Vertex, top
     dN[3] = -0.5 * (v1 * (1.0 + t) - tt1);
-    dN[4] =  0.5 * (v2 * (1.0 + t) - tt1);
-    dN[5] =  0.0;
+    dN[4] = 0.5 * (v2 * (1.0 + t) - tt1);
+    dN[5] = 0.0;
     // Middle point, bottom
-    dN[6] =  2.0 * (L0 -L1) * (1.0 - t);
-    dN[7] =  2.0 * L2 * (1.0 - t);
+    dN[6] = 2.0 * (L0 - L1) * (1.0 - t);
+    dN[7] = 2.0 * L2 * (1.0 - t);
     dN[8] = -dN[7];
     // Middle point, top
-    dN[9] =  2.0 * (L0 - L1) * (1.0 + t);
+    dN[9] = 2.0 * (L0 - L1) * (1.0 + t);
     dN[10] = 2.0 * L2 * (1.0 + t);
     dN[11] = -dN[10];
     // Middle point, center
     dN[12] = -tt1;
-    dN[13] =  tt1;
-    dN[14] =  0.0;
+    dN[13] = tt1;
+    dN[14] = 0.0;
 
     //---dN/dL2
     v1 = (4.0 * L2 - 1);
     // Vertex, bottom
-    dN[15] =  dN[0];
-    dN[16] =  0.0;
-    dN[17] =  0.5 * (v1 * (1.0 - t) - tt1);
+    dN[15] = dN[0];
+    dN[16] = 0.0;
+    dN[17] = 0.5 * (v1 * (1.0 - t) - tt1);
     // Vertex, top
-    dN[18] =  dN[3];
-    dN[19] =  0.0;
-    dN[20] =  0.5 * (v1 * (1.0 + t) - tt1);
+    dN[18] = dN[3];
+    dN[19] = 0.0;
+    dN[20] = 0.5 * (v1 * (1.0 + t) - tt1);
     // Middle point, bottom
     dN[21] = -2.0 * L1 * (1.0 - t);
     dN[22] = -dN[21];
-    v1 = 2.0 * (L0 -  L2);
-    dN[23] =  v1 * (1.0 - t);
+    v1 = 2.0 * (L0 - L2);
+    dN[23] = v1 * (1.0 - t);
     // Middle point, top
     dN[24] = -2.0 * L1 * (1.0 + t);
     dN[25] = -dN[24];
-    dN[26] =  v1 * (1.0 + t);
+    dN[26] = v1 * (1.0 + t);
     // Middle point, center
     dN[27] = -tt1;
-    dN[28] =  0.0;
-    dN[29] =  tt1;
+    dN[28] = 0.0;
+    dN[29] = tt1;
 
     //---dN/dt
     v1 = 2.0 * L0 - 1;
diff --git a/NumLib/Fem/ShapeFunction/ShapePrism15.h b/NumLib/Fem/ShapeFunction/ShapePrism15.h
index 76f18262f5b3e450b13a372baf155a94c1e6626c..5f813f799a771737acb391242e648c98122de347 100644
--- a/NumLib/Fem/ShapeFunction/ShapePrism15.h
+++ b/NumLib/Fem/ShapeFunction/ShapePrism15.h
@@ -14,7 +14,6 @@
 
 namespace NumLib
 {
-
 /**
  *  Shape function for a 15-nodes prism element in natural coordinates
  *
diff --git a/NumLib/Fem/ShapeFunction/ShapePrism6-impl.h b/NumLib/Fem/ShapeFunction/ShapePrism6-impl.h
index 72682b5ecdc2f3d7108a35e57e1ad2619e656a0e..92c98d7ede9ea5ad4ece0e4a94a2e67077243bb9 100644
--- a/NumLib/Fem/ShapeFunction/ShapePrism6-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapePrism6-impl.h
@@ -10,9 +10,8 @@
 
 namespace NumLib
 {
-
 template <class T_X, class T_N>
-void ShapePrism6::computeShapeFunction(const T_X &x, T_N &N)
+void ShapePrism6::computeShapeFunction(const T_X& x, T_N& N)
 {
     const double L1 = x[0];
     const double L2 = x[1];
@@ -26,7 +25,7 @@ void ShapePrism6::computeShapeFunction(const T_X &x, T_N &N)
 }
 
 template <class T_X, class T_N>
-void ShapePrism6::computeGradShapeFunction(const T_X &x, T_N &dN)
+void ShapePrism6::computeGradShapeFunction(const T_X& x, T_N& dN)
 {
     const double L1 = x[0];
     const double L2 = x[1];
@@ -34,15 +33,15 @@ void ShapePrism6::computeGradShapeFunction(const T_X &x, T_N &dN)
     //  dN/dL1
     dN[0] = -0.5 * (1.0 - t);
     dN[1] = -dN[0];
-    dN[2] =  0.0;
+    dN[2] = 0.0;
     dN[3] = -0.5 * (1.0 + t);
     dN[4] = -dN[3];
-    dN[5] =  0.0;
+    dN[5] = 0.0;
     //  dN/dL2
-    dN[6] =  dN[0];
-    dN[7] =  0.0;
+    dN[6] = dN[0];
+    dN[7] = 0.0;
     dN[8] = -dN[0];
-    dN[9] =  dN[3];
+    dN[9] = dN[3];
     dN[10] = 0.0;
     dN[11] = -dN[3];
     //  dN/dt
diff --git a/NumLib/Fem/ShapeFunction/ShapePrism6.h b/NumLib/Fem/ShapeFunction/ShapePrism6.h
index ec571f3f3c8025e24aea4ececd42e6dd2ddff1bf..b715d9d21281dbe9aec9c0051166301096d1ced7 100644
--- a/NumLib/Fem/ShapeFunction/ShapePrism6.h
+++ b/NumLib/Fem/ShapeFunction/ShapePrism6.h
@@ -14,7 +14,6 @@
 
 namespace NumLib
 {
-
 /**
  *  Shape function for a 6-nodes prism element in natural coordinates
  *
diff --git a/NumLib/Fem/ShapeFunction/ShapePyra13-impl.h b/NumLib/Fem/ShapeFunction/ShapePyra13-impl.h
index 93a4732a9b36b7dcc4df94f51f42d9a5e3cd28bf..b1334000d54f1e53945c219c389ab7353203aab8 100644
--- a/NumLib/Fem/ShapeFunction/ShapePyra13-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapePyra13-impl.h
@@ -10,18 +10,25 @@
 
 namespace NumLib
 {
-
 template <class T_X, class T_N>
-void ShapePyra13::computeShapeFunction(const T_X &x, T_N &N)
+void ShapePyra13::computeShapeFunction(const T_X& x, T_N& N)
 {
     const double r = x[0];
     const double s = x[1];
     const double t = x[2];
 
-    N[0] = -0.0625 * (1.0 - r) * (1.0 - s) * (1.0 - t) * (4.0 + 3.0 * r + 3.0 * s + 2.0 * r * s + 2.0 * t + r * t + s * t + 2.0 * r * s * t);
-    N[1] = -0.0625 * (1.0 + r) * (1.0 - s) * (1.0 - t) * (4.0 - 3.0 * r + 3.0 * s - 2.0 * r * s + 2.0 * t - r * t + s * t - 2.0 * r * s * t);
-    N[2] = -0.0625 * (1.0 + r) * (1.0 + s) * (1.0 - t) * (4.0 - 3.0 * r - 3.0 * s + 2.0 * r * s + 2.0 * t - r * t - s * t + 2.0 * r * s * t);
-    N[3] = -0.0625 * (1.0 - r) * (1.0 + s) * (1.0 - t) * (4.0 + 3.0 * r - 3.0 * s - 2.0 * r * s + 2.0 * t + r * t - s * t - 2.0 * r * s * t);
+    N[0] = -0.0625 * (1.0 - r) * (1.0 - s) * (1.0 - t) *
+           (4.0 + 3.0 * r + 3.0 * s + 2.0 * r * s + 2.0 * t + r * t + s * t +
+            2.0 * r * s * t);
+    N[1] = -0.0625 * (1.0 + r) * (1.0 - s) * (1.0 - t) *
+           (4.0 - 3.0 * r + 3.0 * s - 2.0 * r * s + 2.0 * t - r * t + s * t -
+            2.0 * r * s * t);
+    N[2] = -0.0625 * (1.0 + r) * (1.0 + s) * (1.0 - t) *
+           (4.0 - 3.0 * r - 3.0 * s + 2.0 * r * s + 2.0 * t - r * t - s * t +
+            2.0 * r * s * t);
+    N[3] = -0.0625 * (1.0 - r) * (1.0 + s) * (1.0 - t) *
+           (4.0 + 3.0 * r - 3.0 * s - 2.0 * r * s + 2.0 * t + r * t - s * t -
+            2.0 * r * s * t);
     N[4] = 0.5 * t * (1.0 + t);
     N[5] = 0.125 * (1.0 - r * r) * (1.0 - s) * (1.0 - t) * (2.0 + s + s * t);
     N[6] = 0.125 * (1.0 + r) * (1.0 - s * s) * (1.0 - t) * (2.0 - r - r * t);
@@ -34,46 +41,69 @@ void ShapePyra13::computeShapeFunction(const T_X &x, T_N &N)
 }
 
 template <class T_X, class T_N>
-void ShapePyra13::computeGradShapeFunction(const T_X &x, T_N &dN)
+void ShapePyra13::computeGradShapeFunction(const T_X& x, T_N& dN)
 {
     const double r = x[0];
     const double s = x[1];
     const double t = x[2];
     //---dN/dr
-    dN[0] = 0.0625 * (1.0 - s) * (1.0 - t) * (1.0 + 6.0 * r + s + 4.0 * r * s + t + 2.0 * r * t - s * t + 4.0 * r * s * t);
-    dN[1] = -0.0625 * (1.0 - s) * (1.0 - t) * (1.0 - 6.0 * r + s - 4.0 * r * s + t - 2.0 * r * t - s * t - 4.0 * r * s * t);
-    dN[2] = -0.0625 * (1.0 + s) * (1.0 - t) * (1.0 - 6.0 * r - s + 4.0 * r * s + t - 2.0 * r * t + s * t + 4.0 * r * s * t);
-    dN[3] = 0.0625 * (1.0 + s) * (1.0 - t) * (1.0 + 6.0 * r - s - 4.0 * r * s + t + 2.0 * r * t + s * t - 4.0 * r * s * t);
+    dN[0] = 0.0625 * (1.0 - s) * (1.0 - t) *
+            (1.0 + 6.0 * r + s + 4.0 * r * s + t + 2.0 * r * t - s * t +
+             4.0 * r * s * t);
+    dN[1] = -0.0625 * (1.0 - s) * (1.0 - t) *
+            (1.0 - 6.0 * r + s - 4.0 * r * s + t - 2.0 * r * t - s * t -
+             4.0 * r * s * t);
+    dN[2] = -0.0625 * (1.0 + s) * (1.0 - t) *
+            (1.0 - 6.0 * r - s + 4.0 * r * s + t - 2.0 * r * t + s * t +
+             4.0 * r * s * t);
+    dN[3] = 0.0625 * (1.0 + s) * (1.0 - t) *
+            (1.0 + 6.0 * r - s - 4.0 * r * s + t + 2.0 * r * t + s * t -
+             4.0 * r * s * t);
     dN[4] = 0.0;
     dN[5] = -0.25 * r * (1.0 - s) * (1.0 - t) * (2.0 + s + s * t);
     dN[6] = 0.125 * (1.0 - s * s) * (1.0 - t) * (1.0 - 2.0 * r - t - 2 * r * t);
     dN[7] = -0.25 * r * (1.0 + s) * (1.0 - t) * (2.0 - s - s * t);
-    dN[8] = -0.125 * (1.0 - s * s) * (1.0 - t) * (1.0 + 2.0 * r - t + 2 * r * t);
+    dN[8] =
+        -0.125 * (1.0 - s * s) * (1.0 - t) * (1.0 + 2.0 * r - t + 2 * r * t);
     dN[9] = -0.25 * (1.0 - s) * (1.0 - t * t);
     dN[10] = 0.25 * (1.0 - s) * (1.0 - t * t);
     dN[11] = 0.25 * (1.0 + s) * (1.0 - t * t);
     dN[12] = -0.25 * (1.0 + s) * (1.0 - t * t);
 
     //---dN/ds
-    dN[13] = 0.0625 * (1.0 - r) * (1.0 - t) * (1.0 + r + 6.0 * s + 4.0 * r * s + t - r * t + 2.0 * s * t + 4.0 * r * s * t);
-    dN[14] = 0.0625 * (1.0 + r) * (1.0 - t) * (1.0 - r + 6.0 * s - 4.0 * r * s + t + r * t + 2.0 * s * t - 4.0 * r * s * t);
-    dN[15] = -0.0625 * (1.0 + r) * (1.0 - t) * (1.0 - r - 6.0 * s + 4.0 * r * s + t + r * t - 2.0 * s * t + 4.0 * r * s * t);
-    dN[16] = -0.0625 * (1.0 - r) * (1.0 - t) * (1.0 + r - 6.0 * s - 4.0 * r * s + t - r * t - 2.0 * s * t - 4.0 * r * s * t);
+    dN[13] = 0.0625 * (1.0 - r) * (1.0 - t) *
+             (1.0 + r + 6.0 * s + 4.0 * r * s + t - r * t + 2.0 * s * t +
+              4.0 * r * s * t);
+    dN[14] = 0.0625 * (1.0 + r) * (1.0 - t) *
+             (1.0 - r + 6.0 * s - 4.0 * r * s + t + r * t + 2.0 * s * t -
+              4.0 * r * s * t);
+    dN[15] = -0.0625 * (1.0 + r) * (1.0 - t) *
+             (1.0 - r - 6.0 * s + 4.0 * r * s + t + r * t - 2.0 * s * t +
+              4.0 * r * s * t);
+    dN[16] = -0.0625 * (1.0 - r) * (1.0 - t) *
+             (1.0 + r - 6.0 * s - 4.0 * r * s + t - r * t - 2.0 * s * t -
+              4.0 * r * s * t);
     dN[17] = 0.0;
-    dN[18] = -0.125 * (1.0 - r * r) * (1.0 - t) * (1.0 + 2.0 * s - t + 2.0 * s * t);
+    dN[18] =
+        -0.125 * (1.0 - r * r) * (1.0 - t) * (1.0 + 2.0 * s - t + 2.0 * s * t);
     dN[19] = -0.25 * (1.0 + r) * s * (1.0 - t) * (2.0 - r - r * t);
-    dN[20] = 0.125 * (1.0 - r * r) * (1.0 - t) * (1.0 - 2.0 * s - t - 2.0 * s * t);
+    dN[20] =
+        0.125 * (1.0 - r * r) * (1.0 - t) * (1.0 - 2.0 * s - t - 2.0 * s * t);
     dN[21] = -0.25 * (1.0 - r) * s * (1.0 - t) * (2.0 + r + r * t);
     dN[22] = -0.25 * (1.0 - r) * (1.0 - t * t);
     dN[23] = -0.25 * (1.0 + r) * (1.0 - t * t);
     dN[24] = 0.25 * (1.0 + r) * (1.0 - t * t);
-     dN[25] = 0.25 * (1.0 - r) * (1.0 - t * t);
+    dN[25] = 0.25 * (1.0 - r) * (1.0 - t * t);
 
     //---dN/dt
-    dN[26] = 0.125 * (1.0 - r) * (1.0 - s) * (1.0 + r + s + 2.0 * t + r * t + s * t + 2.0 * r * s * t);
-    dN[27] = 0.125 * (1.0 + r) * (1.0 - s) * (1.0 - r + s + 2.0 * t - r * t + s * t - 2.0 * r * s * t);
-    dN[28] = 0.125 * (1.0 + r) * (1.0 + s) * (1.0 - r - s + 2.0 * t - r * t - s * t + 2.0 * r * s * t);
-    dN[29] = 0.125 * (1.0 - r) * (1.0 + s) * (1.0 + r - s + 2.0 * t + r * t - s * t - 2.0 * r * s * t);
+    dN[26] = 0.125 * (1.0 - r) * (1.0 - s) *
+             (1.0 + r + s + 2.0 * t + r * t + s * t + 2.0 * r * s * t);
+    dN[27] = 0.125 * (1.0 + r) * (1.0 - s) *
+             (1.0 - r + s + 2.0 * t - r * t + s * t - 2.0 * r * s * t);
+    dN[28] = 0.125 * (1.0 + r) * (1.0 + s) *
+             (1.0 - r - s + 2.0 * t - r * t - s * t + 2.0 * r * s * t);
+    dN[29] = 0.125 * (1.0 - r) * (1.0 + s) *
+             (1.0 + r - s + 2.0 * t + r * t - s * t - 2.0 * r * s * t);
     dN[30] = 0.5 + t;
     dN[31] = -0.25 * (1.0 - r * r) * (1.0 - s) * (1.0 + s * t);
     dN[32] = -0.25 * (1.0 + r) * (1.0 - s * s) * (1.0 - r * t);
diff --git a/NumLib/Fem/ShapeFunction/ShapePyra13.h b/NumLib/Fem/ShapeFunction/ShapePyra13.h
index 616e8b197185161cb6317c43b913ca8cba36812d..8e049ea11bff46317404d256c507de495b8cec9c 100644
--- a/NumLib/Fem/ShapeFunction/ShapePyra13.h
+++ b/NumLib/Fem/ShapeFunction/ShapePyra13.h
@@ -14,7 +14,6 @@
 
 namespace NumLib
 {
-
 /**
  *  Shape function for a 13-nodes pyramid element in natural coordinates
  *
diff --git a/NumLib/Fem/ShapeFunction/ShapePyra5-impl.h b/NumLib/Fem/ShapeFunction/ShapePyra5-impl.h
index 0a20dc52adc7c33ecaaa5f58a75bd4256f881214..1e3bb56333cbd3826dadc4d508574ecc25b3e020 100644
--- a/NumLib/Fem/ShapeFunction/ShapePyra5-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapePyra5-impl.h
@@ -10,9 +10,8 @@
 
 namespace NumLib
 {
-
 template <class T_X, class T_N>
-void ShapePyra5::computeShapeFunction(const T_X &x, T_N &N)
+void ShapePyra5::computeShapeFunction(const T_X& x, T_N& N)
 {
     const double r = x[0];
     const double s = x[1];
@@ -26,7 +25,7 @@ void ShapePyra5::computeShapeFunction(const T_X &x, T_N &N)
 }
 
 template <class T_X, class T_N>
-void ShapePyra5::computeGradShapeFunction(const T_X &x, T_N &dN)
+void ShapePyra5::computeGradShapeFunction(const T_X& x, T_N& dN)
 {
     const double r = x[0];
     const double s = x[1];
@@ -34,15 +33,15 @@ void ShapePyra5::computeGradShapeFunction(const T_X &x, T_N &dN)
     //  dN/dL1
     dN[0] = -0.125 * (1.0 - s) * (1.0 - t);
     dN[1] = -dN[0];
-    dN[2] =  0.125 * (1.0 + s) * (1.0 - t);
+    dN[2] = 0.125 * (1.0 + s) * (1.0 - t);
     dN[3] = -dN[2];
-    dN[4] =  0.0;
+    dN[4] = 0.0;
     //  dN/dL2
     dN[5] = -0.125 * (1.0 - r) * (1.0 - t);
     dN[6] = -0.125 * (1.0 + r) * (1.0 - t);
     dN[7] = -dN[6];
     dN[8] = -dN[5];
-    dN[9] =  0.0;
+    dN[9] = 0.0;
     //  dN/dt
     dN[10] = -0.125 * (1.0 - r) * (1.0 - s);
     dN[11] = -0.125 * (1.0 + r) * (1.0 - s);
diff --git a/NumLib/Fem/ShapeFunction/ShapePyra5.h b/NumLib/Fem/ShapeFunction/ShapePyra5.h
index 7aa0f03106556bf75e8b28cfe0aa5ef3b3416014..5f1b6d71e266de81399d8bed7611c8101d95504b 100644
--- a/NumLib/Fem/ShapeFunction/ShapePyra5.h
+++ b/NumLib/Fem/ShapeFunction/ShapePyra5.h
@@ -14,7 +14,6 @@
 
 namespace NumLib
 {
-
 /**
  *  Shape function for a 5-nodes pyramid element in natural coordinates
  *
diff --git a/NumLib/Fem/ShapeFunction/ShapeQuad4-impl.h b/NumLib/Fem/ShapeFunction/ShapeQuad4-impl.h
index 311433e55e1e50cc804f658aebbb5d1e1b072e7d..3803e332ddd627650a71a0cc4e6038f22adf43d0 100644
--- a/NumLib/Fem/ShapeFunction/ShapeQuad4-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapeQuad4-impl.h
@@ -12,9 +12,8 @@
 
 namespace NumLib
 {
-
 template <class T_X, class T_N>
-void ShapeQuad4::computeShapeFunction(const T_X &r, T_N &N)
+void ShapeQuad4::computeShapeFunction(const T_X& r, T_N& N)
 {
     N[0] = (1.0 + r[0]) * (1.0 + r[1]) / 4;
     N[1] = (1.0 - r[0]) * (1.0 + r[1]) / 4;
@@ -23,7 +22,7 @@ void ShapeQuad4::computeShapeFunction(const T_X &r, T_N &N)
 }
 
 template <class T_X, class T_N>
-void ShapeQuad4::computeGradShapeFunction(const T_X &r, T_N &dN)
+void ShapeQuad4::computeGradShapeFunction(const T_X& r, T_N& dN)
 {
     dN[0] = +(1.0 + r[1]) / 4;
     dN[1] = -(1.0 + r[1]) / 4;
diff --git a/NumLib/Fem/ShapeFunction/ShapeQuad4.h b/NumLib/Fem/ShapeFunction/ShapeQuad4.h
index fba24c5a03672b228ae14349c8c9229c3e0a205f..1ce5ed948f218c0d9d44f6dc0d82f8171a70f42f 100644
--- a/NumLib/Fem/ShapeFunction/ShapeQuad4.h
+++ b/NumLib/Fem/ShapeFunction/ShapeQuad4.h
@@ -16,9 +16,9 @@
 
 namespace NumLib
 {
-
 /**
- *  Shape function for a quadrilateral element of four nodes in natural coordinates
+ *  Shape function for a quadrilateral element of four nodes in natural
+ * coordinates
  *
  * \verbatim
  *  2 (-1,1)     1 (1,1)
@@ -40,7 +40,7 @@ public:
      * @param [out] N   a vector of calculated shape function.
      */
     template <class T_X, class T_N>
-    static void computeShapeFunction(const T_X &r, T_N &N);
+    static void computeShapeFunction(const T_X& r, T_N& N);
 
     /**
      * Evaluate derivatives of the shape function at the given point
@@ -49,7 +49,7 @@ public:
      * @param [out] dN  a matrix of the derivatives
      */
     template <class T_X, class T_N>
-    static void computeGradShapeFunction(const T_X &r, T_N &dN);
+    static void computeGradShapeFunction(const T_X& r, T_N& dN);
 
     using MeshElement = MeshLib::Quad;
     static const unsigned DIM = MeshElement::dimension;
diff --git a/NumLib/Fem/ShapeFunction/ShapeQuad8-impl.h b/NumLib/Fem/ShapeFunction/ShapeQuad8-impl.h
index 2005f6c5e1c7599aa6d95fc1f28aa69c4860be9f..b7b836731878e31a3ccaecd92faa56c383b690af 100644
--- a/NumLib/Fem/ShapeFunction/ShapeQuad8-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapeQuad8-impl.h
@@ -10,9 +10,8 @@
 
 namespace NumLib
 {
-
 template <class T_X, class T_N>
-void ShapeQuad8::computeShapeFunction(const T_X &r, T_N &N)
+void ShapeQuad8::computeShapeFunction(const T_X& r, T_N& N)
 {
     N[0] = 0.25 * (1.0 + r[0]) * (1.0 + r[1]) * (-1.0 + r[0] + r[1]);
     N[1] = -0.25 * (1.0 - r[0]) * (1.0 + r[1]) * (1.0 + r[0] - r[1]);
@@ -26,7 +25,7 @@ void ShapeQuad8::computeShapeFunction(const T_X &r, T_N &N)
 }
 
 template <class T_X, class T_N>
-void ShapeQuad8::computeGradShapeFunction(const T_X &rs, T_N &dNdr)
+void ShapeQuad8::computeGradShapeFunction(const T_X& rs, T_N& dNdr)
 {
     const double r = rs[0];
     const double s = rs[1];
diff --git a/NumLib/Fem/ShapeFunction/ShapeQuad8.h b/NumLib/Fem/ShapeFunction/ShapeQuad8.h
index 30852be6c7e3a2f36dd3d13e1ca190580ae38112..7528ef9b002f6b47375c2e9e23861ef15401ef5b 100644
--- a/NumLib/Fem/ShapeFunction/ShapeQuad8.h
+++ b/NumLib/Fem/ShapeFunction/ShapeQuad8.h
@@ -14,7 +14,6 @@
 
 namespace NumLib
 {
-
 /**
  *  Shape function for a 8-nodes quadrilateral element
  */
@@ -28,7 +27,7 @@ public:
      * @param [out] N   a vector of calculated shape function.
      */
     template <class T_X, class T_N>
-    static void computeShapeFunction(const T_X &r, T_N &N);
+    static void computeShapeFunction(const T_X& r, T_N& N);
 
     /**
      * Evaluate derivatives of the shape function at the given point
@@ -37,7 +36,7 @@ public:
      * @param [out] dN  a matrix of the derivatives
      */
     template <class T_X, class T_N>
-    static void computeGradShapeFunction(const T_X &r, T_N &dN);
+    static void computeGradShapeFunction(const T_X& r, T_N& dN);
 
     using MeshElement = MeshLib::Quad8;
     static const unsigned DIM = MeshElement::dimension;
diff --git a/NumLib/Fem/ShapeFunction/ShapeQuad9.h b/NumLib/Fem/ShapeFunction/ShapeQuad9.h
index 0e15223ec1ebc647ee490b025ae695deb929675e..b3f8ad92778b57a80ab3aa81a0a4510c4e36a5a8 100644
--- a/NumLib/Fem/ShapeFunction/ShapeQuad9.h
+++ b/NumLib/Fem/ShapeFunction/ShapeQuad9.h
@@ -14,7 +14,6 @@
 
 namespace NumLib
 {
-
 /**
  *  Shape function for a 9-nodes quadrilateral element
  */
@@ -28,7 +27,7 @@ public:
      * @param [out] N   a vector of calculated shape function.
      */
     template <class T_X, class T_N>
-    static void computeShapeFunction(const T_X &r, T_N &N);
+    static void computeShapeFunction(const T_X& r, T_N& N);
 
     /**
      * Evaluate derivatives of the shape function at the given point
@@ -37,7 +36,7 @@ public:
      * @param [out] dN  a matrix of the derivatives
      */
     template <class T_X, class T_N>
-    static void computeGradShapeFunction(const T_X &r, T_N &dN);
+    static void computeGradShapeFunction(const T_X& r, T_N& dN);
 
     using MeshElement = MeshLib::Quad9;
     static const unsigned DIM = MeshElement::dimension;
diff --git a/NumLib/Fem/ShapeFunction/ShapeTet10-impl.h b/NumLib/Fem/ShapeFunction/ShapeTet10-impl.h
index ea52a3fef90d069317af95c62c8ec3eda09dc548..aed33c57a671b3d53222201aef47d8fb05aac1b9 100644
--- a/NumLib/Fem/ShapeFunction/ShapeTet10-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapeTet10-impl.h
@@ -10,9 +10,8 @@
 
 namespace NumLib
 {
-
 template <class T_X, class T_N>
-void ShapeTet10::computeShapeFunction(const T_X &r, T_N &N)
+void ShapeTet10::computeShapeFunction(const T_X& r, T_N& N)
 {
     N[0] = 2. * (1 - r[0] - r[1] - r[2]) * (0.5 - r[0] - r[1] - r[2]);
     N[1] = r[0] * (2. * r[0] - 1);
@@ -27,7 +26,7 @@ void ShapeTet10::computeShapeFunction(const T_X &r, T_N &N)
 }
 
 template <class T_X, class T_N>
-void ShapeTet10::computeGradShapeFunction(const T_X &r, T_N &dNdr)
+void ShapeTet10::computeGradShapeFunction(const T_X& r, T_N& dNdr)
 {
     dNdr[0] = 4.0 * (r[0] + r[1] + r[2]) - 3.0;
     dNdr[1] = 4. * r[0] - 1.;
@@ -40,7 +39,7 @@ void ShapeTet10::computeGradShapeFunction(const T_X &r, T_N &dNdr)
     dNdr[8] = 4.0 * r[2];
     dNdr[9] = 0.0;
 
-    dNdr[10] =  4. * (r[0] + r[1] + r[2]) - 3.;
+    dNdr[10] = 4. * (r[0] + r[1] + r[2]) - 3.;
     dNdr[11] = 0.0;
     dNdr[12] = 4. * r[1] - 1.;
     dNdr[13] = 0.;
diff --git a/NumLib/Fem/ShapeFunction/ShapeTet10.h b/NumLib/Fem/ShapeFunction/ShapeTet10.h
index fdb0c49632e6255909a47f3a85737c54386fb935..60c277bef07cdfd0be586df4e79dc1fd361768a2 100644
--- a/NumLib/Fem/ShapeFunction/ShapeTet10.h
+++ b/NumLib/Fem/ShapeFunction/ShapeTet10.h
@@ -14,7 +14,6 @@
 
 namespace NumLib
 {
-
 /**
  *  Shape function for a 10-nodes tetrahedral element
  */
@@ -28,7 +27,7 @@ public:
      * @param [out] N    a vector of calculated shape function.
      */
     template <class T_X, class T_N>
-    static void computeShapeFunction(const T_X &r, T_N &N);
+    static void computeShapeFunction(const T_X& r, T_N& N);
 
     /**
      * Evaluate derivatives of the shape function at the given point
@@ -38,7 +37,7 @@ public:
      * @param [out] dN   a matrix of the derivatives
      */
     template <class T_X, class T_N>
-    static void computeGradShapeFunction(const T_X &r, T_N &dN);
+    static void computeGradShapeFunction(const T_X& r, T_N& dN);
 
     using MeshElement = MeshLib::Tet10;
     static const unsigned DIM = MeshElement::dimension;
diff --git a/NumLib/Fem/ShapeFunction/ShapeTet4-impl.h b/NumLib/Fem/ShapeFunction/ShapeTet4-impl.h
index 6549a1fa09a4feef41184f4522409415979c77fb..29f4cad6029f914da31d2d8b1768b930ab64b509 100644
--- a/NumLib/Fem/ShapeFunction/ShapeTet4-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapeTet4-impl.h
@@ -10,9 +10,8 @@
 
 namespace NumLib
 {
-
 template <class T_X, class T_N>
-void ShapeTet4::computeShapeFunction(const T_X &r, T_N &N)
+void ShapeTet4::computeShapeFunction(const T_X& r, T_N& N)
 {
     N[0] = 1. - r[0] - r[1] - r[2];
     N[1] = r[0];
@@ -21,21 +20,21 @@ void ShapeTet4::computeShapeFunction(const T_X &r, T_N &N)
 }
 
 template <class T_X, class T_N>
-void ShapeTet4::computeGradShapeFunction(const T_X &/*r*/, T_N &dNdr)
+void ShapeTet4::computeGradShapeFunction(const T_X& /*r*/, T_N& dNdr)
 {
-    //dr
+    // dr
     dNdr[0] = -1.0;
     dNdr[1] = 1.0;
     dNdr[2] = 0.0;
     dNdr[3] = 0.0;
 
-    //ds
+    // ds
     dNdr[4] = -1.0;
     dNdr[5] = 0.0;
     dNdr[6] = 1.0;
     dNdr[7] = 0.0;
 
-    //dt
+    // dt
     dNdr[8] = -1.0;
     dNdr[9] = 0.0;
     dNdr[10] = 0.0;
diff --git a/NumLib/Fem/ShapeFunction/ShapeTet4.h b/NumLib/Fem/ShapeFunction/ShapeTet4.h
index 8efe0f66868cc581775fadf392e8527f10f7692d..1b5189214034432a90e6640328c6e907c76f8782 100644
--- a/NumLib/Fem/ShapeFunction/ShapeTet4.h
+++ b/NumLib/Fem/ShapeFunction/ShapeTet4.h
@@ -14,7 +14,6 @@
 
 namespace NumLib
 {
-
 /**
  *  Shape function for a 4-nodes tetrahedral element
  */
@@ -28,7 +27,7 @@ public:
      * @param [out] N    a vector of calculated shape function.
      */
     template <class T_X, class T_N>
-    static void computeShapeFunction(const T_X &r, T_N &N);
+    static void computeShapeFunction(const T_X& r, T_N& N);
 
     /**
      * Evaluate derivatives of the shape function at the given point
@@ -38,7 +37,7 @@ public:
      * @param [out] dN   a matrix of the derivatives
      */
     template <class T_X, class T_N>
-    static void computeGradShapeFunction(const T_X &r, T_N &dN);
+    static void computeGradShapeFunction(const T_X& r, T_N& dN);
 
     using MeshElement = MeshLib::Tet;
     static const unsigned DIM = MeshElement::dimension;
diff --git a/NumLib/Fem/ShapeFunction/ShapeTri3-impl.h b/NumLib/Fem/ShapeFunction/ShapeTri3-impl.h
index 2ef4ea1bd8d1b90edcd08104cb5f1a715cbd67f9..34663b3c558a1c8ec34b8f4f0f16faaf734b91b3 100644
--- a/NumLib/Fem/ShapeFunction/ShapeTri3-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapeTri3-impl.h
@@ -14,9 +14,8 @@
 
 namespace NumLib
 {
-
 template <class T_X, class T_N>
-void ShapeTri3::computeShapeFunction(const T_X &r, T_N &N)
+void ShapeTri3::computeShapeFunction(const T_X& r, T_N& N)
 {
     N[0] = 1. - r[0] - r[1];
     N[1] = r[0];
@@ -24,13 +23,13 @@ void ShapeTri3::computeShapeFunction(const T_X &r, T_N &N)
 }
 
 template <class T_X, class T_N>
-void ShapeTri3::computeGradShapeFunction(const T_X &/*r*/, T_N &dN)
+void ShapeTri3::computeGradShapeFunction(const T_X& /*r*/, T_N& dN)
 {
-    //dN/dr
+    // dN/dr
     dN[0] = -1.0;
-    dN[1] =  1.0;
-    dN[2] =  0.0;
-    //dN/ds
+    dN[1] = 1.0;
+    dN[2] = 0.0;
+    // dN/ds
     dN[3] = -1.0;
     dN[4] = 0.0;
     dN[5] = 1.0;
diff --git a/NumLib/Fem/ShapeFunction/ShapeTri3.h b/NumLib/Fem/ShapeFunction/ShapeTri3.h
index d83232592ce0c974133349723f22c0a2f213bcb3..3525987c7a0f2347343de6abfc54678e6c9570ad 100644
--- a/NumLib/Fem/ShapeFunction/ShapeTri3.h
+++ b/NumLib/Fem/ShapeFunction/ShapeTri3.h
@@ -18,7 +18,6 @@
 
 namespace NumLib
 {
-
 /**
  *  Shape function for a triangle element of three nodes in natural coordinates
  *
@@ -40,7 +39,7 @@ public:
      * @param [out] N    a vector of calculated shape function.
      */
     template <class T_X, class T_N>
-    static void computeShapeFunction(const T_X &r, T_N &N);
+    static void computeShapeFunction(const T_X& r, T_N& N);
 
     /**
      * Evaluate derivatives of the shape function at the given point
@@ -50,7 +49,7 @@ public:
      * @param [out] dN   a matrix of the derivatives
      */
     template <class T_X, class T_N>
-    static void computeGradShapeFunction(const T_X &r, T_N &dN);
+    static void computeGradShapeFunction(const T_X& r, T_N& dN);
 
     using MeshElement = MeshLib::Tri;
     static const unsigned DIM = MeshElement::dimension;
diff --git a/NumLib/Fem/ShapeFunction/ShapeTri6-impl.h b/NumLib/Fem/ShapeFunction/ShapeTri6-impl.h
index f83f2b889629bb5e3b58f59b39d5d0885ce35f9a..c3fec31c5b068227a3560224090403224c59b44c 100644
--- a/NumLib/Fem/ShapeFunction/ShapeTri6-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapeTri6-impl.h
@@ -10,9 +10,8 @@
 
 namespace NumLib
 {
-
 template <class T_X, class T_N>
-void ShapeTri6::computeShapeFunction(const T_X &r, T_N &N)
+void ShapeTri6::computeShapeFunction(const T_X& r, T_N& N)
 {
     N[0] = 2. * (1. - r[0] - r[1]) * (0.5 - r[0] - r[1]);
     N[1] = r[0] * (2. * r[0] - 1.);
@@ -23,25 +22,25 @@ void ShapeTri6::computeShapeFunction(const T_X &r, T_N &N)
 }
 
 template <class T_X, class T_N>
-void ShapeTri6::computeGradShapeFunction(const T_X &r, T_N &dNdr)
+void ShapeTri6::computeGradShapeFunction(const T_X& r, T_N& dNdr)
 {
-    dNdr[0] = 4. * (r[0] + r[1]) - 3.;     // dN1/dL1
-    dNdr[6] = dNdr[0];                     // dN1/dL2
+    dNdr[0] = 4. * (r[0] + r[1]) - 3.;  // dN1/dL1
+    dNdr[6] = dNdr[0];                  // dN1/dL2
 
-    dNdr[1] = 4. * r[0] - 1.;              // dN2/dL1
-    dNdr[7] = 0.;                          // dN2/dL2
+    dNdr[1] = 4. * r[0] - 1.;  // dN2/dL1
+    dNdr[7] = 0.;              // dN2/dL2
 
-    dNdr[2] = 0.;                          // dN3/dL1
-    dNdr[8] = 4. * r[1] - 1.;              // dN3/dL2
+    dNdr[2] = 0.;              // dN3/dL1
+    dNdr[8] = 4. * r[1] - 1.;  // dN3/dL2
 
-    dNdr[3] =  4. * (1 - 2. * r[0] - r[1]); // dN4/dL1
-    dNdr[9] = -4. * r[0];                  // dN4/dL2
+    dNdr[3] = 4. * (1 - 2. * r[0] - r[1]);  // dN4/dL1
+    dNdr[9] = -4. * r[0];                   // dN4/dL2
 
-    dNdr[4] = 4. * r[1];                   // dN5/dL1
-    dNdr[10] = -dNdr[9];                   // dN5/dL2
+    dNdr[4] = 4. * r[1];  // dN5/dL1
+    dNdr[10] = -dNdr[9];  // dN5/dL2
 
-    dNdr[5] = -dNdr[4];                  // dN6/dL1
-    dNdr[11] = 4. * (1 - r[0] - 2. * r[1]); // dN6/dL2
+    dNdr[5] = -dNdr[4];                      // dN6/dL1
+    dNdr[11] = 4. * (1 - r[0] - 2. * r[1]);  // dN6/dL2
 }
 
 }  // namespace NumLib
diff --git a/NumLib/Fem/ShapeFunction/ShapeTri6.h b/NumLib/Fem/ShapeFunction/ShapeTri6.h
index 23691b3ff29f4cb87118260ee11d3b0869025b79..26bb311519bd8818e318bf9ae63f22e94ce16985 100644
--- a/NumLib/Fem/ShapeFunction/ShapeTri6.h
+++ b/NumLib/Fem/ShapeFunction/ShapeTri6.h
@@ -14,7 +14,6 @@
 
 namespace NumLib
 {
-
 /**
  *  Shape function for a 6-nodes triangle element
  *
@@ -29,7 +28,7 @@ public:
      * @param [out] N    a vector of calculated shape function.
      */
     template <class T_X, class T_N>
-    static void computeShapeFunction(const T_X &r, T_N &N);
+    static void computeShapeFunction(const T_X& r, T_N& N);
 
     /**
      * Evaluate derivatives of the shape function at the given point
@@ -39,7 +38,7 @@ public:
      * @param [out] dN   a matrix of the derivatives
      */
     template <class T_X, class T_N>
-    static void computeGradShapeFunction(const T_X &r, T_N &dN);
+    static void computeGradShapeFunction(const T_X& r, T_N& dN);
 
     using MeshElement = MeshLib::Tri6;
     static const unsigned DIM = MeshElement::dimension;
diff --git a/NumLib/Fem/ShapeMatrixPolicy.h b/NumLib/Fem/ShapeMatrixPolicy.h
index c02817a2824de1507e88ee0917c224c89986cbe9..e0a7e212ed6735f1aeca6397d0c89501b9508303 100644
--- a/NumLib/Fem/ShapeMatrixPolicy.h
+++ b/NumLib/Fem/ShapeMatrixPolicy.h
@@ -10,45 +10,47 @@
 
 #pragma once
 
-#include "NumLib/Fem/CoordinatesMapping/ShapeMatrices.h"
-
 #include <Eigen/Dense>
 
+#include "NumLib/Fem/CoordinatesMapping/ShapeMatrices.h"
+
 namespace detail
 {
-    /// Forwards the Eigen::Matrix type for general N and M.
-    /// There is a partial specialization for M = 1 to store the matrix in
-    /// column major storage order.
-    template <int N, int M>
-    struct EigenMatrixType
-    {
-        using type = Eigen::Matrix<double, N, M, Eigen::RowMajor>;
-    };
+/// Forwards the Eigen::Matrix type for general N and M.
+/// There is a partial specialization for M = 1 to store the matrix in
+/// column major storage order.
+template <int N, int M>
+struct EigenMatrixType
+{
+    using type = Eigen::Matrix<double, N, M, Eigen::RowMajor>;
+};
 
-    /// Specialization for Nx1 matrices which can be stored only in column major
-    /// form in Eigen-3.2.5.
-    template <int N>
-    struct EigenMatrixType<N, 1>
-    {
-        using type = Eigen::Matrix<double, N, 1, Eigen::ColMajor>;
-    };
-
-    /// Specialization for 0xM matrices. Using fixed size Eigen matrices here
-    /// would lead to zero sized arrays, which cause compilation errors on
-    /// some compilers.
-    template <int M>
-    struct EigenMatrixType<0, M>
-    {
-        using type = Eigen::Matrix<double, Eigen::Dynamic, Eigen::Dynamic, Eigen::RowMajor>;
-    };
-
-    template <>
-    struct EigenMatrixType<0, 1>
-    {
-        using type = Eigen::Matrix<double, Eigen::Dynamic, Eigen::Dynamic, Eigen::ColMajor>;
-    };
-
-    }  // namespace detail
+/// Specialization for Nx1 matrices which can be stored only in column major
+/// form in Eigen-3.2.5.
+template <int N>
+struct EigenMatrixType<N, 1>
+{
+    using type = Eigen::Matrix<double, N, 1, Eigen::ColMajor>;
+};
+
+/// Specialization for 0xM matrices. Using fixed size Eigen matrices here
+/// would lead to zero sized arrays, which cause compilation errors on
+/// some compilers.
+template <int M>
+struct EigenMatrixType<0, M>
+{
+    using type =
+        Eigen::Matrix<double, Eigen::Dynamic, Eigen::Dynamic, Eigen::RowMajor>;
+};
+
+template <>
+struct EigenMatrixType<0, 1>
+{
+    using type =
+        Eigen::Matrix<double, Eigen::Dynamic, Eigen::Dynamic, Eigen::ColMajor>;
+};
+
+}  // namespace detail
 
 /// An implementation of ShapeMatrixPolicy using fixed size (compile-time) eigen
 /// matrices and vectors.
@@ -64,21 +66,21 @@ struct EigenFixedShapeMatrixPolicy
     template <int N, int M>
     using MatrixType = typename ::detail::EigenMatrixType<N, M>::type;
 
-    using NodalMatrixType = MatrixType<ShapeFunction::NPOINTS, ShapeFunction::NPOINTS>;
+    using NodalMatrixType =
+        MatrixType<ShapeFunction::NPOINTS, ShapeFunction::NPOINTS>;
     using NodalVectorType = VectorType<ShapeFunction::NPOINTS>;
     using NodalRowVectorType = RowVectorType<ShapeFunction::NPOINTS>;
-    using DimNodalMatrixType = MatrixType<ShapeFunction::DIM, ShapeFunction::NPOINTS>;
+    using DimNodalMatrixType =
+        MatrixType<ShapeFunction::DIM, ShapeFunction::NPOINTS>;
     using DimMatrixType = MatrixType<ShapeFunction::DIM, ShapeFunction::DIM>;
-    using GlobalDimNodalMatrixType = MatrixType<GlobalDim, ShapeFunction::NPOINTS>;
+    using GlobalDimNodalMatrixType =
+        MatrixType<GlobalDim, ShapeFunction::NPOINTS>;
     using GlobalDimMatrixType = MatrixType<GlobalDim, GlobalDim>;
     using GlobalDimVectorType = VectorType<GlobalDim>;
 
     using ShapeMatrices =
-        NumLib::ShapeMatrices<
-            NodalRowVectorType,
-            DimNodalMatrixType,
-            DimMatrixType,
-            GlobalDimNodalMatrixType>;
+        NumLib::ShapeMatrices<NodalRowVectorType, DimNodalMatrixType,
+                              DimMatrixType, GlobalDimNodalMatrixType>;
 };
 
 /// An implementation of ShapeMatrixPolicy using dynamic size eigen matrices and
@@ -89,46 +91,43 @@ struct EigenDynamicShapeMatrixPolicy
     // Dynamic size local matrices are much slower in allocation than their
     // fixed counterparts.
 
-    template<int>
-    using VectorType =
-        Eigen::Matrix<double, Eigen::Dynamic, 1>;
+    template <int>
+    using VectorType = Eigen::Matrix<double, Eigen::Dynamic, 1>;
 
-    template<int>
-    using RowVectorType =
-        Eigen::Matrix<double, 1, Eigen::Dynamic>;
+    template <int>
+    using RowVectorType = Eigen::Matrix<double, 1, Eigen::Dynamic>;
 
-    template<int, int>
+    template <int, int>
     using MatrixType =
         Eigen::Matrix<double, Eigen::Dynamic, Eigen::Dynamic, Eigen::RowMajor>;
 
-    using NodalMatrixType = MatrixType<0,0>;
+    using NodalMatrixType = MatrixType<0, 0>;
     using NodalVectorType = VectorType<0>;
     using NodalRowVectorType = RowVectorType<0>;
-    using DimNodalMatrixType = MatrixType<0,0>;
-    using DimMatrixType = MatrixType<0,0>;
-    using GlobalDimNodalMatrixType = MatrixType<0,0>;
-    using GlobalDimMatrixType = MatrixType<0,0>;
+    using DimNodalMatrixType = MatrixType<0, 0>;
+    using DimMatrixType = MatrixType<0, 0>;
+    using GlobalDimNodalMatrixType = MatrixType<0, 0>;
+    using GlobalDimMatrixType = MatrixType<0, 0>;
     using GlobalDimVectorType = VectorType<0>;
 
     using ShapeMatrices =
-        NumLib::ShapeMatrices<
-            NodalRowVectorType,
-            DimNodalMatrixType,
-            DimMatrixType,
-            GlobalDimNodalMatrixType>;
+        NumLib::ShapeMatrices<NodalRowVectorType, DimNodalMatrixType,
+                              DimMatrixType, GlobalDimNodalMatrixType>;
 };
 
 #ifdef OGS_EIGEN_DYNAMIC_SHAPE_MATRICES
 template <typename ShapeFunction, unsigned GlobalDim>
-using ShapeMatrixPolicyType = EigenDynamicShapeMatrixPolicy<ShapeFunction, GlobalDim>;
+using ShapeMatrixPolicyType =
+    EigenDynamicShapeMatrixPolicy<ShapeFunction, GlobalDim>;
 
 const unsigned OGS_EIGEN_DYNAMIC_SHAPE_MATRICES_FLAG = 1;
 #else
 template <typename ShapeFunction, unsigned GlobalDim>
-using ShapeMatrixPolicyType = EigenFixedShapeMatrixPolicy<ShapeFunction, GlobalDim>;
+using ShapeMatrixPolicyType =
+    EigenFixedShapeMatrixPolicy<ShapeFunction, GlobalDim>;
 
 const unsigned OGS_EIGEN_DYNAMIC_SHAPE_MATRICES_FLAG = 0;
 #endif
 
-//static_assert(std::is_class<ShapeMatrixPolicyType<>::value,
-        //"ShapeMatrixPolicyType was not defined.");
+// static_assert(std::is_class<ShapeMatrixPolicyType<>::value,
+//"ShapeMatrixPolicyType was not defined.");
diff --git a/NumLib/Function/ISpatialFunction.h b/NumLib/Function/ISpatialFunction.h
index 5fd1aa97e23d061cff1ab59f2ddc1b9cf2e4abc8..2a4baa27c064615a4dcfab293f79056ad9345134 100644
--- a/NumLib/Function/ISpatialFunction.h
+++ b/NumLib/Function/ISpatialFunction.h
@@ -18,9 +18,9 @@
 
 namespace NumLib
 {
-
 /**
- * \brief Interface class for any functions of spatial coordinates \f$f(x,y,z)\f$
+ * \brief Interface class for any functions of spatial coordinates
+ * \f$f(x,y,z)\f$
  */
 class ISpatialFunction
 {
diff --git a/NumLib/Function/Interpolation.h b/NumLib/Function/Interpolation.h
index b41c30eb7d41fe03f49393a3ace4b0d3a001a51b..105c0047013bb2571506ff3d2d9121b9a3e70ba2 100644
--- a/NumLib/Function/Interpolation.h
+++ b/NumLib/Function/Interpolation.h
@@ -19,74 +19,78 @@
 
 namespace NumLib
 {
-
 namespace detail
 {
-
 //! \see ::NumLib::shapeFunctionInterpolate()
-template<unsigned DOFOffset, typename NodalValues, typename ShapeMatrix>
-void shapeFunctionInterpolate(
-        const NodalValues &/*nodal_values*/,
-        const ShapeMatrix &/*shape_matrix_N*/)
-{}
+template <unsigned DOFOffset, typename NodalValues, typename ShapeMatrix>
+void shapeFunctionInterpolate(const NodalValues& /*nodal_values*/,
+                              const ShapeMatrix& /*shape_matrix_N*/)
+{
+}
 
 //! \see ::NumLib::shapeFunctionInterpolate()
-template<unsigned DOFOffset, typename NodalValues, typename ShapeMatrix, typename... ScalarTypes>
-void shapeFunctionInterpolate(
-        const NodalValues &nodal_values,
-        const ShapeMatrix &shape_matrix_N,
-        double& interpolated_value,
-        ScalarTypes&... interpolated_values)
+template <unsigned DOFOffset, typename NodalValues, typename ShapeMatrix,
+          typename... ScalarTypes>
+void shapeFunctionInterpolate(const NodalValues& nodal_values,
+                              const ShapeMatrix& shape_matrix_N,
+                              double& interpolated_value,
+                              ScalarTypes&... interpolated_values)
 {
     auto const num_nodes = shape_matrix_N.size();
     double iv = 0.0;
 
-    for (auto n=decltype(num_nodes){0}; n<num_nodes; ++n) {
-        iv += nodal_values[DOFOffset*num_nodes+n] * shape_matrix_N[n];
+    for (auto n = decltype(num_nodes){0}; n < num_nodes; ++n)
+    {
+        iv += nodal_values[DOFOffset * num_nodes + n] * shape_matrix_N[n];
     }
 
     interpolated_value = iv;
 
-    shapeFunctionInterpolate<DOFOffset+1>(nodal_values, shape_matrix_N, interpolated_values...);
+    shapeFunctionInterpolate<DOFOffset + 1>(nodal_values, shape_matrix_N,
+                                            interpolated_values...);
 }
 
-} // namespace detail
+}  // namespace detail
 
 /*!
- * Interpolates variables given at element nodes according to the given shape matrix.
+ * Interpolates variables given at element nodes according to the given shape
+ * matrix.
  *
- * This function simply does the usual finite-element interpolation, i.e. multiplication
- * of nodal values with the shape function.
+ * This function simply does the usual finite-element interpolation, i.e.
+ * multiplication of nodal values with the shape function.
  *
  * \param nodal_values vector of nodal values, ordered by component
  * \param shape_matrix_N shape matrix of the point to which will be interpolated
- * \param interpolated_value interpolated value of the first d.o.f. (output parameter)
- * \param interpolated_values interpolated value of further d.o.f. (output parameter)
+ * \param interpolated_value interpolated value of the first d.o.f. (output
+ * parameter) \param interpolated_values interpolated value of further d.o.f.
+ * (output parameter)
  *
  * \tparam NodalValues  type of the container where nodal values are stored
  * \tparam ShapeMatrix  type of the shape matrix \f$N\f$.
- * \tparam ScalarValues all of the types in this pack must currently be \c double.
+ * \tparam ScalarValues all of the types in this pack must currently be \c
+ * double.
  *
  * \note
- * \c nodal_values have to be ordered by component and it is assumed that all passed d.o.f. are
- * single-component and are interpolated using the same shape function.
+ * \c nodal_values have to be ordered by component and it is assumed that all
+ * passed d.o.f. are single-component and are interpolated using the same shape
+ * function.
  */
-template<typename NodalValues, typename ShapeMatrix, typename... ScalarTypes>
-void shapeFunctionInterpolate(
-        const NodalValues& nodal_values,
-        const ShapeMatrix& shape_matrix_N,
-        double& interpolated_value,
-        ScalarTypes&... interpolated_values
-        )
+template <typename NodalValues, typename ShapeMatrix, typename... ScalarTypes>
+void shapeFunctionInterpolate(const NodalValues& nodal_values,
+                              const ShapeMatrix& shape_matrix_N,
+                              double& interpolated_value,
+                              ScalarTypes&... interpolated_values)
 {
     auto const num_nodal_dof = sizeof...(interpolated_values) + 1;
     auto const num_nodes = shape_matrix_N.size();
 
     assert(num_nodes * num_nodal_dof ==
            static_cast<std::size_t>(nodal_values.size()));
-    (void) num_nodal_dof; (void) num_nodes; // no warnings when not in debug build
+    (void)num_nodal_dof;
+    (void)num_nodes;  // no warnings when not in debug build
 
-    detail::shapeFunctionInterpolate<0>(nodal_values, shape_matrix_N, interpolated_value,
+    detail::shapeFunctionInterpolate<0>(nodal_values, shape_matrix_N,
+                                        interpolated_value,
                                         interpolated_values...);
 }
 
@@ -149,4 +153,4 @@ void interpolateToHigherOrderNodes(
     }
 }
 
-} // namespace NumLib
+}  // namespace NumLib
diff --git a/NumLib/IndexValueVector.h b/NumLib/IndexValueVector.h
index 96ad08ff6357e87038cba4ffec4f593795ea2942..993f608f8fdb9bb50225083c37aaa41bf93bfe17 100644
--- a/NumLib/IndexValueVector.h
+++ b/NumLib/IndexValueVector.h
@@ -14,7 +14,6 @@
 
 namespace NumLib
 {
-
 template <typename IndexType>
 struct IndexValueVector final
 {
diff --git a/NumLib/ODESolver/ConvergenceCriterion.h b/NumLib/ODESolver/ConvergenceCriterion.h
index 0c09352ff0a6ae5a35d266d51556e3573b1b48dc..2197dcf7c14d96d404a2f809b072bb43d99022e5 100644
--- a/NumLib/ODESolver/ConvergenceCriterion.h
+++ b/NumLib/ODESolver/ConvergenceCriterion.h
@@ -11,12 +11,14 @@
 #pragma once
 
 #include <memory>
+
 #include "MathLib/LinAlg/LinAlg.h"  // For MathLib::VecNormType
 #include "NumLib/NumericsConfig.h"
 
-namespace BaseLib {
+namespace BaseLib
+{
 class ConfigTree;
-}  // BaseLib
+}  // namespace BaseLib
 
 namespace NumLib
 {
@@ -78,7 +80,11 @@ public:
     //! to be done anew. This method will make the ConvergenceCriterion forget
     //! the result of all checks already done, s.t. all necessary checks will
     //! have to be repeated in order to satisfy the ConvergenceCriterion.
-    virtual void reset() { _satisfied = true; _is_first_iteration = false; };
+    virtual void reset()
+    {
+        _satisfied = true;
+        _is_first_iteration = false;
+    };
 
     //! Tell if the convergence criterion is satisfied.
     virtual bool isSatisfied() const { return _satisfied; };
@@ -104,4 +110,4 @@ bool checkRelativeTolerance(double const reltol,
                             double const numerator,
                             double const denominator);
 
-} // namespace NumLib
+}  // namespace NumLib
diff --git a/NumLib/ODESolver/ConvergenceCriterionDeltaX.h b/NumLib/ODESolver/ConvergenceCriterionDeltaX.h
index 89d80301404332cde2bdf3cd52825805b012a023..c5093f7dd444ff7380cf90b7382fc93d7aa2ad0e 100644
--- a/NumLib/ODESolver/ConvergenceCriterionDeltaX.h
+++ b/NumLib/ODESolver/ConvergenceCriterionDeltaX.h
@@ -38,6 +38,7 @@ public:
     void checkResidual(const GlobalVector& /*residual*/) override {}
 
     void reset() override { this->_satisfied = true; }
+
 private:
     const std::optional<double> _abstol;
     const std::optional<double> _reltol;
diff --git a/NumLib/ODESolver/ConvergenceCriterionPerComponent.h b/NumLib/ODESolver/ConvergenceCriterionPerComponent.h
index 6a36f5b07d16bf3883b9d713ca7f1e6913d38340..995e146cb061014be68dd74ccdae427005df97c3 100644
--- a/NumLib/ODESolver/ConvergenceCriterionPerComponent.h
+++ b/NumLib/ODESolver/ConvergenceCriterionPerComponent.h
@@ -11,7 +11,6 @@
 #pragma once
 
 #include "ConvergenceCriterion.h"
-
 #include "MathLib/LinAlg/LinAlg.h"  // For MathLib::VecNormType
 
 namespace MeshLib
diff --git a/NumLib/ODESolver/ConvergenceCriterionPerComponentDeltaX.h b/NumLib/ODESolver/ConvergenceCriterionPerComponentDeltaX.h
index 1d2f51dbcda63d3ccd9f4600d0363242c101379b..dbe7626e81c3739a5d0daf9ed29aa78f1ca0f024 100644
--- a/NumLib/ODESolver/ConvergenceCriterionPerComponentDeltaX.h
+++ b/NumLib/ODESolver/ConvergenceCriterionPerComponentDeltaX.h
@@ -10,8 +10,8 @@
 
 #pragma once
 
-#include "MathLib/LinAlg/LinAlgEnums.h"
 #include "ConvergenceCriterionPerComponent.h"
+#include "MathLib/LinAlg/LinAlgEnums.h"
 
 namespace NumLib
 {
diff --git a/NumLib/ODESolver/ConvergenceCriterionPerComponentResidual.cpp b/NumLib/ODESolver/ConvergenceCriterionPerComponentResidual.cpp
index 29cf5ea453bdf07d1a8ca4c4163e5eee69f0ad22..2e6e47ed1cc66d6c6e9ea8efc9a888c56045ba66 100644
--- a/NumLib/ODESolver/ConvergenceCriterionPerComponentResidual.cpp
+++ b/NumLib/ODESolver/ConvergenceCriterionPerComponentResidual.cpp
@@ -107,7 +107,6 @@ void ConvergenceCriterionPerComponentResidual::checkResidual(
                                    _residual_norms_0[global_component]);
         _satisfied = _satisfied && (satisfied_abs || satisfied_rel);
     }
-
 }
 
 void ConvergenceCriterionPerComponentResidual::setDOFTable(
diff --git a/NumLib/ODESolver/ConvergenceCriterionPerComponentResidual.h b/NumLib/ODESolver/ConvergenceCriterionPerComponentResidual.h
index 1d8518dacdd4d2219e239e5472d77a5dfd6cbd1d..e6713711e5d8fbf2235988b32e175af69066a5bb 100644
--- a/NumLib/ODESolver/ConvergenceCriterionPerComponentResidual.h
+++ b/NumLib/ODESolver/ConvergenceCriterionPerComponentResidual.h
@@ -11,8 +11,9 @@
 #pragma once
 
 #include <vector>
-#include "MathLib/LinAlg/LinAlgEnums.h"
+
 #include "ConvergenceCriterionPerComponent.h"
+#include "MathLib/LinAlg/LinAlgEnums.h"
 
 namespace NumLib
 {
diff --git a/NumLib/ODESolver/ConvergenceCriterionResidual.h b/NumLib/ODESolver/ConvergenceCriterionResidual.h
index dd402f1afd56d984a3dae9d95e404ba0dad24fd3..89245cc964c4e3a9b3ef3e0b750150217c81a87b 100644
--- a/NumLib/ODESolver/ConvergenceCriterionResidual.h
+++ b/NumLib/ODESolver/ConvergenceCriterionResidual.h
@@ -45,7 +45,7 @@ private:
     double _residual_norm_0;
 };
 
-std::unique_ptr<ConvergenceCriterionResidual> createConvergenceCriterionResidual(
-    BaseLib::ConfigTree const& config);
+std::unique_ptr<ConvergenceCriterionResidual>
+createConvergenceCriterionResidual(BaseLib::ConfigTree const& config);
 
 }  // namespace NumLib
diff --git a/NumLib/ODESolver/MatrixTranslator.h b/NumLib/ODESolver/MatrixTranslator.h
index 1fa3351eec50cf430fae77a91c324024a19b3546..11a4d79b569cfeb1d8570310507826e75885d303 100644
--- a/NumLib/ODESolver/MatrixTranslator.h
+++ b/NumLib/ODESolver/MatrixTranslator.h
@@ -12,11 +12,10 @@
 
 #include <memory>
 
+#include "MathLib/LinAlg/LinAlg.h"
 #include "TimeDiscretization.h"
 #include "Types.h"
 
-#include "MathLib/LinAlg/LinAlg.h"
-
 namespace NumLib
 {
 //! \addtogroup ODESolver
@@ -32,7 +31,8 @@ template <ODESystemTag ODETag>
 class MatrixTranslator;
 
 /*! Translates matrices assembled by a provided first order implicit
- * quasi-linear ODE to some other matrices suitable to be passed on to nonlinear solvers.
+ * quasi-linear ODE to some other matrices suitable to be passed on to nonlinear
+ * solvers.
  *
  * \see ODESystemTag::FirstOrderImplicitQuasilinear
  */
@@ -107,8 +107,7 @@ public:
 
     //! Computes \f$ r = M \cdot \hat x + K \cdot x_C - b \f$.
     void computeResidual(GlobalMatrix const& M, GlobalMatrix const& K,
-                         GlobalVector const& b,
-                         GlobalVector const& x_curr,
+                         GlobalVector const& b, GlobalVector const& x_curr,
                          GlobalVector const& xdot,
                          GlobalVector& res) const override;
 
@@ -118,8 +117,7 @@ public:
                          GlobalMatrix& Jac_out) const override;
 
 private:
-    TimeDiscretization const&
-        _time_disc;  //!< the time discretization used.
+    TimeDiscretization const& _time_disc;  //!< the time discretization used.
 
     //! ID of the vector storing intermediate computations.
     mutable std::size_t _tmp_id = 0u;
diff --git a/NumLib/ODESolver/NonlinearSolver.h b/NumLib/ODESolver/NonlinearSolver.h
index 183368e2fab9625256ab12f3d5802f4179a1c9a9..d991019d7ea0f8c29eee1a9d70babff920faac9d 100644
--- a/NumLib/ODESolver/NonlinearSolver.h
+++ b/NumLib/ODESolver/NonlinearSolver.h
@@ -212,8 +212,8 @@ private:
     const int _maxiter;  //!< maximum number of iterations
 
     GlobalVector* _r_neq = nullptr;  //!< non-equilibrium initial residuum.
-    std::size_t _A_id = 0u;      //!< ID of the \f$ A \f$ matrix.
-    std::size_t _rhs_id = 0u;    //!< ID of the right-hand side vector.
+    std::size_t _A_id = 0u;          //!< ID of the \f$ A \f$ matrix.
+    std::size_t _rhs_id = 0u;        //!< ID of the right-hand side vector.
     std::size_t _x_new_id = 0u;  //!< ID of the vector storing the solution of
                                  //! the linearized equation.
     std::size_t _r_neq_id = 0u;  //!< ID of the non-equilibrium initial
@@ -236,9 +236,8 @@ private:
  *         the Picard or Newton-Raphson method
  */
 std::pair<std::unique_ptr<NonlinearSolverBase>, NonlinearSolverTag>
-createNonlinearSolver(
-    GlobalLinearSolver& linear_solver,
-    BaseLib::ConfigTree const& config);
+createNonlinearSolver(GlobalLinearSolver& linear_solver,
+                      BaseLib::ConfigTree const& config);
 
 //! @}
 
diff --git a/NumLib/ODESolver/ODESolver.dox b/NumLib/ODESolver/ODESolver.dox
index 88622e5c97282cc58c19605d110321742400a375..b85ea34f41efc99538f0e4a10ddf29cc77d04dac 100644
--- a/NumLib/ODESolver/ODESolver.dox
+++ b/NumLib/ODESolver/ODESolver.dox
@@ -1,41 +1,57 @@
 /*! \defgroup ODESolver ODE Solver Library
 
-This ODE solver library has been designed with an implicit first-order quasilinear ODE in mind.
-However, it is in principle not restricted to such a kind of equation, but can be extended
-to also solve other equation types.
-In particular it is possible to introduce equation types that are no ODEs, but are nonlinear equations without time derivative terms.
-
-The aim of the library's design is being able to formulate FEM processes without having to care which time discretization scheme and which nonlinear iteration method will be used to solve it.
-
-The library offers different time discretization schemes, cf. \ref concept_time_discretization "the conceputal remarks on them",
-namely the forward and backward Euler and Crank-Nicolson methods and Backward Differentiation Formulas.
-The design follows Gear's method, which also underlies the DASSL algorithm of
-Petzold et al., cf. Differential-algebraic equations article, section
-[Numerical methods/Direct discretization]
+This ODE solver library has been designed with an implicit first-order
+quasilinear ODE in mind. However, it is in principle not restricted to such a
+kind of equation, but can be extended to also solve other equation types. In
+particular it is possible to introduce equation types that are no ODEs, but are
+nonlinear equations without time derivative terms.
+
+The aim of the library's design is being able to formulate FEM processes without
+having to care which time discretization scheme and which nonlinear iteration
+method will be used to solve it.
+
+The library offers different time discretization schemes, cf. \ref
+concept_time_discretization "the conceputal remarks on them", namely the forward
+and backward Euler and Crank-Nicolson methods and Backward Differentiation
+Formulas. The design follows Gear's method, which also underlies the DASSL
+algorithm of Petzold et al., cf. Differential-algebraic equations article,
+section [Numerical methods/Direct discretization]
 (http://www.scholarpedia.org/article/Differential-algebraic_equations#Numerical_methods.2FDirect_discretization)
 \cite Campbell:2008.
 
-A rough overview over the interplay between the various parts of this library is given in the image below.
-Therein red symbols indicate which classes \e own which matrices or vectors
-(for the meaning of the different symbols refer to the documentation of the respective classes).
-The word \e own should not be taken too strict in the sense of C++ member ownership, although currently it is implemented as such; but in the future this implementation detail might change.
-Rather \e own means that the class is in charge of the respective matrix or vector, i.e., it can read from and write to it or pass it on to functions;
-or in other words: The class knows about the meaning of that matrix/vector.
-Note that only matrices and vectors that describe some proper state of the respective classes are shown; those storing only intermediate computations have been omitted from the image.
-
-\image html  ode-solver-concept.png "Interplay of the different parts of the ODE solver library at the example of a first-order implicit quasilinear ODE."
-\image latex ode-solver-concept.pdf "Interplay of the different parts of the ODE solver library at the example of a first-order implicit quasilinear ODE."
-
-In the ODE solver library the instances of some classes can work together with several instances of other classes throughout there lifetime, whereas they have a strict one-to-one correspondence to objects of some different type.
-Those relations are given in the following table.
+A rough overview over the interplay between the various parts of this library is
+given in the image below. Therein red symbols indicate which classes \e own
+which matrices or vectors (for the meaning of the different symbols refer to the
+documentation of the respective classes). The word \e own should not be taken
+too strict in the sense of C++ member ownership, although currently it is
+implemented as such; but in the future this implementation detail might change.
+Rather \e own means that the class is in charge of the respective matrix or
+vector, i.e., it can read from and write to it or pass it on to functions; or in
+other words: The class knows about the meaning of that matrix/vector. Note that
+only matrices and vectors that describe some proper state of the respective
+classes are shown; those storing only intermediate computations have been
+omitted from the image.
+
+\image html  ode-solver-concept.png "Interplay of the different parts of the ODE
+solver library at the example of a first-order implicit quasilinear ODE." \image
+latex ode-solver-concept.pdf "Interplay of the different parts of the ODE solver
+library at the example of a first-order implicit quasilinear ODE."
+
+In the ODE solver library the instances of some classes can work together with
+several instances of other classes throughout there lifetime, whereas they have
+a strict one-to-one correspondence to objects of some different type. Those
+relations are given in the following table.
 
 Class 1                  | Class 2            | Relation | Remarks
 -----------------------: | :----------------- | :------: | :----------
-TimeDiscretizedODESystem | ODESystem          | 1:1      | the ODESystem represents part of the state of the TimeDiscretizedODESystem
-TimeDiscretizedODESystem | TimeDiscretization | 1:1      | analogous for the TimeDiscretization
-TimeDiscretizedODESystem | MatrixTranslator   | 1:1      | analogous for the MatrixTranslator
-NonlinearSolver          | NonlinearSystem    | 1:n      | a nonlinear solver can solve various equations, one after the other
-LinearSolver             | NonlinearSolver    | 1:n      | various NonlinearSolver's can share the same LinearSolver
+TimeDiscretizedODESystem | ODESystem          | 1:1      | the ODESystem
+represents part of the state of the TimeDiscretizedODESystem
+TimeDiscretizedODESystem | TimeDiscretization | 1:1      | analogous for the
+TimeDiscretization TimeDiscretizedODESystem | MatrixTranslator   | 1:1      |
+analogous for the MatrixTranslator NonlinearSolver          | NonlinearSystem |
+1:n      | a nonlinear solver can solve various equations, one after the other
+LinearSolver             | NonlinearSolver    | 1:n      | various
+NonlinearSolver's can share the same LinearSolver
 
 
 */
diff --git a/NumLib/ODESolver/ODESystem.h b/NumLib/ODESolver/ODESystem.h
index 9620dce5475eaa99a243fad4182b3c30d57ba368..14b412a05a74260f56087c787c710a96f4e8f518 100644
--- a/NumLib/ODESolver/ODESystem.h
+++ b/NumLib/ODESolver/ODESystem.h
@@ -10,10 +10,9 @@
 
 #pragma once
 
+#include "EquationSystem.h"
 #include "MathLib/LinAlg/MatrixVectorTraits.h"
 #include "NumLib/IndexValueVector.h"
-
-#include "EquationSystem.h"
 #include "Types.h"
 
 namespace NumLib
diff --git a/NumLib/ODESolver/TimeDiscretization.h b/NumLib/ODESolver/TimeDiscretization.h
index 0d8f9ecf0d23e2ce706ade6874a02267db2b5f18..f4ff55e926995151a3f627f05f06004725682a88 100644
--- a/NumLib/ODESolver/TimeDiscretization.h
+++ b/NumLib/ODESolver/TimeDiscretization.h
@@ -23,17 +23,18 @@ namespace NumLib
 
 /*! Interface of time discretization schemes for first-order ODEs.
  *
- * The purpose of TimeDiscretization instances is to store the solution history of
- * an ODE, i. e., to keep the solution at as many timestamps as is required by the
- * respective time discretization scheme. Furthermore, TimeDiscretization instances
- * compute the discretized approximation of the time derivative \f$ \partial x/\partial t \f$.
+ * The purpose of TimeDiscretization instances is to store the solution history
+ * of an ODE, i. e., to keep the solution at as many timestamps as is required
+ * by the respective time discretization scheme. Furthermore, TimeDiscretization
+ * instances compute the discretized approximation of the time derivative \f$
+ * \partial x/\partial t \f$.
  *
- * \note The method documentation of this class uses quantities introduced in the
- *       following section.
+ * \note The method documentation of this class uses quantities introduced in
+ * the following section.
  *
  * \todo Currently this interface does not yet support adaptive timestepping.
- *       While implementing that will lead to no changes for single-step methods,
- *       for multi-step methods this interface will have to be extended.
+ *       While implementing that will lead to no changes for single-step
+ * methods, for multi-step methods this interface will have to be extended.
  *
  *
  * Discretizing first-order ODEs {#concept_time_discretization}
@@ -49,8 +50,9 @@ namespace NumLib
  *
  * \f[ F(\hat x, x_C, t_C) \stackrel{!}{=} 0. \f]
  *
- * This interface has been designed with first-order implicit quasi-linear ODEs in mind.
- * They can be expressed as follows and are given here only to serve as an example.
+ * This interface has been designed with first-order implicit quasi-linear ODEs
+ * in mind. They can be expressed as follows and are given here only to serve as
+ * an example.
  *
  * \f[ M(x,t)\cdot \dot x + K(x,t) \cdot x - b(x,t)
  *  =: r(\dot x, x, t) \stackrel{!}{=} 0. \f]
@@ -61,27 +63,30 @@ namespace NumLib
  *  =: r(\hat x, x_C, t_C) \stackrel{!}{=} 0. \f]
  *
  * The meaning of indices for \f$ x \f$ and \f$ t \f$ is as follows:
- *   * \f$ C \f$ -- "Current": The values of \f$ x \f$ and \f$ t \f$ at which the discretized
- *                             ODE is being assembled.
- *   * \f$ N \f$ -- "New": The values of \f$ x \f$ and \f$ t \f$ at the new timestep that is
- *                         being calculated right now by the ODE solver.
- *   * \f$ O \f$ -- "Old": The results from the preceding time step (or a linear combination of
- *                         results of the preceding time steps in the case of multistep methods)
- *                         weighted by a scalar factor.
+ *   * \f$ C \f$ -- "Current": The values of \f$ x \f$ and \f$ t \f$ at which
+ * the discretized ODE is being assembled.
+ *   * \f$ N \f$ -- "New": The values of \f$ x \f$ and \f$ t \f$ at the new
+ * timestep that is being calculated right now by the ODE solver.
+ *   * \f$ O \f$ -- "Old": The results from the preceding time step (or a linear
+ * combination of results of the preceding time steps in the case of multistep
+ * methods) weighted by a scalar factor.
  *   * \f$ n \f$ -- Numerical index indicating the timestep.
  *
- * \f$ \hat x \f$ is the discrete approximation of \f$ \dot x := \partial x/\partial t\f$.
- * It is assumed that \f$ \hat x \f$ can be written in the following form:
- * \f[ \hat x = \alpha \cdot x_N - x_O, \f]
- * where \f$ \alpha := \partial \hat x / \partial x_N \f$ is a scalar.
- *
- * For different time discretization schemes \f$ x_C \f$, \f$ t_C \f$, \f$ x_N \f$,
- * \f$ x_O \f$ and \f$ \alpha \f$ take different values.
- * Those for the time implemented schemes are given in the table below.
- *
- * Scheme         | \f$ x_C \f$     | \f$ t_C \f$     | \f$ \alpha \f$        | \f$ x_N \f$     | \f$ x_O \f$
- * -------------- | --------------- | --------------- | --------------------- | --------------- | ----------------------
- * Backward Euler | \f$ x_{n+1} \f$ | \f$ t_{n+1} \f$ | \f$ 1/\Delta t \f$    | \f$ x_{n+1} \f$ | \f$ x_n / \Delta t \f$
+ * \f$ \hat x \f$ is the discrete approximation of \f$ \dot x := \partial
+ * x/\partial t\f$. It is assumed that \f$ \hat x \f$ can be written in the
+ * following form: \f[ \hat x = \alpha \cdot x_N - x_O, \f] where \f$ \alpha :=
+ * \partial \hat x / \partial x_N \f$ is a scalar.
+ *
+ * For different time discretization schemes \f$ x_C \f$, \f$ t_C \f$, \f$ x_N
+ * \f$, \f$ x_O \f$ and \f$ \alpha \f$ take different values. Those for the time
+ * implemented schemes are given in the table below.
+ *
+ * Scheme         | \f$ x_C \f$     | \f$ t_C \f$     | \f$ \alpha \f$        |
+ * \f$ x_N \f$     | \f$ x_O \f$
+ * -------------- | --------------- | --------------- | --------------------- |
+ * --------------- | ---------------------- Backward Euler | \f$ x_{n+1} \f$ |
+ * \f$ t_{n+1} \f$ | \f$ 1/\Delta t \f$    | \f$ x_{n+1} \f$ | \f$ x_n / \Delta
+ * t \f$
  *
  */
 class TimeDiscretization
diff --git a/NumLib/ODESolver/Types.h b/NumLib/ODESolver/Types.h
index 2fef43933a6b94afbfff037c4b392ab2368cf27f..cdd07cd1278bee472bbaf224f29012636c417ddd 100644
--- a/NumLib/ODESolver/Types.h
+++ b/NumLib/ODESolver/Types.h
@@ -12,12 +12,12 @@
 
 namespace NumLib
 {
-
 //! \addtogroup ODESolver
 //! @{
 
 //! Tag used to specify which nonlinear solver will be used.
-enum class NonlinearSolverTag : bool {
+enum class NonlinearSolverTag : bool
+{
     Picard /*!< Picard fixpoint iteration scheme */,
     Newton /*!< Newton-Raphson iteration scheme */
 };
@@ -32,9 +32,9 @@ enum class ODESystemTag : char
      *  =: r(\dot x, x, t) \stackrel{!}{=} 0 \f$
      */
     FirstOrderImplicitQuasilinear,
-    NeumannBC // Sure, that's misuse of this enum, so sue me!
+    NeumannBC  // Sure, that's misuse of this enum, so sue me!
 };
 
 //! @}
 
-} // namespace NumLib
+}  // namespace NumLib
diff --git a/NumLib/TimeStepping/CreateTimeStepper.h b/NumLib/TimeStepping/CreateTimeStepper.h
index bb198fd02af70037c5b10e77ffbdf8ed1d3bfbf7..a6d5b4436f8ddf7081b3543c05fe8ae11b5b182f 100644
--- a/NumLib/TimeStepping/CreateTimeStepper.h
+++ b/NumLib/TimeStepping/CreateTimeStepper.h
@@ -23,4 +23,4 @@ namespace NumLib
 class TimeStepAlgorithm;
 std::unique_ptr<TimeStepAlgorithm> createTimeStepper(
     BaseLib::ConfigTree const& config);
-};
+};  // namespace NumLib