diff --git a/Documentation/ProjectFile/prj/processes/process/HEAT_TRANSPORT_BHE/borehole_heat_exchangers/borehole_heat_exchanger/flow_and_temperature_control/BuildingPowerCurveConstantFlow/c_BuildingPowerCurveConstantFlow.md b/Documentation/ProjectFile/prj/processes/process/HEAT_TRANSPORT_BHE/borehole_heat_exchangers/borehole_heat_exchanger/flow_and_temperature_control/BuildingPowerCurveConstantFlow/c_BuildingPowerCurveConstantFlow.md
new file mode 100644
index 0000000000000000000000000000000000000000..b12f779696b3be2873611105c86c9ea48ef59c99
--- /dev/null
+++ b/Documentation/ProjectFile/prj/processes/process/HEAT_TRANSPORT_BHE/borehole_heat_exchangers/borehole_heat_exchanger/flow_and_temperature_control/BuildingPowerCurveConstantFlow/c_BuildingPowerCurveConstantFlow.md
@@ -0,0 +1 @@
+It is the BHE boundary condition of various heat load from buildings. Meanwhile, the COP of the heat pump is intergrated and used for calculating the transit heat load on the BHE.
diff --git a/Documentation/ProjectFile/prj/processes/process/HEAT_TRANSPORT_BHE/borehole_heat_exchangers/borehole_heat_exchanger/flow_and_temperature_control/BuildingPowerCurveConstantFlow/t_cop_heating_curve.md b/Documentation/ProjectFile/prj/processes/process/HEAT_TRANSPORT_BHE/borehole_heat_exchangers/borehole_heat_exchanger/flow_and_temperature_control/BuildingPowerCurveConstantFlow/t_cop_heating_curve.md
new file mode 100644
index 0000000000000000000000000000000000000000..5d71d38a26b1a3650d814386e975a0f1ee27ba23
--- /dev/null
+++ b/Documentation/ProjectFile/prj/processes/process/HEAT_TRANSPORT_BHE/borehole_heat_exchangers/borehole_heat_exchanger/flow_and_temperature_control/BuildingPowerCurveConstantFlow/t_cop_heating_curve.md
@@ -0,0 +1 @@
+It is the COP curve of the heat pump at different outflow temperature from the BHE.
diff --git a/Documentation/ProjectFile/prj/processes/process/HEAT_TRANSPORT_BHE/borehole_heat_exchangers/borehole_heat_exchanger/flow_and_temperature_control/BuildingPowerCurveConstantFlow/t_flow_rate.md b/Documentation/ProjectFile/prj/processes/process/HEAT_TRANSPORT_BHE/borehole_heat_exchangers/borehole_heat_exchanger/flow_and_temperature_control/BuildingPowerCurveConstantFlow/t_flow_rate.md
new file mode 100644
index 0000000000000000000000000000000000000000..9aecbc9292d30a2fe3782175ebca3f0c82ed85ba
--- /dev/null
+++ b/Documentation/ProjectFile/prj/processes/process/HEAT_TRANSPORT_BHE/borehole_heat_exchangers/borehole_heat_exchanger/flow_and_temperature_control/BuildingPowerCurveConstantFlow/t_flow_rate.md
@@ -0,0 +1 @@
+It is the flow rate of the BHE and it is a constant value in this BC.
diff --git a/Documentation/ProjectFile/prj/processes/process/HEAT_TRANSPORT_BHE/borehole_heat_exchangers/borehole_heat_exchanger/flow_and_temperature_control/BuildingPowerCurveConstantFlow/t_power_curve.md b/Documentation/ProjectFile/prj/processes/process/HEAT_TRANSPORT_BHE/borehole_heat_exchangers/borehole_heat_exchanger/flow_and_temperature_control/BuildingPowerCurveConstantFlow/t_power_curve.md
new file mode 100644
index 0000000000000000000000000000000000000000..de4ddb4d360250495dc89aa4d93707b999a08189
--- /dev/null
+++ b/Documentation/ProjectFile/prj/processes/process/HEAT_TRANSPORT_BHE/borehole_heat_exchangers/borehole_heat_exchanger/flow_and_temperature_control/BuildingPowerCurveConstantFlow/t_power_curve.md
@@ -0,0 +1 @@
+It is the building heat load curve.
diff --git a/ProcessLib/HeatTransportBHE/BHE/BHECommonCoaxial.cpp b/ProcessLib/HeatTransportBHE/BHE/BHECommonCoaxial.cpp
index 5f3b2cc6627a154d19f2bf7a35a6039d5cad1b56..15090b71e66d4c0b54f6fd649c02af5023249998 100644
--- a/ProcessLib/HeatTransportBHE/BHE/BHECommonCoaxial.cpp
+++ b/ProcessLib/HeatTransportBHE/BHE/BHECommonCoaxial.cpp
@@ -87,7 +87,8 @@ BHECommonCoaxial::pipeHeatConductions() const
 }
 
 std::array<Eigen::Vector3d, BHECommonCoaxial::number_of_unknowns>
-BHECommonCoaxial::pipeAdvectionVectors() const
+BHECommonCoaxial::pipeAdvectionVectors(
+    Eigen::Vector3d const& /*elem_direction*/) const
 {
     double const rho_r = refrigerant.density;
     double const Cp_r = refrigerant.specific_heat_capacity;
@@ -130,6 +131,26 @@ BHECommonCoaxial::calcThermalResistances(double const Nu_inner_pipe,
     return getThermalResistances(R_gs, R_ff, R_fg);
 }
 
+std::array<std::pair<std::size_t /*node_id*/, int /*component*/>, 2>
+BHECommonCoaxial::getBHEInflowDirichletBCNodesAndComponents(
+    std::size_t const top_node_id,
+    std::size_t const /*bottom_node_id*/,
+    int const in_component_id) const
+{
+    return {std::make_pair(top_node_id, in_component_id),
+            std::make_pair(top_node_id, in_component_id + 1)};
+}
+
+std::optional<
+    std::array<std::pair<std::size_t /*node_id*/, int /*component*/>, 2>>
+BHECommonCoaxial::getBHEBottomDirichletBCNodesAndComponents(
+    std::size_t const bottom_node_id, int const in_component_id,
+    int const out_component_id) const
+{
+    return {{std::make_pair(bottom_node_id, in_component_id),
+             std::make_pair(bottom_node_id, out_component_id)}};
+}
+
 void BHECommonCoaxial::updateHeatTransferCoefficients(double const flow_rate)
 {
     auto const tm_flow_properties_annulus =
diff --git a/ProcessLib/HeatTransportBHE/BHE/BHECommonCoaxial.h b/ProcessLib/HeatTransportBHE/BHE/BHECommonCoaxial.h
index b033891a34e223708f2c39ffeeab2b1b1f4aa31a..60db9261ea18e2aa062a0ac918c02a6f67a4d56e 100644
--- a/ProcessLib/HeatTransportBHE/BHE/BHECommonCoaxial.h
+++ b/ProcessLib/HeatTransportBHE/BHE/BHECommonCoaxial.h
@@ -10,6 +10,7 @@
 #pragma once
 
 #include <Eigen/Eigen>
+#include <optional>
 #include "BHECommon.h"
 #include "FlowAndTemperatureControl.h"
 #include "PipeConfigurationCoaxial.h"
@@ -48,10 +49,22 @@ public:
     static constexpr std::pair<int, int> inflow_outflow_bc_component_ids[] = {
         {0, 1}};
 
+    std::array<std::pair<std::size_t /*node_id*/, int /*component*/>, 2>
+    getBHEInflowDirichletBCNodesAndComponents(
+        std::size_t const top_node_id,
+        std::size_t const /*bottom_node_id*/,
+        int const in_component_id) const;
+
+    std::optional<
+        std::array<std::pair<std::size_t /*node_id*/, int /*component*/>, 2>>
+    getBHEBottomDirichletBCNodesAndComponents(std::size_t const bottom_node_id,
+                                              int const in_component_id,
+                                              int const out_component_id) const;
+
     std::array<double, number_of_unknowns> pipeHeatConductions() const;
 
-    std::array<Eigen::Vector3d, number_of_unknowns> pipeAdvectionVectors()
-        const;
+    std::array<Eigen::Vector3d, number_of_unknowns> pipeAdvectionVectors(
+        Eigen::Vector3d const& /*elem_direction*/) const;
 
     double cross_section_area_inner_pipe, cross_section_area_annulus,
         cross_section_area_grout;
diff --git a/ProcessLib/HeatTransportBHE/BHE/BHETypes.h b/ProcessLib/HeatTransportBHE/BHE/BHETypes.h
index e3677b7a73fb64077fd0d5b6a906ff8795d9948c..75b59581d7c6a40ce63f264e677b5b06d75c213b 100644
--- a/ProcessLib/HeatTransportBHE/BHE/BHETypes.h
+++ b/ProcessLib/HeatTransportBHE/BHE/BHETypes.h
@@ -11,6 +11,7 @@
 #pragma once
 
 #include <variant>
+#include "BHE_1P.h"
 #include "BHE_1U.h"
 #include "BHE_2U.h"
 #include "BHE_CXA.h"
@@ -22,7 +23,7 @@ namespace HeatTransportBHE
 {
 namespace BHE
 {
-using BHETypes = std::variant<BHE_1U, BHE_CXA, BHE_CXC, BHE_2U>;
+using BHETypes = std::variant<BHE_1U, BHE_CXA, BHE_CXC, BHE_2U, BHE_1P>;
 }  // end of namespace BHE
 }  // end of namespace HeatTransportBHE
 }  // end of namespace ProcessLib
diff --git a/ProcessLib/HeatTransportBHE/BHE/BHE_1P.cpp b/ProcessLib/HeatTransportBHE/BHE/BHE_1P.cpp
new file mode 100644
index 0000000000000000000000000000000000000000..436a4c73f596668cb0659dfd2ef22ed4c2a79e24
--- /dev/null
+++ b/ProcessLib/HeatTransportBHE/BHE/BHE_1P.cpp
@@ -0,0 +1,187 @@
+/**
+ * \file
+ * \copyright
+ * Copyright (c) 2012-2020, OpenGeoSys Community (http://www.opengeosys.org)
+ *            Distributed under a Modified BSD License.
+ *              See accompanying file LICENSE.txt or
+ *              http://www.opengeosys.org/project/license
+ *
+ */
+
+#include "BHE_1P.h"
+
+#include <boost/math/constants/constants.hpp>
+#include "FlowAndTemperatureControl.h"
+#include "Physics.h"
+#include "ThermoMechanicalFlowProperties.h"
+
+namespace ProcessLib
+{
+namespace HeatTransportBHE
+{
+namespace BHE
+{
+BHE_1P::BHE_1P(BoreholeGeometry const& borehole,
+               RefrigerantProperties const& refrigerant,
+               GroutParameters const& grout,
+               FlowAndTemperatureControl const& flowAndTemperatureControl,
+               PipeConfiguration1PType const& pipes,
+               bool const use_python_bcs)
+    : BHECommon{borehole, refrigerant, grout, flowAndTemperatureControl,
+                use_python_bcs},
+      _pipe(pipes)
+{
+    _thermal_resistances.fill(std::numeric_limits<double>::quiet_NaN());
+
+    // Initialize thermal resistances.
+    auto values = visit(
+        [&](auto const& control) {
+            return control(refrigerant.reference_temperature,
+                           0. /* initial time */);
+        },
+        flowAndTemperatureControl);
+    updateHeatTransferCoefficients(values.flow_rate);
+}
+
+std::array<double, BHE_1P::number_of_unknowns> BHE_1P::pipeHeatCapacities()
+    const
+{
+    double const rho_r = refrigerant.density;
+    double const specific_heat_capacity = refrigerant.specific_heat_capacity;
+    double const rho_g = grout.rho_g;
+    double const porosity_g = grout.porosity_g;
+    double const heat_cap_g = grout.heat_cap_g;
+
+    return {{
+        /*pipe*/ rho_r * specific_heat_capacity,
+        /*grout*/ (1.0 - porosity_g) * rho_g * heat_cap_g,
+    }};
+}
+
+std::array<double, BHE_1P::number_of_unknowns> BHE_1P::pipeHeatConductions()
+    const
+{
+    double const lambda_r = refrigerant.thermal_conductivity;
+    double const rho_r = refrigerant.density;
+    double const Cp_r = refrigerant.specific_heat_capacity;
+    double const alpha_L = _pipe.longitudinal_dispersion_length;
+    double const porosity_g = grout.porosity_g;
+    double const lambda_g = grout.lambda_g;
+
+    // Here we calculate the laplace coefficients in the governing
+    // equations of the BHE.
+    return {{
+        // pipe, Eq. 19
+        (lambda_r + rho_r * Cp_r * alpha_L * _flow_velocity),
+        // grout, Eq. 21
+        (1.0 - porosity_g) * lambda_g,
+    }};
+}
+
+std::array<Eigen::Vector3d, BHE_1P::number_of_unknowns>
+BHE_1P::pipeAdvectionVectors(Eigen::Vector3d const& elem_direction) const
+{
+    double const& rho_r = refrigerant.density;
+    double const& Cp_r = refrigerant.specific_heat_capacity;
+    Eigen::Vector3d adv_vector = rho_r * Cp_r * _flow_velocity * elem_direction;
+
+    return {// pipe, Eq. 19
+            adv_vector,
+            // grout, Eq. 21
+            {0, 0, 0}};
+}
+
+double BHE_1P::compute_R_gs(double const chi, double const R_g)
+{
+    return (1 - chi) * R_g;
+}
+
+void BHE_1P::updateHeatTransferCoefficients(double const flow_rate)
+
+{
+    auto const tm_flow_properties = calculateThermoMechanicalFlowPropertiesPipe(
+        _pipe.single_pipe, borehole_geometry.length, refrigerant, flow_rate);
+
+    _flow_velocity = tm_flow_properties.velocity;
+    _thermal_resistances =
+        calcThermalResistances(tm_flow_properties.nusselt_number);
+}
+
+// Nu is the Nusselt number.
+std::array<double, BHE_1P::number_of_unknowns> BHE_1P::calcThermalResistances(
+    double const Nu)
+{
+    constexpr double pi = boost::math::constants::pi<double>();
+
+    double const lambda_r = refrigerant.thermal_conductivity;
+    double const lambda_g = grout.lambda_g;
+    double const lambda_p = _pipe.single_pipe.wall_thermal_conductivity;
+
+    // thermal resistances due to advective flow of refrigerant in the pipe
+    double const R_adv_i1 = 1.0 / (Nu * lambda_r * pi);
+
+    // thermal resistance due to thermal conductivity of the pipe wall material
+    double const R_con_a = std::log(_pipe.single_pipe.outsideDiameter() /
+                                    _pipe.single_pipe.diameter) /
+                           (2.0 * pi * lambda_p);
+
+    // thermal resistances of the grout
+    double const D = borehole_geometry.diameter;
+    double const pipe_outside_diameter = _pipe.single_pipe.outsideDiameter();
+
+    double const chi = std::log(std::sqrt(D * D + pipe_outside_diameter *
+                                                      pipe_outside_diameter) /
+                                std::sqrt(2) / pipe_outside_diameter) /
+                       std::log(D / pipe_outside_diameter);
+    double const R_g =
+        std::log(D / pipe_outside_diameter) / 2 / (pi * lambda_g);
+
+    double const R_con_b = chi * R_g;
+
+    // thermal resistances due to grout-soil exchange
+    double const R_gs = compute_R_gs(chi, R_g);
+
+    // Eq. 29 and 30
+    double const R_fg = R_adv_i1 + R_con_a + R_con_b;
+
+    return {{R_fg, R_gs}};
+}
+
+std::array<std::pair<std::size_t /*node_id*/, int /*component*/>, 2>
+BHE_1P::getBHEInflowDirichletBCNodesAndComponents(
+    std::size_t const top_node_id,
+    std::size_t const bottom_node_id,
+    int const in_component_id) const
+{
+    return {std::make_pair(top_node_id, in_component_id),
+            std::make_pair(bottom_node_id, in_component_id)};
+}
+
+std::optional<
+    std::array<std::pair<std::size_t /*node_id*/, int /*component*/>, 2>>
+BHE_1P::getBHEBottomDirichletBCNodesAndComponents(
+    std::size_t const /*bottom_node_id*/,
+    int const /*in_component_id*/,
+    int const /*out_component_id*/) const
+{
+    return {};
+}
+
+std::array<double, BHE_1P::number_of_unknowns> BHE_1P::crossSectionAreas() const
+{
+    return {{_pipe.single_pipe.area(),
+             borehole_geometry.area() - _pipe.single_pipe.outsideArea()}};
+}
+
+double BHE_1P::updateFlowRateAndTemperature(double const T_out,
+                                            double const current_time)
+{
+    auto values =
+        visit([&](auto const& control) { return control(T_out, current_time); },
+              flowAndTemperatureControl);
+    updateHeatTransferCoefficients(values.flow_rate);
+    return values.temperature;
+}
+}  // namespace BHE
+}  // namespace HeatTransportBHE
+}  // namespace ProcessLib
diff --git a/ProcessLib/HeatTransportBHE/BHE/BHE_1P.h b/ProcessLib/HeatTransportBHE/BHE/BHE_1P.h
new file mode 100644
index 0000000000000000000000000000000000000000..1c23ae53c1ef6e2ea773343aa7ebd200031f441b
--- /dev/null
+++ b/ProcessLib/HeatTransportBHE/BHE/BHE_1P.h
@@ -0,0 +1,152 @@
+/**
+ * \file
+ * \copyright
+ * Copyright (c) 2012-2020, OpenGeoSys Community (http://www.opengeosys.org)
+ *            Distributed under a Modified BSD License.
+ *              See accompanying file LICENSE.txt or
+ *              http://www.opengeosys.org/project/license
+ *
+ */
+
+#pragma once
+
+#include <Eigen/Eigen>
+#include <optional>
+
+#include "BaseLib/Error.h"
+
+#include "BHECommon.h"
+#include "FlowAndTemperatureControl.h"
+#include "PipeConfiguration1PType.h"
+
+namespace ProcessLib
+{
+namespace HeatTransportBHE
+{
+namespace BHE
+{
+/**
+ * The BHE_1P class is the realization of single-pipe type of Borehole Heate
+ * Exchanger. In this class, the pipe heat capacity, pipe heat conductiion, pie
+ * advection vectors are intialized according to the geometry of the single-pipe
+ * type of BHE. For this type of BHE, 2 primary unknowns are assigned on the 1D
+ * BHE elements. They are the temperature in the pipe T_p, and temperature of
+ * the grout zone sorrounding the single pipe T_g. These two primary varaibles
+ * are solved according to heat convection and conduction equations on the pipes
+ * and also in the grout zones. The interaction of the 1P type of BHE and the
+ * sorrounding soil is regulated through the thermal resistance values, which
+ * are calculated specifically during the initialization of the class.
+ */
+class BHE_1P final : public BHECommon
+{
+public:
+    BHE_1P(BoreholeGeometry const& borehole,
+           RefrigerantProperties const& refrigerant,
+           GroutParameters const& grout,
+           FlowAndTemperatureControl const& flowAndTemperatureControl,
+           PipeConfiguration1PType const& pipes,
+           bool const use_python_bcs);
+
+    static constexpr int number_of_unknowns = 2;
+    static constexpr int number_of_grout_zones = 1;
+
+    std::array<double, number_of_unknowns> pipeHeatCapacities() const;
+
+    std::array<double, number_of_unknowns> pipeHeatConductions() const;
+
+    std::array<Eigen::Vector3d, number_of_unknowns> pipeAdvectionVectors(
+        Eigen::Vector3d const& elem_direction) const;
+
+    template <int NPoints,
+              typename SingleUnknownMatrixType,
+              typename RMatrixType,
+              typename RPiSMatrixType,
+              typename RSMatrixType>
+    void assembleRMatrices(
+        int const idx_bhe_unknowns,
+        Eigen::MatrixBase<SingleUnknownMatrixType> const& matBHE_loc_R,
+        Eigen::MatrixBase<RMatrixType>& R_matrix,
+        Eigen::MatrixBase<RPiSMatrixType>& R_pi_s_matrix,
+        Eigen::MatrixBase<RSMatrixType>& R_s_matrix) const
+    {
+        // Here we are looping over two resistance terms
+        // First PHI_fg is the resistance between pipe and grout
+        // Second PHI_gs is the resistance between grout and soil
+        switch (idx_bhe_unknowns)
+        {
+            case 0:  // PHI_fg
+                R_matrix.block(0, NPoints, NPoints, NPoints) +=
+                    -1.0 * matBHE_loc_R;
+                R_matrix.block(NPoints, 0, NPoints, NPoints) +=
+                    -1.0 * matBHE_loc_R;
+
+                R_matrix.block(0, 0, NPoints, NPoints) +=
+                    matBHE_loc_R;  // K_i/o
+                R_matrix.block(NPoints, NPoints, NPoints, NPoints) +=
+                    matBHE_loc_R;  // K_fg
+                return;
+            case 1:  // PHI_gs
+                R_s_matrix += matBHE_loc_R;
+
+                R_pi_s_matrix.block(NPoints, 0, NPoints, NPoints) +=
+                    -1.0 * matBHE_loc_R;
+
+                R_matrix.block(NPoints, NPoints, NPoints, NPoints) +=
+                    matBHE_loc_R;  // K_fg
+                return;
+            default:
+                OGS_FATAL(
+                    "Error!!! In the function BHE_1P::assembleRMatrices, "
+                    "the index of bhe resistance term is out of range! ");
+        }
+    }
+
+    /// Return the inflow temperature for the boundary condition.
+    double updateFlowRateAndTemperature(double T_out, double current_time);
+
+    double thermalResistance(int const unknown_index) const
+    {
+        return _thermal_resistances[unknown_index];
+    }
+
+    static constexpr std::pair<int, int> inflow_outflow_bc_component_ids[] = {
+        {0, 1}};
+
+    std::array<std::pair<std::size_t /*node_id*/, int /*component*/>, 2>
+    getBHEInflowDirichletBCNodesAndComponents(std::size_t const top_node_id,
+                                              std::size_t const bottom_node_id,
+                                              int const in_component_id) const;
+
+    std::optional<
+        std::array<std::pair<std::size_t /*node_id*/, int /*component*/>, 2>>
+    getBHEBottomDirichletBCNodesAndComponents(
+        std::size_t const /*bottom_node_id*/,
+        int const /*in_component_id*/,
+        int const /*out_component_id*/) const;
+
+public:
+    std::array<double, number_of_unknowns> crossSectionAreas() const;
+
+    void updateHeatTransferCoefficients(double const flow_rate);
+
+protected:
+    PipeConfiguration1PType const _pipe;
+
+    /// Flow velocity inside the pipes. Depends on the flow_rate.
+    double _flow_velocity = std::numeric_limits<double>::quiet_NaN();
+
+private:
+    std::array<double, number_of_unknowns> calcThermalResistances(
+        double const Nu);
+
+    double compute_R_gs(double const chi, double const R_g);
+
+private:
+    /// PHI_fg, PHI_gs;
+    /// Here we store the thermal resistances needed for computation of the heat
+    /// exchange coefficients in the governing equations of BHE.
+    std::array<double, number_of_unknowns> _thermal_resistances;
+};
+}  // namespace BHE
+}  // namespace HeatTransportBHE
+}  // namespace ProcessLib
diff --git a/ProcessLib/HeatTransportBHE/BHE/BHE_1U.cpp b/ProcessLib/HeatTransportBHE/BHE/BHE_1U.cpp
index c5451e452d24fc05b09ff67d06eb6c7c5ea298af..38e0f829ccceab9784f56c548db6bae193b5d559 100644
--- a/ProcessLib/HeatTransportBHE/BHE/BHE_1U.cpp
+++ b/ProcessLib/HeatTransportBHE/BHE/BHE_1U.cpp
@@ -84,7 +84,7 @@ std::array<double, BHE_1U::number_of_unknowns> BHE_1U::pipeHeatConductions()
 }
 
 std::array<Eigen::Vector3d, BHE_1U::number_of_unknowns>
-BHE_1U::pipeAdvectionVectors() const
+BHE_1U::pipeAdvectionVectors(Eigen::Vector3d const& /*elem_direction*/) const
 {
     double const& rho_r = refrigerant.density;
     double const& Cp_r = refrigerant.specific_heat_capacity;
@@ -228,6 +228,27 @@ std::array<double, BHE_1U::number_of_unknowns> BHE_1U::calcThermalResistances(
     // -------------------------------------------------------------------------
 }
 
+std::array<std::pair<std::size_t /*node_id*/, int /*component*/>, 2>
+BHE_1U::getBHEInflowDirichletBCNodesAndComponents(
+    std::size_t const top_node_id,
+    std::size_t const /*bottom_node_id*/,
+    int const in_component_id) const
+{
+    return {std::make_pair(top_node_id, in_component_id),
+            std::make_pair(top_node_id, in_component_id + 1)};
+}
+
+std::optional<
+    std::array<std::pair<std::size_t /*node_id*/, int /*component*/>, 2>>
+BHE_1U::getBHEBottomDirichletBCNodesAndComponents(
+    std::size_t const bottom_node_id,
+    int const in_component_id,
+    int const out_component_id) const
+{
+    return {{std::make_pair(bottom_node_id, in_component_id),
+             std::make_pair(bottom_node_id, out_component_id)}};
+}
+
 std::array<double, BHE_1U::number_of_unknowns> BHE_1U::crossSectionAreas() const
 {
     return {{_pipes.inlet.area(), _pipes.outlet.area(),
diff --git a/ProcessLib/HeatTransportBHE/BHE/BHE_1U.h b/ProcessLib/HeatTransportBHE/BHE/BHE_1U.h
index 6702d7322a67c87d4f5d750c758f8b5dd7fe28d9..076e8fbd8b56f7b15c3dc0ce7705c540bbb7b1e6 100644
--- a/ProcessLib/HeatTransportBHE/BHE/BHE_1U.h
+++ b/ProcessLib/HeatTransportBHE/BHE/BHE_1U.h
@@ -11,6 +11,7 @@
 #pragma once
 
 #include <Eigen/Eigen>
+#include <optional>
 
 #include "BaseLib/Error.h"
 
@@ -55,8 +56,8 @@ public:
 
     std::array<double, number_of_unknowns> pipeHeatConductions() const;
 
-    std::array<Eigen::Vector3d, number_of_unknowns> pipeAdvectionVectors()
-        const;
+    std::array<Eigen::Vector3d, number_of_unknowns> pipeAdvectionVectors(
+        Eigen::Vector3d const& /*elem_direction*/) const;
 
     template <int NPoints,
               typename SingleUnknownMatrixType,
@@ -138,6 +139,17 @@ public:
     static constexpr std::pair<int, int> inflow_outflow_bc_component_ids[] = {
         {0, 1}};
 
+    std::array<std::pair<std::size_t /*node_id*/, int /*component*/>, 2>
+    getBHEInflowDirichletBCNodesAndComponents(
+        std::size_t const top_node_id,
+        std::size_t const /*bottom_node_id*/,
+        int const in_component_id) const;
+    std::optional<
+        std::array<std::pair<std::size_t /*node_id*/, int /*component*/>, 2>>
+    getBHEBottomDirichletBCNodesAndComponents(std::size_t const bottom_node_id,
+                                              int const in_component_id,
+                                              int const out_component_id) const;
+
 public:
     std::array<double, number_of_unknowns> crossSectionAreas() const;
 
diff --git a/ProcessLib/HeatTransportBHE/BHE/BHE_2U.cpp b/ProcessLib/HeatTransportBHE/BHE/BHE_2U.cpp
index 734058abeabf52fd5e06cd5e07f5884f0ce69172..75a862340f543929679328c7f9a0d1135d0303ae 100644
--- a/ProcessLib/HeatTransportBHE/BHE/BHE_2U.cpp
+++ b/ProcessLib/HeatTransportBHE/BHE/BHE_2U.cpp
@@ -94,7 +94,7 @@ std::array<double, BHE_2U::number_of_unknowns> BHE_2U::pipeHeatConductions()
 }
 
 std::array<Eigen::Vector3d, BHE_2U::number_of_unknowns>
-BHE_2U::pipeAdvectionVectors() const
+BHE_2U::pipeAdvectionVectors(Eigen::Vector3d const& /*elem_direction*/) const
 {
     double const rho_r = refrigerant.density;
     double const Cp_r = refrigerant.specific_heat_capacity;
@@ -258,6 +258,27 @@ std::array<double, BHE_2U::number_of_unknowns> BHE_2U::calcThermalResistances(
     // -------------------------------------------------------------------------
 }
 
+std::array<std::pair<std::size_t /*node_id*/, int /*component*/>, 2>
+BHE_2U::getBHEInflowDirichletBCNodesAndComponents(
+    std::size_t const top_node_id,
+    std::size_t const /*bottom_node_id*/,
+    int const in_component_id) const
+{
+    return {std::make_pair(top_node_id, in_component_id),
+            std::make_pair(top_node_id, in_component_id + 2)};
+}
+
+std::optional<
+    std::array<std::pair<std::size_t /*node_id*/, int /*component*/>, 2>>
+BHE_2U::getBHEBottomDirichletBCNodesAndComponents(
+    std::size_t const bottom_node_id,
+    int const in_component_id,
+    int const out_component_id) const
+{
+    return {{std::make_pair(bottom_node_id, in_component_id),
+             std::make_pair(bottom_node_id, out_component_id)}};
+}
+
 std::array<double, BHE_2U::number_of_unknowns> BHE_2U::crossSectionAreas() const
 {
     return {{
diff --git a/ProcessLib/HeatTransportBHE/BHE/BHE_2U.h b/ProcessLib/HeatTransportBHE/BHE/BHE_2U.h
index c63ff205d3833d960d6bdde40d045486b69604c4..d703b3b79570f6a36fb3dab780e39fdd64212916 100644
--- a/ProcessLib/HeatTransportBHE/BHE/BHE_2U.h
+++ b/ProcessLib/HeatTransportBHE/BHE/BHE_2U.h
@@ -12,6 +12,7 @@
 
 #include <Eigen/Eigen>
 
+#include <optional>
 #include "BaseLib/Error.h"
 
 #include "BHECommon.h"
@@ -55,8 +56,8 @@ public:
 
     std::array<double, number_of_unknowns> pipeHeatConductions() const;
 
-    std::array<Eigen::Vector3d, number_of_unknowns> pipeAdvectionVectors()
-        const;
+    std::array<Eigen::Vector3d, number_of_unknowns> pipeAdvectionVectors(
+        Eigen::Vector3d const& /*elem_direction*/) const;
 
     template <int NPoints,
               typename SingleUnknownMatrixType,
@@ -200,6 +201,18 @@ public:
     static constexpr std::pair<int, int> inflow_outflow_bc_component_ids[] = {
         {0, 2}, {1, 3}};
 
+    std::array<std::pair<std::size_t /*node_id*/, int /*component*/>, 2>
+    getBHEInflowDirichletBCNodesAndComponents(
+        std::size_t const top_node_id,
+        std::size_t const /*bottom_node_id*/,
+        int const in_component_id) const;
+
+    std::optional<
+        std::array<std::pair<std::size_t /*node_id*/, int /*component*/>, 2>>
+    getBHEBottomDirichletBCNodesAndComponents(std::size_t const bottom_node_id,
+                                              int const in_component_id,
+                                              int const out_component_id) const;
+
 public:
     std::array<double, number_of_unknowns> crossSectionAreas() const;
 
diff --git a/ProcessLib/HeatTransportBHE/BHE/BHE_CXC.h b/ProcessLib/HeatTransportBHE/BHE/BHE_CXC.h
index 3ddbb6c526e9f66182372127313e781f7b92275d..d35f302c7c783a577ea510a3342623e097ce1b4a 100644
--- a/ProcessLib/HeatTransportBHE/BHE/BHE_CXC.h
+++ b/ProcessLib/HeatTransportBHE/BHE/BHE_CXC.h
@@ -12,8 +12,6 @@
 
 #include <Eigen/Eigen>
 
-#include "BaseLib/Error.h"
-
 #include "BHECommonCoaxial.h"
 
 namespace ProcessLib
diff --git a/ProcessLib/HeatTransportBHE/BHE/BuildingPowerCurves.h b/ProcessLib/HeatTransportBHE/BHE/BuildingPowerCurves.h
new file mode 100644
index 0000000000000000000000000000000000000000..bc220c114ca2657435ac340db8cc8c835b190a55
--- /dev/null
+++ b/ProcessLib/HeatTransportBHE/BHE/BuildingPowerCurves.h
@@ -0,0 +1,31 @@
+/**
+ * \file
+ *
+ * \copyright
+ * Copyright (c) 2012-2020, OpenGeoSys Community (http://www.opengeosys.org)
+ *            Distributed under a Modified BSD License.
+ *              See accompanying file LICENSE.txt or
+ *              http://www.opengeosys.org/project/license
+ */
+
+#pragma once
+
+namespace MathLib
+{
+class PiecewiseLinearInterpolation;
+}
+
+namespace ProcessLib
+{
+namespace HeatTransportBHE
+{
+namespace BHE
+{
+struct BuildingPowerCurves
+{
+    MathLib::PiecewiseLinearInterpolation const& power_curve;
+    MathLib::PiecewiseLinearInterpolation const& cop_heating_curve;
+};
+}  // namespace BHE
+}  // namespace HeatTransportBHE
+}  // namespace ProcessLib
diff --git a/ProcessLib/HeatTransportBHE/BHE/CreateBHE1PType.cpp b/ProcessLib/HeatTransportBHE/BHE/CreateBHE1PType.cpp
new file mode 100644
index 0000000000000000000000000000000000000000..2331f513e02a913653ff5259e58f3397c647519f
--- /dev/null
+++ b/ProcessLib/HeatTransportBHE/BHE/CreateBHE1PType.cpp
@@ -0,0 +1,98 @@
+/**
+ * \file
+ *
+ * \copyright
+ * Copyright (c) 2012-2020, OpenGeoSys Community (http://www.opengeosys.org)
+ *            Distributed under a Modified BSD License.
+ *              See accompanying file LICENSE.txt or
+ *              http://www.opengeosys.org/project/license
+ */
+
+#include "BaseLib/ConfigTree.h"
+#include "CreateBHEUType.h"
+
+#include "BHE_1P.h"
+#include "CreateFlowAndTemperatureControl.h"
+
+namespace ProcessLib
+{
+namespace HeatTransportBHE
+{
+namespace BHE
+{
+static std::tuple<BoreholeGeometry,
+                  RefrigerantProperties,
+                  GroutParameters,
+                  FlowAndTemperatureControl,
+                  PipeConfiguration1PType,
+                  bool>
+parseBHE1PTypeConfig(
+    BaseLib::ConfigTree const& config,
+    std::map<std::string,
+             std::unique_ptr<MathLib::PiecewiseLinearInterpolation>> const&
+        curves)
+{
+    // if the BHE is using python boundary condition
+    auto const bhe_if_use_python_bc_conf =
+        //! \ogs_file_param{prj__processes__process__HEAT_TRANSPORT_BHE__borehole_heat_exchangers__borehole_heat_exchanger__use_bhe_pipe_network}
+        config.getConfigParameter<bool>("use_bhe_pipe_network", false);
+
+    if (bhe_if_use_python_bc_conf)
+    {
+        DBUG("BHE 1P using python boundary conditions.");
+    }
+
+    auto const borehole_geometry =
+        //! \ogs_file_param{prj__processes__process__HEAT_TRANSPORT_BHE__borehole_heat_exchangers__borehole_heat_exchanger__borehole}
+        createBoreholeGeometry(config.getConfigSubtree("borehole"));
+
+    //! \ogs_file_param{prj__processes__process__HEAT_TRANSPORT_BHE__borehole_heat_exchangers__borehole_heat_exchanger__pipes}
+    auto const& pipes_config = config.getConfigSubtree("pipes");
+    //! \ogs_file_param{prj__processes__process__HEAT_TRANSPORT_BHE__borehole_heat_exchangers__borehole_heat_exchanger__pipes__inlet}
+    Pipe const inlet_pipe = createPipe(pipes_config.getConfigSubtree("inlet"));
+
+    const auto pipe_longitudinal_dispersion_length =
+        //! \ogs_file_param{prj__processes__process__HEAT_TRANSPORT_BHE__borehole_heat_exchangers__borehole_heat_exchanger__pipes__longitudinal_dispersion_length}
+        pipes_config.getConfigParameter<double>(
+            "longitudinal_dispersion_length");
+    PipeConfiguration1PType const pipes{inlet_pipe,
+                                        pipe_longitudinal_dispersion_length};
+
+    //! \ogs_file_param{prj__processes__process__HEAT_TRANSPORT_BHE__borehole_heat_exchangers__borehole_heat_exchanger__grout}
+    auto const grout = createGroutParameters(config.getConfigSubtree("grout"));
+
+    auto const refrigerant =
+        //! \ogs_file_param{prj__processes__process__HEAT_TRANSPORT_BHE__borehole_heat_exchangers__borehole_heat_exchanger__refrigerant}
+        createRefrigerantProperties(config.getConfigSubtree("refrigerant"));
+
+    auto const flowAndTemperatureControl = createFlowAndTemperatureControl(
+        //! \ogs_file_param{prj__processes__process__HEAT_TRANSPORT_BHE__borehole_heat_exchangers__borehole_heat_exchanger__flow_and_temperature_control}
+        config.getConfigSubtree("flow_and_temperature_control"),
+        curves,
+        refrigerant);
+
+    return {borehole_geometry,         refrigerant, grout,
+            flowAndTemperatureControl, pipes,       bhe_if_use_python_bc_conf};
+}
+
+template <typename T_BHE>
+T_BHE createBHE1PType(
+    BaseLib::ConfigTree const& config,
+    std::map<std::string,
+             std::unique_ptr<MathLib::PiecewiseLinearInterpolation>> const&
+        curves)
+{
+    auto SinglePipeType = parseBHE1PTypeConfig(config, curves);
+    return {std::get<0>(SinglePipeType), std::get<1>(SinglePipeType),
+            std::get<2>(SinglePipeType), std::get<3>(SinglePipeType),
+            std::get<4>(SinglePipeType), std::get<5>(SinglePipeType)};
+}
+
+template BHE_1P createBHE1PType<BHE_1P>(
+    BaseLib::ConfigTree const& config,
+    std::map<std::string,
+             std::unique_ptr<MathLib::PiecewiseLinearInterpolation>> const&
+        curves);
+}  // namespace BHE
+}  // namespace HeatTransportBHE
+}  // namespace ProcessLib
diff --git a/ProcessLib/HeatTransportBHE/BHE/CreateBHE1PType.h b/ProcessLib/HeatTransportBHE/BHE/CreateBHE1PType.h
new file mode 100644
index 0000000000000000000000000000000000000000..708e116846a3dc92f4dee82d0c718854bac7018d
--- /dev/null
+++ b/ProcessLib/HeatTransportBHE/BHE/CreateBHE1PType.h
@@ -0,0 +1,35 @@
+/**
+ * \file
+ * \copyright
+ * Copyright (c) 2012-2020, OpenGeoSys Community (http://www.opengeosys.org)
+ *            Distributed under a Modified BSD License.
+ *              See accompanying file LICENSE.txt or
+ *              http://www.opengeosys.org/project/license
+ *
+ */
+
+#pragma once
+
+#include <map>
+#include <memory>
+#include <string>
+
+namespace BaseLib
+{
+class ConfigTree;
+}
+namespace ProcessLib
+{
+namespace HeatTransportBHE
+{
+namespace BHE
+{
+template <typename T_BHE>
+T_BHE createBHE1PType(
+    BaseLib::ConfigTree const& config,
+    std::map<std::string,
+             std::unique_ptr<MathLib::PiecewiseLinearInterpolation>> const&
+        curves);
+}  // namespace BHE
+}  // namespace HeatTransportBHE
+}  // namespace ProcessLib
diff --git a/ProcessLib/HeatTransportBHE/BHE/CreateBHEUType.cpp b/ProcessLib/HeatTransportBHE/BHE/CreateBHEUType.cpp
index 7b8d91b20b36351823c4c05d3da270ce09e13c0c..37766ce994dc721a873d2017ce1496d5a4a3957e 100644
--- a/ProcessLib/HeatTransportBHE/BHE/CreateBHEUType.cpp
+++ b/ProcessLib/HeatTransportBHE/BHE/CreateBHEUType.cpp
@@ -11,6 +11,7 @@
 #include "CreateBHEUType.h"
 #include "BaseLib/ConfigTree.h"
 
+#include "BHE_1P.h"
 #include "BHE_1U.h"
 #include "BHE_2U.h"
 #include "CreateFlowAndTemperatureControl.h"
diff --git a/ProcessLib/HeatTransportBHE/BHE/CreateFlowAndTemperatureControl.cpp b/ProcessLib/HeatTransportBHE/BHE/CreateFlowAndTemperatureControl.cpp
index 25fb12fc7cf8ca2d8bb68604e20db9ab13b1efae..abd3a1717588a8dbcaf59f029161642a73b670de 100644
--- a/ProcessLib/HeatTransportBHE/BHE/CreateFlowAndTemperatureControl.cpp
+++ b/ProcessLib/HeatTransportBHE/BHE/CreateFlowAndTemperatureControl.cpp
@@ -12,6 +12,7 @@
 #include "BaseLib/ConfigTree.h"
 #include "MathLib/InterpolationAlgorithms/PiecewiseLinearInterpolation.h"
 
+#include "BuildingPowerCurves.h"
 #include "CreateFlowAndTemperatureControl.h"
 #include "RefrigerantProperties.h"
 
@@ -86,6 +87,31 @@ FlowAndTemperatureControl createFlowAndTemperatureControl(
                                       refrigerant.specific_heat_capacity,
                                       refrigerant.density};
     }
+
+    if (type == "BuildingPowerCurveConstantFlow")
+    {
+        auto const& power_curve = *BaseLib::getOrError(
+            curves,
+            //! \ogs_file_param{prj__processes__process__HEAT_TRANSPORT_BHE__borehole_heat_exchangers__borehole_heat_exchanger__flow_and_temperature_control__BuildingPowerCurveConstantFlow__power_curve}
+            config.getConfigParameter<std::string>("power_curve"),
+            "Required power curve not found.");
+
+        auto const& cop_heating_curve = *BaseLib::getOrError(
+            curves,
+            //! \ogs_file_param{prj__processes__process__HEAT_TRANSPORT_BHE__borehole_heat_exchangers__borehole_heat_exchanger__flow_and_temperature_control__BuildingPowerCurveConstantFlow__cop_heating_curve}
+            config.getConfigParameter<std::string>("cop_heating_curve"),
+            "Required power curve not found.");
+
+        BuildingPowerCurves const building_power_curves{power_curve,
+                                                        cop_heating_curve};
+
+        //! \ogs_file_param{prj__processes__process__HEAT_TRANSPORT_BHE__borehole_heat_exchangers__borehole_heat_exchanger__flow_and_temperature_control__BuildingPowerCurveConstantFlow__flow_rate}
+        auto const flow_rate = config.getConfigParameter<double>("flow_rate");
+
+        return BuildingPowerCurveConstantFlow{
+            building_power_curves, flow_rate,
+            refrigerant.specific_heat_capacity, refrigerant.density};
+    }
     OGS_FATAL("FlowAndTemperatureControl type '%s' is not implemented.",
               type.c_str());
 }
diff --git a/ProcessLib/HeatTransportBHE/BHE/FlowAndTemperatureControl.h b/ProcessLib/HeatTransportBHE/BHE/FlowAndTemperatureControl.h
index e7d50bdb78579dd495c63ce225279a4ad8056f1f..a718751a9733075986dd81bddd679885eeaf4f44 100644
--- a/ProcessLib/HeatTransportBHE/BHE/FlowAndTemperatureControl.h
+++ b/ProcessLib/HeatTransportBHE/BHE/FlowAndTemperatureControl.h
@@ -11,6 +11,7 @@
 #pragma once
 
 #include <variant>
+#include "BuildingPowerCurves.h"
 #include "MathLib/InterpolationAlgorithms/PiecewiseLinearInterpolation.h"
 
 namespace ProcessLib
@@ -81,10 +82,34 @@ struct PowerCurveConstantFlow
     double density;
 };
 
+struct BuildingPowerCurveConstantFlow
+{
+    FlowAndTemperature operator()(double const T_out, double const time) const
+    {
+        double const power = building_power_curves.power_curve.getValue(time);
+        double const cop =
+            building_power_curves.cop_heating_curve.getValue(T_out);
+
+        if (power == 0)
+        {
+            return {0.0, T_out};
+        }
+        return {flow_rate,
+                power * (cop - 1) / cop / flow_rate / heat_capacity / density +
+                    T_out};
+    }
+    BuildingPowerCurves const building_power_curves;
+
+    double flow_rate;
+    double heat_capacity;
+    double density;
+};
+
 using FlowAndTemperatureControl = std::variant<TemperatureCurveConstantFlow,
                                                FixedPowerConstantFlow,
                                                FixedPowerFlowCurve,
-                                               PowerCurveConstantFlow>;
+                                               PowerCurveConstantFlow,
+                                               BuildingPowerCurveConstantFlow>;
 }  // namespace BHE
 }  // namespace HeatTransportBHE
 }  // namespace ProcessLib
diff --git a/ProcessLib/HeatTransportBHE/BHE/PipeConfiguration1PType.h b/ProcessLib/HeatTransportBHE/BHE/PipeConfiguration1PType.h
new file mode 100644
index 0000000000000000000000000000000000000000..3c1046955106315db1d89f1fe6ee1020e4db4653
--- /dev/null
+++ b/ProcessLib/HeatTransportBHE/BHE/PipeConfiguration1PType.h
@@ -0,0 +1,29 @@
+/**
+ * \file
+ *
+ * \copyright
+ * Copyright (c) 2012-2020, OpenGeoSys Community (http://www.opengeosys.org)
+ *            Distributed under a Modified BSD License.
+ *              See accompanying file LICENSE.txt or
+ *              http://www.opengeosys.org/project/license
+ */
+
+#pragma once
+
+#include "Pipe.h"
+
+namespace ProcessLib
+{
+namespace HeatTransportBHE
+{
+namespace BHE
+{
+struct PipeConfiguration1PType
+{
+    Pipe const single_pipe;
+
+    double const longitudinal_dispersion_length;
+};
+}  // namespace BHE
+}  // namespace HeatTransportBHE
+}  // namespace ProcessLib
diff --git a/ProcessLib/HeatTransportBHE/BHE/PipeConfigurationUType.h b/ProcessLib/HeatTransportBHE/BHE/PipeConfigurationUType.h
index 74e03994bcb2ede095bee5346c44d48545c5b73f..023d469a6b4f6a2951f83949dd1360f797ee78e0 100644
--- a/ProcessLib/HeatTransportBHE/BHE/PipeConfigurationUType.h
+++ b/ProcessLib/HeatTransportBHE/BHE/PipeConfigurationUType.h
@@ -9,7 +9,7 @@
  */
 
 #pragma once
-#include "BaseLib/ConfigTree.h"
+
 #include "Pipe.h"
 
 namespace ProcessLib
diff --git a/ProcessLib/HeatTransportBHE/CreateHeatTransportBHEProcess.cpp b/ProcessLib/HeatTransportBHE/CreateHeatTransportBHEProcess.cpp
index d5baf91fdb60942c4190ee36beb86c54b186e139..64279e35d6e52432f2ed47d6039a37b52b947f87 100644
--- a/ProcessLib/HeatTransportBHE/CreateHeatTransportBHEProcess.cpp
+++ b/ProcessLib/HeatTransportBHE/CreateHeatTransportBHEProcess.cpp
@@ -18,6 +18,7 @@
 #include "BHE/BHETypes.h"
 #include "BHE/CreateBHECoaxial.h"
 #include "BHE/CreateBHEUType.h"
+#include "BHE/CreateBHE1PType.h"
 #include "HeatTransportBHEProcess.h"
 #include "HeatTransportBHEProcessData.h"
 #ifdef OGS_USE_PYTHON
@@ -136,6 +137,13 @@ std::unique_ptr<Process> createHeatTransportBHEProcess(
                 BHE::createBHEUType<BHE::BHE_2U>(bhe_config, curves));
             continue;
         }
+
+        if (bhe_type == "1P")
+        {
+            bhes.emplace_back(
+                BHE::createBHE1PType<BHE::BHE_1P>(bhe_config, curves));
+            continue;
+        }
         OGS_FATAL("Unknown BHE type '%s'.", bhe_type.c_str());
     }
     // end of reading BHE parameters -------------------------------------------
diff --git a/ProcessLib/HeatTransportBHE/HeatTransportBHEProcess.cpp b/ProcessLib/HeatTransportBHE/HeatTransportBHEProcess.cpp
index 20d39b268bbc18693ab3d5403e586c6f25ea4a3c..cf4ca0df634524d5f523bb5d42b25743002562f4 100644
--- a/ProcessLib/HeatTransportBHE/HeatTransportBHEProcess.cpp
+++ b/ProcessLib/HeatTransportBHE/HeatTransportBHEProcess.cpp
@@ -284,6 +284,7 @@ void HeatTransportBHEProcess::createBHEBoundaryConditionTopBottom(
         const int variable_id = bhe_i + 1;
 
         std::vector<MeshLib::Node*> bhe_boundary_nodes;
+
         // cherry-pick the boundary nodes according to
         // the number of connected line elements.
         for (auto const& bhe_node : bhe_nodes)
@@ -366,20 +367,31 @@ void HeatTransportBHEProcess::createBHEBoundaryConditionTopBottom(
                     bcs.addBoundaryCondition(
                         createBHEInflowDirichletBoundaryCondition(
                             get_global_bhe_bc_indices(
-                                {{{bc_top_node_id, in_out_component_id.first},
-                                  {bc_top_node_id,
-                                   in_out_component_id.second}}}),
+                                bhe.getBHEInflowDirichletBCNodesAndComponents(
+                                    bc_top_node_id, bc_bottom_node_id,
+                                    in_out_component_id.first)),
                             [&bhe](double const T, double const t) {
                                 return bhe.updateFlowRateAndTemperature(T, t);
                             }));
                 }
-                // Bottom, outflow, all cases
-                bcs.addBoundaryCondition(
-                    createBHEBottomDirichletBoundaryCondition(
-                        get_global_bhe_bc_indices(
-                            {{{bc_bottom_node_id, in_out_component_id.first},
-                              {bc_bottom_node_id,
-                               in_out_component_id.second}}})));
+
+                auto const bottom_nodes_and_components =
+                    bhe.getBHEBottomDirichletBCNodesAndComponents(
+                        bc_bottom_node_id,
+                        in_out_component_id.first,
+                        in_out_component_id.second);
+
+                if (bottom_nodes_and_components)
+                {
+                    // Bottom, outflow, all cases
+                    bcs.addBoundaryCondition(
+                        createBHEBottomDirichletBoundaryCondition(
+                            get_global_bhe_bc_indices(
+                                {{{bc_bottom_node_id, in_out_component_id.first},
+                                  {bc_bottom_node_id,
+                                   in_out_component_id.second}}})));
+                }
+
             }
         };
         visit(createBCs, _process_data._vec_BHE_property[bhe_i]);
diff --git a/ProcessLib/HeatTransportBHE/LocalAssemblers/HeatTransportBHELocalAssemblerBHE-impl.h b/ProcessLib/HeatTransportBHE/LocalAssemblers/HeatTransportBHELocalAssemblerBHE-impl.h
index 7a86e76315fdfdf6c625ff4e8f10e555f8c7a52c..548e2efa719983d27f364c424de1fcb7c5a41f09 100644
--- a/ProcessLib/HeatTransportBHE/LocalAssemblers/HeatTransportBHELocalAssemblerBHE-impl.h
+++ b/ProcessLib/HeatTransportBHE/LocalAssemblers/HeatTransportBHELocalAssemblerBHE-impl.h
@@ -57,9 +57,17 @@ HeatTransportBHELocalAssemblerBHE<ShapeFunction, IntegrationMethod, BHEType>::
         _secondary_data.N[ip] = sm.N;
     }
 
+    // calculate the element direction vector
+    auto const p0 =
+        Eigen::Map<Eigen::Vector3d const>(e.getNode(0)->getCoords(), 3);
+    auto const p1 =
+        Eigen::Map<Eigen::Vector3d const>(e.getNode(1)->getCoords(), 3);
+
+    _element_direction = (p1 - p0).normalized();
+
     _R_matrix.setZero(bhe_unknowns_size, bhe_unknowns_size);
-    _R_pi_s_matrix.setZero(bhe_unknowns_size, temperature_size);
-    _R_s_matrix.setZero(temperature_size, temperature_size);
+    _R_pi_s_matrix.setZero(bhe_unknowns_size, soil_temperature_size);
+    _R_s_matrix.setZero(soil_temperature_size, soil_temperature_size);
     static constexpr int max_num_thermal_exchange_terms = 5;
     // formulate the local BHE R matrix
     for (int idx_bhe_unknowns = 0; idx_bhe_unknowns < bhe_unknowns;
@@ -131,7 +139,8 @@ void HeatTransportBHELocalAssemblerBHE<ShapeFunction, IntegrationMethod,
 
     auto const& pipe_heat_capacities = _bhe.pipeHeatCapacities();
     auto const& pipe_heat_conductions = _bhe.pipeHeatConductions();
-    auto const& pipe_advection_vectors = _bhe.pipeAdvectionVectors();
+    auto const& pipe_advection_vectors =
+        _bhe.pipeAdvectionVectors(_element_direction);
     auto const& cross_section_areas = _bhe.crossSectionAreas();
 
     // the mass and conductance matrix terms
@@ -187,18 +196,18 @@ void HeatTransportBHELocalAssemblerBHE<ShapeFunction, IntegrationMethod,
 
     // add the R_pi_s matrix to local_K
     local_K
-        .template block<bhe_unknowns_size, temperature_size>(bhe_unknowns_index,
-                                                             temperature_index)
+        .template block<bhe_unknowns_size, soil_temperature_size>(
+            bhe_unknowns_index, soil_temperature_index)
         .noalias() += _R_pi_s_matrix;
     local_K
-        .template block<temperature_size, bhe_unknowns_size>(temperature_index,
-                                                             bhe_unknowns_index)
+        .template block<soil_temperature_size, bhe_unknowns_size>(
+            soil_temperature_index, bhe_unknowns_index)
         .noalias() += _R_pi_s_matrix.transpose();
 
     // add the R_s matrix to local_K
     local_K
-        .template block<temperature_size, temperature_size>(temperature_index,
-                                                            temperature_index)
+        .template block<soil_temperature_size, soil_temperature_size>(
+            soil_temperature_index, soil_temperature_index)
         .noalias() += _bhe.number_of_grout_zones * _R_s_matrix;
 
     // debugging
diff --git a/ProcessLib/HeatTransportBHE/LocalAssemblers/HeatTransportBHELocalAssemblerBHE.h b/ProcessLib/HeatTransportBHE/LocalAssemblers/HeatTransportBHELocalAssemblerBHE.h
index 468df3ffccf8f54a5c24942eb80c3eca90c316f1..b20fcdd7d6be92c5fbf2b1968a13662eeb666dc3 100644
--- a/ProcessLib/HeatTransportBHE/LocalAssemblers/HeatTransportBHELocalAssemblerBHE.h
+++ b/ProcessLib/HeatTransportBHE/LocalAssemblers/HeatTransportBHELocalAssemblerBHE.h
@@ -30,13 +30,13 @@ class HeatTransportBHELocalAssemblerBHE
 {
     static constexpr int bhe_unknowns = BHEType::number_of_unknowns;
     static constexpr int single_bhe_unknowns_size = ShapeFunction::NPOINTS;
-    static constexpr int temperature_size = ShapeFunction::NPOINTS;
-    static constexpr int temperature_index = 0;
+    static constexpr int soil_temperature_size = ShapeFunction::NPOINTS;
+    static constexpr int soil_temperature_index = 0;
     static constexpr int bhe_unknowns_size =
         single_bhe_unknowns_size * bhe_unknowns;
     static constexpr int bhe_unknowns_index = ShapeFunction::NPOINTS;
     static constexpr int local_matrix_size =
-        temperature_size + bhe_unknowns_size;
+        soil_temperature_size + bhe_unknowns_size;
 
 public:
     using ShapeMatricesType =
@@ -91,16 +91,18 @@ private:
 
     SecondaryData<typename ShapeMatrices::ShapeType> _secondary_data;
 
+    Eigen::Vector3d _element_direction;
+
     typename ShapeMatricesType::template MatrixType<bhe_unknowns_size,
                                                     bhe_unknowns_size>
         _R_matrix;
 
-    typename ShapeMatricesType::template MatrixType<temperature_size,
-                                                    temperature_size>
+    typename ShapeMatricesType::template MatrixType<soil_temperature_size,
+                                                    soil_temperature_size>
         _R_s_matrix;
 
     typename ShapeMatricesType::template MatrixType<bhe_unknowns_size,
-                                                    temperature_size>
+                                                    soil_temperature_size>
         _R_pi_s_matrix;
 };
 }  // namespace HeatTransportBHE
diff --git a/ProcessLib/HeatTransportBHE/LocalAssemblers/LocalDataInitializer.h b/ProcessLib/HeatTransportBHE/LocalAssemblers/LocalDataInitializer.h
index 80c8ac60ff4b5d952ba0bed3b0134c12da1d7e9a..f3d8ca38e3a010877e206c9ef81f1005e23f71e8 100644
--- a/ProcessLib/HeatTransportBHE/LocalAssemblers/LocalDataInitializer.h
+++ b/ProcessLib/HeatTransportBHE/LocalAssemblers/LocalDataInitializer.h
@@ -283,6 +283,13 @@ private:
                     e, std::get<BHE::BHE_2U>(bhe),
                     std::forward<ConstructorArgs>(args)...}};
             }
+
+            if (std::holds_alternative<BHE::BHE_1P>(bhe))
+            {
+                return LADataIntfPtr{new LADataBHE<ShapeFunction, BHE::BHE_1P>{
+                    e, std::get<BHE::BHE_1P>(bhe),
+                    std::forward<ConstructorArgs>(args)...}};
+            }
             OGS_FATAL(
                 "Trying to create local assembler for an unknown BHE type.");
         };
diff --git a/ProcessLib/HeatTransportBHE/Tests.cmake b/ProcessLib/HeatTransportBHE/Tests.cmake
index 2a50eae93ac27fa6434d8d538e38334896209bab..05da3e9dcde21c6d85c7f4975e76f2ee3aab45f2 100644
--- a/ProcessLib/HeatTransportBHE/Tests.cmake
+++ b/ProcessLib/HeatTransportBHE/Tests.cmake
@@ -98,3 +98,17 @@ AddTest(
     3bhes_1U_pcs_0_ts_10_t_7200.000000.vtu 3bhes_1U_pcs_0_ts_10_t_7200.000000.vtu temperature_BHE2 temperature_BHE2 1e-10 1e-13
     3bhes_1U_pcs_0_ts_10_t_7200.000000.vtu 3bhes_1U_pcs_0_ts_10_t_7200.000000.vtu temperature_BHE3 temperature_BHE3 1e-10 1e-13
 )
+
+AddTest(
+    NAME HeatTransportBHE_single_pipe_flow_EUBHE
+    PATH Parabolic/T/BHE_1P
+    RUNTIME 60
+    EXECUTABLE ogs
+    EXECUTABLE_ARGS BHE_1P.prj
+    WRAPPER time
+    TESTER vtkdiff
+    REQUIREMENTS NOT OGS_USE_MPI
+    DIFF_DATA
+    BHE_1P_pcs_0_ts_10_t_600.000000.vtu BHE_1P_pcs_0_ts_10_t_600.000000.vtu temperature_BHE1 temperature_BHE1 1e-12 1e-14
+    BHE_1P_pcs_0_ts_10_t_600.000000.vtu BHE_1P_pcs_0_ts_10_t_600.000000.vtu temperature_soil temperature_soil 1e-12 1e-13
+)
diff --git a/Tests/Data/Parabolic/T/BHE_1P/BHE_1P.gml b/Tests/Data/Parabolic/T/BHE_1P/BHE_1P.gml
new file mode 100644
index 0000000000000000000000000000000000000000..0af93b9a8bc690fde13d1395a92347ea47f4fc27
--- /dev/null
+++ b/Tests/Data/Parabolic/T/BHE_1P/BHE_1P.gml
@@ -0,0 +1,3 @@
+version https://git-lfs.github.com/spec/v1
+oid sha256:f5f2ea46df3da46228e5cca06960a8544d2d917c9a640365f2ade2677eb9bddb
+size 654
diff --git a/Tests/Data/Parabolic/T/BHE_1P/BHE_1P.prj b/Tests/Data/Parabolic/T/BHE_1P/BHE_1P.prj
new file mode 100644
index 0000000000000000000000000000000000000000..0636d47a6efbeade69b3b71a092de0191d69b34d
--- /dev/null
+++ b/Tests/Data/Parabolic/T/BHE_1P/BHE_1P.prj
@@ -0,0 +1,228 @@
+<?xml version="1.0" encoding="ISO-8859-1"?>
+<OpenGeoSysProject>
+    <mesh>BHE_1P.vtu</mesh>
+    <geometry>BHE_1P.gml</geometry>
+    <processes>
+        <process>
+            <name>HeatTransportBHE</name>
+            <type>HEAT_TRANSPORT_BHE</type>
+            <integration_order>2</integration_order>
+            <process_variables>
+                <process_variable>temperature_soil</process_variable>
+                <process_variable>temperature_BHE1</process_variable>
+            </process_variables>
+            <borehole_heat_exchangers>
+                <borehole_heat_exchanger>
+                    <type>1P</type>
+                    <flow_and_temperature_control>
+                        <type>TemperatureCurveConstantFlow</type>
+                        <flow_rate>0.0002</flow_rate>
+                        <temperature_curve>inflow_temperature</temperature_curve>
+                    </flow_and_temperature_control>
+                    <borehole>
+                        <length>30.0</length>
+                        <diameter>0.28</diameter>
+                    </borehole>
+                    <grout>
+                        <density>2190.0</density>
+                        <porosity>0.0</porosity>
+                        <heat_capacity>1735.160</heat_capacity>
+                        <thermal_conductivity>0.73</thermal_conductivity>
+                    </grout>
+                    <pipes>
+                        <inlet>
+                            <diameter> 0.25826</diameter>
+                            <wall_thickness>0.00587</wall_thickness>
+                            <wall_thermal_conductivity>1.3</wall_thermal_conductivity>
+                        </inlet>
+                        <longitudinal_dispersion_length>0.001</longitudinal_dispersion_length>
+                    </pipes>
+                    <refrigerant>
+                        <density>1000.0</density>
+                        <viscosity>0.00114</viscosity>
+                        <specific_heat_capacity>4190</specific_heat_capacity>
+                        <thermal_conductivity>0.59</thermal_conductivity>
+                        <reference_temperature>25</reference_temperature>
+                    </refrigerant>
+                </borehole_heat_exchanger>
+            </borehole_heat_exchangers>
+        </process>
+    </processes>
+    <media>
+        <medium id="0">
+            <phases>
+                <phase>
+                    <type>AqueousLiquid</type>
+                    <properties>
+                        <property>
+                            <name>phase_velocity</name>
+                            <type>Constant</type>
+                            <value>0 0 0</value>
+                        </property>
+                        <property>
+                            <name>specific_heat_capacity</name>
+                            <type>Constant</type>
+                            <value>4068</value>
+                        </property>
+                        <property>
+                            <name>density</name>
+                            <type>Constant</type>
+                            <value>992.92</value>
+                        </property>
+                    </properties>
+                </phase>
+                <phase>
+                    <type>Solid</type>
+                    <properties>
+                        <property>
+                            <name>specific_heat_capacity</name>
+                            <type>Constant</type>
+                            <value>1778</value>
+                        </property>
+                        <property>
+                            <name>density</name>
+                            <type>Constant</type>
+                            <value>1800</value>
+                        </property>
+                    </properties>
+                </phase>
+                <phase>
+                    <type>Gas</type>
+                    <properties>
+                        <property>
+                            <name>specific_heat_capacity</name>
+                            <type>Constant</type>
+                            <value>1000</value>
+                        </property>
+                        <property>
+                            <name>density</name>
+                            <type>Constant</type>
+                            <value>2500</value>
+                        </property>
+                    </properties>
+                </phase>
+            </phases>
+            <properties>
+                <property>
+                    <name>porosity</name>
+                    <type>Constant</type>
+                    <value>0</value>
+                </property>
+                <property>
+                    <name>thermal_conductivity</name>
+                    <type>Constant</type>
+                    <value>2.78018</value>
+                </property>
+                <property>
+                    <name>thermal_longitudinal_dispersivity</name>
+                    <type>Constant</type>
+                    <value>0</value>
+                </property>
+                <property>
+                    <name>thermal_transversal_dispersivity</name>
+                    <type>Constant</type>
+                    <value>0</value>
+                </property>
+            </properties>
+        </medium>
+    </media>
+    <time_loop>
+        <processes>
+            <process ref="HeatTransportBHE">
+                <nonlinear_solver>basic_picard</nonlinear_solver>
+                <convergence_criterion>
+                    <type>DeltaX</type>
+                    <norm_type>NORM2</norm_type>
+                    <reltol>1e-6</reltol>
+                </convergence_criterion>
+                <time_discretization>
+                    <type>BackwardEuler</type>
+                </time_discretization>
+                <time_stepping>
+                    <type>FixedTimeStepping</type>
+                    <t_initial> 0.0 </t_initial>
+                    <t_end> 600 </t_end>
+                    <timesteps>
+                        <pair>
+                            <repeat>10</repeat>
+                            <delta_t>60</delta_t>
+                        </pair>
+                    </timesteps>
+                </time_stepping>
+            </process>
+        </processes>
+        <output>
+            <type>VTK</type>
+            <prefix>BHE_1P</prefix>
+            <timesteps>
+                <pair>
+                    <repeat> 1</repeat>
+                    <each_steps> 1 </each_steps>
+                </pair>
+            </timesteps>
+            <variables>
+                <variable>temperature_soil</variable>
+                <variable>temperature_BHE1</variable>
+            </variables>
+        </output>
+    </time_loop>
+    <parameters>
+        <parameter>
+            <name>T0</name>
+            <type>Constant</type>
+            <value>55</value>
+        </parameter>
+        <parameter>
+            <name>T0_BHE1</name>
+            <type>Constant</type>
+            <values>20 20</values>
+        </parameter>
+    </parameters>
+    <process_variables>
+        <process_variable>
+            <name>temperature_soil</name>
+            <components>1</components>
+            <order>1</order>
+            <initial_condition>T0</initial_condition>
+            <boundary_conditions>
+            </boundary_conditions>
+        </process_variable>
+        <process_variable>
+            <name>temperature_BHE1</name>
+            <components>2</components>
+            <order>1</order>
+            <initial_condition>T0_BHE1</initial_condition>
+        </process_variable>
+    </process_variables>
+    <nonlinear_solvers>
+        <nonlinear_solver>
+            <name>basic_picard</name>
+            <type>Picard</type>
+            <max_iter>200</max_iter>
+            <linear_solver>general_linear_solver</linear_solver>
+        </nonlinear_solver>
+    </nonlinear_solvers>
+    <linear_solvers>
+        <linear_solver>
+            <name>general_linear_solver</name>
+            <lis>-i cg -p jacobi -tol 1e-16 -maxiter 10000</lis>
+            <eigen>
+                <solver_type>BiCGSTAB</solver_type>
+                <precon_type>ILUT</precon_type>
+                <max_iteration_step>1000</max_iteration_step>
+                <error_tolerance>1e-16</error_tolerance>
+            </eigen>
+            <petsc>
+                <prefix>gw</prefix>
+                <parameters>-gw_ksp_type cg -gw_pc_type bjacobi -gw_ksp_rtol 1e-16 -gw_ksp_max_it 10000</parameters>
+            </petsc>
+        </linear_solver>
+    </linear_solvers>
+    <curves>
+        <curve>
+            <name>inflow_temperature</name>
+            <coords>0 864000</coords>
+            <values>20 20</values>
+        </curve>
+    </curves>
+</OpenGeoSysProject>
diff --git a/Tests/Data/Parabolic/T/BHE_1P/BHE_1P.vtu b/Tests/Data/Parabolic/T/BHE_1P/BHE_1P.vtu
new file mode 100644
index 0000000000000000000000000000000000000000..bb094752e53f241021f91b06e9b239a266a94e86
--- /dev/null
+++ b/Tests/Data/Parabolic/T/BHE_1P/BHE_1P.vtu
@@ -0,0 +1,3 @@
+version https://git-lfs.github.com/spec/v1
+oid sha256:51bb8d2525afa8df7480be2d8b57a12ba1b5a2f898db2044254026baaf4fea63
+size 2464940
diff --git a/Tests/Data/Parabolic/T/BHE_1P/BHE_1P_pcs_0_ts_10_t_600.000000.vtu b/Tests/Data/Parabolic/T/BHE_1P/BHE_1P_pcs_0_ts_10_t_600.000000.vtu
new file mode 100644
index 0000000000000000000000000000000000000000..77989a67b07c9b1e17d79b7870185abbbfd5230e
--- /dev/null
+++ b/Tests/Data/Parabolic/T/BHE_1P/BHE_1P_pcs_0_ts_10_t_600.000000.vtu
@@ -0,0 +1,3 @@
+version https://git-lfs.github.com/spec/v1
+oid sha256:bafd6d04d423325b54bd2d752f8f4ac48c6400ed40eb2d8d399152e416cc1334
+size 912582
diff --git a/web/content/docs/benchmarks/heat-transport-bhe/Analytical_wellbore_heat_transport.zip b/web/content/docs/benchmarks/heat-transport-bhe/Analytical_wellbore_heat_transport.zip
new file mode 100644
index 0000000000000000000000000000000000000000..c0082f1983d190975c842c85a2976d7a1da7171d
Binary files /dev/null and b/web/content/docs/benchmarks/heat-transport-bhe/Analytical_wellbore_heat_transport.zip differ
diff --git a/web/content/docs/benchmarks/heat-transport-bhe/pipe_flow_EBHE.pandoc b/web/content/docs/benchmarks/heat-transport-bhe/pipe_flow_EBHE.pandoc
new file mode 100644
index 0000000000000000000000000000000000000000..8714d87ad72d1722d8cf71f6a4daad8888e4c3a3
--- /dev/null
+++ b/web/content/docs/benchmarks/heat-transport-bhe/pipe_flow_EBHE.pandoc
@@ -0,0 +1,101 @@
++++
+author = "Chaofan Chen, Haibing Shao"
+date = "2020-02-24T13:44:00+01:00"
+title = "Wellbore Heat Transport - EUBHE"
+weight = 123
+project = "Parabolic/T/BHE_1P/BHE_1P.prj"
+
+[menu]
+  [menu.benchmarks]
+    parent = "heat-transport-bhe"
+
++++
+
+{{< data-link >}}
+
+## Problem description
+
+Ramey (Ramey et al. (1962)) proposed the analytical solution concerning the wellbore heat transmission, which can be used to quantify the fluid temperature change in the wellbore. In order to verify the single pipe flow model in the OGS, the numerical results was compared with the [Ramey's analytical solution](../Analytical_wellbore_heat_transport.zip). The detailed calculation of the Ramey's analytical solution is given below.
+
+## Model Setup
+
+In this benchmark, the length of the wellbore is 30 m as shown in Figure 1 and the cold water is injected into the inlet point of the wellbore with temperature of 20 $^{\circ}$C. The initial temperature of the fluid and grout in the wellbore is 20 $^{\circ}$C, and temperature of the surrounding rock is 55 $^{\circ}$C. The wellbore and pipe diameter are 0.28 m and 0.25826 m, respectively. And the flow rate is 0.0002 $m^3/s$.
+
+{{< img src="../pipe_flow_EBHE_figures/pipe_flow_3d_model.png" width="80">}}
+
+Figure 1: Single pipe flow model
+
+## Ramey's analytical solution
+
+In Ramey's analytical solution (Ramey et al. (1962)), the outlet temperature of the pipe inside the wellbore can be calculated by,
+
+\begin{equation}
+    T_o(t) = T_{s} + (T_i(t) - T_{s})\exp(-\Delta z/X)
+\end{equation}
+
+\noindent where, $q$ is the flow rate of the fluid in the wellbore and coefficient $X$ is determined by,
+
+\begin{equation}
+    X = \frac{q\rho_fc_{p,f}(\lambda_{s}+r_pUf(t))}{2\pi r_pU \lambda_{s}}
+\end{equation}
+
+with dimensionless time $t_D = \frac{\lambda_{s}t}{(\rho_{s}c_{p,s}r_b)}$, the time function $f(t)$ can be calculated by,
+
+\begin{align}
+    &f(t) = [0.4063+0.5\ln(t_D)][1+\frac{0.6}{t_D}], & t_D > 1.5
+    \\
+    &f(t) = 1.1281\sqrt{t_D}(1-0.3\sqrt{t_D}), & t_D \leqslant 1.5
+\end{align}
+
+\noindent and the overall heat transfer coefficient $U$ is written as follows,
+
+\begin{equation}
+    U = [\frac{r_{pi}+t_{pi}}{r_{pi}h}+(r_{pi}+t_{pi})(\frac{\ln{\frac{r_{pi}+t_{pi}}{r_{pi}}}}{\lambda_{pi}}+\frac{\ln{\frac{r_b}{r_{pi}+t_{pi}}}}{\lambda_{grout}})]^{-1}
+\end{equation}
+
+\begin{equation}
+    h = \frac{\lambda_f Nu}{2r_{pi}}
+\end{equation}
+
+The Nusselt number can be determined according to the Gnielinski's equation (Gnielinski et al. (1975)),
+
+\begin{align}
+    & Nu = 4.364, & Re < 2300 \\
+    & Nu = \frac{\frac{f}{8}(Re - 1000)Pr}{1+12.7\sqrt{\frac{f}{8}}(Pr^{\frac{2}{3}}-1)}, &  2300\leqslant Re < 5 \times 10^6
+\end{align}
+
+Pr is the Prandtl number, and the friction factor $f$, is evaluated by Churchill correlation (Churchill et al. (1977)),
+
+\begin{equation}
+    f = \frac{1}{(\frac{1}{[((\frac{8}{Re})^{10}+(\frac{Re}{36500})^{20})]^{1/2}}+[2.21(\ln{\frac{Re}{7}})]^{10})^{1/5}}
+\end{equation}
+
+The Prandtl and Reynolds number can be calculated as follows,
+
+\begin{align}
+    & Pr = \frac{\mu_f c_{p,f}}{\lambda_f}
+    & Re = \frac{\rho_f v d_{pi}}{\mu_f}
+\end{align}
+\noindent where, $\mu_f, \rho_f$ and $\lambda_f$ is the fluid viscosity, density and thermal conductivity.
+
+## Results and discussion
+
+The outlet temperature change over time was compared against analytical solution and presented in Figure 2. After 30 days, the fluid temperature distribution in the wellbore is shown in Figure 3. The maximum relative error between the numerical model and Ramey's analytical solution is less than 0.15 \%.
+
+In numerical model, the outlet temperature at beginning stage is affected by the initial temperature in the pipe inside the wellbore. The initial fluid temperature set in the benchmark means there is water with 20 $^{\circ}$C filled in the wellbore already before injecting water into the wellbore. But in the analytical solution, no initial temperature is set and the temperature keeps equilibrium state at every moment. The impact of initial temperature condition in numerical model is decreasing with increasement of the operational time as shown in Figure 2.
+
+{{< img src="../pipe_flow_EBHE_figures/T_out_comparison.png" width="120">}}
+
+Figure 2: Comparison with analytical solution results
+
+{{< img src="../pipe_flow_EBHE_figures/absolute_error_fluid_T_30d.png" width="200">}}
+
+Figure 3: Distributed temperature of fluid and absolute error.
+
+## References
+
+[1] Ramey Jr, H. J. (1962). Wellbore heat transmission. Journal of petroleum Technology, 14(04), 427-435.
+
+[2] Gnielinski, V. (1975). New equations for heat and mass transfer in the turbulent flow in pipes and channels. NASA STI/recon technical report A, 75, 8-16.
+
+[3] Churchill, S. W. (1977). Comprehensive correlating equations for heat, mass and momentum transfer in fully developed flow in smooth tubes. Industrial & Engineering Chemistry Fundamentals, 16(1), 109-116.
diff --git a/web/content/docs/benchmarks/heat-transport-bhe/pipe_flow_EBHE_figures/T_out_comparison.png b/web/content/docs/benchmarks/heat-transport-bhe/pipe_flow_EBHE_figures/T_out_comparison.png
new file mode 100644
index 0000000000000000000000000000000000000000..c6da5181330bb1bb9c24d670021d9259a9124fa5
--- /dev/null
+++ b/web/content/docs/benchmarks/heat-transport-bhe/pipe_flow_EBHE_figures/T_out_comparison.png
@@ -0,0 +1,3 @@
+version https://git-lfs.github.com/spec/v1
+oid sha256:07e9a3c4114e57f5aa671423ec59e2dcf07b838cd67daa8d53ce9ce266ded4a4
+size 52500
diff --git a/web/content/docs/benchmarks/heat-transport-bhe/pipe_flow_EBHE_figures/absolute_error_fluid_T_30d.png b/web/content/docs/benchmarks/heat-transport-bhe/pipe_flow_EBHE_figures/absolute_error_fluid_T_30d.png
new file mode 100644
index 0000000000000000000000000000000000000000..1a42a0eb17707ae5bce2fcde1fc04635424e9285
--- /dev/null
+++ b/web/content/docs/benchmarks/heat-transport-bhe/pipe_flow_EBHE_figures/absolute_error_fluid_T_30d.png
@@ -0,0 +1,3 @@
+version https://git-lfs.github.com/spec/v1
+oid sha256:d10c3715c55cc99d5f1511c2642badeae60bfe00ccc8378bb8760cecc7f789ed
+size 82189
diff --git a/web/content/docs/benchmarks/heat-transport-bhe/pipe_flow_EBHE_figures/pipe_flow_3d_model.png b/web/content/docs/benchmarks/heat-transport-bhe/pipe_flow_EBHE_figures/pipe_flow_3d_model.png
new file mode 100644
index 0000000000000000000000000000000000000000..768c58fcbee5faecd4c888cb70d6f731b3c8f9a0
--- /dev/null
+++ b/web/content/docs/benchmarks/heat-transport-bhe/pipe_flow_EBHE_figures/pipe_flow_3d_model.png
@@ -0,0 +1,3 @@
+version https://git-lfs.github.com/spec/v1
+oid sha256:05ab5d28b42e3f280ec05966371cada8406fafdaa1ea4f6acddf3f7d80fd9060
+size 46647