Skip to content

Commit

Permalink
Terrain-Aware Immersed Forcing Method (#1115)
Browse files Browse the repository at this point in the history
Co-authored-by: Harish Gopalan <[email protected]>
  • Loading branch information
hgopalan authored Oct 8, 2024
1 parent 25760c3 commit ea6129b
Show file tree
Hide file tree
Showing 19 changed files with 5,301 additions and 18 deletions.
3 changes: 2 additions & 1 deletion amr-wind/equation_systems/icns/source_terms/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -13,5 +13,6 @@ target_sources(${amr_wind_lib_name} PRIVATE
ABLMesoForcingMom.cpp
BurggrafFlowForcing.cpp
RayleighDamping.cpp
NonLinearSGSTerm.cpp
NonLinearSGSTerm.cpp
DragForcing.cpp
)
55 changes: 55 additions & 0 deletions amr-wind/equation_systems/icns/source_terms/DragForcing.H
Original file line number Diff line number Diff line change
@@ -0,0 +1,55 @@
#ifndef DRAGFORCING_H
#define DRAGFORCING_H

#include "amr-wind/equation_systems/icns/MomentumSource.H"
#include "amr-wind/core/SimTime.H"
#include "amr-wind/CFDSim.H"

namespace amr_wind::pde::icns {

/** Adds the forcing term to include the presence of immersed boundary
*
* \ingroup icns_src
*
*
*/
class DragForcing : public MomentumSource::Register<DragForcing>
{
public:
static std::string identifier() { return "DragForcing"; }

explicit DragForcing(const CFDSim& sim);

~DragForcing() override;

void operator()(
const int lev,
const amrex::MFIter& mfi,
const amrex::Box& bx,
const FieldState fstate,
const amrex::Array4<amrex::Real>& src_term) const override;

private:
const SimTime& m_time;
const CFDSim& m_sim;
const amrex::AmrCore& m_mesh;
const Field& m_velocity;
amrex::Gpu::DeviceVector<amrex::Real> m_device_vel_ht;
amrex::Gpu::DeviceVector<amrex::Real> m_device_vel_vals;
amrex::Real m_drag_coefficient{10.0};
amrex::Real m_sponge_strength{1.0};
amrex::Real m_sponge_density{1.0};
amrex::Real m_sponge_distance_west{-1000};
amrex::Real m_sponge_distance_east{1000};
amrex::Real m_sponge_distance_south{-1000};
amrex::Real m_sponge_distance_north{1000};
int m_sponge_west{0};
int m_sponge_east{1};
int m_sponge_south{0};
int m_sponge_north{1};
bool m_is_laminar{false};
};

} // namespace amr_wind::pde::icns

#endif
181 changes: 181 additions & 0 deletions amr-wind/equation_systems/icns/source_terms/DragForcing.cpp
Original file line number Diff line number Diff line change
@@ -0,0 +1,181 @@
#include "amr-wind/equation_systems/icns/source_terms/DragForcing.H"
#include "amr-wind/utilities/IOManager.H"

#include "AMReX_Gpu.H"
#include "AMReX_Random.H"
#include "amr-wind/wind_energy/ABL.H"

namespace amr_wind::pde::icns {

DragForcing::DragForcing(const CFDSim& sim)
: m_time(sim.time())
, m_sim(sim)
, m_mesh(sim.mesh())
, m_velocity(sim.repo().get_field("velocity"))
{
amrex::ParmParse pp("DragForcing");
pp.query("drag_coefficient", m_drag_coefficient);
pp.query("sponge_strength", m_sponge_strength);
pp.query("sponge_density", m_sponge_density);
pp.query("sponge_distance_west", m_sponge_distance_west);
pp.query("sponge_distance_east", m_sponge_distance_east);
pp.query("sponge_distance_south", m_sponge_distance_south);
pp.query("sponge_distance_north", m_sponge_distance_north);
pp.query("sponge_west", m_sponge_west);
pp.query("sponge_east", m_sponge_east);
pp.query("sponge_south", m_sponge_south);
pp.query("sponge_north", m_sponge_north);
pp.query("is_laminar", m_is_laminar);
const auto& phy_mgr = m_sim.physics_manager();
if (phy_mgr.contains("ABL")) {
const auto& abl = m_sim.physics_manager().get<amr_wind::ABL>();
const auto& fa_velocity = abl.abl_statistics().vel_profile_coarse();
m_device_vel_ht.resize(fa_velocity.line_centroids().size());
m_device_vel_vals.resize(fa_velocity.line_average().size());
amrex::Gpu::copy(
amrex::Gpu::hostToDevice, fa_velocity.line_centroids().begin(),
fa_velocity.line_centroids().end(), m_device_vel_ht.begin());
amrex::Gpu::copy(
amrex::Gpu::hostToDevice, fa_velocity.line_average().begin(),
fa_velocity.line_average().end(), m_device_vel_vals.begin());
} else {
m_sponge_strength = 0.0;
}
}

DragForcing::~DragForcing() = default;

void DragForcing::operator()(
const int lev,
const amrex::MFIter& mfi,
const amrex::Box& bx,
const FieldState fstate,
const amrex::Array4<amrex::Real>& src_term) const
{
const auto& vel =
m_velocity.state(field_impl::dof_state(fstate))(lev).const_array(mfi);
const bool is_terrain =
this->m_sim.repo().int_field_exists("terrain_blank");
if (!is_terrain) {
amrex::Abort("Need terrain blanking variable to use this source term");
}
auto* const m_terrain_blank =
&this->m_sim.repo().get_int_field("terrain_blank");
const auto& blank = (*m_terrain_blank)(lev).const_array(mfi);
auto* const m_terrain_drag =
&this->m_sim.repo().get_int_field("terrain_drag");
const auto& drag = (*m_terrain_drag)(lev).const_array(mfi);
auto* const m_terrainz0 = &this->m_sim.repo().get_field("terrainz0");
const auto& terrainz0 = (*m_terrainz0)(lev).const_array(mfi);
const auto& geom = m_mesh.Geom(lev);
const auto& dx = geom.CellSizeArray();
const auto& prob_lo = geom.ProbLoArray();
const auto& prob_hi = geom.ProbHiArray();
const amrex::Real drag_coefficient = m_drag_coefficient;
const amrex::Real sponge_strength = m_sponge_strength;
const amrex::Real sponge_density = m_sponge_density;
const amrex::Real start_east = prob_hi[0] - m_sponge_distance_east;
const amrex::Real start_west = prob_lo[0] - m_sponge_distance_west;
const amrex::Real start_north = prob_hi[1] - m_sponge_distance_north;
const amrex::Real start_south = prob_lo[1] - m_sponge_distance_south;
const int sponge_east = m_sponge_east;
const int sponge_west = m_sponge_west;
const int sponge_south = m_sponge_south;
const int sponge_north = m_sponge_north;
// Copy Data
const auto* device_vel_ht = m_device_vel_ht.data();
const auto* device_vel_vals = m_device_vel_vals.data();
const unsigned vsize = m_device_vel_ht.size();
const auto& dt = m_time.delta_t();
const bool is_laminar = m_is_laminar;
const amrex::Real scale_factor = (dx[2] < 1.0) ? 1.0 : 1.0 / dx[2];
const amrex::Real Cd =
(is_laminar && dx[2] < 1) ? drag_coefficient : drag_coefficient / dx[2];
const amrex::Real z0_min = 1e-4;
const auto tiny = std::numeric_limits<amrex::Real>::epsilon();
const amrex::Real kappa = 0.41;
const amrex::Real cd_max = 1000.0;
amrex::ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
const amrex::Real x = prob_lo[0] + (i + 0.5) * dx[0];
const amrex::Real y = prob_lo[1] + (j + 0.5) * dx[1];
const amrex::Real z = prob_lo[2] + (k + 0.5) * dx[2];
amrex::Real xstart_damping = 0;
amrex::Real ystart_damping = 0;
amrex::Real xend_damping = 0;
amrex::Real yend_damping = 0;
amrex::Real xi_end = (x - start_east) / (prob_hi[0] - start_east);
amrex::Real xi_start = (start_west - x) / (start_west - prob_lo[0]);
xi_start = sponge_west * std::max(xi_start, 0.0);
xi_end = sponge_east * std::max(xi_end, 0.0);
xstart_damping = sponge_west * sponge_strength * xi_start * xi_start;
xend_damping = sponge_east * sponge_strength * xi_end * xi_end;
amrex::Real yi_end = (y - start_north) / (prob_hi[1] - start_north);
amrex::Real yi_start = (start_south - y) / (start_south - prob_lo[1]);
yi_start = sponge_south * std::max(yi_start, 0.0);
yi_end = sponge_north * std::max(yi_end, 0.0);
ystart_damping = sponge_strength * yi_start * yi_start;
yend_damping = sponge_strength * yi_end * yi_end;
amrex::Real spongeVelX = 0.0;
amrex::Real spongeVelY = 0.0;
amrex::Real spongeVelZ = 0.0;
amrex::Real residual = 1000;
amrex::Real height_error = 0.0;
for (unsigned ii = 0; ii < vsize; ++ii) {
height_error = std::abs(z - device_vel_ht[ii]);
if (height_error < residual) {
residual = height_error;
const unsigned ix = 3 * ii;
const unsigned iy = 3 * ii + 1;
const unsigned iz = 3 * ii + 2;
spongeVelX = device_vel_vals[ix];
spongeVelY = device_vel_vals[iy];
spongeVelZ = device_vel_vals[iz];
}
}
amrex::Real Dxz = 0.0;
amrex::Real Dyz = 0.0;
amrex::Real bc_forcing_x = 0;
amrex::Real bc_forcing_y = 0;
const amrex::Real ux1 = vel(i, j, k, 0);
const amrex::Real uy1 = vel(i, j, k, 1);
const amrex::Real uz1 = vel(i, j, k, 2);
const amrex::Real m = std::sqrt(ux1 * ux1 + uy1 * uy1 + uz1 * uz1);
if (drag(i, j, k) == 1 && (!is_laminar)) {
const amrex::Real ux2 = vel(i, j, k + 1, 0);
const amrex::Real uy2 = vel(i, j, k + 1, 1);
const amrex::Real m2 = std::sqrt(ux2 * ux2 + uy2 * uy2);
const amrex::Real z0 = std::max(terrainz0(i, j, k), z0_min);
const amrex::Real ustar = m2 * kappa / std::log(1.5 * dx[2] / z0);
const amrex::Real uTarget =
ustar / kappa * std::log(0.5 * dx[2] / z0);
const amrex::Real uxTarget =
uTarget * ux2 / (tiny + std::sqrt(ux2 * ux2 + uy2 * uy2));
const amrex::Real uyTarget =
uTarget * uy2 / (tiny + std::sqrt(ux2 * ux2 + uy2 * uy2));
bc_forcing_x = -(uxTarget - ux1) / dt;
bc_forcing_y = -(uyTarget - uy1) / dt;
Dxz = -ustar * ustar * ux1 /
(tiny + std::sqrt(ux1 * ux1 + uy1 * uy1)) / dx[2];
Dyz = -ustar * ustar * uy1 /
(tiny + std::sqrt(ux1 * ux1 + uy1 * uy1)) / dx[2];
}
const amrex::Real CdM =
std::min(Cd / (m + tiny), cd_max / scale_factor);
src_term(i, j, k, 0) -=
(CdM * m * ux1 * blank(i, j, k) + Dxz * drag(i, j, k) +
bc_forcing_x * drag(i, j, k) +
(xstart_damping + xend_damping + ystart_damping + yend_damping) *
(ux1 - sponge_density * spongeVelX));
src_term(i, j, k, 1) -=
(CdM * m * uy1 * blank(i, j, k) + Dyz * drag(i, j, k) +
bc_forcing_y * drag(i, j, k) +
(xstart_damping + xend_damping + ystart_damping + yend_damping) *
(uy1 - sponge_density * spongeVelY));
src_term(i, j, k, 2) -=
(CdM * m * uz1 * blank(i, j, k) +
(xstart_damping + xend_damping + ystart_damping + yend_damping) *
(uz1 - sponge_density * spongeVelZ));
});
}

} // namespace amr_wind::pde::icns
Original file line number Diff line number Diff line change
@@ -1,4 +1,5 @@
target_sources(${amr_wind_lib_name} PRIVATE
ABLMesoForcingTemp.cpp BodyForce.cpp
HurricaneTempForcing.cpp
DragTempForcing.cpp
)
Original file line number Diff line number Diff line change
@@ -0,0 +1,36 @@
#ifndef DRAGTEMPFORCING_H
#define DRAGTEMPFORCING_H

#include "amr-wind/equation_systems/temperature/TemperatureSource.H"
#include "amr-wind/core/SimTime.H"
#include "amr-wind/CFDSim.H"

namespace amr_wind::pde::temperature {

class DragTempForcing : public TemperatureSource::Register<DragTempForcing>
{
public:
static std::string identifier() { return "DragTempForcing"; }

explicit DragTempForcing(const CFDSim& sim);

~DragTempForcing() override;

void operator()(
const int lev,
const amrex::MFIter& mfi,
const amrex::Box& bx,
const FieldState /*fstate*/,
const amrex::Array4<amrex::Real>& src_term) const override;

private:
const CFDSim& m_sim;
const amrex::AmrCore& m_mesh;
const Field& m_velocity;
const Field& m_temperature;
amrex::Real m_drag_coefficient{1.0};
amrex::Real m_reference_temperature{300.0};
};

} // namespace amr_wind::pde::temperature
#endif
Original file line number Diff line number Diff line change
@@ -0,0 +1,63 @@

#include "amr-wind/equation_systems/temperature/source_terms/DragTempForcing.H"
#include "amr-wind/utilities/IOManager.H"

#include "AMReX_ParmParse.H"
#include "AMReX_Gpu.H"
#include "AMReX_Random.H"

namespace amr_wind::pde::temperature {

DragTempForcing::DragTempForcing(const CFDSim& sim)
: m_sim(sim)
, m_mesh(sim.mesh())
, m_velocity(sim.repo().get_field("velocity"))
, m_temperature(sim.repo().get_field("temperature"))
{
amrex::ParmParse pp("DragTempForcing");
pp.query("drag_coefficient", m_drag_coefficient);
pp.query("reference_temperature", m_reference_temperature);
}

DragTempForcing::~DragTempForcing() = default;

void DragTempForcing::operator()(
const int lev,
const amrex::MFIter& mfi,
const amrex::Box& bx,
const FieldState fstate,
const amrex::Array4<amrex::Real>& src_term) const
{
const auto& vel =
m_velocity.state(field_impl::dof_state(fstate))(lev).const_array(mfi);
const auto& temperature =
m_temperature.state(field_impl::dof_state(fstate))(lev).const_array(
mfi);
const bool is_terrain =
this->m_sim.repo().int_field_exists("terrain_blank");
if (!is_terrain) {
amrex::Abort("Need terrain blanking variable to use this source term");
}
auto* const m_terrain_blank =
&this->m_sim.repo().get_int_field("terrain_blank");
const auto& blank = (*m_terrain_blank)(lev).const_array(mfi);
const auto& geom = m_mesh.Geom(lev);
const auto& dx = geom.CellSizeArray();
const amrex::Real drag_coefficient = m_drag_coefficient / dx[2];
const amrex::Real reference_temperature = m_reference_temperature;
const auto tiny = std::numeric_limits<amrex::Real>::epsilon();
const amrex::Real cd_max = 10.0;
amrex::ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
const amrex::Real ux1 = vel(i, j, k, 0);
const amrex::Real uy1 = vel(i, j, k, 1);
const amrex::Real uz1 = vel(i, j, k, 2);
const amrex::Real m = std::sqrt(ux1 * ux1 + uy1 * uy1 + uz1 * uz1);
const amrex::Real Cd =
std::min(drag_coefficient / (m + tiny), cd_max / dx[2]);
src_term(i, j, k, 0) -=
(Cd * (temperature(i, j, k, 0) - reference_temperature) *
blank(i, j, k, 0));
});
}

} // namespace amr_wind::pde::temperature
1 change: 1 addition & 0 deletions amr-wind/physics/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -16,6 +16,7 @@ target_sources(${amr_wind_lib_name}
ScalarAdvection.cpp
VortexDipole.cpp
BurggrafFlow.cpp
TerrainDrag.cpp
ActuatorSourceTagging.cpp
Intermittency.cpp
)
Expand Down
Loading

0 comments on commit ea6129b

Please sign in to comment.