diff --git a/Applications/ApplicationsLib/TestDefinition.cpp b/Applications/ApplicationsLib/TestDefinition.cpp
index 7c6c3b014e61a16ff685f32978e49f009eb7df35..ed09d59d6d92d5bde60225856ff92adacacdfe78 100644
--- a/Applications/ApplicationsLib/TestDefinition.cpp
+++ b/Applications/ApplicationsLib/TestDefinition.cpp
@@ -39,19 +39,21 @@ bool isConvertibleToDouble(std::string const& s)
     }
     catch (...)
     {
-        OGS_FATAL("The given string '{:s}' is not convertible to double.", s);
+        ERR("The given string '{:s}' is not convertible to double.", s);
+        return false;
     }
     if (pos != s.size())
     {
-        OGS_FATAL(
-            "Only {:d} characters were used for double conversion of string "
+        ERR("Only {:d} characters were used for double conversion of string "
             "'{:s}'",
             pos, s);
+        return false;
     }
 
     if (std::isnan(value))
     {
-        OGS_FATAL("The given string '{:s}' results in a NaN value.", s);
+        ERR("The given string '{:s}' results in a NaN value.", s);
+        return false;
     }
     return true;
 }
diff --git a/Applications/FileIO/PetrelInterface.cpp b/Applications/FileIO/PetrelInterface.cpp
index 38cd33578b613c4cefb862251e6b1c6680204ae8..53f7ab75ec24bea1184d81b4027e3763203aa71a 100644
--- a/Applications/FileIO/PetrelInterface.cpp
+++ b/Applications/FileIO/PetrelInterface.cpp
@@ -191,10 +191,10 @@ void PetrelInterface::readPetrelWellTrace(std::istream& in)
 
 void PetrelInterface::readPetrelWellTraceData(std::istream& in)
 {
-    std::string line = readLine(in);
+    readLine(in);
 
     // read yet another header line
-    line = readLine(in);
+    std::string line = readLine(in);
     while (line[0] == '#')
     {
         line = readLine(in);
diff --git a/ChemistryLib/CreateChemicalSolverInterface.cpp b/ChemistryLib/CreateChemicalSolverInterface.cpp
index 9da6a484ab594fbaa9cf3190f68d20c4285edea9..8ad2d0acc01bc295d681d6c247ec3336577daba9 100644
--- a/ChemistryLib/CreateChemicalSolverInterface.cpp
+++ b/ChemistryLib/CreateChemicalSolverInterface.cpp
@@ -91,7 +91,7 @@ createChemicalSolverInterface<ChemicalSolver::Phreeqc>(
     auto const ls_name =
         //! \ogs_file_param{prj__chemical_system__linear_solver}
         config.getConfigParameter<std::string>("linear_solver");
-    auto& linear_solver = BaseLib::getOrError(
+    auto const& linear_solver = BaseLib::getOrError(
         linear_solvers, ls_name,
         "A linear solver with the given name does not exist.");
 
diff --git a/ChemistryLib/PhreeqcKernel.cpp b/ChemistryLib/PhreeqcKernel.cpp
index 614b7a912a9fe70d19b5feb9910a20f8b717310c..b269c854d67686d57351d3bf0876ae27faebf3c9 100644
--- a/ChemistryLib/PhreeqcKernel.cpp
+++ b/ChemistryLib/PhreeqcKernel.cpp
@@ -144,9 +144,7 @@ void PhreeqcKernel::loadDatabase(std::string const& database)
 
 void PhreeqcKernel::reinitializeRates()
 {
-    count_rates = _reaction_rates.size();
-    rates = (struct rate*)realloc(
-        rates, (std::size_t)(count_rates) * sizeof(struct rate));
+    std::vector<struct rate> rates(_reaction_rates.size());
     int rate_id = 0;
     for (auto const& reaction_rate : _reaction_rates)
     {
diff --git a/ChemistryLib/PhreeqcKernelData/ReactionRate.cpp b/ChemistryLib/PhreeqcKernelData/ReactionRate.cpp
index 9375a7709e38764ebeae24ec8a3e3d9cc96085bc..c3f7a83329a33cacd9553c10bfac3b36ab7ab8a8 100644
--- a/ChemistryLib/PhreeqcKernelData/ReactionRate.cpp
+++ b/ChemistryLib/PhreeqcKernelData/ReactionRate.cpp
@@ -14,8 +14,8 @@ namespace ChemistryLib
 {
 namespace PhreeqcKernelData
 {
-ReactionRate::ReactionRate(
-    std::string kinetic_reactant_, std::vector<std::string> statements)
+ReactionRate::ReactionRate(std::string kinetic_reactant_,
+                           std::vector<std::string> const& statements)
     : kinetic_reactant(std::move(kinetic_reactant_))
 {
     int line_number = 1;
diff --git a/ChemistryLib/PhreeqcKernelData/ReactionRate.h b/ChemistryLib/PhreeqcKernelData/ReactionRate.h
index 0050de792267f7766e4c9f91f61b266c831a6d0b..796dc6ec6db5bef9c0d76389b7cac3a2e02a8c6d 100644
--- a/ChemistryLib/PhreeqcKernelData/ReactionRate.h
+++ b/ChemistryLib/PhreeqcKernelData/ReactionRate.h
@@ -21,7 +21,7 @@ class ReactionRate
 {
 public:
     ReactionRate(std::string kinetic_reactant_,
-                 std::vector<std::string> statements);
+                 std::vector<std::string> const& statements);
 
     std::string const& commands() const { return _commands; }
 
diff --git a/GeoLib/EarClippingTriangulation.cpp b/GeoLib/EarClippingTriangulation.cpp
index 9e493498f061f2e054100b4d2a7d84df81df6a27..4da3fce4117a4199af2b78ecbeaa633923ac461c 100644
--- a/GeoLib/EarClippingTriangulation.cpp
+++ b/GeoLib/EarClippingTriangulation.cpp
@@ -321,9 +321,7 @@ void EarClippingTriangulation::clipEars()
                     _ear_list.remove(*next);
                     if (orientation == GeoLib::COLLINEAR)
                     {
-                        next = _vertex_list.erase(next);
-                        if (next == _vertex_list.end())
-                            next = _vertex_list.begin();
+                        _vertex_list.erase(next);
                     }
                 }
             }
diff --git a/GeoLib/GEOObjects.cpp b/GeoLib/GEOObjects.cpp
index ad16d68e75dbe9a67021f72b8872c089ee32ef5c..4073331e9710886543b3ecc1cd31ed9d7cec9975 100644
--- a/GeoLib/GEOObjects.cpp
+++ b/GeoLib/GEOObjects.cpp
@@ -330,7 +330,7 @@ bool GEOObjects::isPntVecUsed(const std::string& name) const
 
 void GEOObjects::getStationVectorNames(std::vector<std::string>& names) const
 {
-    for (auto point : _pnt_vecs)
+    for (auto const* point : _pnt_vecs)
     {
         if (point->getType() == PointVec::PointType::STATION)
         {
@@ -342,7 +342,7 @@ void GEOObjects::getStationVectorNames(std::vector<std::string>& names) const
 std::vector<std::string> GEOObjects::getGeometryNames() const
 {
     std::vector<std::string> names;
-    for (auto const point : _pnt_vecs)
+    for (auto const* point : _pnt_vecs)
     {
         if (point->getType() == PointVec::PointType::POINT)
         {
@@ -743,16 +743,16 @@ GeoLib::GeoObject const* GEOObjects::getGeoObject(
 
 std::size_t GEOObjects::exists(const std::string& geometry_name) const
 {
-    std::size_t const size(_pnt_vecs.size());
-    auto const it = findVectorByName(_pnt_vecs, geometry_name);
-    if (it != _pnt_vecs.end())
+    if (auto const it = findVectorByName(_pnt_vecs, geometry_name);
+        it != _pnt_vecs.end())
     {
         return std::distance(_pnt_vecs.begin(), it);
     }
 
     // HACK for enabling conversion of files without loading the associated
     // geometry
-    if (size > 0 && _pnt_vecs[0]->getName() == "conversionTestRun#1")
+    if (_pnt_vecs.size() > 0 &&
+        _pnt_vecs[0]->getName() == "conversionTestRun#1")
     {
         return 1;
     }
diff --git a/GeoLib/IO/AsciiRasterInterface.cpp b/GeoLib/IO/AsciiRasterInterface.cpp
index 230575b25a4798a13f5e5ce5c77de3f1e2655622..1e30fae7a432d293572a66df6d42239089c356ac 100644
--- a/GeoLib/IO/AsciiRasterInterface.cpp
+++ b/GeoLib/IO/AsciiRasterInterface.cpp
@@ -371,17 +371,16 @@ void AsciiRasterInterface::writeRasterAsASC(GeoLib::Raster const& raster,
 /// Checks if all raster files actually exist
 static bool allRastersExist(std::vector<std::string> const& raster_paths)
 {
-    for (const auto& raster_path : raster_paths)
-    {
-        std::ifstream file_stream(raster_path, std::ifstream::in);
-        if (!file_stream.good())
-        {
-            ERR("Opening raster file {} failed.", raster_path);
-            return false;
-        }
-        file_stream.close();
-    }
-    return true;
+    return std::all_of(raster_paths.begin(), raster_paths.end(),
+                       [](std::string const& raster_path)
+                       {
+                           if (BaseLib::IsFileExisting(raster_path))
+                           {
+                               return true;
+                           }
+                           ERR("Opening raster file {} failed.", raster_path);
+                           return false;
+                       });
 }
 
 std::optional<std::vector<GeoLib::Raster const*>> readRasters(
diff --git a/GeoLib/OctTree-impl.h b/GeoLib/OctTree-impl.h
index 886fa38d1433248aa45c2876e3f2a04a3e42aa30..686580c55d72c02a26ae007beec4505c3accaec7 100644
--- a/GeoLib/OctTree-impl.h
+++ b/GeoLib/OctTree-impl.h
@@ -303,12 +303,11 @@ void OctTree<POINT, MAX_POINTS>::splitNode(POINT* pnt)
     const std::size_t n_pnts(_pnts.size());
     for (std::size_t j(0); j < n_pnts; j++)
     {
-        for (auto c : _children)
+        if (std::any_of(begin(_children), end(_children),
+                        [&](auto* child)
+                        { return child->addPointToChild(_pnts[j]); }))
         {
-            if (c->addPointToChild(_pnts[j]))
-            {
-                break;
-            }
+            continue;
         }
     }
     _is_leaf = false;
diff --git a/MaterialLib/Adsorption/ReactionCaOH2.cpp b/MaterialLib/Adsorption/ReactionCaOH2.cpp
index ba7b2ec855d32b93dae5e7f0c55c48eea08e77bd..fb69fb5b380fedd5cd0786bcfe93b6b5fd8e391f 100644
--- a/MaterialLib/Adsorption/ReactionCaOH2.cpp
+++ b/MaterialLib/Adsorption/ReactionCaOH2.cpp
@@ -17,25 +17,25 @@
 
 namespace Adsorption
 {
-const double ReactionCaOH2::_reaction_enthalpy = -1.12e+05;
-const double ReactionCaOH2::_reaction_entropy = -143.5;
-const double ReactionCaOH2::_M_carrier =
-    MaterialLib::PhysicalConstant::MolarMass::N2;
-const double ReactionCaOH2::_M_react =
-    MaterialLib::PhysicalConstant::MolarMass::Water;
 
-const double ReactionCaOH2::_tol_l = 1e-4;
-const double ReactionCaOH2::_tol_u = 1.0 - 1e-4;
-const double ReactionCaOH2::_tol_rho = 0.1;
+//! reaction enthalpy in J/mol; negative for exothermic composition reaction
+constexpr double reaction_enthalpy = -1.12e+05;
+//! reaction entropy in J/mol/K
+constexpr double reaction_entropy = -143.5;
+//! inert component molar mass
+constexpr double M_carrier = MaterialLib::PhysicalConstant::MolarMass::N2;
+//! reactive component molar mass
+constexpr double M_react = MaterialLib::PhysicalConstant::MolarMass::Water;
 
-const double ReactionCaOH2::rho_low = 1656.0;
-const double ReactionCaOH2::rho_up = 2200.0;
+constexpr double tol_l = 1e-4;
+constexpr double tol_u = 1.0 - 1e-4;
+constexpr double tol_rho = 0.1;
 
 double ReactionCaOH2::getEnthalpy(const double /*p_Ads*/,
                                   const double /*T_Ads*/,
                                   const double /*M_Ads*/) const
 {
-    return -_reaction_enthalpy / _M_react;
+    return -reaction_enthalpy / M_react;
 }
 
 double ReactionCaOH2::getReactionRate(const double /*p_Ads*/,
@@ -68,7 +68,7 @@ void ReactionCaOH2::calculateQR()
 {
     // Convert mass fraction into mole fraction
     const double mol_frac_react =
-        AdsorptionReaction::getMolarFraction(_x_react, _M_react, _M_carrier);
+        AdsorptionReaction::getMolarFraction(_x_react, M_react, M_carrier);
 
     _p_r_g = std::max(mol_frac_react * _p_gas, 1.0e-3);  // avoid illdefined log
     setChemicalEquilibrium();
@@ -81,19 +81,19 @@ void ReactionCaOH2::setChemicalEquilibrium()
 {
     const double R = MaterialLib::PhysicalConstant::IdealGasConstant;
 
-    _X_D = (_rho_s - rho_up - _tol_rho) / (rho_low - rho_up - 2.0 * _tol_rho);
+    _X_D = (_rho_s - rho_up - tol_rho) / (rho_low - rho_up - 2.0 * tol_rho);
     _X_D = (_X_D < 0.5)
-               ? std::max(_tol_l, _X_D)
-               : std::min(_X_D, _tol_u);  // constrain to interval [tol_l;tol_u]
+               ? std::max(tol_l, _X_D)
+               : std::min(_X_D, tol_u);  // constrain to interval [tol_l;tol_u]
 
     _X_H = 1.0 - _X_D;
 
     // calculate equilibrium
     // using the p_eq to calculate the T_eq - Clausius-Clapeyron
-    _T_eq = (_reaction_enthalpy / R) /
-            ((_reaction_entropy / R) + std::log(_p_r_g));  // unit of p in bar
+    _T_eq = (reaction_enthalpy / R) /
+            ((reaction_entropy / R) + std::log(_p_r_g));  // unit of p in bar
     // Alternative: Use T_s as T_eq and calculate p_eq - for Schaube kinetics
-    _p_eq = std::exp((_reaction_enthalpy / R) / _T_s - (_reaction_entropy / R));
+    _p_eq = std::exp((reaction_enthalpy / R) / _T_s - (reaction_entropy / R));
 }
 
 double ReactionCaOH2::CaHydration()
@@ -114,7 +114,7 @@ double ReactionCaOH2::CaHydration()
         dXdt = -1.0 * (1.0 - X_H) * (T_s - T_eq) / T_eq * 0.2 *
                conversion_rate::x_react;
 #else  // this is from Schaube
-        if (_X_H == _tol_u || _rho_s == rho_up)
+        if (_X_H == tol_u || _rho_s == rho_up)
         {
             dXdt = 0.0;
         }
@@ -139,7 +139,7 @@ double ReactionCaOH2::CaHydration()
 #ifdef SIMPLE_KINETICS  // this is from P. Schmidt
         dXdt = -1.0 * (1.0 - X_D) * (T_s - T_eq) / T_eq * 0.05;
 #else
-        if (_X_D == _tol_u || _rho_s == rho_low)
+        if (_X_D == tol_u || _rho_s == rho_low)
         {
             dXdt = 0.0;
         }
diff --git a/MaterialLib/Adsorption/ReactionCaOH2.h b/MaterialLib/Adsorption/ReactionCaOH2.h
index c31805a8334131bafa99915d70706963635058be..f868522dfb514ec279a2e98aa7aaeef4d8883447 100644
--- a/MaterialLib/Adsorption/ReactionCaOH2.h
+++ b/MaterialLib/Adsorption/ReactionCaOH2.h
@@ -51,26 +51,19 @@ private:
     void setChemicalEquilibrium();
     double CaHydration();
 
-    double _rho_s;           //!< solid phase density
-    double _p_gas;           //!< gas phase pressure in unit bar
-    double _p_r_g;           //!< pressure of H2O on gas phase
-    double _p_eq = 1.0;      //!< equilibrium pressure in bar
-    double _T_eq;            //!< equilibrium temperature
-    double _T_s;             //!< solid phase temperature
-    double _qR;              //!< rate of solid density change
-    double _x_react;         //!< mass fraction of water in gas phase
-    double _X_D;             //!< mass fraction of dehydration (CaO) in the solid phase
-    double _X_H;             //!< mass fraction of hydration in the solid phase
-
-    //! reaction enthalpy in J/mol; negative for exothermic composition reaction
-    static const double _reaction_enthalpy;
-    static const double _reaction_entropy; //!< reaction entropy in J/mol/K
-    static const double _M_carrier;        //!< inert component molar mass
-    static const double _M_react;          //!< reactive component molar mass
-
-    static const double _tol_l;
-    static const double _tol_u;
-    static const double _tol_rho;
+    static constexpr double nan = std::numeric_limits<double>::quiet_NaN();
+
+    double _rho_s = nan;    //!< solid phase density
+    double _p_gas = nan;    //!< gas phase pressure in unit bar
+    double _p_r_g = nan;    //!< pressure of H2O on gas phase
+    double _p_eq = 1.0;     //!< equilibrium pressure in bar
+    double _T_eq = nan;     //!< equilibrium temperature
+    double _T_s = nan;      //!< solid phase temperature
+    double _qR = nan;       //!< rate of solid density change
+    double _x_react = nan;  //!< mass fraction of water in gas phase
+    double _X_D =
+        nan;  //!< mass fraction of dehydration (CaO) in the solid phase
+    double _X_H = nan;  //!< mass fraction of hydration in the solid phase
 
     const BaseLib::ConfigTree _ode_solver_config;
 
@@ -78,8 +71,10 @@ private:
     friend class ProcessLib::TESFEMReactionAdaptorCaOH2;
 
 public:
-    static MATERIALLIB_EXPORT const double rho_low; //! lower density limit
-    static MATERIALLIB_EXPORT const double rho_up;  //! upper density limit
+    static MATERIALLIB_EXPORT constexpr double rho_low =
+        1656.0;  //!< lower density limit
+    static MATERIALLIB_EXPORT constexpr double rho_up =
+        2200.0;  //!< upper density limit
 };
 
 }  // namespace Adsorption
diff --git a/MaterialLib/MPL/Properties/SpecificHeatCapacityWithLatentHeat.h b/MaterialLib/MPL/Properties/SpecificHeatCapacityWithLatentHeat.h
index ec6112b4f1c5d23f641bbd781e3bcceee47db3a4..b2359ba1418ccf4abec6d604bc34a0046d12f659 100644
--- a/MaterialLib/MPL/Properties/SpecificHeatCapacityWithLatentHeat.h
+++ b/MaterialLib/MPL/Properties/SpecificHeatCapacityWithLatentHeat.h
@@ -38,9 +38,9 @@ class SpecificHeatCapacityWithLatentHeat final : public Property
 {
     struct PhaseProperties
     {
-        const Property* liquid;
-        const Property* frozen;
-        const Property* porous;
+        Property const* liquid = nullptr;
+        Property const* frozen = nullptr;
+        Property const* porous = nullptr;
     };
 
 public:
diff --git a/MaterialLib/SolidModels/MFront/MFrontGeneric.h b/MaterialLib/SolidModels/MFront/MFrontGeneric.h
index 10201f6c374a8c25e396b470231d6f448daa48b3..92f4ef6d264b7aff076ea3251bfca140d7d3f2a5 100644
--- a/MaterialLib/SolidModels/MFront/MFrontGeneric.h
+++ b/MaterialLib/SolidModels/MFront/MFrontGeneric.h
@@ -222,8 +222,10 @@ public:
                 // TODO allow reordering of gradients and thermodynamic forces?
                 if (grads[i].name != Grad::name)
                 {
-                    OGS_FATAL("The behaviour's {}th driver must be {}.", i,
-                              Grad::name);
+                    OGS_FATAL(
+                        "OGS expects the {}th gradient to be {} but MFront "
+                        "provides {}.",
+                        i, Grad::name, grads[i].name);
                 }
 
                 if (grads[i].type != Grad::type)
@@ -264,16 +266,16 @@ public:
                 if (tdfs[i].name != TDF::name)
                 {
                     OGS_FATAL(
-                        "The behaviour's {}th thermodynamic force must be {}.",
-                        i, TDF::name);
+                        "OGS expects the {}th thermodynamic force to be {} but "
+                        "MFront provides {}.",
+                        i, TDF::name, tdfs[i].name);
                 }
 
                 if (tdfs[i].type != TDF::type)
                 {
                     OGS_FATAL(
                         "The behaviour's {}th thermodynamic force ({}) must be "
-                        "of "
-                        "type {}.",
+                        "of type {}.",
                         i, tdfs[i].name, varTypeToString(TDF::type));
                 }
 
@@ -282,8 +284,7 @@ public:
                 {
                     OGS_FATAL(
                         "The behaviour's {}th thermodynamic force ({}) must "
-                        "have "
-                        "size {} instead of {}.",
+                        "have size {} instead of {}.",
                         i, tdfs[i].name, TDF::template size<DisplacementDim>(),
                         mgis::behaviour::getVariableSize(tdfs[i], hyp));
                 }
diff --git a/MeshLib/IO/XDMF/HdfWriter.cpp b/MeshLib/IO/XDMF/HdfWriter.cpp
index 2728c1d1637d825653397c019464a583045e5a8f..f6e2290b988f4536380c469b860011ecc6769c55 100644
--- a/MeshLib/IO/XDMF/HdfWriter.cpp
+++ b/MeshLib/IO/XDMF/HdfWriter.cpp
@@ -206,7 +206,7 @@ struct HdfWriter::HdfMesh final
     std::vector<HdfData> const variable_attributes;
 };
 
-HdfWriter::HdfWriter(std::vector<MeshHdfData> meshes,
+HdfWriter::HdfWriter(std::vector<MeshHdfData> const& meshes,
                      unsigned long long const initial_step,
                      std::filesystem::path const& filepath,
                      bool const use_compression,
diff --git a/MeshLib/IO/XDMF/HdfWriter.h b/MeshLib/IO/XDMF/HdfWriter.h
index 3e400b8e4036786c5435a07e5f48e0c339f70c18..48a7d8396edec7cbc9c0f2964ce62bd434b6867c 100644
--- a/MeshLib/IO/XDMF/HdfWriter.h
+++ b/MeshLib/IO/XDMF/HdfWriter.h
@@ -45,7 +45,7 @@ public:
      * @param is_file_manager True if process (in parallel execution) is
      * @param n_files Number of output files
      */
-    HdfWriter(std::vector<MeshHdfData> meshes,
+    HdfWriter(std::vector<MeshHdfData> const& meshes,
               unsigned long long initial_step,
               std::filesystem::path const& filepath,
               bool use_compression,
diff --git a/MeshLib/Vtk/VtkMappedMeshSource.cpp b/MeshLib/Vtk/VtkMappedMeshSource.cpp
index 435c24d90cbe8246a195265ffa2134f5b71cb255..8d10c9da60901bd47049252596086c43dbdfbf1a 100644
--- a/MeshLib/Vtk/VtkMappedMeshSource.cpp
+++ b/MeshLib/Vtk/VtkMappedMeshSource.cpp
@@ -123,54 +123,59 @@ int VtkMappedMeshSource::RequestData(vtkInformation* /*request*/,
         {
             continue;
         }
-        if (auto p = dynamic_cast<PropertyVector<double>*>(property))
+        if (auto const* p = dynamic_cast<PropertyVector<double>*>(property))
         {
             addProperty(*p);
         }
-        else if (auto p = dynamic_cast<PropertyVector<float>*>(property))
+        else if (auto const* p = dynamic_cast<PropertyVector<float>*>(property))
         {
             addProperty(*p);
         }
-        else if (auto p = dynamic_cast<PropertyVector<int>*>(property))
+        else if (auto const* p = dynamic_cast<PropertyVector<int>*>(property))
         {
             addProperty(*p);
         }
-        else if (auto p = dynamic_cast<PropertyVector<unsigned>*>(property))
+        else if (auto const* p =
+                     dynamic_cast<PropertyVector<unsigned>*>(property))
         {
             addProperty(*p);
         }
-        else if (auto p = dynamic_cast<PropertyVector<long>*>(property))
+        else if (auto const* p = dynamic_cast<PropertyVector<long>*>(property))
         {
             addProperty(*p);
         }
-        else if (auto p = dynamic_cast<PropertyVector<long long>*>(property))
+        else if (auto const* p =
+                     dynamic_cast<PropertyVector<long long>*>(property))
         {
             addProperty(*p);
         }
-        else if (auto p =
+        else if (auto const* p =
                      dynamic_cast<PropertyVector<unsigned long>*>(property))
         {
             addProperty(*p);
         }
-        else if (auto p = dynamic_cast<PropertyVector<unsigned long long>*>(
-                     property))
+        else if (auto const* p =
+                     dynamic_cast<PropertyVector<unsigned long long>*>(
+                         property))
         {
             addProperty(*p);
         }
-        else if (auto p = dynamic_cast<PropertyVector<std::size_t>*>(property))
+        else if (auto const* p =
+                     dynamic_cast<PropertyVector<std::size_t>*>(property))
         {
             addProperty(*p);
         }
-        else if (auto p = dynamic_cast<PropertyVector<char>*>(property))
+        else if (auto const* p = dynamic_cast<PropertyVector<char>*>(property))
         {
             addProperty(*p);
         }
-        else if (auto p =
+        else if (auto const* p =
                      dynamic_cast<PropertyVector<unsigned char>*>(property))
         {
             addProperty(*p);
         }
-        else if (auto p = dynamic_cast<PropertyVector<uint8_t>*>(property))
+        else if (auto const* p =
+                     dynamic_cast<PropertyVector<uint8_t>*>(property))
         {
             addProperty(*p);
         }
diff --git a/MeshToolsLib/IntegrationPointDataTools.cpp b/MeshToolsLib/IntegrationPointDataTools.cpp
index 3320a43d821e3a2efc0bf5ce11d27843ddbf690a..1dfcc6f946f09904e41aa699b3460548c9e2110b 100644
--- a/MeshToolsLib/IntegrationPointDataTools.cpp
+++ b/MeshToolsLib/IntegrationPointDataTools.cpp
@@ -115,7 +115,7 @@ std::vector<std::size_t> getIntegrationPointDataOffsetsOfMeshElements(
         MeshLib::getIntegrationPointMetaData(properties, pv.getPropertyName());
     for (std::size_t i = 0; i < mesh_elements.size(); i++)
     {
-        auto const element = mesh_elements[i];
+        auto const* const element = mesh_elements[i];
 
         // Assuming that the order of elements in mesh_elements is not touched.
         element_ip_data_offsets[i] = counter;
diff --git a/MeshToolsLib/MeshEditing/MeshRevision.cpp b/MeshToolsLib/MeshEditing/MeshRevision.cpp
index a72e0d6e60b95c6980a00b5ad1e6c61ccbf9b551..e2474e67119789763d00594774b1c8d0353a9825 100644
--- a/MeshToolsLib/MeshEditing/MeshRevision.cpp
+++ b/MeshToolsLib/MeshEditing/MeshRevision.cpp
@@ -937,7 +937,7 @@ MeshLib::Properties copyProperties(MeshLib::Properties const& props,
         if (props.existsPropertyVector<int>(name, MeshLib::MeshItemType::Node,
                                             1))
         {
-            auto p = props.getPropertyVector<int>(
+            auto const* p = props.getPropertyVector<int>(
                 name, MeshLib::MeshItemType::Node, 1);
             auto new_node_vec = new_properties.createNewPropertyVector<int>(
                 name, MeshLib::MeshItemType::Node, 1);
@@ -947,7 +947,7 @@ MeshLib::Properties copyProperties(MeshLib::Properties const& props,
         if (props.existsPropertyVector<float>(name, MeshLib::MeshItemType::Node,
                                               1))
         {
-            auto p = props.getPropertyVector<float>(
+            auto const* p = props.getPropertyVector<float>(
                 name, MeshLib::MeshItemType::Node, 1);
             auto new_node_vec = new_properties.createNewPropertyVector<float>(
                 name, MeshLib::MeshItemType::Node, 1);
@@ -957,7 +957,7 @@ MeshLib::Properties copyProperties(MeshLib::Properties const& props,
         if (props.existsPropertyVector<double>(name,
                                                MeshLib::MeshItemType::Node, 1))
         {
-            auto p = props.getPropertyVector<double>(
+            auto const* p = props.getPropertyVector<double>(
                 name, MeshLib::MeshItemType::Node, 1);
             auto new_node_vec = new_properties.createNewPropertyVector<double>(
                 name, MeshLib::MeshItemType::Node, 1);
@@ -967,7 +967,7 @@ MeshLib::Properties copyProperties(MeshLib::Properties const& props,
         if (props.existsPropertyVector<int>(name, MeshLib::MeshItemType::Cell,
                                             1))
         {
-            auto p = props.getPropertyVector<int>(
+            auto const* p = props.getPropertyVector<int>(
                 name, MeshLib::MeshItemType::Cell, 1);
             auto new_cell_vec = new_properties.createNewPropertyVector<int>(
                 name, MeshLib::MeshItemType::Cell, 1);
@@ -977,7 +977,7 @@ MeshLib::Properties copyProperties(MeshLib::Properties const& props,
         if (props.existsPropertyVector<float>(name, MeshLib::MeshItemType::Cell,
                                               1))
         {
-            auto p = props.getPropertyVector<float>(
+            auto const* p = props.getPropertyVector<float>(
                 name, MeshLib::MeshItemType::Cell, 1);
             auto new_cell_vec = new_properties.createNewPropertyVector<float>(
                 name, MeshLib::MeshItemType::Cell, 1);
@@ -987,7 +987,7 @@ MeshLib::Properties copyProperties(MeshLib::Properties const& props,
         if (props.existsPropertyVector<double>(name,
                                                MeshLib::MeshItemType::Cell, 1))
         {
-            auto p = props.getPropertyVector<double>(
+            auto const* p = props.getPropertyVector<double>(
                 name, MeshLib::MeshItemType::Cell, 1);
             auto new_cell_vec = new_properties.createNewPropertyVector<double>(
                 name, MeshLib::MeshItemType::Cell, 1);
diff --git a/MeshToolsLib/MeshInformation.cpp b/MeshToolsLib/MeshInformation.cpp
index fe9b43eb97b0c9e34ff56e998af17f3b4b043e9e..015f140d765e133a6d65a26341c3da107eba3e83 100644
--- a/MeshToolsLib/MeshInformation.cpp
+++ b/MeshToolsLib/MeshInformation.cpp
@@ -77,51 +77,56 @@ void MeshInformation::writePropertyVectorInformation(const MeshLib::Mesh& mesh)
 
     for (auto [name, property] : properties)
     {
-        if (auto p = dynamic_cast<MeshLib::PropertyVector<double>*>(property))
+        if (auto const* p =
+                dynamic_cast<MeshLib::PropertyVector<double>*>(property))
         {
             printBounds(*p);
         }
-        else if (auto p =
+        else if (auto const* p =
                      dynamic_cast<MeshLib::PropertyVector<float>*>(property))
         {
             printBounds(*p);
         }
-        else if (auto p = dynamic_cast<MeshLib::PropertyVector<int>*>(property))
+        else if (auto const* p =
+                     dynamic_cast<MeshLib::PropertyVector<int>*>(property))
         {
             printBounds(*p);
         }
-        else if (auto p =
+        else if (auto const* p =
                      dynamic_cast<MeshLib::PropertyVector<unsigned>*>(property))
         {
             printBounds(*p);
         }
-        else if (auto p =
+        else if (auto const* p =
                      dynamic_cast<MeshLib::PropertyVector<long>*>(property))
         {
             printBounds(*p);
         }
-        else if (auto p = dynamic_cast<MeshLib::PropertyVector<long long>*>(
-                     property))
+        else if (auto const* p =
+                     dynamic_cast<MeshLib::PropertyVector<long long>*>(
+                         property))
         {
             printBounds(*p);
         }
-        else if (auto p = dynamic_cast<MeshLib::PropertyVector<unsigned long>*>(
-                     property))
+        else if (auto const* p =
+                     dynamic_cast<MeshLib::PropertyVector<unsigned long>*>(
+                         property))
         {
             printBounds(*p);
         }
-        else if (auto p =
+        else if (auto const* p =
                      dynamic_cast<MeshLib::PropertyVector<unsigned long long>*>(
                          property))
         {
             printBounds(*p);
         }
-        else if (auto p = dynamic_cast<MeshLib::PropertyVector<std::size_t>*>(
-                     property))
+        else if (auto const* p =
+                     dynamic_cast<MeshLib::PropertyVector<std::size_t>*>(
+                         property))
         {
             printBounds(*p);
         }
-        else if (auto p =
+        else if (auto const* p =
                      dynamic_cast<MeshLib::PropertyVector<char>*>(property))
         {
             printBounds(*p);
diff --git a/MeshToolsLib/MeshQuality/MeshValidation.cpp b/MeshToolsLib/MeshQuality/MeshValidation.cpp
index 3db81708983cb1fccda818685034d15e8ff46936..76895d4cf4ce295e2095233683e8efb991b2960a 100644
--- a/MeshToolsLib/MeshQuality/MeshValidation.cpp
+++ b/MeshToolsLib/MeshQuality/MeshValidation.cpp
@@ -145,7 +145,7 @@ std::vector<ElementErrorCode> MeshValidation::testElementGeometry(
         std::accumulate(error_count, error_count + nErrorCodes, 0.0)));
     if (error_sum != 0)
     {
-        ElementErrorFlag flags[nErrorCodes] = {
+        ElementErrorFlag const flags[nErrorCodes] = {
             ElementErrorFlag::ZeroVolume, ElementErrorFlag::NonCoplanar,
             ElementErrorFlag::NonConvex, ElementErrorFlag::NodeOrder};
         for (std::size_t i = 0; i < nErrorCodes; ++i)
diff --git a/MeshToolsLib/MeshSurfaceExtraction.cpp b/MeshToolsLib/MeshSurfaceExtraction.cpp
index a24971642502be38fe7f87841522f5d9c58d672d..db0cb4e3b1d116417610fd7a01525b8ecda1bb33 100644
--- a/MeshToolsLib/MeshSurfaceExtraction.cpp
+++ b/MeshToolsLib/MeshSurfaceExtraction.cpp
@@ -93,60 +93,65 @@ bool createSfcMeshProperties(MeshLib::Mesh& sfc_mesh,
         }
 
         auto const& id_map = *id_maps.at(property->getMeshItemType());
-        if (auto p = dynamic_cast<MeshLib::PropertyVector<double>*>(property))
+        if (auto const* p =
+                dynamic_cast<MeshLib::PropertyVector<double>*>(property))
         {
             processPropertyVector(*p, id_map, sfc_mesh);
             vectors_copied++;
         }
-        else if (auto p =
+        else if (auto const* p =
                      dynamic_cast<MeshLib::PropertyVector<float>*>(property))
         {
             processPropertyVector(*p, id_map, sfc_mesh);
             vectors_copied++;
         }
-        else if (auto p = dynamic_cast<MeshLib::PropertyVector<int>*>(property))
+        else if (auto const* p =
+                     dynamic_cast<MeshLib::PropertyVector<int>*>(property))
         {
             processPropertyVector(*p, id_map, sfc_mesh);
             vectors_copied++;
         }
-        else if (auto p =
+        else if (auto const* p =
                      dynamic_cast<MeshLib::PropertyVector<unsigned>*>(property))
         {
             processPropertyVector(*p, id_map, sfc_mesh);
             vectors_copied++;
         }
-        else if (auto p =
+        else if (auto const* p =
                      dynamic_cast<MeshLib::PropertyVector<long>*>(property))
         {
             processPropertyVector(*p, id_map, sfc_mesh);
             vectors_copied++;
         }
-        else if (auto p = dynamic_cast<MeshLib::PropertyVector<long long>*>(
-                     property))
+        else if (auto const* p =
+                     dynamic_cast<MeshLib::PropertyVector<long long>*>(
+                         property))
         {
             processPropertyVector(*p, id_map, sfc_mesh);
             vectors_copied++;
         }
-        else if (auto p = dynamic_cast<MeshLib::PropertyVector<unsigned long>*>(
-                     property))
+        else if (auto const* p =
+                     dynamic_cast<MeshLib::PropertyVector<unsigned long>*>(
+                         property))
         {
             processPropertyVector(*p, id_map, sfc_mesh);
             vectors_copied++;
         }
-        else if (auto p =
+        else if (auto const* p =
                      dynamic_cast<MeshLib::PropertyVector<unsigned long long>*>(
                          property))
         {
             processPropertyVector(*p, id_map, sfc_mesh);
             vectors_copied++;
         }
-        else if (auto p = dynamic_cast<MeshLib::PropertyVector<std::size_t>*>(
-                     property))
+        else if (auto const* p =
+                     dynamic_cast<MeshLib::PropertyVector<std::size_t>*>(
+                         property))
         {
             processPropertyVector(*p, id_map, sfc_mesh);
             vectors_copied++;
         }
-        else if (auto p =
+        else if (auto const* p =
                      dynamic_cast<MeshLib::PropertyVector<char>*>(property))
         {
             processPropertyVector(*p, id_map, sfc_mesh);
@@ -272,10 +277,9 @@ MeshLib::Mesh* MeshSurfaceExtraction::getMeshSurface(
     std::for_each(sfc_elements.begin(), sfc_elements.end(),
                   [](MeshLib::Element* e) { delete e; });
 
-    std::vector<std::size_t> id_map;
-    id_map.reserve(sfc_nodes.size());
-    std::transform(begin(sfc_nodes), end(sfc_nodes), std::back_inserter(id_map),
-                   [](MeshLib::Node* const n) { return n->getID(); });
+    auto sfc_node_ids = sfc_nodes | MeshLib::views::ids;
+    std::vector<std::size_t> const id_map(sfc_node_ids.begin(),
+                                          sfc_node_ids.end());
 
     MeshLib::Mesh* result(new MeshLib::Mesh(subsfc_mesh.getName() + "-Surface",
                                             sfc_nodes, new_elements));
@@ -495,11 +499,10 @@ std::unique_ptr<MeshLib::Mesh> getBoundaryElementsAsMesh(
         delete e;
     }
 
-    std::vector<std::size_t> nodes_to_bulk_nodes_id_map;
-    nodes_to_bulk_nodes_id_map.reserve(boundary_nodes.size());
-    std::transform(begin(boundary_nodes), end(boundary_nodes),
-                   std::back_inserter(nodes_to_bulk_nodes_id_map),
-                   [](MeshLib::Node* const n) { return n->getID(); });
+    auto boundary_node_ids = boundary_nodes | MeshLib::views::ids;
+
+    std::vector<std::size_t> const nodes_to_bulk_nodes_id_map(
+        boundary_node_ids.begin(), boundary_node_ids.end());
 
     std::unique_ptr<MeshLib::Mesh> boundary_mesh(new MeshLib::Mesh(
         bulk_mesh.getName() + "-boundary", boundary_nodes, new_elements));
diff --git a/NumLib/Fem/ShapeFunction/ShapeHex20-impl.h b/NumLib/Fem/ShapeFunction/ShapeHex20-impl.h
index 304d12c3306b13f09ed9dc98ece63079a142e748..c085df51e8f15b0894e65d05bc852a8e8d1863a5 100644
--- a/NumLib/Fem/ShapeFunction/ShapeHex20-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapeHex20-impl.h
@@ -89,7 +89,7 @@ void ShapeHex20::computeShapeFunction(const T_X& rst, T_N& N)
 }
 
 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& dN)
 {
     const double r = rst[0];
     const double s = rst[1];
@@ -99,44 +99,44 @@ void ShapeHex20::computeGradShapeFunction(const T_X& rst, T_N& dNdr)
     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] =
+        dN[20 * i + 0] = dShapeFunctionHexHQ_Corner(r, s, t, i);
+        dN[20 * i + 1] = sign1[i] * dShapeFunctionHexHQ_Corner(-r, s, t, i);
+        dN[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] =
+        dN[20 * i + 3] = sign2[i] * dShapeFunctionHexHQ_Corner(r, -s, t, i);
+        dN[20 * i + 4] = sign3[i] * dShapeFunctionHexHQ_Corner(r, s, -t, i);
+        dN[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] =
+        dN[20 * i + 6] = sign1[i] * sign2[i] * sign3[i] *
+                         dShapeFunctionHexHQ_Corner(-r, -s, -t, i);
+        dN[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] =
+        dN[20 * i + 8] = dShapeFunctionHexHQ_Middle(r, s, t, i);
+        dN[20 * i + 10] = sign2[i] * dShapeFunctionHexHQ_Middle(r, -s, t, i);
+        dN[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);
+        dN[20 * i + 12] = sign3[i] * dShapeFunctionHexHQ_Middle(r, s, -t, i);
 
         {
             int const co = (i + 2) % 3;
-            dNdr[20 * i + 11] = dShapeFunctionHexHQ_Middle(s, t, r, co);
-            dNdr[20 * i + 15] =
+            dN[20 * i + 11] = dShapeFunctionHexHQ_Middle(s, t, r, co);
+            dN[20 * i + 15] =
                 sign3[i] * dShapeFunctionHexHQ_Middle(s, -t, r, co);
-            dNdr[20 * i + 13] =
+            dN[20 * i + 13] =
                 sign1[i] * sign3[i] * dShapeFunctionHexHQ_Middle(s, -t, -r, co);
-            dNdr[20 * i + 9] =
+            dN[20 * i + 9] =
                 sign1[i] * dShapeFunctionHexHQ_Middle(s, t, -r, co);
         }
 
         {
             int const co = (i + 1) % 3;
-            dNdr[20 * i + 16] = dShapeFunctionHexHQ_Middle(t, r, s, co);
-            dNdr[20 * i + 17] =
+            dN[20 * i + 16] = dShapeFunctionHexHQ_Middle(t, r, s, co);
+            dN[20 * i + 17] =
                 sign1[i] * dShapeFunctionHexHQ_Middle(t, -r, s, co);
-            dNdr[20 * i + 18] =
+            dN[20 * i + 18] =
                 sign1[i] * sign2[i] * dShapeFunctionHexHQ_Middle(t, -r, -s, co);
-            dNdr[20 * i + 19] =
+            dN[20 * i + 19] =
                 sign2[i] * dShapeFunctionHexHQ_Middle(t, r, -s, co);
         }
     }
diff --git a/NumLib/Fem/ShapeFunction/ShapeHex20.h b/NumLib/Fem/ShapeFunction/ShapeHex20.h
index 9ccd0c335cf7421a20c238c5ea678c8e86081aae..5048171e023ecd0bf345b62d1c20aa2cc894db40 100644
--- a/NumLib/Fem/ShapeFunction/ShapeHex20.h
+++ b/NumLib/Fem/ShapeFunction/ShapeHex20.h
@@ -24,20 +24,20 @@ public:
     /**
      * Evaluate the shape function at the given point
      *
-     * @param [in]  r   natural coordinates (r,s,t)
+     * @param [in]  rst natural coordinates (r,s,t)
      * @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& rst, T_N& N);
 
     /**
      * Evaluate derivatives of the shape function at the given point
      *
-     * @param [in]  r   natural coordinates (r,s,t)
+     * @param [in]  rst natural coordinates (r,s,t)
      * @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& rst, T_N& dN);
 
     using MeshElement = MeshLib::Hex20;
     static const unsigned DIM = MeshElement::dimension;
diff --git a/NumLib/Fem/ShapeFunction/ShapeQuad8-impl.h b/NumLib/Fem/ShapeFunction/ShapeQuad8-impl.h
index d20a875eac2040a167b4358ae147606b0e5ced97..fd6edc569f093314969267878767db3c0b3ecbb9 100644
--- a/NumLib/Fem/ShapeFunction/ShapeQuad8-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapeQuad8-impl.h
@@ -25,32 +25,32 @@ 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& dN)
 {
     const double r = rs[0];
     const double s = rs[1];
 
     // dN/dr
-    dNdr[0] = (1 + s) * (2 * r + s) * 0.25;
-    dNdr[1] = (1 + s) * (2 * r - s) * 0.25;
-    dNdr[2] = (1 - s) * (2 * r + s) * 0.25;
-    dNdr[3] = (1 - s) * (2 * r - s) * 0.25;
+    dN[0] = (1 + s) * (2 * r + s) * 0.25;
+    dN[1] = (1 + s) * (2 * r - s) * 0.25;
+    dN[2] = (1 - s) * (2 * r + s) * 0.25;
+    dN[3] = (1 - s) * (2 * r - s) * 0.25;
 
-    dNdr[4] = -r * (1 + s);
-    dNdr[5] = -(1 - s * s) * 0.5;
-    dNdr[6] = -r * (1 - s);
-    dNdr[7] = (1 - s * s) * 0.5;
+    dN[4] = -r * (1 + s);
+    dN[5] = -(1 - s * s) * 0.5;
+    dN[6] = -r * (1 - s);
+    dN[7] = (1 - s * s) * 0.5;
 
     // dN/ds
-    dNdr[8] = (1 + r) * (r + 2 * s) * 0.25;
-    dNdr[9] = -(1 - r) * (r - 2 * s) * 0.25;
-    dNdr[10] = (1 - r) * (r + 2 * s) * 0.25;
-    dNdr[11] = -(1 + r) * (r - 2 * s) * 0.25;
+    dN[8] = (1 + r) * (r + 2 * s) * 0.25;
+    dN[9] = -(1 - r) * (r - 2 * s) * 0.25;
+    dN[10] = (1 - r) * (r + 2 * s) * 0.25;
+    dN[11] = -(1 + r) * (r - 2 * s) * 0.25;
 
-    dNdr[12] = (1 - r * r) * 0.5;
-    dNdr[13] = -(1 - r) * s;
-    dNdr[14] = -(1 - r * r) * 0.5;
-    dNdr[15] = -(1 + r) * s;
+    dN[12] = (1 - r * r) * 0.5;
+    dN[13] = -(1 - r) * s;
+    dN[14] = -(1 - r * r) * 0.5;
+    dN[15] = -(1 + r) * s;
 }
 
 }  // namespace NumLib
diff --git a/NumLib/Fem/ShapeFunction/ShapeQuad8.h b/NumLib/Fem/ShapeFunction/ShapeQuad8.h
index ad74f0a53a752ee20e36e33554d103952783e431..b95834cbbdd6c74ad1094dfb48e4ceb673ad60ec 100644
--- a/NumLib/Fem/ShapeFunction/ShapeQuad8.h
+++ b/NumLib/Fem/ShapeFunction/ShapeQuad8.h
@@ -32,11 +32,11 @@ public:
     /**
      * Evaluate derivatives of the shape function at the given point
      *
-     * @param [in]  r    point coordinates
+     * @param [in]  rs   point coordinates
      * @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& rs, T_N& dN);
 
     using MeshElement = MeshLib::Quad8;
     static const unsigned DIM = MeshElement::dimension;
diff --git a/NumLib/Fem/ShapeFunction/ShapeQuad9-impl.h b/NumLib/Fem/ShapeFunction/ShapeQuad9-impl.h
index 025354f54cffb61a9d6ce266913fec4bc3480885..1652dc24f23fe75a48cb1044f09b2aa1ab2c7927 100644
--- a/NumLib/Fem/ShapeFunction/ShapeQuad9-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapeQuad9-impl.h
@@ -25,26 +25,26 @@ void ShapeQuad9::computeShapeFunction(const T_X& r, T_N& N)
 }
 
 template <class T_X, class T_N>
-void ShapeQuad9::computeGradShapeFunction(const T_X& r, T_N& dNdr)
+void ShapeQuad9::computeGradShapeFunction(const T_X& r, T_N& dN)
 {
-    dNdr[0] = (r[0] + 0.5) * r[1] * (r[1] + 1) / 2;
-    dNdr[1] = (r[0] - 0.5) * r[1] * (r[1] + 1) / 2;
-    dNdr[2] = (r[0] - 0.5) * r[1] * (r[1] - 1) / 2;
-    dNdr[3] = (r[0] + 0.5) * r[1] * (r[1] - 1) / 2;
-    dNdr[4] = -r[0] * r[1] * (1 + r[1]);
-    dNdr[5] = (1 - r[1] * r[1]) * (r[0] - 0.5);
-    dNdr[6] = r[0] * r[1] * (1 - r[1]);
-    dNdr[7] = (1 - r[1] * r[1]) * (r[0] + 0.5);
-    dNdr[8] = 2 * r[0] * (r[1] * r[1] - 1);
+    dN[0] = (r[0] + 0.5) * r[1] * (r[1] + 1) / 2;
+    dN[1] = (r[0] - 0.5) * r[1] * (r[1] + 1) / 2;
+    dN[2] = (r[0] - 0.5) * r[1] * (r[1] - 1) / 2;
+    dN[3] = (r[0] + 0.5) * r[1] * (r[1] - 1) / 2;
+    dN[4] = -r[0] * r[1] * (1 + r[1]);
+    dN[5] = (1 - r[1] * r[1]) * (r[0] - 0.5);
+    dN[6] = r[0] * r[1] * (1 - r[1]);
+    dN[7] = (1 - r[1] * r[1]) * (r[0] + 0.5);
+    dN[8] = 2 * r[0] * (r[1] * r[1] - 1);
 
-    dNdr[10] = (r[1] + 0.5) * r[0] * (r[0] - 1) / 2;
-    dNdr[11] = (r[1] - 0.5) * r[0] * (r[0] - 1) / 2;
-    dNdr[12] = (r[1] - 0.5) * r[0] * (r[0] + 1) / 2;
-    dNdr[13] = (1 - r[0] * r[0]) * (r[1] + 0.5);
-    dNdr[14] = r[0] * r[1] * (1 - r[0]);
-    dNdr[15] = (1 - r[0] * r[0]) * (r[1] - 0.5);
-    dNdr[16] = -r[0] * r[1] * (1 + r[0]);
-    dNdr[17] = 2 * r[1] * (r[0] * r[0] - 1);
-    dNdr[9] = (r[1] + 0.5) * r[0] * (r[0] + 1) / 2;
+    dN[10] = (r[1] + 0.5) * r[0] * (r[0] - 1) / 2;
+    dN[11] = (r[1] - 0.5) * r[0] * (r[0] - 1) / 2;
+    dN[12] = (r[1] - 0.5) * r[0] * (r[0] + 1) / 2;
+    dN[13] = (1 - r[0] * r[0]) * (r[1] + 0.5);
+    dN[14] = r[0] * r[1] * (1 - r[0]);
+    dN[15] = (1 - r[0] * r[0]) * (r[1] - 0.5);
+    dN[16] = -r[0] * r[1] * (1 + r[0]);
+    dN[17] = 2 * r[1] * (r[0] * r[0] - 1);
+    dN[9] = (r[1] + 0.5) * r[0] * (r[0] + 1) / 2;
 }
 }  // namespace NumLib
diff --git a/NumLib/Fem/ShapeFunction/ShapeTet10-impl.h b/NumLib/Fem/ShapeFunction/ShapeTet10-impl.h
index 4cfe2a44a2444d62e3fd59473be505c75d4fa9e3..822c3b27664515fb2fc5ec2d60b116a39245e198 100644
--- a/NumLib/Fem/ShapeFunction/ShapeTet10-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapeTet10-impl.h
@@ -26,40 +26,40 @@ 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& dN)
 {
-    dNdr[0] = 4.0 * (r[0] + r[1] + r[2]) - 3.0;
-    dNdr[1] = 4. * r[0] - 1.;
-    dNdr[2] = 0.0;
-    dNdr[3] = 0.0;
-    dNdr[4] = 4.0 * (1.0 - 2.0 * r[0] - r[1] - r[2]);
-    dNdr[5] = 4.0 * r[1];
-    dNdr[6] = -4.0 * r[1];
-    dNdr[7] = -4.0 * r[2];
-    dNdr[8] = 4.0 * r[2];
-    dNdr[9] = 0.0;
+    dN[0] = 4.0 * (r[0] + r[1] + r[2]) - 3.0;
+    dN[1] = 4. * r[0] - 1.;
+    dN[2] = 0.0;
+    dN[3] = 0.0;
+    dN[4] = 4.0 * (1.0 - 2.0 * r[0] - r[1] - r[2]);
+    dN[5] = 4.0 * r[1];
+    dN[6] = -4.0 * r[1];
+    dN[7] = -4.0 * r[2];
+    dN[8] = 4.0 * r[2];
+    dN[9] = 0.0;
 
-    dNdr[10] = 4. * (r[0] + r[1] + r[2]) - 3.;
-    dNdr[11] = 0.0;
-    dNdr[12] = 4. * r[1] - 1.;
-    dNdr[13] = 0.;
-    dNdr[14] = -4.0 * r[0];
-    dNdr[15] = 4.0 * r[0];
-    dNdr[16] = 4.0 * (1.0 - r[0] - 2.0 * r[1] - r[2]);
-    dNdr[17] = -4.0 * r[2];
-    dNdr[18] = 0.0;
-    dNdr[19] = 4.0 * r[2];
+    dN[10] = 4. * (r[0] + r[1] + r[2]) - 3.;
+    dN[11] = 0.0;
+    dN[12] = 4. * r[1] - 1.;
+    dN[13] = 0.;
+    dN[14] = -4.0 * r[0];
+    dN[15] = 4.0 * r[0];
+    dN[16] = 4.0 * (1.0 - r[0] - 2.0 * r[1] - r[2]);
+    dN[17] = -4.0 * r[2];
+    dN[18] = 0.0;
+    dN[19] = 4.0 * r[2];
 
-    dNdr[20] = 4. * (r[0] + r[1] + r[2]) - 3.;
-    dNdr[21] = 0.;
-    dNdr[22] = 0.;
-    dNdr[23] = 4. * r[2] - 1.;
-    dNdr[24] = -4.0 * r[0];
-    dNdr[25] = 0.0;
-    dNdr[26] = -4.0 * r[1];
-    dNdr[27] = 4.0 * (1.0 - r[0] - r[1] - 2.0 * r[2]);
-    dNdr[28] = 4.0 * r[0];
-    dNdr[29] = 4.0 * r[1];
+    dN[20] = 4. * (r[0] + r[1] + r[2]) - 3.;
+    dN[21] = 0.;
+    dN[22] = 0.;
+    dN[23] = 4. * r[2] - 1.;
+    dN[24] = -4.0 * r[0];
+    dN[25] = 0.0;
+    dN[26] = -4.0 * r[1];
+    dN[27] = 4.0 * (1.0 - r[0] - r[1] - 2.0 * r[2]);
+    dN[28] = 4.0 * r[0];
+    dN[29] = 4.0 * r[1];
 }
 
 }  // namespace NumLib
diff --git a/NumLib/Fem/ShapeFunction/ShapeTet4-impl.h b/NumLib/Fem/ShapeFunction/ShapeTet4-impl.h
index c7bc2945c67e6d8a54d2a97ad61db843560f096e..34c62bfaa2dbbd9cb69d80cd5b50b91315bcc380 100644
--- a/NumLib/Fem/ShapeFunction/ShapeTet4-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapeTet4-impl.h
@@ -20,25 +20,25 @@ 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& dN)
 {
     // dr
-    dNdr[0] = -1.0;
-    dNdr[1] = 1.0;
-    dNdr[2] = 0.0;
-    dNdr[3] = 0.0;
+    dN[0] = -1.0;
+    dN[1] = 1.0;
+    dN[2] = 0.0;
+    dN[3] = 0.0;
 
     // ds
-    dNdr[4] = -1.0;
-    dNdr[5] = 0.0;
-    dNdr[6] = 1.0;
-    dNdr[7] = 0.0;
+    dN[4] = -1.0;
+    dN[5] = 0.0;
+    dN[6] = 1.0;
+    dN[7] = 0.0;
 
     // dt
-    dNdr[8] = -1.0;
-    dNdr[9] = 0.0;
-    dNdr[10] = 0.0;
-    dNdr[11] = 1.0;
+    dN[8] = -1.0;
+    dN[9] = 0.0;
+    dN[10] = 0.0;
+    dN[11] = 1.0;
 }
 
 }  // namespace NumLib
diff --git a/NumLib/Fem/ShapeFunction/ShapeTri6-impl.h b/NumLib/Fem/ShapeFunction/ShapeTri6-impl.h
index a397d7d3febe191a5a4eb8a572a3acf8a2f45aa1..df66e612a88e50d87b4da9ee22fc6b4e2344fc79 100644
--- a/NumLib/Fem/ShapeFunction/ShapeTri6-impl.h
+++ b/NumLib/Fem/ShapeFunction/ShapeTri6-impl.h
@@ -22,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& dN)
 {
-    dNdr[0] = 4. * (r[0] + r[1]) - 3.;  // dN1/dL1
-    dNdr[6] = dNdr[0];                  // dN1/dL2
+    dN[0] = 4. * (r[0] + r[1]) - 3.;  // dN1/dL1
+    dN[6] = dN[0];                    // dN1/dL2
 
-    dNdr[1] = 4. * r[0] - 1.;  // dN2/dL1
-    dNdr[7] = 0.;              // dN2/dL2
+    dN[1] = 4. * r[0] - 1.;  // dN2/dL1
+    dN[7] = 0.;              // dN2/dL2
 
-    dNdr[2] = 0.;              // dN3/dL1
-    dNdr[8] = 4. * r[1] - 1.;  // dN3/dL2
+    dN[2] = 0.;              // dN3/dL1
+    dN[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
+    dN[3] = 4. * (1 - 2. * r[0] - r[1]);  // dN4/dL1
+    dN[9] = -4. * r[0];                   // dN4/dL2
 
-    dNdr[4] = 4. * r[1];  // dN5/dL1
-    dNdr[10] = -dNdr[9];  // dN5/dL2
+    dN[4] = 4. * r[1];  // dN5/dL1
+    dN[10] = -dN[9];    // dN5/dL2
 
-    dNdr[5] = -dNdr[4];                      // dN6/dL1
-    dNdr[11] = 4. * (1 - r[0] - 2. * r[1]);  // dN6/dL2
+    dN[5] = -dN[4];                        // dN6/dL1
+    dN[11] = 4. * (1 - r[0] - 2. * r[1]);  // dN6/dL2
 }
 
 }  // namespace NumLib
diff --git a/ProcessLib/ComponentTransport/CreateComponentTransportProcess.cpp b/ProcessLib/ComponentTransport/CreateComponentTransportProcess.cpp
index 022adcac2c3e6f5ed5ab9685ca281b4f09237b2c..0082703f4366ac86a6b40c75a928b85d67fe078f 100644
--- a/ProcessLib/ComponentTransport/CreateComponentTransportProcess.cpp
+++ b/ProcessLib/ComponentTransport/CreateComponentTransportProcess.cpp
@@ -76,7 +76,7 @@ void checkMPLProperties(
 }
 
 std::unique_ptr<Process> createComponentTransportProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/ComponentTransport/CreateComponentTransportProcess.h b/ProcessLib/ComponentTransport/CreateComponentTransportProcess.h
index 060dcfcd175f4ab07a6c49be5ffef772ab15ce22..c561d977739b2c7b34a67e38f4c9254ec03b2a1a 100644
--- a/ProcessLib/ComponentTransport/CreateComponentTransportProcess.h
+++ b/ProcessLib/ComponentTransport/CreateComponentTransportProcess.h
@@ -28,7 +28,7 @@ namespace ProcessLib
 namespace ComponentTransport
 {
 std::unique_ptr<Process> createComponentTransportProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/CreateProcessData.cpp b/ProcessLib/CreateProcessData.cpp
index cde92a31db7d93dc50ad631247380a49f2267053..921784342fa434fba84a5cc8edcc642997da80ba 100644
--- a/ProcessLib/CreateProcessData.cpp
+++ b/ProcessLib/CreateProcessData.cpp
@@ -30,9 +30,6 @@ static std::unique_ptr<ProcessData> makeProcessData(
 {
     using Tag = NumLib::NonlinearSolverTag;
 
-    NumLib::TimeStep previous_timestep(timestepper->begin());
-    NumLib::TimeStep current_timestep(previous_timestep);
-
     if (auto* nonlinear_solver_picard =
             dynamic_cast<NumLib::NonlinearSolver<Tag::Picard>*>(
                 &nonlinear_solver))
@@ -40,9 +37,8 @@ static std::unique_ptr<ProcessData> makeProcessData(
         nonlinear_solver_picard->compensateNonEquilibriumInitialResiduum(
             compensate_non_equilibrium_initial_residuum);
         return std::make_unique<ProcessData>(
-            previous_timestep, current_timestep, std::move(timestepper),
-            Tag::Picard, *nonlinear_solver_picard, std::move(conv_crit),
-            std::move(time_disc), process_id, process);
+            std::move(timestepper), Tag::Picard, *nonlinear_solver_picard,
+            std::move(conv_crit), std::move(time_disc), process_id, process);
     }
     if (auto* nonlinear_solver_newton =
             dynamic_cast<NumLib::NonlinearSolver<Tag::Newton>*>(
@@ -51,7 +47,6 @@ static std::unique_ptr<ProcessData> makeProcessData(
         nonlinear_solver_newton->compensateNonEquilibriumInitialResiduum(
             compensate_non_equilibrium_initial_residuum);
         return std::make_unique<ProcessData>(
-            std::move(previous_timestep), std::move(current_timestep),
             std::move(timestepper), Tag::Newton, *nonlinear_solver_newton,
             std::move(conv_crit), std::move(time_disc), process_id, process);
     }
@@ -60,9 +55,8 @@ static std::unique_ptr<ProcessData> makeProcessData(
             dynamic_cast<NumLib::PETScNonlinearSolver*>(&nonlinear_solver))
     {
         return std::make_unique<ProcessData>(
-            previous_timestep, current_timestep, std::move(timestepper),
-            Tag::Newton, *nonlinear_solver_petsc, std::move(conv_crit),
-            std::move(time_disc), process_id, process);
+            std::move(timestepper), Tag::Newton, *nonlinear_solver_petsc,
+            std::move(conv_crit), std::move(time_disc), process_id, process);
     }
 #endif  // USE_PETSC
 
diff --git a/ProcessLib/HT/CreateHTProcess.cpp b/ProcessLib/HT/CreateHTProcess.cpp
index 208e66d349b938bb50df8628be11f9fb86ead708..b5f0862f80f5c18747c112123bd58bd25f4efa58 100644
--- a/ProcessLib/HT/CreateHTProcess.cpp
+++ b/ProcessLib/HT/CreateHTProcess.cpp
@@ -62,7 +62,7 @@ void checkMPLProperties(
 }
 
 std::unique_ptr<Process> createHTProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/HT/CreateHTProcess.h b/ProcessLib/HT/CreateHTProcess.h
index 70fe85f3b8df06fa421d9787d4909b2e70ac47c1..f133cc4001dbd0b9b2b4385dd8995c4586eab4d8 100644
--- a/ProcessLib/HT/CreateHTProcess.h
+++ b/ProcessLib/HT/CreateHTProcess.h
@@ -24,7 +24,7 @@ namespace ProcessLib
 namespace HT
 {
 std::unique_ptr<Process> createHTProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/HeatConduction/CreateHeatConductionProcess.cpp b/ProcessLib/HeatConduction/CreateHeatConductionProcess.cpp
index 55609f3352274523a35f20d6691814e18f6b1d9b..d14037c3a52e663f986ba5b47dc5abdcdd99235f 100644
--- a/ProcessLib/HeatConduction/CreateHeatConductionProcess.cpp
+++ b/ProcessLib/HeatConduction/CreateHeatConductionProcess.cpp
@@ -39,7 +39,7 @@ void checkMPLProperties(
 }
 
 std::unique_ptr<Process> createHeatConductionProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/HeatConduction/CreateHeatConductionProcess.h b/ProcessLib/HeatConduction/CreateHeatConductionProcess.h
index 11d1ed854047f4b753a432ba7c7a36786b2d4f77..fc0d5e26a70f96952aaefbda5b94f87250b16b70 100644
--- a/ProcessLib/HeatConduction/CreateHeatConductionProcess.h
+++ b/ProcessLib/HeatConduction/CreateHeatConductionProcess.h
@@ -23,7 +23,7 @@ namespace ProcessLib
 namespace HeatConduction
 {
 std::unique_ptr<Process> createHeatConductionProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/HeatTransportBHE/CreateHeatTransportBHEProcess.cpp b/ProcessLib/HeatTransportBHE/CreateHeatTransportBHEProcess.cpp
index f115c00c62b6c5d0c9e3a38bab7b9b0d12284329..7ca9bcf1dae9d21e16a13835bce4df9cb34c4d51 100644
--- a/ProcessLib/HeatTransportBHE/CreateHeatTransportBHEProcess.cpp
+++ b/ProcessLib/HeatTransportBHE/CreateHeatTransportBHEProcess.cpp
@@ -28,7 +28,7 @@ namespace ProcessLib
 namespace HeatTransportBHE
 {
 std::unique_ptr<Process> createHeatTransportBHEProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/HeatTransportBHE/CreateHeatTransportBHEProcess.h b/ProcessLib/HeatTransportBHE/CreateHeatTransportBHEProcess.h
index c5f0a0328dff12a2dea768bf4b2cfbcafae43a1d..061b55e631ac58307fbe733003f5f88dfdd0d986 100644
--- a/ProcessLib/HeatTransportBHE/CreateHeatTransportBHEProcess.h
+++ b/ProcessLib/HeatTransportBHE/CreateHeatTransportBHEProcess.h
@@ -20,7 +20,7 @@ namespace ProcessLib
 namespace HeatTransportBHE
 {
 std::unique_ptr<Process> createHeatTransportBHEProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/HydroMechanics/CreateHydroMechanicsProcess.cpp b/ProcessLib/HydroMechanics/CreateHydroMechanicsProcess.cpp
index a40c37308aed02ffaa990b4d076f392e21185ef8..35dc9873386ec4764520693e8907529fb14d6108 100644
--- a/ProcessLib/HydroMechanics/CreateHydroMechanicsProcess.cpp
+++ b/ProcessLib/HydroMechanics/CreateHydroMechanicsProcess.cpp
@@ -81,7 +81,7 @@ CouplingScheme parseCouplingScheme(
 
 template <int DisplacementDim>
 std::unique_ptr<Process> createHydroMechanicsProcess(
-    std::string name, MeshLib::Mesh& mesh,
+    std::string const& name, MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
     std::vector<std::unique_ptr<ParameterLib::ParameterBase>> const& parameters,
@@ -259,7 +259,7 @@ std::unique_ptr<Process> createHydroMechanicsProcess(
 }
 
 template std::unique_ptr<Process> createHydroMechanicsProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -271,7 +271,7 @@ template std::unique_ptr<Process> createHydroMechanicsProcess<2>(
     std::map<int, std::shared_ptr<MaterialPropertyLib::Medium>> const& media);
 
 template std::unique_ptr<Process> createHydroMechanicsProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/HydroMechanics/CreateHydroMechanicsProcess.h b/ProcessLib/HydroMechanics/CreateHydroMechanicsProcess.h
index 5d7ce89899f65c0fdcb76875b130b217fb16cc9e..f1b7f1ccb9c3e076d31ebde1c42466fc19fd2933 100644
--- a/ProcessLib/HydroMechanics/CreateHydroMechanicsProcess.h
+++ b/ProcessLib/HydroMechanics/CreateHydroMechanicsProcess.h
@@ -46,7 +46,7 @@ namespace HydroMechanics
 {
 template <int DisplacementDim>
 std::unique_ptr<Process> createHydroMechanicsProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -58,7 +58,7 @@ std::unique_ptr<Process> createHydroMechanicsProcess(
     std::map<int, std::shared_ptr<MaterialPropertyLib::Medium>> const& media);
 
 extern template std::unique_ptr<Process> createHydroMechanicsProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -70,7 +70,7 @@ extern template std::unique_ptr<Process> createHydroMechanicsProcess<2>(
     std::map<int, std::shared_ptr<MaterialPropertyLib::Medium>> const& media);
 
 extern template std::unique_ptr<Process> createHydroMechanicsProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/LIE/Common/LevelSetFunction.cpp b/ProcessLib/LIE/Common/LevelSetFunction.cpp
index 4602b2b1478dbd47d8cb7e2aad32296c2ef64378..d0fb130ebde9c8f580704128b3d0f8d484e7f267 100644
--- a/ProcessLib/LIE/Common/LevelSetFunction.cpp
+++ b/ProcessLib/LIE/Common/LevelSetFunction.cpp
@@ -63,7 +63,7 @@ std::vector<double> uGlobalEnrichments(
             std::accumulate(cbegin(frac->branches_slave),
                             cend(frac->branches_slave), levelsets[i],
                             [&](bool const enrich, auto const& branch)
-                            { return enrich & levelsetBranch(branch, x); }));
+                            { return enrich && levelsetBranch(branch, x); }));
     }
 
     // junctions
diff --git a/ProcessLib/LIE/Common/PostUtils.cpp b/ProcessLib/LIE/Common/PostUtils.cpp
index 2970b6a472062914bad30c5c7f8de60dbaac8f87..d9f550e263fcff26be585e029084cec02bc11972 100644
--- a/ProcessLib/LIE/Common/PostUtils.cpp
+++ b/ProcessLib/LIE/Common/PostUtils.cpp
@@ -212,51 +212,56 @@ PostProcessTool::PostProcessTool(
 
     for (auto [name, property] : _org_mesh.getProperties())
     {
-        if (auto p = dynamic_cast<MeshLib::PropertyVector<double>*>(property))
+        if (auto const* p =
+                dynamic_cast<MeshLib::PropertyVector<double>*>(property))
         {
             copyPropertyValues(*p, createProperty(*p));
         }
-        else if (auto p =
+        else if (auto const* p =
                      dynamic_cast<MeshLib::PropertyVector<float>*>(property))
         {
             copyPropertyValues(*p, createProperty(*p));
         }
-        else if (auto p = dynamic_cast<MeshLib::PropertyVector<int>*>(property))
+        else if (auto const* p =
+                     dynamic_cast<MeshLib::PropertyVector<int>*>(property))
         {
             copyPropertyValues(*p, createProperty(*p));
         }
-        else if (auto p =
+        else if (auto const* p =
                      dynamic_cast<MeshLib::PropertyVector<unsigned>*>(property))
         {
             copyPropertyValues(*p, createProperty(*p));
         }
-        else if (auto p =
+        else if (auto const* p =
                      dynamic_cast<MeshLib::PropertyVector<long>*>(property))
         {
             copyPropertyValues(*p, createProperty(*p));
         }
-        else if (auto p = dynamic_cast<MeshLib::PropertyVector<long long>*>(
-                     property))
+        else if (auto const* p =
+                     dynamic_cast<MeshLib::PropertyVector<long long>*>(
+                         property))
         {
             copyPropertyValues(*p, createProperty(*p));
         }
-        else if (auto p = dynamic_cast<MeshLib::PropertyVector<unsigned long>*>(
-                     property))
+        else if (auto const* p =
+                     dynamic_cast<MeshLib::PropertyVector<unsigned long>*>(
+                         property))
         {
             copyPropertyValues(*p, createProperty(*p));
         }
-        else if (auto p =
+        else if (auto const* p =
                      dynamic_cast<MeshLib::PropertyVector<unsigned long long>*>(
                          property))
         {
             copyPropertyValues(*p, createProperty(*p));
         }
-        else if (auto p = dynamic_cast<MeshLib::PropertyVector<std::size_t>*>(
-                     property))
+        else if (auto const* p =
+                     dynamic_cast<MeshLib::PropertyVector<std::size_t>*>(
+                         property))
         {
             copyPropertyValues(*p, createProperty(*p));
         }
-        else if (auto p =
+        else if (auto const* p =
                      dynamic_cast<MeshLib::PropertyVector<char>*>(property))
         {
             copyPropertyValues(*p, createProperty(*p));
diff --git a/ProcessLib/LIE/HydroMechanics/CreateHydroMechanicsProcess.cpp b/ProcessLib/LIE/HydroMechanics/CreateHydroMechanicsProcess.cpp
index 2d200032113d63846f8280efa220494f1ed62186..58babe6a117d57cb3fe684319b3e5709ce52c709 100644
--- a/ProcessLib/LIE/HydroMechanics/CreateHydroMechanicsProcess.cpp
+++ b/ProcessLib/LIE/HydroMechanics/CreateHydroMechanicsProcess.cpp
@@ -30,7 +30,7 @@ namespace HydroMechanics
 {
 template <int GlobalDim>
 std::unique_ptr<Process> createHydroMechanicsProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -353,7 +353,7 @@ std::unique_ptr<Process> createHydroMechanicsProcess(
 }
 
 template std::unique_ptr<Process> createHydroMechanicsProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -363,7 +363,7 @@ template std::unique_ptr<Process> createHydroMechanicsProcess<2>(
     unsigned const integration_order,
     BaseLib::ConfigTree const& config);
 template std::unique_ptr<Process> createHydroMechanicsProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/LIE/HydroMechanics/CreateHydroMechanicsProcess.h b/ProcessLib/LIE/HydroMechanics/CreateHydroMechanicsProcess.h
index 33a0f1579b824d0db6954b1647ba90643503a1c3..373742615f3ab3e2d999e7b4c0fc98ab28d8dd26 100644
--- a/ProcessLib/LIE/HydroMechanics/CreateHydroMechanicsProcess.h
+++ b/ProcessLib/LIE/HydroMechanics/CreateHydroMechanicsProcess.h
@@ -43,7 +43,7 @@ namespace HydroMechanics
 {
 template <int GlobalDim>
 std::unique_ptr<Process> createHydroMechanicsProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/LIE/SmallDeformation/CreateSmallDeformationProcess.cpp b/ProcessLib/LIE/SmallDeformation/CreateSmallDeformationProcess.cpp
index 8d5dc4824ecea86996ab5390048e555d03789e6a..0c96a1075d9393d462cf14c0234de05faacf33e5 100644
--- a/ProcessLib/LIE/SmallDeformation/CreateSmallDeformationProcess.cpp
+++ b/ProcessLib/LIE/SmallDeformation/CreateSmallDeformationProcess.cpp
@@ -29,7 +29,7 @@ namespace SmallDeformation
 {
 template <int DisplacementDim>
 std::unique_ptr<Process> createSmallDeformationProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -197,7 +197,7 @@ std::unique_ptr<Process> createSmallDeformationProcess(
 }
 
 template std::unique_ptr<Process> createSmallDeformationProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -208,7 +208,7 @@ template std::unique_ptr<Process> createSmallDeformationProcess<2>(
     BaseLib::ConfigTree const& config);
 
 template std::unique_ptr<Process> createSmallDeformationProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/LIE/SmallDeformation/CreateSmallDeformationProcess.h b/ProcessLib/LIE/SmallDeformation/CreateSmallDeformationProcess.h
index ebb0a5858970bb053f43e2cf4c9c6f01a474d1c7..3834f07f6571484956d0a1ce109b307317c79e3f 100644
--- a/ProcessLib/LIE/SmallDeformation/CreateSmallDeformationProcess.h
+++ b/ProcessLib/LIE/SmallDeformation/CreateSmallDeformationProcess.h
@@ -43,7 +43,7 @@ namespace SmallDeformation
 {
 template <int DisplacementDim>
 std::unique_ptr<Process> createSmallDeformationProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/LIE/SmallDeformation/LocalAssembler/SmallDeformationLocalAssemblerFracture-impl.h b/ProcessLib/LIE/SmallDeformation/LocalAssembler/SmallDeformationLocalAssemblerFracture-impl.h
index b214c225e2d98c7a046e669b85fef8356fef6f82..787293cebdc517965203bc3a37856987c952effa 100644
--- a/ProcessLib/LIE/SmallDeformation/LocalAssembler/SmallDeformationLocalAssemblerFracture-impl.h
+++ b/ProcessLib/LIE/SmallDeformation/LocalAssembler/SmallDeformationLocalAssemblerFracture-impl.h
@@ -11,6 +11,8 @@
 #pragma once
 
 #include <Eigen/Core>
+#include <range/v3/range/conversion.hpp>
+#include <range/v3/view/transform.hpp>
 
 #include "MathLib/LinAlg/Eigen/EigenMapTools.h"
 #include "NumLib/Fem/InitShapeMatrices.h"
@@ -62,10 +64,11 @@ SmallDeformationLocalAssemblerFracture<ShapeFunction, DisplacementDim>::
         _fracture_props.push_back(&_process_data.fracture_properties[fid]);
     }
 
-    for (auto jid : process_data._vec_ele_connected_junctionIDs[e.getID()])
-    {
-        _junction_props.push_back(&_process_data.junction_properties[jid]);
-    }
+    _junction_props = process_data._vec_ele_connected_junctionIDs[e.getID()] |
+                      ranges::views::transform(
+                          [&](auto const jid)
+                          { return &_process_data.junction_properties[jid]; }) |
+                      ranges::to<std::vector>;
 
     ParameterLib::SpatialPosition x_position;
     x_position.setElementID(_element.getID());
@@ -184,7 +187,7 @@ void SmallDeformationLocalAssemblerFracture<ShapeFunction, DisplacementDim>::
         auto const& w_prev = ip_data.w_prev;
         auto& C = ip_data.C;
         auto& state = *ip_data.material_state_variables;
-        auto& N = _secondary_data.N[ip];
+        auto const& N = _secondary_data.N[ip];
 
         auto const ip_physical_coords(computePhysicalCoordinates(_element, N));
         std::vector<double> const levelsets(duGlobalEnrichments(
diff --git a/ProcessLib/LIE/SmallDeformation/LocalAssembler/SmallDeformationLocalAssemblerMatrix-impl.h b/ProcessLib/LIE/SmallDeformation/LocalAssembler/SmallDeformationLocalAssemblerMatrix-impl.h
index a026e2d42d33a3056c8ec9c2aae9fdc19dd1020b..895e6f9b98db8ab23e3f1990ac968ec984b88c2b 100644
--- a/ProcessLib/LIE/SmallDeformation/LocalAssembler/SmallDeformationLocalAssemblerMatrix-impl.h
+++ b/ProcessLib/LIE/SmallDeformation/LocalAssembler/SmallDeformationLocalAssemblerMatrix-impl.h
@@ -183,7 +183,7 @@ void SmallDeformationLocalAssemblerMatrix<ShapeFunction, DisplacementDim>::
         _integration_method.getNumberOfPoints();
     for (unsigned ip = 0; ip < n_integration_points; ip++)
     {
-        auto& ip_data = _ip_data[ip];
+        auto const& ip_data = _ip_data[ip];
 
         ele_stress += ip_data._sigma;
         ele_strain += ip_data._eps;
diff --git a/ProcessLib/LIE/SmallDeformation/LocalAssembler/SmallDeformationLocalAssemblerMatrixNearFracture-impl.h b/ProcessLib/LIE/SmallDeformation/LocalAssembler/SmallDeformationLocalAssemblerMatrixNearFracture-impl.h
index ad101a3be4d4fb38d683f4cfa313c564ed143da5..5480e48e890dc595a00528a7944c2c52334c9c89 100644
--- a/ProcessLib/LIE/SmallDeformation/LocalAssembler/SmallDeformationLocalAssemblerMatrixNearFracture-impl.h
+++ b/ProcessLib/LIE/SmallDeformation/LocalAssembler/SmallDeformationLocalAssemblerMatrixNearFracture-impl.h
@@ -11,7 +11,8 @@
 #pragma once
 
 #include <Eigen/Core>
-#include <valarray>
+#include <range/v3/range/conversion.hpp>
+#include <range/v3/view/transform.hpp>
 #include <vector>
 
 #include "IntegrationPointDataMatrix.h"
@@ -107,10 +108,11 @@ SmallDeformationLocalAssemblerMatrixNearFracture<ShapeFunction,
         _fracture_props.push_back(&_process_data.fracture_properties[fid]);
     }
 
-    for (auto jid : process_data._vec_ele_connected_junctionIDs[e.getID()])
-    {
-        _junction_props.push_back(&_process_data.junction_properties[jid]);
-    }
+    _junction_props = process_data._vec_ele_connected_junctionIDs[e.getID()] |
+                      ranges::views::transform(
+                          [&](auto const jid)
+                          { return &_process_data.junction_properties[jid]; }) |
+                      ranges::to<std::vector>;
 }
 
 template <typename ShapeFunction, int DisplacementDim>
@@ -315,7 +317,7 @@ void SmallDeformationLocalAssemblerMatrixNearFracture<ShapeFunction,
         _integration_method.getNumberOfPoints();
     for (unsigned ip = 0; ip < n_integration_points; ip++)
     {
-        auto& ip_data = _ip_data[ip];
+        auto const& ip_data = _ip_data[ip];
 
         ele_stress += ip_data._sigma;
         ele_strain += ip_data._eps;
diff --git a/ProcessLib/LiquidFlow/CreateLiquidFlowProcess.cpp b/ProcessLib/LiquidFlow/CreateLiquidFlowProcess.cpp
index c01dfc07c4cfa4a695d09f7deaed0ef467195f32..3e6cd606ee719fd72ec81e31895539df37110a6c 100644
--- a/ProcessLib/LiquidFlow/CreateLiquidFlowProcess.cpp
+++ b/ProcessLib/LiquidFlow/CreateLiquidFlowProcess.cpp
@@ -53,7 +53,7 @@ void checkMPLProperties(
 }
 
 std::unique_ptr<Process> createLiquidFlowProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/LiquidFlow/CreateLiquidFlowProcess.h b/ProcessLib/LiquidFlow/CreateLiquidFlowProcess.h
index 86944849a79bbae47e7fb795bd86beac68157cb0..00fe636baaf5f91840a347609ab861edde3de185 100644
--- a/ProcessLib/LiquidFlow/CreateLiquidFlowProcess.h
+++ b/ProcessLib/LiquidFlow/CreateLiquidFlowProcess.h
@@ -25,7 +25,7 @@ namespace ProcessLib
 namespace LiquidFlow
 {
 std::unique_ptr<Process> createLiquidFlowProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/PhaseField/CreatePhaseFieldProcess.cpp b/ProcessLib/PhaseField/CreatePhaseFieldProcess.cpp
index 8bafb7080c2d51d960d7c77dfd3bb1066f7847db..3c71b1847f701e7e9f85fae8d34c6e72ca2396e7 100644
--- a/ProcessLib/PhaseField/CreatePhaseFieldProcess.cpp
+++ b/ProcessLib/PhaseField/CreatePhaseFieldProcess.cpp
@@ -26,7 +26,7 @@ namespace PhaseField
 {
 template <int DisplacementDim>
 std::unique_ptr<Process> createPhaseFieldProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -304,7 +304,7 @@ std::unique_ptr<Process> createPhaseFieldProcess(
 }
 
 template std::unique_ptr<Process> createPhaseFieldProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -315,7 +315,7 @@ template std::unique_ptr<Process> createPhaseFieldProcess<2>(
     BaseLib::ConfigTree const& config);
 
 template std::unique_ptr<Process> createPhaseFieldProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/PhaseField/CreatePhaseFieldProcess.h b/ProcessLib/PhaseField/CreatePhaseFieldProcess.h
index bc3d99285a1b3bc9c5f0330679b9114635825ba4..ccd528a186735c505d45e66207cf2d34d9166bc6 100644
--- a/ProcessLib/PhaseField/CreatePhaseFieldProcess.h
+++ b/ProcessLib/PhaseField/CreatePhaseFieldProcess.h
@@ -41,7 +41,7 @@ namespace PhaseField
 {
 template <int DisplacementDim>
 std::unique_ptr<Process> createPhaseFieldProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -52,7 +52,7 @@ std::unique_ptr<Process> createPhaseFieldProcess(
     BaseLib::ConfigTree const& config);
 
 extern template std::unique_ptr<Process> createPhaseFieldProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -63,7 +63,7 @@ extern template std::unique_ptr<Process> createPhaseFieldProcess<2>(
     BaseLib::ConfigTree const& config);
 
 extern template std::unique_ptr<Process> createPhaseFieldProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/ProcessData.h b/ProcessLib/ProcessData.h
index 7aa2c9c4204e5f05a878a64480e2dc926f9de8d6..876c0be9233201411181d3e14a57cf20f3f9968f 100644
--- a/ProcessLib/ProcessData.h
+++ b/ProcessLib/ProcessData.h
@@ -23,16 +23,15 @@ namespace ProcessLib
 struct ProcessData
 {
     ProcessData(
-        NumLib::TimeStep timestep_previous_, NumLib::TimeStep timestep_current_,
         std::unique_ptr<NumLib::TimeStepAlgorithm>&& timestep_algorithm_,
         NumLib::NonlinearSolverTag const nonlinear_solver_tag_,
         NumLib::NonlinearSolverBase& nonlinear_solver_,
         std::unique_ptr<NumLib::ConvergenceCriterion>&& conv_crit_,
         std::unique_ptr<NumLib::TimeDiscretization>&& time_disc_,
         int const process_id_, Process& process_)
-        : timestep_previous(timestep_previous_),
-          timestep_current(timestep_current_),
-          timestep_algorithm(std::move(timestep_algorithm_)),
+        : timestep_algorithm(std::move(timestep_algorithm_)),
+          timestep_previous(timestep_algorithm->begin()),
+          timestep_current(timestep_previous),
           nonlinear_solver_tag(nonlinear_solver_tag_),
           nonlinear_solver(nonlinear_solver_),
           nonlinear_solver_status{true, 0},
@@ -43,24 +42,13 @@ struct ProcessData
     {
     }
 
-    ProcessData(ProcessData&& pd)
-        : timestep_previous(pd.timestep_previous),
-          timestep_current(pd.timestep_current),
-          timestep_algorithm(std::move(pd.timestep_algorithm)),
-          nonlinear_solver_tag(pd.nonlinear_solver_tag),
-          nonlinear_solver(pd.nonlinear_solver),
-          nonlinear_solver_status(pd.nonlinear_solver_status),
-          conv_crit(std::move(pd.conv_crit)),
-          time_disc(std::move(pd.time_disc)),
-          tdisc_ode_sys(std::move(pd.tdisc_ode_sys)),
-          process_id(pd.process_id),
-          process(pd.process)
-    {
-    }
+    ProcessData(ProcessData&& pd) = delete;
+    ProcessData& operator=(ProcessData const& pd) = delete;
+    ProcessData& operator=(ProcessData&& pd) = delete;
 
+    std::unique_ptr<NumLib::TimeStepAlgorithm> timestep_algorithm;
     NumLib::TimeStep timestep_previous;
     NumLib::TimeStep timestep_current;
-    std::unique_ptr<NumLib::TimeStepAlgorithm> timestep_algorithm;
 
     //! Tag containing the missing type information necessary to cast the
     //! other members of this struct to their concrety types.
diff --git a/ProcessLib/RichardsComponentTransport/CreateRichardsComponentTransportProcess.cpp b/ProcessLib/RichardsComponentTransport/CreateRichardsComponentTransportProcess.cpp
index a94e9842b0cbb3015bec52a397fd25cfd88114ee..4af0e66b0a941fb8b63619e78d1b573bf5ab4f9e 100644
--- a/ProcessLib/RichardsComponentTransport/CreateRichardsComponentTransportProcess.cpp
+++ b/ProcessLib/RichardsComponentTransport/CreateRichardsComponentTransportProcess.cpp
@@ -76,7 +76,7 @@ void checkMPLProperties(
 }  // namespace
 
 std::unique_ptr<Process> createRichardsComponentTransportProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/RichardsComponentTransport/CreateRichardsComponentTransportProcess.h b/ProcessLib/RichardsComponentTransport/CreateRichardsComponentTransportProcess.h
index 62dbda48b54ee410ca251b4ea33ab1815f0b634c..802c915669f02b86a0e102c7251f879352e55cb5 100644
--- a/ProcessLib/RichardsComponentTransport/CreateRichardsComponentTransportProcess.h
+++ b/ProcessLib/RichardsComponentTransport/CreateRichardsComponentTransportProcess.h
@@ -24,7 +24,7 @@ namespace ProcessLib
 namespace RichardsComponentTransport
 {
 std::unique_ptr<Process> createRichardsComponentTransportProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/RichardsFlow/CreateRichardsFlowProcess.cpp b/ProcessLib/RichardsFlow/CreateRichardsFlowProcess.cpp
index e91927e5c15447a8fef85468570edc7d04209f32..7b977846acd2cdce20e25d74ebc9b512ad92ccae 100644
--- a/ProcessLib/RichardsFlow/CreateRichardsFlowProcess.cpp
+++ b/ProcessLib/RichardsFlow/CreateRichardsFlowProcess.cpp
@@ -50,7 +50,7 @@ void checkMPLProperties(
 }
 
 std::unique_ptr<Process> createRichardsFlowProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/RichardsFlow/CreateRichardsFlowProcess.h b/ProcessLib/RichardsFlow/CreateRichardsFlowProcess.h
index dddefcff8f7082b797cadf25cf4d63d769c624ec..7bdbc3b6d11baa50a0e48ce2cb590658a175ca79 100644
--- a/ProcessLib/RichardsFlow/CreateRichardsFlowProcess.h
+++ b/ProcessLib/RichardsFlow/CreateRichardsFlowProcess.h
@@ -23,7 +23,7 @@ namespace ProcessLib
 namespace RichardsFlow
 {
 std::unique_ptr<Process> createRichardsFlowProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/RichardsMechanics/CreateRichardsMechanicsProcess.cpp b/ProcessLib/RichardsMechanics/CreateRichardsMechanicsProcess.cpp
index 0d77b0d18990a0e931a46ceadc10a4193f0537ad..8efe2cdf3f2f81981cfd16415e8ea19438bebb86 100644
--- a/ProcessLib/RichardsMechanics/CreateRichardsMechanicsProcess.cpp
+++ b/ProcessLib/RichardsMechanics/CreateRichardsMechanicsProcess.cpp
@@ -54,7 +54,7 @@ void checkMPLProperties(
 
 template <int DisplacementDim>
 std::unique_ptr<Process> createRichardsMechanicsProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -218,7 +218,7 @@ std::unique_ptr<Process> createRichardsMechanicsProcess(
 }
 
 template std::unique_ptr<Process> createRichardsMechanicsProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -230,7 +230,7 @@ template std::unique_ptr<Process> createRichardsMechanicsProcess<2>(
     std::map<int, std::shared_ptr<MaterialPropertyLib::Medium>> const& media);
 
 template std::unique_ptr<Process> createRichardsMechanicsProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/RichardsMechanics/CreateRichardsMechanicsProcess.h b/ProcessLib/RichardsMechanics/CreateRichardsMechanicsProcess.h
index 0657170f92147175d7ef7dfa8525c32c46703b81..614b34fe1571408873034126865b298cb3a99063 100644
--- a/ProcessLib/RichardsMechanics/CreateRichardsMechanicsProcess.h
+++ b/ProcessLib/RichardsMechanics/CreateRichardsMechanicsProcess.h
@@ -50,7 +50,7 @@ namespace RichardsMechanics
 {
 template <int DisplacementDim>
 std::unique_ptr<Process> createRichardsMechanicsProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -62,7 +62,7 @@ std::unique_ptr<Process> createRichardsMechanicsProcess(
     std::map<int, std::shared_ptr<MaterialPropertyLib::Medium>> const& media);
 
 extern template std::unique_ptr<Process> createRichardsMechanicsProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -74,7 +74,7 @@ extern template std::unique_ptr<Process> createRichardsMechanicsProcess<2>(
     std::map<int, std::shared_ptr<MaterialPropertyLib::Medium>> const& media);
 
 extern template std::unique_ptr<Process> createRichardsMechanicsProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/SmallDeformation/CreateSmallDeformationProcess.cpp b/ProcessLib/SmallDeformation/CreateSmallDeformationProcess.cpp
index 1ec05ff5627d3fe6559cfaf236103a640fb68864..0bab8b56a0f9c0d3f855db5807fe1f70898afc1e 100644
--- a/ProcessLib/SmallDeformation/CreateSmallDeformationProcess.cpp
+++ b/ProcessLib/SmallDeformation/CreateSmallDeformationProcess.cpp
@@ -25,7 +25,7 @@ namespace SmallDeformation
 {
 template <int DisplacementDim>
 std::unique_ptr<Process> createSmallDeformationProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -133,7 +133,7 @@ std::unique_ptr<Process> createSmallDeformationProcess(
 }
 
 template std::unique_ptr<Process> createSmallDeformationProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -144,7 +144,7 @@ template std::unique_ptr<Process> createSmallDeformationProcess<2>(
     BaseLib::ConfigTree const& config);
 
 template std::unique_ptr<Process> createSmallDeformationProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/SmallDeformation/CreateSmallDeformationProcess.h b/ProcessLib/SmallDeformation/CreateSmallDeformationProcess.h
index bcd1b88f57455571cc5849c7409025b1b374db45..cd126daa3235a698c69ab2b8039200e9278893f3 100644
--- a/ProcessLib/SmallDeformation/CreateSmallDeformationProcess.h
+++ b/ProcessLib/SmallDeformation/CreateSmallDeformationProcess.h
@@ -41,7 +41,7 @@ namespace SmallDeformation
 {
 template <int DisplacementDim>
 std::unique_ptr<Process> createSmallDeformationProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -52,7 +52,7 @@ std::unique_ptr<Process> createSmallDeformationProcess(
     BaseLib::ConfigTree const& config);
 
 extern template std::unique_ptr<Process> createSmallDeformationProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -63,7 +63,7 @@ extern template std::unique_ptr<Process> createSmallDeformationProcess<2>(
     BaseLib::ConfigTree const& config);
 
 extern template std::unique_ptr<Process> createSmallDeformationProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/SmallDeformationNonlocal/CreateSmallDeformationNonlocalProcess.cpp b/ProcessLib/SmallDeformationNonlocal/CreateSmallDeformationNonlocalProcess.cpp
index f52d00d3fccd22fab9a9c6e15692b3c0acef34f7..9f088519881464f227692d5ba716c04ed348cf0d 100644
--- a/ProcessLib/SmallDeformationNonlocal/CreateSmallDeformationNonlocalProcess.cpp
+++ b/ProcessLib/SmallDeformationNonlocal/CreateSmallDeformationNonlocalProcess.cpp
@@ -25,7 +25,7 @@ namespace SmallDeformationNonlocal
 {
 template <int DisplacementDim>
 std::unique_ptr<Process> createSmallDeformationNonlocalProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -124,7 +124,7 @@ std::unique_ptr<Process> createSmallDeformationNonlocalProcess(
 }
 
 template std::unique_ptr<Process> createSmallDeformationNonlocalProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -135,7 +135,7 @@ template std::unique_ptr<Process> createSmallDeformationNonlocalProcess<2>(
     BaseLib::ConfigTree const& config);
 
 template std::unique_ptr<Process> createSmallDeformationNonlocalProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/SmallDeformationNonlocal/CreateSmallDeformationNonlocalProcess.h b/ProcessLib/SmallDeformationNonlocal/CreateSmallDeformationNonlocalProcess.h
index e53ddfdbcc90b6d469bc110e53507c44931c98c4..36b51b8f7e5efebd0e1ce2bbb1f7bcf83068329a 100644
--- a/ProcessLib/SmallDeformationNonlocal/CreateSmallDeformationNonlocalProcess.h
+++ b/ProcessLib/SmallDeformationNonlocal/CreateSmallDeformationNonlocalProcess.h
@@ -41,7 +41,7 @@ namespace SmallDeformationNonlocal
 {
 template <int DisplacementDim>
 std::unique_ptr<Process> createSmallDeformationNonlocalProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -53,7 +53,7 @@ std::unique_ptr<Process> createSmallDeformationNonlocalProcess(
 
 extern template std::unique_ptr<Process>
 createSmallDeformationNonlocalProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -65,7 +65,7 @@ createSmallDeformationNonlocalProcess<2>(
 
 extern template std::unique_ptr<Process>
 createSmallDeformationNonlocalProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/SteadyStateDiffusion/CreateSteadyStateDiffusion.cpp b/ProcessLib/SteadyStateDiffusion/CreateSteadyStateDiffusion.cpp
index 701fc67b45c85cab1bcd508f0c16176e61270011..51a1facba0b7a1646e835791fa5a8880e920f869 100644
--- a/ProcessLib/SteadyStateDiffusion/CreateSteadyStateDiffusion.cpp
+++ b/ProcessLib/SteadyStateDiffusion/CreateSteadyStateDiffusion.cpp
@@ -39,7 +39,7 @@ void checkMPLProperties(
 }
 
 std::unique_ptr<Process> createSteadyStateDiffusion(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/SteadyStateDiffusion/CreateSteadyStateDiffusion.h b/ProcessLib/SteadyStateDiffusion/CreateSteadyStateDiffusion.h
index 74572e2585a56905ff1036e9acd67f982b2ab249..19a3cdd70150aec8eebec4015ee8abc712cfa916 100644
--- a/ProcessLib/SteadyStateDiffusion/CreateSteadyStateDiffusion.h
+++ b/ProcessLib/SteadyStateDiffusion/CreateSteadyStateDiffusion.h
@@ -23,7 +23,7 @@ namespace ProcessLib
 namespace SteadyStateDiffusion
 {
 std::unique_ptr<Process> createSteadyStateDiffusion(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/StokesFlow/CreateStokesFlowProcess.cpp b/ProcessLib/StokesFlow/CreateStokesFlowProcess.cpp
index 955011e536ee1ad909d4e99bf9d4c60195223c5c..90264123151898959c5c609fdebb3a180e54cf3e 100644
--- a/ProcessLib/StokesFlow/CreateStokesFlowProcess.cpp
+++ b/ProcessLib/StokesFlow/CreateStokesFlowProcess.cpp
@@ -52,7 +52,7 @@ void checkMPLProperties(
 
 template <int GlobalDim>
 std::unique_ptr<Process> createStokesFlowProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -166,7 +166,7 @@ std::unique_ptr<Process> createStokesFlowProcess(
 }
 
 template std::unique_ptr<Process> createStokesFlowProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/StokesFlow/CreateStokesFlowProcess.h b/ProcessLib/StokesFlow/CreateStokesFlowProcess.h
index 16065a8e3fd36329b7d171fd178e49cd0affea96..ef32fb61cc8322ed021e89fcf102e91ad847e486 100644
--- a/ProcessLib/StokesFlow/CreateStokesFlowProcess.h
+++ b/ProcessLib/StokesFlow/CreateStokesFlowProcess.h
@@ -23,7 +23,7 @@ namespace ProcessLib::StokesFlow
 {
 template <int GlobalDim>
 std::unique_ptr<Process> createStokesFlowProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -33,7 +33,7 @@ std::unique_ptr<Process> createStokesFlowProcess(
     std::map<int, std::shared_ptr<MaterialPropertyLib::Medium>> const& media);
 
 extern template std::unique_ptr<Process> createStokesFlowProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/TES/CreateTESProcess.cpp b/ProcessLib/TES/CreateTESProcess.cpp
index dc628569649bd6dedf4fc3898ddc5e36366d5dbc..7ea9d862c8a796a59cbd8d4a47f3ad9605b071f7 100644
--- a/ProcessLib/TES/CreateTESProcess.cpp
+++ b/ProcessLib/TES/CreateTESProcess.cpp
@@ -19,7 +19,7 @@ namespace ProcessLib
 namespace TES
 {
 std::unique_ptr<Process> createTESProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/TES/CreateTESProcess.h b/ProcessLib/TES/CreateTESProcess.h
index eecd6ff78a3a725dcab6b5cb2c7186aeacd9973a..9c5af9ee0f5d7d0bcf77134a1f0c8ad0db34df60 100644
--- a/ProcessLib/TES/CreateTESProcess.h
+++ b/ProcessLib/TES/CreateTESProcess.h
@@ -18,7 +18,7 @@ namespace ProcessLib
 namespace TES
 {
 std::unique_ptr<Process> createTESProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/TH2M/CreateTH2MProcess.cpp b/ProcessLib/TH2M/CreateTH2MProcess.cpp
index adfe6c372425b7a56317e4598a8da650b09ac1a7..ebcd1dcb8d6c48cc720ade05808f487ebec82920 100644
--- a/ProcessLib/TH2M/CreateTH2MProcess.cpp
+++ b/ProcessLib/TH2M/CreateTH2MProcess.cpp
@@ -53,7 +53,7 @@ std::unique_ptr<PhaseTransitionModel> createPhaseTransitionModel(
 
 template <int DisplacementDim>
 std::unique_ptr<Process> createTH2MProcess(
-    std::string name, MeshLib::Mesh& mesh,
+    std::string const& name, MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
     std::vector<std::unique_ptr<ParameterLib::ParameterBase>> const& parameters,
@@ -249,7 +249,7 @@ std::unique_ptr<Process> createTH2MProcess(
 }
 
 template std::unique_ptr<Process> createTH2MProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -261,7 +261,7 @@ template std::unique_ptr<Process> createTH2MProcess<2>(
     std::map<int, std::shared_ptr<MaterialPropertyLib::Medium>> const& media);
 
 template std::unique_ptr<Process> createTH2MProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/TH2M/CreateTH2MProcess.h b/ProcessLib/TH2M/CreateTH2MProcess.h
index f2b3a5f110afb9927e1bca69b5874b1d581eed54..208628e8e325a4954f614259d0713afe205239be 100644
--- a/ProcessLib/TH2M/CreateTH2MProcess.h
+++ b/ProcessLib/TH2M/CreateTH2MProcess.h
@@ -49,7 +49,7 @@ namespace TH2M
 {
 template <int DisplacementDim>
 std::unique_ptr<Process> createTH2MProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -61,7 +61,7 @@ std::unique_ptr<Process> createTH2MProcess(
     std::map<int, std::shared_ptr<MaterialPropertyLib::Medium>> const& media);
 
 extern template std::unique_ptr<Process> createTH2MProcess<2>(
-    std::string name, MeshLib::Mesh& mesh,
+    std::string const& name, MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
     std::vector<std::unique_ptr<ParameterLib::ParameterBase>> const& parameters,
@@ -71,7 +71,7 @@ extern template std::unique_ptr<Process> createTH2MProcess<2>(
     std::map<int, std::shared_ptr<MaterialPropertyLib::Medium>> const& media);
 
 extern template std::unique_ptr<Process> createTH2MProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/ThermalTwoPhaseFlowWithPP/CreateThermalTwoPhaseFlowWithPPProcess.cpp b/ProcessLib/ThermalTwoPhaseFlowWithPP/CreateThermalTwoPhaseFlowWithPPProcess.cpp
index 229e9cb6719a5d6808489f57a33497eb8eea41c4..953fc6e88f18e2f1f383b32ada42d00d7941d9dc 100644
--- a/ProcessLib/ThermalTwoPhaseFlowWithPP/CreateThermalTwoPhaseFlowWithPPProcess.cpp
+++ b/ProcessLib/ThermalTwoPhaseFlowWithPP/CreateThermalTwoPhaseFlowWithPPProcess.cpp
@@ -92,7 +92,7 @@ void checkMPLProperties(
 }
 
 std::unique_ptr<Process> createThermalTwoPhaseFlowWithPPProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/ThermalTwoPhaseFlowWithPP/CreateThermalTwoPhaseFlowWithPPProcess.h b/ProcessLib/ThermalTwoPhaseFlowWithPP/CreateThermalTwoPhaseFlowWithPPProcess.h
index 0857171bd65bcddc02670a8d1a7aff0cc0b31031..964326edab41a08b36c70c0133bc4128f551a057 100644
--- a/ProcessLib/ThermalTwoPhaseFlowWithPP/CreateThermalTwoPhaseFlowWithPPProcess.h
+++ b/ProcessLib/ThermalTwoPhaseFlowWithPP/CreateThermalTwoPhaseFlowWithPPProcess.h
@@ -20,7 +20,7 @@ namespace ProcessLib
 namespace ThermalTwoPhaseFlowWithPP
 {
 std::unique_ptr<Process> createThermalTwoPhaseFlowWithPPProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/ThermoHydroMechanics/CreateThermoHydroMechanicsProcess.cpp b/ProcessLib/ThermoHydroMechanics/CreateThermoHydroMechanicsProcess.cpp
index 64985ebfb0ae2bf4b44d0be88cf44d4d82b86d64..fb985caf257b8a0a62058ab480df75bae6ec24fa 100644
--- a/ProcessLib/ThermoHydroMechanics/CreateThermoHydroMechanicsProcess.cpp
+++ b/ProcessLib/ThermoHydroMechanics/CreateThermoHydroMechanicsProcess.cpp
@@ -30,7 +30,7 @@ namespace ThermoHydroMechanics
 {
 template <int DisplacementDim>
 std::unique_ptr<Process> createThermoHydroMechanicsProcess(
-    std::string name, MeshLib::Mesh& mesh,
+    std::string const& name, MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
     std::vector<std::unique_ptr<ParameterLib::ParameterBase>> const& parameters,
@@ -203,7 +203,7 @@ std::unique_ptr<Process> createThermoHydroMechanicsProcess(
 }
 
 template std::unique_ptr<Process> createThermoHydroMechanicsProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -215,7 +215,7 @@ template std::unique_ptr<Process> createThermoHydroMechanicsProcess<2>(
     std::map<int, std::shared_ptr<MaterialPropertyLib::Medium>> const& media);
 
 template std::unique_ptr<Process> createThermoHydroMechanicsProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/ThermoHydroMechanics/CreateThermoHydroMechanicsProcess.h b/ProcessLib/ThermoHydroMechanics/CreateThermoHydroMechanicsProcess.h
index 53b0218fedbbd8ecb557d66b06a0c2ad496d12eb..40fe60f7d74d5ebed69929c89220bcf5e2897573 100644
--- a/ProcessLib/ThermoHydroMechanics/CreateThermoHydroMechanicsProcess.h
+++ b/ProcessLib/ThermoHydroMechanics/CreateThermoHydroMechanicsProcess.h
@@ -49,7 +49,7 @@ namespace ThermoHydroMechanics
 {
 template <int DisplacementDim>
 std::unique_ptr<Process> createThermoHydroMechanicsProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -61,7 +61,7 @@ std::unique_ptr<Process> createThermoHydroMechanicsProcess(
     std::map<int, std::shared_ptr<MaterialPropertyLib::Medium>> const& media);
 
 extern template std::unique_ptr<Process> createThermoHydroMechanicsProcess<2>(
-    std::string name, MeshLib::Mesh& mesh,
+    std::string const& name, MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
     std::vector<std::unique_ptr<ParameterLib::ParameterBase>> const& parameters,
@@ -71,7 +71,7 @@ extern template std::unique_ptr<Process> createThermoHydroMechanicsProcess<2>(
     std::map<int, std::shared_ptr<MaterialPropertyLib::Medium>> const& media);
 
 extern template std::unique_ptr<Process> createThermoHydroMechanicsProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/ThermoMechanicalPhaseField/CreateThermoMechanicalPhaseFieldProcess.cpp b/ProcessLib/ThermoMechanicalPhaseField/CreateThermoMechanicalPhaseFieldProcess.cpp
index 866126aab172cac3883439b4c8943fa5a5995509..7b74054e52456b706894d52654d0c832c7648e3f 100644
--- a/ProcessLib/ThermoMechanicalPhaseField/CreateThermoMechanicalPhaseFieldProcess.cpp
+++ b/ProcessLib/ThermoMechanicalPhaseField/CreateThermoMechanicalPhaseFieldProcess.cpp
@@ -26,7 +26,7 @@ namespace ThermoMechanicalPhaseField
 {
 template <int DisplacementDim>
 std::unique_ptr<Process> createThermoMechanicalPhaseFieldProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -244,7 +244,7 @@ std::unique_ptr<Process> createThermoMechanicalPhaseFieldProcess(
 }
 
 template std::unique_ptr<Process> createThermoMechanicalPhaseFieldProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -255,7 +255,7 @@ template std::unique_ptr<Process> createThermoMechanicalPhaseFieldProcess<2>(
     BaseLib::ConfigTree const& config);
 
 template std::unique_ptr<Process> createThermoMechanicalPhaseFieldProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/ThermoMechanicalPhaseField/CreateThermoMechanicalPhaseFieldProcess.h b/ProcessLib/ThermoMechanicalPhaseField/CreateThermoMechanicalPhaseFieldProcess.h
index 770b7802a805471510f880e57c7fd6ed009dcab7..f37ab151c2f475eaedb5965391ec7703beb6575e 100644
--- a/ProcessLib/ThermoMechanicalPhaseField/CreateThermoMechanicalPhaseFieldProcess.h
+++ b/ProcessLib/ThermoMechanicalPhaseField/CreateThermoMechanicalPhaseFieldProcess.h
@@ -41,7 +41,7 @@ namespace ThermoMechanicalPhaseField
 {
 template <int DisplacementDim>
 std::unique_ptr<Process> createThermoMechanicalPhaseFieldProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -53,7 +53,7 @@ std::unique_ptr<Process> createThermoMechanicalPhaseFieldProcess(
 
 extern template std::unique_ptr<Process>
 createThermoMechanicalPhaseFieldProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -65,7 +65,7 @@ createThermoMechanicalPhaseFieldProcess<2>(
 
 extern template std::unique_ptr<Process>
 createThermoMechanicalPhaseFieldProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/ThermoMechanics/CreateThermoMechanicsProcess.cpp b/ProcessLib/ThermoMechanics/CreateThermoMechanicsProcess.cpp
index daff8c8f7a4d3394e3026f88f8667d1d190c91f2..3d8d083b87b615f2cfefd3c219e49ec024ee1364 100644
--- a/ProcessLib/ThermoMechanics/CreateThermoMechanicsProcess.cpp
+++ b/ProcessLib/ThermoMechanics/CreateThermoMechanicsProcess.cpp
@@ -44,7 +44,7 @@ void checkMPLProperties(
 
 template <int DisplacementDim>
 std::unique_ptr<Process> createThermoMechanicsProcess(
-    std::string name, MeshLib::Mesh& mesh,
+    std::string const& name, MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
     std::vector<std::unique_ptr<ParameterLib::ParameterBase>> const& parameters,
@@ -191,7 +191,7 @@ std::unique_ptr<Process> createThermoMechanicsProcess(
 }
 
 template std::unique_ptr<Process> createThermoMechanicsProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -203,7 +203,7 @@ template std::unique_ptr<Process> createThermoMechanicsProcess<2>(
     std::map<int, std::shared_ptr<MaterialPropertyLib::Medium>> const& media);
 
 template std::unique_ptr<Process> createThermoMechanicsProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/ThermoMechanics/CreateThermoMechanicsProcess.h b/ProcessLib/ThermoMechanics/CreateThermoMechanicsProcess.h
index 4fd2e31dfc62004276895e96256d1d4ec8ecec7a..8580cb3e89da15cb15ea9ba18166cd9d8b1ca513 100644
--- a/ProcessLib/ThermoMechanics/CreateThermoMechanicsProcess.h
+++ b/ProcessLib/ThermoMechanics/CreateThermoMechanicsProcess.h
@@ -48,7 +48,7 @@ namespace ThermoMechanics
 {
 template <int DisplacementDim>
 std::unique_ptr<Process> createThermoMechanicsProcess(
-    std::string name, MeshLib::Mesh& mesh,
+    std::string const& name, MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
     std::vector<std::unique_ptr<ParameterLib::ParameterBase>> const& parameters,
@@ -58,7 +58,7 @@ std::unique_ptr<Process> createThermoMechanicsProcess(
     std::map<int, std::shared_ptr<MaterialPropertyLib::Medium>> const& media);
 
 extern template std::unique_ptr<Process> createThermoMechanicsProcess<2>(
-    std::string name, MeshLib::Mesh& mesh,
+    std::string const& name, MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
     std::vector<std::unique_ptr<ParameterLib::ParameterBase>> const& parameters,
@@ -68,7 +68,7 @@ extern template std::unique_ptr<Process> createThermoMechanicsProcess<2>(
     std::map<int, std::shared_ptr<MaterialPropertyLib::Medium>> const& media);
 
 extern template std::unique_ptr<Process> createThermoMechanicsProcess<3>(
-    std::string name, MeshLib::Mesh& mesh,
+    std::string const& name, MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
     std::vector<std::unique_ptr<ParameterLib::ParameterBase>> const& parameters,
diff --git a/ProcessLib/ThermoRichardsFlow/CreateThermoRichardsFlowProcess.cpp b/ProcessLib/ThermoRichardsFlow/CreateThermoRichardsFlowProcess.cpp
index 664b1f64af796a9e0b48500fa5f91b900a3d2cd3..0a32fa6d66ee0d45fab837ac1870a78811b46764 100644
--- a/ProcessLib/ThermoRichardsFlow/CreateThermoRichardsFlowProcess.cpp
+++ b/ProcessLib/ThermoRichardsFlow/CreateThermoRichardsFlowProcess.cpp
@@ -45,7 +45,7 @@ void checkMPLProperties(
     std::array const required_solid_properties = {MaterialPropertyLib::density};
 
     // Thermal properties are not checked because they can be phase property or
-    // meduim property (will be enabled later).
+    // medium property (will be enabled later).
     for (auto const& m : media)
     {
         checkRequiredProperties(*m.second, required_medium_properties);
@@ -69,7 +69,7 @@ void checkProcessVariableComponents(ProcessVariable const& variable)
 }
 
 std::unique_ptr<Process> createThermoRichardsFlowProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/ThermoRichardsFlow/CreateThermoRichardsFlowProcess.h b/ProcessLib/ThermoRichardsFlow/CreateThermoRichardsFlowProcess.h
index cad36d142506358154a1c1dd8dc4dc22f9433cc0..36ea142fbd4f0e74c20b8640e5fd952adb6d5d83 100644
--- a/ProcessLib/ThermoRichardsFlow/CreateThermoRichardsFlowProcess.h
+++ b/ProcessLib/ThermoRichardsFlow/CreateThermoRichardsFlowProcess.h
@@ -43,7 +43,7 @@ namespace ProcessLib
 namespace ThermoRichardsFlow
 {
 std::unique_ptr<Process> createThermoRichardsFlowProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/ThermoRichardsMechanics/CreateThermoRichardsMechanicsProcess.cpp b/ProcessLib/ThermoRichardsMechanics/CreateThermoRichardsMechanicsProcess.cpp
index 505714afbac23fa969463c866e424cc4c2627c00..dc0b718815bb267a1ee727454ecc970fb4f0c271 100644
--- a/ProcessLib/ThermoRichardsMechanics/CreateThermoRichardsMechanicsProcess.cpp
+++ b/ProcessLib/ThermoRichardsMechanics/CreateThermoRichardsMechanicsProcess.cpp
@@ -46,7 +46,7 @@ void checkMPLProperties(
     std::array const required_solid_properties = {MaterialPropertyLib::density};
 
     // Thermal properties are not checked because they can be phase property or
-    // meduim property (will be enabled later).
+    // medium property (will be enabled later).
     for (auto const& m : media)
     {
         checkRequiredProperties(*m.second, required_medium_properties);
@@ -77,7 +77,7 @@ void checkProcessVariableComponents(ProcessVariable const& variable,
 template <int DisplacementDim, typename ConstitutiveTraits,
           typename CreateConstitutiveSetting>
 std::unique_ptr<Process> createThermoRichardsMechanicsProcessStage2(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -209,7 +209,7 @@ std::unique_ptr<Process> createThermoRichardsMechanicsProcessStage2(
 
     return std::make_unique<
         ThermoRichardsMechanicsProcess<DisplacementDim, ConstitutiveTraits>>(
-        std::move(name), mesh, std::move(jacobian_assembler), parameters,
+        name, mesh, std::move(jacobian_assembler), parameters,
         integration_order, std::move(process_variables),
         std::move(process_data), std::move(secondary_variables),
         use_monolithic_scheme);
@@ -217,7 +217,7 @@ std::unique_ptr<Process> createThermoRichardsMechanicsProcessStage2(
 
 template <int DisplacementDim>
 std::unique_ptr<Process> createThermoRichardsMechanicsProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -272,7 +272,7 @@ std::unique_ptr<Process> createThermoRichardsMechanicsProcess(
 }
 
 template std::unique_ptr<Process> createThermoRichardsMechanicsProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -284,7 +284,7 @@ template std::unique_ptr<Process> createThermoRichardsMechanicsProcess<2>(
     std::map<int, std::shared_ptr<MaterialPropertyLib::Medium>> const& media);
 
 template std::unique_ptr<Process> createThermoRichardsMechanicsProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/ThermoRichardsMechanics/CreateThermoRichardsMechanicsProcess.h b/ProcessLib/ThermoRichardsMechanics/CreateThermoRichardsMechanicsProcess.h
index 2c0626f37f40ae790788b2aed37b9cc02dae29a7..f4a579ca256e0e8a3b5a50655a98679a1ad6e3c0 100644
--- a/ProcessLib/ThermoRichardsMechanics/CreateThermoRichardsMechanicsProcess.h
+++ b/ProcessLib/ThermoRichardsMechanics/CreateThermoRichardsMechanicsProcess.h
@@ -24,10 +24,6 @@ namespace MeshLib
 {
 class Mesh;
 }
-namespace MathLib
-{
-class PiecewiseLinearInterpolation;
-}
 namespace MaterialPropertyLib
 {
 class Medium;
@@ -50,7 +46,7 @@ namespace ThermoRichardsMechanics
 {
 template <int DisplacementDim>
 std::unique_ptr<Process> createThermoRichardsMechanicsProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -63,7 +59,7 @@ std::unique_ptr<Process> createThermoRichardsMechanicsProcess(
 
 extern template std::unique_ptr<Process>
 createThermoRichardsMechanicsProcess<2>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
@@ -76,7 +72,7 @@ createThermoRichardsMechanicsProcess<2>(
 
 extern template std::unique_ptr<Process>
 createThermoRichardsMechanicsProcess<3>(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/TimeLoop.cpp b/ProcessLib/TimeLoop.cpp
index 28633f000deafddb0ff415bb4bfdbf13f11d00f5..ddd7026da8160826542f102c9343f8d1b775b844 100644
--- a/ProcessLib/TimeLoop.cpp
+++ b/ProcessLib/TimeLoop.cpp
@@ -151,7 +151,7 @@ setInitialConditions(
     std::vector<GlobalVector*> process_solutions;
     std::vector<GlobalVector*> process_solutions_prev;
 
-    for (auto& process_data : per_process_data)
+    for (auto const& process_data : per_process_data)
     {
         auto const process_id = process_data->process_id;
         auto& ode_sys = *process_data->tdisc_ode_sys;
@@ -165,7 +165,7 @@ setInitialConditions(
                 ode_sys.getMatrixSpecifications(process_id)));
     }
 
-    for (auto& process_data : per_process_data)
+    for (auto const& process_data : per_process_data)
     {
         auto& pcs = process_data->process;
         auto const process_id = process_data->process_id;
@@ -184,7 +184,7 @@ void calculateNonEquilibriumInitialResiduum(
     std::vector<GlobalVector*> const& process_solutions,
     std::vector<GlobalVector*> const& process_solutions_prev)
 {
-    for (auto& process_data : per_process_data)
+    for (auto const& process_data : per_process_data)
     {
         auto& nonlinear_solver = process_data->nonlinear_solver;
 
@@ -255,7 +255,7 @@ TimeLoop::TimeLoop(std::vector<Output>&& outputs,
 
 void TimeLoop::setCoupledSolutions()
 {
-    for (auto& process_data : _per_process_data)
+    for (auto const& process_data : _per_process_data)
     {
         auto const& x = *_process_solutions[process_data->process_id];
 
@@ -465,7 +465,7 @@ TimeLoop::generateOutputTimeStepConstraints(
 /// initialize output, convergence criterion, etc.
 void TimeLoop::initialize()
 {
-    for (auto& process_data : _per_process_data)
+    for (auto const& process_data : _per_process_data)
     {
         auto& pcs = process_data->process;
         for (auto& output : _outputs)
@@ -656,7 +656,7 @@ NumLib::NonlinearSolverStatus TimeLoop::solveUncoupledEquationSystems(
 {
     NumLib::NonlinearSolverStatus nonlinear_solver_status;
 
-    for (auto& process_data : _per_process_data)
+    for (auto const& process_data : _per_process_data)
     {
         auto const process_id = process_data->process_id;
         nonlinear_solver_status = solveMonolithicProcess(
@@ -796,7 +796,7 @@ TimeLoop::solveCoupledEquationSystemsByStaggeredScheme(
     }
 
     {
-        for (auto& process_data : _per_process_data)
+        for (auto const& process_data : _per_process_data)
         {
             auto& pcs = process_data->process;
             int const process_id = process_data->process_id;
@@ -826,7 +826,7 @@ void TimeLoop::outputSolutions(bool const output_initial_condition,
     bool const is_staggered_coupling =
         !isMonolithicProcess(*_per_process_data[0]);
 
-    for (auto& process_data : _per_process_data)
+    for (auto const& process_data : _per_process_data)
     {
         // If nonlinear solver diverged, the solution has already been
         // saved.
diff --git a/ProcessLib/TwoPhaseFlowWithPP/CreateTwoPhaseFlowWithPPProcess.cpp b/ProcessLib/TwoPhaseFlowWithPP/CreateTwoPhaseFlowWithPPProcess.cpp
index 13075941f4c51ae4c355d912a91deb7665de5d7f..d75f4a6487aefaf855a198bd52cbad9d447dea17 100644
--- a/ProcessLib/TwoPhaseFlowWithPP/CreateTwoPhaseFlowWithPPProcess.cpp
+++ b/ProcessLib/TwoPhaseFlowWithPP/CreateTwoPhaseFlowWithPPProcess.cpp
@@ -23,7 +23,7 @@ namespace ProcessLib
 namespace TwoPhaseFlowWithPP
 {
 std::unique_ptr<Process> createTwoPhaseFlowWithPPProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/TwoPhaseFlowWithPP/CreateTwoPhaseFlowWithPPProcess.h b/ProcessLib/TwoPhaseFlowWithPP/CreateTwoPhaseFlowWithPPProcess.h
index 792dcbc3f8899734bda2fc33a96a9b0ed6d45c3f..a4f95a985c4922c23a2a93840351b2e86152c373 100644
--- a/ProcessLib/TwoPhaseFlowWithPP/CreateTwoPhaseFlowWithPPProcess.h
+++ b/ProcessLib/TwoPhaseFlowWithPP/CreateTwoPhaseFlowWithPPProcess.h
@@ -53,7 +53,7 @@ namespace ProcessLib
 namespace TwoPhaseFlowWithPP
 {
 std::unique_ptr<Process> createTwoPhaseFlowWithPPProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/TwoPhaseFlowWithPrho/CreateTwoPhaseFlowWithPrhoProcess.cpp b/ProcessLib/TwoPhaseFlowWithPrho/CreateTwoPhaseFlowWithPrhoProcess.cpp
index 7a7f75d34c21be846a3d0158d3a86805fb84bd68..2bdc6c8a76801b1466093b4b7bd96429a52d5f8a 100644
--- a/ProcessLib/TwoPhaseFlowWithPrho/CreateTwoPhaseFlowWithPrhoProcess.cpp
+++ b/ProcessLib/TwoPhaseFlowWithPrho/CreateTwoPhaseFlowWithPrhoProcess.cpp
@@ -24,7 +24,7 @@ namespace ProcessLib
 namespace TwoPhaseFlowWithPrho
 {
 std::unique_ptr<Process> createTwoPhaseFlowWithPrhoProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/ProcessLib/TwoPhaseFlowWithPrho/CreateTwoPhaseFlowWithPrhoProcess.h b/ProcessLib/TwoPhaseFlowWithPrho/CreateTwoPhaseFlowWithPrhoProcess.h
index 55b2aecdb8c9d4e4ae05593b57e61295e00fbd62..c540d11c7997a5e398cb8b6c0486095fe44e8db7 100644
--- a/ProcessLib/TwoPhaseFlowWithPrho/CreateTwoPhaseFlowWithPrhoProcess.h
+++ b/ProcessLib/TwoPhaseFlowWithPrho/CreateTwoPhaseFlowWithPrhoProcess.h
@@ -53,7 +53,7 @@ namespace ProcessLib
 namespace TwoPhaseFlowWithPrho
 {
 std::unique_ptr<Process> createTwoPhaseFlowWithPrhoProcess(
-    std::string name,
+    std::string const& name,
     MeshLib::Mesh& mesh,
     std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
     std::vector<ProcessVariable> const& variables,
diff --git a/Tests/Data/LIE/Mechanics/mohr_coulomb_load_path_nu0p3.prj b/Tests/Data/LIE/Mechanics/mohr_coulomb_load_path_nu0p3.prj
index a640df6046aa00fca2ef68443b69b8be8c288c0a..f57a605f1f07e624d8070877785a3ede2dd229f5 100644
--- a/Tests/Data/LIE/Mechanics/mohr_coulomb_load_path_nu0p3.prj
+++ b/Tests/Data/LIE/Mechanics/mohr_coulomb_load_path_nu0p3.prj
@@ -304,7 +304,7 @@
         <vtkdiff>
             <regex>out_mohr_coulomb_load_path_nu0p3_ts_(.*)_t_2.500000.vtu</regex>
             <field>stress_xy</field>
-            <absolute_tolerance>2.2e-3</absolute_tolerance>
+            <absolute_tolerance>2.6e-3</absolute_tolerance>
             <relative_tolerance>0</relative_tolerance>
         </vtkdiff>
         <vtkdiff>
diff --git a/scripts/cmake/CompilerSetup.cmake b/scripts/cmake/CompilerSetup.cmake
index e2c700b57397811ffe91ab8d7621afaf082fe0da..13081c36390849f2b8455a4df3d5253fd9328dc0 100644
--- a/scripts/cmake/CompilerSetup.cmake
+++ b/scripts/cmake/CompilerSetup.cmake
@@ -76,6 +76,14 @@ if(COMPILER_IS_GCC OR COMPILER_IS_CLANG OR COMPILER_IS_INTEL)
                 $<$<COMPILE_LANGUAGE:CXX>:-Wno-stringop-overread>
             )
         endif()
+        if(CMAKE_CXX_COMPILER_VERSION VERSION_EQUAL 13.2.1)
+            # A smaller set than that for 13.1.1
+            add_compile_options(
+                $<$<COMPILE_LANGUAGE:CXX>:-Wno-dangling-reference>
+                $<$<COMPILE_LANGUAGE:CXX>:-Wno-array-bounds>
+                $<$<COMPILE_LANGUAGE:CXX>:-Wno-stringop-overread>
+            )
+        endif()
     endif()
 
     if(COMPILER_IS_CLANG)