Skip to content

Commit

Permalink
Rename all files related to the VANS solver using Fluid Dynamics pref…
Browse files Browse the repository at this point in the history
…ix (#1225)

Description
This PR changes the name of the main class and the name of the files related to the lethe-fluid-vans application. Is the second PR on a series of PRs that aim to rename all the Navier Stokes solvers of Lethe using the prefix FluidDynamics and removing GLS.

Testing
All the existent tests pass without any change.

Former-commit-id: f87d2d1
  • Loading branch information
lpsaavedra authored Aug 6, 2024
1 parent f63db2a commit 5ccaa11
Show file tree
Hide file tree
Showing 13 changed files with 200 additions and 202 deletions.
6 changes: 4 additions & 2 deletions CHANGELOG.md
Original file line number Diff line number Diff line change
Expand Up @@ -7,9 +7,11 @@ The format is based on [Keep a Changelog](http://keepachangelog.com/).

### Changed

- MINOR Renamed all the files related to the `lethe-fluid-matrix-free` application: `mf_navier_stokes` to `fluid_dynamics_matrix_free` and `mf_navier_stokes_operators` to `fluid_dynamics_matrix_free_operators`. The main class `MFNavierStokesSolver` was also renamed to `FluidDynamicsMatrixFree`. [#1222](https://github.com/chaos-polymtl/lethe/pull/1222)
- MINOR Renamed the main file related to the `lethe-fluid-vans` application: `gls_vans` to `fluid_dynamics_vans`. The name of the `GLSVansAssembler...` classes were changed to `VANSAssembler...`, and the main class `GLSVANSSolver` was also renamed to `FluidDynamicsVANS`. [#1225](https://github.com/chaos-polymtl/lethe/pull/1225)

## [Master] - 2024-08-05
### Changed

- MINOR Renamed all the files related to the `lethe-fluid-matrix-free` application: `mf_navier_stokes` to `fluid_dynamics_matrix_free` and `mf_navier_stokes_operators` to `fluid_dynamics_matrix_free_operators`. The main class `MFNavierStokesSolver` was also renamed to `FluidDynamicsMatrixFree`. [#1222](https://github.com/chaos-polymtl/lethe/pull/1222)

### Removed

Expand Down
2 changes: 1 addition & 1 deletion applications/lethe-fluid-vans/CMakeLists.txt
Original file line number Diff line number Diff line change
@@ -1,3 +1,3 @@
add_executable(lethe-fluid-vans gls_vans.cc)
add_executable(lethe-fluid-vans fluid_dynamics_vans.cc)
deal_ii_setup_target(lethe-fluid-vans)
target_link_libraries(lethe-fluid-vans lethe-fem-dem)
Original file line number Diff line number Diff line change
Expand Up @@ -14,7 +14,7 @@
* ---------------------------------------------------------------------
*/

#include "fem-dem/gls_vans.h"
#include "fem-dem/fluid_dynamics_vans.h"

int
main(int argc, char *argv[])
Expand Down Expand Up @@ -42,7 +42,7 @@ main(int argc, char *argv[])
prm.parse_input(argv[1]);
NSparam.parse(prm);

GLSVANSSolver<2> problem(NSparam);
FluidDynamicsVANS<2> problem(NSparam);
problem.solve();
}

Expand All @@ -55,7 +55,7 @@ main(int argc, char *argv[])
prm.parse_input(argv[1]);
NSparam.parse(prm);

GLSVANSSolver<3> problem(NSparam);
FluidDynamicsVANS<3> problem(NSparam);
problem.solve();
}

Expand Down
2 changes: 1 addition & 1 deletion doc/doxygen/main.h
Original file line number Diff line number Diff line change
Expand Up @@ -41,7 +41,7 @@
auxiliary_physics:e -> auxiliary_physics_3:w [dir=back];
auxiliary_physics:e -> auxiliary_physics_4:w [dir=back];
navier_stokes_base_1_1 [label=<<B>GLSVANSSolver</B> <br/>(lethe-fluid-vans)>,href="https://chaos-polymtl.github.io/lethe/doxygen/classGLSVANSSolver.html", tooltip="GLSVANSSolver"];
navier_stokes_base_1_1 [label=<<B>FluidDynamicsVANS</B> <br/>(lethe-fluid-vans)>,href="https://chaos-polymtl.github.io/lethe/doxygen/classFluidDynamicsVANS.html", tooltip="FluidDynamicsVANS"];
navier_stokes_base_1_2 [label=<<B>GLSSharpNavierStokesSolver</B> <br/>(lethe-fluid-sharp)>,href="https://chaos-polymtl.github.io/lethe/doxygen/classGLSSharpNavierStokesSolver.html", tooltip="GLSSharpNavierStokesSolver"];
navier_stokes_base_1_3 [label=<<B>GLSNitscheNavierStokesSolver</B> <br/>(lethe-fluid-nitsche)>,href="https://chaos-polymtl.github.io/lethe/doxygen/classGLSNitscheNavierStokesSolver.html", tooltip="GLSNitscheNavierStokesSolver"];
Expand Down
2 changes: 1 addition & 1 deletion doc/source/parameters/unresolved-cfd-dem/cfd-dem.rst
Original file line number Diff line number Diff line change
@@ -1,7 +1,7 @@
=======
CFD-DEM
=======
This subsection includes parameters related to multiphase flow simulations using the both the gls_vans solver and the cfd-dem_coupling solver within Lethe.
This subsection includes parameters related to multiphase flow simulations using the both the `lethe-fluid-vans` solver and the `lethe-fluid-particles` solver within Lethe.

.. code-block:: text
Expand Down
2 changes: 1 addition & 1 deletion doc/source/parameters/unresolved-cfd-dem/void-fraction.rst
Original file line number Diff line number Diff line change
Expand Up @@ -35,7 +35,7 @@ If the ``mode`` chosen is ``pcm``, then the void fraction is calculated using th
set particle refinement factor = 0
* The ``read dem`` allows us to read an already existing dem simulation result which can be obtained from checkpointing the Lethe-DEM simulation. This is important as the gls_vans solver requires reading an initial dem triangulation and particle information to simulate flows in the presence of particles.
* The ``read dem`` allows us to read an already existing dem simulation result which can be obtained from checkpointing the Lethe-DEM simulation. This is important as the `lethe-fluid-vans` solver requires reading an initial dem triangulation and particle information to simulate flows in the presence of particles.
* The ``dem_file_name`` parameter specifies the prefix of the dem files that must be read.
* The ``l2 smoothing factor`` is a smoothing length used for smoothing the L2 projection of the void fraction to avoid sharp discontinuities which can lead to instabilities in the simulation.
* The ``l2 lower bound`` and ``l2 upper bound`` are the minimum and maximum values around which the void fraction is bounded. This is important especially for upper bounds as the void fraction can sometimes slightly exceed a value of 1 when projected.
Expand Down
4 changes: 2 additions & 2 deletions include/fem-dem/cfd_dem_coupling.h
Original file line number Diff line number Diff line change
Expand Up @@ -31,7 +31,7 @@
#include <dem/lagrangian_post_processing.h>
#include <dem/periodic_boundaries_manipulator.h>
#include <fem-dem/cfd_dem_simulation_parameters.h>
#include <fem-dem/gls_vans.h>
#include <fem-dem/fluid_dynamics_vans.h>
#include <fem-dem/postprocessing_cfd_dem.h>

#include <deal.II/base/work_stream.h>
Expand All @@ -53,7 +53,7 @@ using namespace dealii;
* simulate solid-fluid flow with two-way coupling.
*/
template <int dim>
class CFDDEMSolver : public GLSVANSSolver<dim>
class CFDDEMSolver : public FluidDynamicsVANS<dim>
{
public:
CFDDEMSolver(CFDDEMSimulationParameters<dim> &nsparam);
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -40,8 +40,8 @@
#include <boost/archive/text_iarchive.hpp>
#include <boost/archive/text_oarchive.hpp>

#ifndef lethe_gls_vans_h
# define lethe_gls_vans_h
#ifndef lethe_fluid_dynamics_vans_h
# define lethe_fluid_dynamics_vans_h

using namespace dealii;

Expand Down Expand Up @@ -112,12 +112,12 @@ particle_sphere_intersection_3d(double r_particle,
*/

template <int dim>
class GLSVANSSolver : public GLSNavierStokesSolver<dim>
class FluidDynamicsVANS : public GLSNavierStokesSolver<dim>
{
public:
GLSVANSSolver(CFDDEMSimulationParameters<dim> &nsparam);
FluidDynamicsVANS(CFDDEMSimulationParameters<dim> &nsparam);

~GLSVANSSolver();
~FluidDynamicsVANS();

virtual void
solve() override;
Expand Down
87 changes: 42 additions & 45 deletions include/fem-dem/vans_assemblers.h
Original file line number Diff line number Diff line change
Expand Up @@ -64,12 +64,11 @@ class ParticleFluidAssemblerBase
* @ingroup assemblers
*/
template <int dim>
class GLSVansAssemblerCoreModelB : public NavierStokesAssemblerBase<dim>
class VANSAssemblerCoreModelB : public NavierStokesAssemblerBase<dim>
{
public:
GLSVansAssemblerCoreModelB(
std::shared_ptr<SimulationControl> simulation_control,
Parameters::CFDDEM cfd_dem)
VANSAssemblerCoreModelB(std::shared_ptr<SimulationControl> simulation_control,
Parameters::CFDDEM cfd_dem)
: simulation_control(simulation_control)
, cfd_dem(cfd_dem)
{}
Expand Down Expand Up @@ -106,12 +105,11 @@ class GLSVansAssemblerCoreModelB : public NavierStokesAssemblerBase<dim>
* @ingroup assemblers
*/
template <int dim>
class GLSVansAssemblerCoreModelA : public NavierStokesAssemblerBase<dim>
class VANSAssemblerCoreModelA : public NavierStokesAssemblerBase<dim>
{
public:
GLSVansAssemblerCoreModelA(
std::shared_ptr<SimulationControl> simulation_control,
Parameters::CFDDEM cfd_dem)
VANSAssemblerCoreModelA(std::shared_ptr<SimulationControl> simulation_control,
Parameters::CFDDEM cfd_dem)
: simulation_control(simulation_control)
, cfd_dem(cfd_dem)
{}
Expand Down Expand Up @@ -153,11 +151,11 @@ class GLSVansAssemblerCoreModelA : public NavierStokesAssemblerBase<dim>
*/

template <int dim>
class GLSVansAssemblerBDF : public NavierStokesAssemblerBase<dim>
class VANSAssemblerBDF : public NavierStokesAssemblerBase<dim>
{
public:
GLSVansAssemblerBDF(std::shared_ptr<SimulationControl> simulation_control,
Parameters::CFDDEM cfd_dem)
VANSAssemblerBDF(std::shared_ptr<SimulationControl> simulation_control,
Parameters::CFDDEM cfd_dem)
: simulation_control(simulation_control)
, cfd_dem(cfd_dem)
{}
Expand Down Expand Up @@ -201,10 +199,10 @@ class GLSVansAssemblerBDF : public NavierStokesAssemblerBase<dim>
*/

template <int dim>
class GLSVansAssemblerDiFelice : public ParticleFluidAssemblerBase<dim>
class VANSAssemblerDiFelice : public ParticleFluidAssemblerBase<dim>
{
public:
GLSVansAssemblerDiFelice(Parameters::CFDDEM cfd_dem)
VANSAssemblerDiFelice(Parameters::CFDDEM cfd_dem)
: cfd_dem(cfd_dem)
{}

Expand Down Expand Up @@ -237,10 +235,10 @@ class GLSVansAssemblerDiFelice : public ParticleFluidAssemblerBase<dim>
*/

template <int dim>
class GLSVansAssemblerRong : public ParticleFluidAssemblerBase<dim>
class VANSAssemblerRong : public ParticleFluidAssemblerBase<dim>
{
public:
GLSVansAssemblerRong(Parameters::CFDDEM cfd_dem)
VANSAssemblerRong(Parameters::CFDDEM cfd_dem)
: cfd_dem(cfd_dem)
{}

Expand Down Expand Up @@ -269,10 +267,10 @@ class GLSVansAssemblerRong : public ParticleFluidAssemblerBase<dim>
*/

template <int dim>
class GLSVansAssemblerDallavalle : public ParticleFluidAssemblerBase<dim>
class VANSAssemblerDallavalle : public ParticleFluidAssemblerBase<dim>
{
public:
GLSVansAssemblerDallavalle(Parameters::CFDDEM cfd_dem)
VANSAssemblerDallavalle(Parameters::CFDDEM cfd_dem)
: cfd_dem(cfd_dem)
{}

Expand Down Expand Up @@ -317,10 +315,10 @@ class GLSVansAssemblerDallavalle : public ParticleFluidAssemblerBase<dim>
*/

template <int dim>
class GLSVansAssemblerKochHill : public ParticleFluidAssemblerBase<dim>
class VANSAssemblerKochHill : public ParticleFluidAssemblerBase<dim>
{
public:
GLSVansAssemblerKochHill(Parameters::CFDDEM cfd_dem)
VANSAssemblerKochHill(Parameters::CFDDEM cfd_dem)
: cfd_dem(cfd_dem)
{}

Expand Down Expand Up @@ -358,10 +356,10 @@ class GLSVansAssemblerKochHill : public ParticleFluidAssemblerBase<dim>
*/

template <int dim>
class GLSVansAssemblerBeetstra : public ParticleFluidAssemblerBase<dim>
class VANSAssemblerBeetstra : public ParticleFluidAssemblerBase<dim>
{
public:
GLSVansAssemblerBeetstra(Parameters::CFDDEM cfd_dem)
VANSAssemblerBeetstra(Parameters::CFDDEM cfd_dem)
: cfd_dem(cfd_dem)
{}

Expand Down Expand Up @@ -407,10 +405,10 @@ class GLSVansAssemblerBeetstra : public ParticleFluidAssemblerBase<dim>
*/

template <int dim>
class GLSVansAssemblerGidaspow : public ParticleFluidAssemblerBase<dim>
class VANSAssemblerGidaspow : public ParticleFluidAssemblerBase<dim>
{
public:
GLSVansAssemblerGidaspow(Parameters::CFDDEM cfd_dem)
VANSAssemblerGidaspow(Parameters::CFDDEM cfd_dem)
: cfd_dem(cfd_dem)
{}

Expand Down Expand Up @@ -441,12 +439,11 @@ class GLSVansAssemblerGidaspow : public ParticleFluidAssemblerBase<dim>
*/

template <int dim>
class GLSVansAssemblerSaffmanMei : public ParticleFluidAssemblerBase<dim>
class VANSAssemblerSaffmanMei : public ParticleFluidAssemblerBase<dim>
{
public:
GLSVansAssemblerSaffmanMei(
Parameters::Lagrangian::LagrangianPhysicalProperties
lagrangian_physical_properties)
VANSAssemblerSaffmanMei(Parameters::Lagrangian::LagrangianPhysicalProperties
lagrangian_physical_properties)
: lagrangian_physical_properties(lagrangian_physical_properties)

{}
Expand Down Expand Up @@ -477,11 +474,11 @@ class GLSVansAssemblerSaffmanMei : public ParticleFluidAssemblerBase<dim>
*/

template <int dim>
class GLSVansAssemblerMagnus : public ParticleFluidAssemblerBase<dim>
class VANSAssemblerMagnus : public ParticleFluidAssemblerBase<dim>
{
public:
GLSVansAssemblerMagnus(Parameters::Lagrangian::LagrangianPhysicalProperties
lagrangian_physical_properties)
VANSAssemblerMagnus(Parameters::Lagrangian::LagrangianPhysicalProperties
lagrangian_physical_properties)
: lagrangian_physical_properties(lagrangian_physical_properties)

{}
Expand All @@ -506,18 +503,18 @@ class GLSVansAssemblerMagnus : public ParticleFluidAssemblerBase<dim>
* M_viscous_rotation = pi * pow(dp, 3) * mu * (- omega_p)
*
* The complete model described by Derksen is composed of
* GLSVansAssemblerViscousTorque + GLSVansAssemblerVorticalTorque
* VANSAssemblerViscousTorque + VANSAssemblerVorticalTorque
*
* @tparam dim An integer that denotes the number of spatial dimensions
*
* @ingroup assemblers
*/

template <int dim>
class GLSVansAssemblerViscousTorque : public ParticleFluidAssemblerBase<dim>
class VANSAssemblerViscousTorque : public ParticleFluidAssemblerBase<dim>
{
public:
GLSVansAssemblerViscousTorque(
VANSAssemblerViscousTorque(
Parameters::Lagrangian::LagrangianPhysicalProperties
lagrangian_physical_properties)
: lagrangian_physical_properties(lagrangian_physical_properties)
Expand All @@ -543,18 +540,18 @@ class GLSVansAssemblerViscousTorque : public ParticleFluidAssemblerBase<dim>
* M_viscous_vorticity = pi * pow(dp, 3) * mu * (0.5 * vorticity)
*
* The complete model described by Derksen is composed of
* GLSVansAssemblerViscousTorque + GLSVansAssemblerVorticalTorque
* VANSAssemblerViscousTorque + VANSAssemblerVorticalTorque
*
* @tparam dim An integer that denotes the number of spatial dimensions
*
* @ingroup assemblers
*/

template <int dim>
class GLSVansAssemblerVorticalTorque : public ParticleFluidAssemblerBase<dim>
class VANSAssemblerVorticalTorque : public ParticleFluidAssemblerBase<dim>
{
public:
GLSVansAssemblerVorticalTorque(
VANSAssemblerVorticalTorque(
Parameters::Lagrangian::LagrangianPhysicalProperties
lagrangian_physical_properties)
: lagrangian_physical_properties(lagrangian_physical_properties)
Expand Down Expand Up @@ -586,11 +583,11 @@ class GLSVansAssemblerVorticalTorque : public ParticleFluidAssemblerBase<dim>
*/

template <int dim>
class GLSVansAssemblerBuoyancy : public ParticleFluidAssemblerBase<dim>
class VANSAssemblerBuoyancy : public ParticleFluidAssemblerBase<dim>
{
public:
GLSVansAssemblerBuoyancy(Parameters::Lagrangian::LagrangianPhysicalProperties
lagrangian_physical_properties)
VANSAssemblerBuoyancy(Parameters::Lagrangian::LagrangianPhysicalProperties
lagrangian_physical_properties)
: lagrangian_physical_properties(lagrangian_physical_properties)

{}
Expand Down Expand Up @@ -619,10 +616,10 @@ class GLSVansAssemblerBuoyancy : public ParticleFluidAssemblerBase<dim>
*/

template <int dim>
class GLSVansAssemblerPressureForce : public ParticleFluidAssemblerBase<dim>
class VANSAssemblerPressureForce : public ParticleFluidAssemblerBase<dim>
{
public:
GLSVansAssemblerPressureForce(Parameters::CFDDEM cfd_dem)
VANSAssemblerPressureForce(Parameters::CFDDEM cfd_dem)
: cfd_dem(cfd_dem)
{}

Expand All @@ -648,10 +645,10 @@ class GLSVansAssemblerPressureForce : public ParticleFluidAssemblerBase<dim>
*/

template <int dim>
class GLSVansAssemblerShearForce : public ParticleFluidAssemblerBase<dim>
class VANSAssemblerShearForce : public ParticleFluidAssemblerBase<dim>
{
public:
GLSVansAssemblerShearForce(Parameters::CFDDEM cfd_dem)
VANSAssemblerShearForce(Parameters::CFDDEM cfd_dem)
: cfd_dem(cfd_dem)
{}

Expand All @@ -677,10 +674,10 @@ class GLSVansAssemblerShearForce : public ParticleFluidAssemblerBase<dim>
*/

template <int dim>
class GLSVansAssemblerFPI : public NavierStokesAssemblerBase<dim>
class VANSAssemblerFPI : public NavierStokesAssemblerBase<dim>
{
public:
GLSVansAssemblerFPI(Parameters::CFDDEM cfd_dem)
VANSAssemblerFPI(Parameters::CFDDEM cfd_dem)
: cfd_dem(cfd_dem)

{}
Expand Down
4 changes: 2 additions & 2 deletions source/fem-dem/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@ add_library(lethe-fem-dem
cfd_dem_coupling.cc
cfd_dem_simulation_parameters.cc
gls_sharp_navier_stokes.cc
gls_vans.cc
fluid_dynamics_vans.cc
ib_particles_dem.cc
parameters_cfd_dem.cc
postprocessing_cfd_dem.cc
Expand All @@ -12,7 +12,7 @@ add_library(lethe-fem-dem
../../include/fem-dem/cfd_dem_coupling.h
../../include/fem-dem/cfd_dem_simulation_parameters.h
../../include/fem-dem/gls_sharp_navier_stokes.h
../../include/fem-dem/gls_vans.h
../../include/fem-dem/fluid_dynamics_vans.h
../../include/fem-dem/ib_particles_dem.h
../../include/fem-dem/parameters_cfd_dem.h
../../include/fem-dem/postprocessing_cfd_dem.h
Expand Down
Loading

0 comments on commit 5ccaa11

Please sign in to comment.