diff --git a/Documentation/ProjectFile/prj/time_loop/global_process_coupling/i_global_process_coupling.md b/Documentation/ProjectFile/prj/time_loop/global_process_coupling/i_global_process_coupling.md
index 7073b6fc9037a736ebb07b99ac1373e313b4570b..5b4e2f190e8e92b61697d31ae647c0a846afb20c 100644
--- a/Documentation/ProjectFile/prj/time_loop/global_process_coupling/i_global_process_coupling.md
+++ b/Documentation/ProjectFile/prj/time_loop/global_process_coupling/i_global_process_coupling.md
@@ -1 +1 @@
-Defines global convergence controls of the coupling iterations.
\ No newline at end of file
+Defines the global convergence controls for the staggered scheme.
\ No newline at end of file
diff --git a/ProcessLib/HydroMechanics/HydroMechanicsFEM.h b/ProcessLib/HydroMechanics/HydroMechanicsFEM.h
index df32f26f29081ecee5abe1e0787efeefef11d2ea..5ee1922dc08ef3ca2c5e3b46a61a6c7b55dd40bf 100644
--- a/ProcessLib/HydroMechanics/HydroMechanicsFEM.h
+++ b/ProcessLib/HydroMechanics/HydroMechanicsFEM.h
@@ -333,7 +333,7 @@ private:
      *            \nabla (\sigma - \alpha_b p \mathrm{I}) = f
      *      \f]
      * where \f$ \sigma\f$ is the effective stress tensor, \f$p\f$ is the pore
-     * pressure, \f$\alpha_b\f$ is the Biots constant, \f$\mathrm{I}\f$ is the
+     * pressure, \f$\alpha_b\f$ is the Biot constant, \f$\mathrm{I}\f$ is the
      * identity tensor, and \f$f\f$ is the body force.
      *
      * @param t               Time
@@ -342,11 +342,11 @@ private:
      * @param dx_dx           Value of \f$ x \cdot dx\f$.
      * @param local_M_data    Mass matrix of an element, which takes the form of
      *                        \f$ \inta N^T N\mathrm{d}\Omega\f$. Not used.
-     * @param local_K_data    Lappacian matrix of an element, which takes the
+     * @param local_K_data    Laplacian matrix of an element, which takes the
      *         form of \f$ \int (\nabla N)^T K \nabla N\mathrm{d}\Omega\f$.
      *                        Not used.
      * @param local_b_data    Right hand side vector of an element.
-     * @param local_Jac_data  Element Jacobian matrix from the Newton-Raphson
+     * @param local_Jac_data  Element Jacobian matrix for the Newton-Raphson
      *                        method.
      * @param local_coupled_solutions Nodal values of solutions of the coupled
      *                                processes of an element.
@@ -377,11 +377,11 @@ private:
      * @param dx_dx           Value of \f$ x \cdot dx\f$.
      * @param local_M_data    Mass matrix of an element, which takes the form of
      *                        \f$ \inta N^T N\mathrm{d}\Omega\f$. Not used.
-     * @param local_K_data    Lappacian matrix of an element, which takes the
+     * @param local_K_data    Laplacian matrix of an element, which takes the
      *         form of \f$ \int (\nabla N)^T K \nabla N\mathrm{d}\Omega\f$.
      *                        Not used.
      * @param local_b_data    Right hand side vector of an element.
-     * @param local_Jac_data  Element Jacobian matrix from the Newton-Raphson
+     * @param local_Jac_data  Element Jacobian matrix for the Newton-Raphson
      *                        method.
      * @param local_coupled_solutions Nodal values of solutions of the coupled
      *                                processes of an element.
diff --git a/ProcessLib/HydroMechanics/HydroMechanicsProcess-impl.h b/ProcessLib/HydroMechanics/HydroMechanicsProcess-impl.h
index 65f9fd4657abb55e701a76f8223097b7e28ddd16..c77505de58db96360c712ff6ae14ebe16d8bc483 100644
--- a/ProcessLib/HydroMechanics/HydroMechanicsProcess-impl.h
+++ b/ProcessLib/HydroMechanics/HydroMechanicsProcess-impl.h
@@ -99,10 +99,12 @@ void HydroMechanicsProcess<DisplacementDim>::constructDofTable()
         all_mesh_subsets.emplace_back(_mesh_subset_base_nodes.get());
 
         // For displacement.
-        const int process_id = 0;
+        const int monolithic_process_id = 0;
         std::generate_n(
             std::back_inserter(all_mesh_subsets),
-            getProcessVariables(process_id)[1].get().getNumberOfComponents(),
+            getProcessVariables(monolithic_process_id)[1]
+                .get()
+                .getNumberOfComponents(),
             [&]() {
                 return MeshLib::MeshSubsets{_mesh_subset_all_nodes.get()};
             });
@@ -156,13 +158,13 @@ void HydroMechanicsProcess<DisplacementDim>::initializeConcreteProcess(
     MeshLib::Mesh const& mesh,
     unsigned const integration_order)
 {
-    const int mechinical_process_id = _use_monolithic_scheme ? 0 : 1;
+    const int mechanical_process_id = _use_monolithic_scheme ? 0 : 1;
     const int deformation_variable_id = _use_monolithic_scheme ? 1 : 0;
     ProcessLib::HydroMechanics::createLocalAssemblers<
         DisplacementDim, HydroMechanicsLocalAssembler>(
         mesh.getDimension(), mesh.getElements(), dof_table,
         // use displacement process variable to set shape function order
-        getProcessVariables(mechinical_process_id)[deformation_variable_id]
+        getProcessVariables(mechanical_process_id)[deformation_variable_id]
             .get()
             .getShapeFunctionOrder(),
         _local_assemblers, mesh.isAxiallySymmetric(), integration_order,
@@ -279,39 +281,36 @@ void HydroMechanicsProcess<DisplacementDim>::
                                         GlobalMatrix& K, GlobalVector& b,
                                         GlobalMatrix& Jac)
 {
+    std::vector<std::reference_wrapper<NumLib::LocalToGlobalIndexMap>>
+        dof_tables;
     // For the monolithic scheme
     if (_use_monolithic_scheme)
     {
         DBUG(
             "Assemble the Jacobian of HydroMechanics for the monolithic"
             " scheme.");
-        std::vector<std::reference_wrapper<NumLib::LocalToGlobalIndexMap>>
-            dof_table = {std::ref(*_local_to_global_index_map)};
-        // Call global assembler for each local assembly item.
-        GlobalExecutor::executeMemberDereferenced(
-            _global_assembler, &VectorMatrixAssembler::assembleWithJacobian,
-            _local_assemblers, dof_table, t, x, xdot, dxdot_dx, dx_dx, M, K, b,
-            Jac, _coupled_solutions);
-        return;
-    }
-
-    // For the staggered scheme
-    if (_coupled_solutions->process_id == 0)
-    {
-        DBUG(
-            "Assemble the Jacobian equations of liquid fluid process in "
-            "HydroMechanics for the staggered scheme.");
+        dof_tables.push_back(std::ref(*_local_to_global_index_map));
     }
     else
     {
-        DBUG(
-            "Assemble the Jacobian equations of mechanical process in "
-            "HydroMechanics for the staggered scheme.");
+        // For the staggered scheme
+        if (_coupled_solutions->process_id == 0)
+        {
+            DBUG(
+                "Assemble the Jacobian equations of liquid fluid process in "
+                "HydroMechanics for the staggered scheme.");
+        }
+        else
+        {
+            DBUG(
+                "Assemble the Jacobian equations of mechanical process in "
+                "HydroMechanics for the staggered scheme.");
+        }
+        std::vector<std::reference_wrapper<NumLib::LocalToGlobalIndexMap>>
+            dof_tables = {std::ref(*_local_to_global_index_map_with_base_nodes),
+                          std::ref(*_local_to_global_index_map)};
     }
 
-    std::vector<std::reference_wrapper<NumLib::LocalToGlobalIndexMap>>
-        dof_tables = {std::ref(*_local_to_global_index_map_with_base_nodes),
-                      std::ref(*_local_to_global_index_map)};
     GlobalExecutor::executeMemberDereferenced(
         _global_assembler, &VectorMatrixAssembler::assembleWithJacobian,
         _local_assemblers, dof_tables, t, x, xdot, dxdot_dx, dx_dx, M, K, b,
diff --git a/ProcessLib/LIE/HydroMechanics/HydroMechanicsProcess.cpp b/ProcessLib/LIE/HydroMechanics/HydroMechanicsProcess.cpp
index 549ff8016ad799fa54a150be4963899bbe493d5c..46c456ca7556fe577ddf8089968e2a8b3147b6d7 100644
--- a/ProcessLib/LIE/HydroMechanics/HydroMechanicsProcess.cpp
+++ b/ProcessLib/LIE/HydroMechanics/HydroMechanicsProcess.cpp
@@ -81,8 +81,8 @@ HydroMechanicsProcess<GlobalDim>::HydroMechanicsProcess(
     }
 
     // need to use a custom Neumann BC assembler for displacement jumps
-    const int process_id = 0;
-    for (ProcessVariable& pv : getProcessVariables(process_id))
+    const int monolithic_process_id = 0;
+    for (ProcessVariable& pv : getProcessVariables(monolithic_process_id))
     {
         if (pv.getName().find("displacement_jump") == std::string::npos)
             continue;
@@ -112,8 +112,9 @@ HydroMechanicsProcess<GlobalDim>::HydroMechanicsProcess(
             std::make_unique<MeshLib::ElementStatus>(&mesh,
                                                      vec_p_inactive_matIDs);
 
-        const int process_id = 0;
-        ProcessVariable const& pv_p = getProcessVariables(process_id)[0];
+        const int monolithic_process_id = 0;
+        ProcessVariable const& pv_p =
+            getProcessVariables(monolithic_process_id)[0];
         _process_data.p0 = &pv_p.getInitialCondition();
     }
 }
@@ -194,16 +195,17 @@ void HydroMechanicsProcess<GlobalDim>::initializeConcreteProcess(
 {
     assert(mesh.getDimension() == GlobalDim);
     INFO("[LIE/HM] creating local assemblers");
-    const int process_id = 0;
+    const int monolithic_process_id = 0;
     ProcessLib::LIE::HydroMechanics::createLocalAssemblers<
         GlobalDim, HydroMechanicsLocalAssemblerMatrix,
         HydroMechanicsLocalAssemblerMatrixNearFracture,
         HydroMechanicsLocalAssemblerFracture>(
         mesh.getElements(), dof_table,
         // use displacment process variable for shapefunction order
-        getProcessVariables(process_id)[1].get().getShapeFunctionOrder(),
-        _local_assemblers, mesh.isAxiallySymmetric(), integration_order,
-        _process_data);
+        getProcessVariables(
+            monolithic_process_id)[1].get().getShapeFunctionOrder(),
+            _local_assemblers, mesh.isAxiallySymmetric(), integration_order,
+            _process_data);
 
     auto mesh_prop_sigma_xx = MeshLib::getOrCreateMeshProperty<double>(
         const_cast<MeshLib::Mesh&>(mesh), "stress_xx",
@@ -424,14 +426,15 @@ void HydroMechanicsProcess<GlobalDim>::computeSecondaryVariableConcrete(
         int global_component_offset_next = 0;
         int global_component_offset = 0;
 
-        const int process_id = 0;
+        const int monolithic_process_id = 0;
         for (int variable_id = 0;
              variable_id <
-             static_cast<int>(this->getProcessVariables(process_id).size());
+             static_cast<int>(this->getProcessVariables(
+                              monolithic_process_id).size());
              ++variable_id)
         {
             ProcessVariable& pv =
-                this->getProcessVariables(process_id)[variable_id];
+                this->getProcessVariables(monolithic_process_id)[variable_id];
             int const n_components = pv.getNumberOfComponents();
             global_component_offset = global_component_offset_next;
             global_component_offset_next += n_components;
@@ -446,9 +449,9 @@ void HydroMechanicsProcess<GlobalDim>::computeSecondaryVariableConcrete(
 
     MathLib::LinAlg::setLocalAccessibleVector(x);
 
-    const int process_id = 0;
+    const int monolithic_process_id = 0;
     ProcessVariable& pv_g =
-        this->getProcessVariables(process_id)[g_variable_id];
+        this->getProcessVariables(monolithic_process_id)[g_variable_id];
     auto& mesh_prop_g = pv_g.getOrCreateMeshProperty();
     auto const num_comp = pv_g.getNumberOfComponents();
     for (int component_id = 0; component_id < num_comp; ++component_id)
diff --git a/ProcessLib/Process.cpp b/ProcessLib/Process.cpp
index 217be2524953a0795e94d81ae50d519df4c38580..be40b175407b338dce319520f89598f0f0c307c2 100644
--- a/ProcessLib/Process.cpp
+++ b/ProcessLib/Process.cpp
@@ -61,12 +61,9 @@ void Process::initializeProcessBoundaryCondition(
                                               _integration_order);
 
     std::vector<std::unique_ptr<NodalSourceTerm>> per_process_source_terms;
-    for (std::size_t variable_id = 0;
-         variable_id < per_process_variables.size();
-         variable_id++)
+    for (auto& pv : per_process_variables)
     {
-        ProcessVariable& pv = per_process_variables[variable_id];
-        auto sts = pv.createSourceTerms(dof_table, 0, _integration_order);
+        auto sts = pv.get().createSourceTerms(dof_table, 0, _integration_order);
 
         std::move(sts.begin(), sts.end(),
                   std::back_inserter(per_process_source_terms));
diff --git a/ProcessLib/Process.h b/ProcessLib/Process.h
index 7074ccadf242c5dbcb250176089d570e9daaaf89..92e7e823cf74e4ccd57f6f845f6fa9c34b90ac29 100644
--- a/ProcessLib/Process.h
+++ b/ProcessLib/Process.h
@@ -149,9 +149,6 @@ protected:
      * Initialize the boundary conditions for a single process or coupled
      * processes modelled by the monolithic scheme. It is called by
      * initializeBoundaryConditions().
-     * 
-     * @param dof_table DOF table
-     * @param process_id Process ID
      */
     void initializeProcessBoundaryCondition(
         const NumLib::LocalToGlobalIndexMap& dof_table, const int process_id);
@@ -164,7 +161,7 @@ private:
         unsigned const integration_order) = 0;
 
     /// Member function to initialize the boundary conditions for all coupled
-    // PDEs. It is called by initialize().
+    /// processes. It is called by initialize().
     virtual void initializeBoundaryConditions();
 
     virtual void preAssembleConcreteProcess(const double /*t*/,
diff --git a/ProcessLib/RichardsComponentTransport/RichardsComponentTransportProcess.cpp b/ProcessLib/RichardsComponentTransport/RichardsComponentTransportProcess.cpp
index e15b9e5e26cadf6b81e2dc7ffadae69cbd88e1a2..9eaaa8a0d3ff17ad1e35072eb990ef31aa8fbcf3 100644
--- a/ProcessLib/RichardsComponentTransport/RichardsComponentTransportProcess.cpp
+++ b/ProcessLib/RichardsComponentTransport/RichardsComponentTransportProcess.cpp
@@ -41,8 +41,9 @@ void RichardsComponentTransportProcess::initializeConcreteProcess(
     MeshLib::Mesh const& mesh,
     unsigned const integration_order)
 {
-    const int process_id = 0;
-    ProcessLib::ProcessVariable const& pv = getProcessVariables(process_id)[0];
+    const int monolithic_process_id = 0;
+    ProcessLib::ProcessVariable const& pv =
+        getProcessVariables(monolithic_process_id)[0];
     ProcessLib::createLocalAssemblers<LocalAssemblerData>(
         mesh.getDimension(), mesh.getElements(), dof_table,
         pv.getShapeFunctionOrder(), _local_assemblers,
diff --git a/ProcessLib/TES/TESProcess.cpp b/ProcessLib/TES/TESProcess.cpp
index 217001080fd296e08e30c825982d4f03bd35675b..a162c814b96e1e3b9efc6dd88f54fe185fc60ecc 100644
--- a/ProcessLib/TES/TESProcess.cpp
+++ b/ProcessLib/TES/TESProcess.cpp
@@ -141,8 +141,9 @@ void TESProcess::initializeConcreteProcess(
     NumLib::LocalToGlobalIndexMap const& dof_table,
     MeshLib::Mesh const& mesh, unsigned const integration_order)
 {
-    const int process_id = 0;
-    ProcessLib::ProcessVariable const& pv = getProcessVariables(process_id)[0];
+    const int monolithic_process_id = 0;
+    ProcessLib::ProcessVariable const& pv =
+        getProcessVariables(monolithic_process_id)[0];
     ProcessLib::createLocalAssemblers<TESLocalAssembler>(
         mesh.getDimension(), mesh.getElements(), dof_table,
         pv.getShapeFunctionOrder(), _local_assemblers,
diff --git a/ProcessLib/ThermalTwoPhaseFlowWithPP/ThermalTwoPhaseFlowWithPPProcess.cpp b/ProcessLib/ThermalTwoPhaseFlowWithPP/ThermalTwoPhaseFlowWithPPProcess.cpp
index fcb75282219c1950008e43ecc95642adcf53a08d..e3e43f9faa052bcddf2c790bc6ff30200455670d 100644
--- a/ProcessLib/ThermalTwoPhaseFlowWithPP/ThermalTwoPhaseFlowWithPPProcess.cpp
+++ b/ProcessLib/ThermalTwoPhaseFlowWithPP/ThermalTwoPhaseFlowWithPPProcess.cpp
@@ -51,8 +51,9 @@ void ThermalTwoPhaseFlowWithPPProcess::initializeConcreteProcess(
     MeshLib::Mesh const& mesh,
     unsigned const integration_order)
 {
-    const int process_id = 0;
-    ProcessLib::ProcessVariable const& pv = getProcessVariables(process_id)[0];
+    const int monolithic_process_id = 0;
+    ProcessLib::ProcessVariable const& pv =
+        getProcessVariables(monolithic_process_id)[0];
     ProcessLib::createLocalAssemblers<ThermalTwoPhaseFlowWithPPLocalAssembler>(
         mesh.getDimension(), mesh.getElements(), dof_table,
         pv.getShapeFunctionOrder(), _local_assemblers,
diff --git a/web/content/docs/benchmarks/hydro-mechanics/InjectionProduction.md b/web/content/docs/benchmarks/hydro-mechanics/InjectionProduction.md
index 48938b9205a2bde4b6ae42ac82b9579b15816ed5..60e79510b25bd48612e21a964dd7d91e52151c2f 100644
--- a/web/content/docs/benchmarks/hydro-mechanics/InjectionProduction.md
+++ b/web/content/docs/benchmarks/hydro-mechanics/InjectionProduction.md
@@ -18,27 +18,24 @@ author = "Wenqing Wang"
 
 {{< img src="../InjectionProduction.png" >}}
 
-Based on an example about injection and
+Based on one of  the examples about injection and
 production well that is present by Kim et al. \cite kimTchJua2011, this benchmark
- is used to verified the staggered scheme
-that is implemented in ogs 6 for modelling the coupled hydraulic
-mechanical (HM) processes in the porous media. The problem of the example is defined
- in a 10 x 150 m
- <span class="math inline"><em></em><sup>2</sup></span>
+ is used to verify the staggered scheme, which
+  is implemented in OGS-6 for modelling of the coupled hydro-mechanical (HM)
+ processes in the porous media. The problem of the example is defined
+ in a 10 x 150 m  <span class="math inline"><em></em><sup>2</sup></span>
 domain (as shown in the figure). The deformation is solved under the plane strain
  assumption. Initially, the pore pressure and the
-initial stress are set to zero, respectively. All boundaries are
-assigned with no fluid flux for the hydraulic process. On the lateral
-and the bottom boundaries, no normal displacement is prescribed. On
-the top surface, a vertical traction boundary condition of 2.125 MP is
-applied. The gravity related term is neglected in both of the Darcy velocity and the
-momentum balance equation.
+ stress are set to zero. On all boundaries no fluid flux condition is
+ applied for the hydraulic process. On the lateral
+and the bottom boundaries, zero normal displacement is prescribed. On
+the top surface a vertical traction boundary condition of 2.125 MP is
+applied. The gravity related terms are neglected in both: the Darcy velocity
+ and the momentum balance equation.
 
 The material properties are shown in the following table.
-
-<p>The material properties are shown in the following table.</p>
 <table>
-<caption>Material properties of fluid injection and production example</caption>
+<caption>Material properties</caption>
 <thead>
 <tr class="header">
 <th align="left">Property</th>
@@ -78,16 +75,16 @@ The material properties are shown in the following table.
 <td align="left">Pa</td>
 </tr>
 <tr class="odd">
-<td align="left">Posson ratio</td>
+<td align="left">Poisson ratio</td>
 <td align="left">0.3</td>
 <td align="left">–</td>
 </tr>
 </tbody>
 </table>
 
-The time duration is 8.64 8.64 <span class="math inline">â‹…10<sup>6</sup></span> s, 
+The time duration is 8.64 <span class="math inline">â‹…10<sup>6</sup></span> s, 
 and the time step size is 8.64 <span class="math inline">â‹…10<sup>4</sup></span> s.
- For the verification, the example is also solved by the monolithic
+ For the verification the example is also solved by the monolithic
 scheme. The displacement solution at the last
 time step is shown in the enclosed figure too.