ESPResSo
Extensible Simulation Package for Research on Soft Matter Systems
Loading...
Searching...
No Matches
utils.cuh File Reference
#include "utils.hpp"
#include <cuda.h>
#include <cuda_runtime.h>
#include <string>

Go to the source code of this file.

Classes

class  cuda_runtime_error_cuda
 

Macros

#define CUDA_CHECK(statement)
 Convert CUDA error codes into runtime errors.
 
#define cuda_safe_mem(a)   cuda_safe_mem_exit((a), __FILE__, __LINE__)
 
#define KERNELCALL_shared(_function, _grid, _block, _stream, ...)
 
#define KERNELCALL(_function, _grid, _block, ...)    KERNELCALL_shared(_function, _grid, _block, 0, ##__VA_ARGS__)
 

Functions

void cuda_safe_mem_exit (cudaError_t CU_err, const char *file, unsigned int line)
 In case of error during CUDA memory allocation and memory copy, print the error message and exit.
 
void cuda_check_errors_exit (const dim3 &block, const dim3 &grid, const char *function, const char *file, unsigned int line)
 In case of error during a CUDA operation, print the error message and exit.
 

Variables

cudaStream_t stream [1]
 CUDA streams for parallel computing on CPU and GPU.
 

Macro Definition Documentation

◆ CUDA_CHECK

#define CUDA_CHECK (   statement)
Value:
{ \
cudaError_t const error_code = (statement); \
if (error_code != cudaSuccess) { \
static_cast<void>(cudaGetLastError()); /* clear non-sticky errors */ \
throw cuda_runtime_error_cuda(error_code); \
} \
}
cudaStream_t stream[1]
CUDA streams for parallel computing on CPU and GPU.

Convert CUDA error codes into runtime errors.

Definition at line 46 of file utils.cuh.

◆ cuda_safe_mem

#define cuda_safe_mem (   a)    cuda_safe_mem_exit((a), __FILE__, __LINE__)

Definition at line 73 of file utils.cuh.

◆ KERNELCALL

#define KERNELCALL (   _function,
  _grid,
  _block,
  ... 
)     KERNELCALL_shared(_function, _grid, _block, 0, ##__VA_ARGS__)

Definition at line 79 of file utils.cuh.

◆ KERNELCALL_shared

#define KERNELCALL_shared (   _function,
  _grid,
  _block,
  _stream,
  ... 
)

Function Documentation

◆ cuda_check_errors_exit()

void cuda_check_errors_exit ( const dim3 block,
const dim3 grid,
const char function,
const char file,
unsigned int  line 
)

In case of error during a CUDA operation, print the error message and exit.

Definition at line 48 of file common_cuda.cu.

References block(), and stream.

Referenced by assign_charges(), and assign_forces().

◆ cuda_safe_mem_exit()

void cuda_safe_mem_exit ( cudaError_t  CU_err,
const char file,
unsigned int  line 
)

In case of error during CUDA memory allocation and memory copy, print the error message and exit.

Parameters
CU_errcuda error code
file.cu file were the error took place
lineline of the file were the error took place

Definition at line 61 of file common_cuda.cu.

References stream.

Variable Documentation

◆ stream

cudaStream_t stream[1]
extern

CUDA streams for parallel computing on CPU and GPU.

Definition at line 34 of file common_cuda.cu.

Referenced by walberla::pystencils::internal_advectivefluxkernel_double_precision_cuda_advectivefluxkernel_double_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_advectivefluxkernel_single_precision_cuda_advectivefluxkernel_single_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_continuitykernel_double_precision_cuda_continuitykernel_double_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_continuitykernel_single_precision_cuda_continuitykernel_single_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_diffusivefluxkernel_double_precision_cuda_diffusivefluxkernel_double_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_diffusivefluxkernel_single_precision_cuda_diffusivefluxkernel_single_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_diffusivefluxkernelthermalized_double_precision_cuda_diffusivefluxkernelthermalized_double_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_diffusivefluxkernelthermalized_single_precision_cuda_diffusivefluxkernelthermalized_single_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_diffusivefluxkernelwithelectrostatic_double_precision_cuda_diffusivefluxkernelwithelectrostatic_double_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_diffusivefluxkernelwithelectrostatic_single_precision_cuda_diffusivefluxkernelwithelectrostatic_single_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_diffusivefluxkernelwithelectrostaticthermalized_double_precision_cuda_diffusivefluxkernelwithelectrostaticthermalized_double_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_diffusivefluxkernelwithelectrostaticthermalized_single_precision_cuda_diffusivefluxkernelwithelectrostaticthermalized_single_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_dirichlet_double_precision_cuda_boundary_Dirichlet_double_precision_CUDA::__launch_bounds__(), walberla::pystencils::internal_dirichlet_single_precision_cuda_boundary_Dirichlet_single_precision_CUDA::__launch_bounds__(), walberla::lbm::internal_dynamicubbdoubleprecisioncuda_boundary_DynamicUBBDoublePrecisionCUDA::__launch_bounds__(), walberla::lbm::internal_dynamicubbsingleprecisioncuda_boundary_DynamicUBBSinglePrecisionCUDA::__launch_bounds__(), walberla::pystencils::internal_fixedflux_double_precision_cuda_boundary_FixedFlux_double_precision_CUDA::__launch_bounds__(), walberla::pystencils::internal_fixedflux_single_precision_cuda_boundary_FixedFlux_single_precision_CUDA::__launch_bounds__(), walberla::pystencils::internal_frictioncouplingkernel_double_precision_cuda_frictioncouplingkernel_double_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_frictioncouplingkernel_single_precision_cuda_frictioncouplingkernel_single_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_initialpdfssetterdoubleprecisioncuda_initialpdfssetterdoubleprecisioncuda::__launch_bounds__(), walberla::pystencils::internal_initialpdfssettersingleprecisioncuda_initialpdfssettersingleprecisioncuda::__launch_bounds__(), walberla::pystencils::internal_pack_B::__launch_bounds__(), walberla::pystencils::internal_pack_B::__launch_bounds__(), walberla::pystencils::internal_pack_BE::__launch_bounds__(), walberla::pystencils::internal_pack_BE::__launch_bounds__(), walberla::pystencils::internal_pack_BN::__launch_bounds__(), walberla::pystencils::internal_pack_BN::__launch_bounds__(), walberla::pystencils::internal_pack_BS::__launch_bounds__(), walberla::pystencils::internal_pack_BS::__launch_bounds__(), walberla::pystencils::internal_pack_BW::__launch_bounds__(), walberla::pystencils::internal_pack_BW::__launch_bounds__(), walberla::pystencils::internal_pack_E::__launch_bounds__(), walberla::pystencils::internal_pack_E::__launch_bounds__(), walberla::pystencils::internal_pack_N::__launch_bounds__(), walberla::pystencils::internal_pack_N::__launch_bounds__(), walberla::pystencils::internal_pack_NE::__launch_bounds__(), walberla::pystencils::internal_pack_NE::__launch_bounds__(), walberla::pystencils::internal_pack_NW::__launch_bounds__(), walberla::pystencils::internal_pack_NW::__launch_bounds__(), walberla::pystencils::internal_pack_S::__launch_bounds__(), walberla::pystencils::internal_pack_S::__launch_bounds__(), walberla::pystencils::internal_pack_SE::__launch_bounds__(), walberla::pystencils::internal_pack_SE::__launch_bounds__(), walberla::pystencils::internal_pack_SW::__launch_bounds__(), walberla::pystencils::internal_pack_SW::__launch_bounds__(), walberla::pystencils::internal_pack_SW_BW_W_TW_NW_BS_S_TS_B_C_T_BN_N_TN_SE_BE_E_TE_NE::__launch_bounds__(), walberla::pystencils::internal_pack_SW_BW_W_TW_NW_BS_S_TS_B_C_T_BN_N_TN_SE_BE_E_TE_NE::__launch_bounds__(), walberla::pystencils::internal_pack_T::__launch_bounds__(), walberla::pystencils::internal_pack_T::__launch_bounds__(), walberla::pystencils::internal_pack_TE::__launch_bounds__(), walberla::pystencils::internal_pack_TE::__launch_bounds__(), walberla::pystencils::internal_pack_TN::__launch_bounds__(), walberla::pystencils::internal_pack_TN::__launch_bounds__(), walberla::pystencils::internal_pack_TS::__launch_bounds__(), walberla::pystencils::internal_pack_TS::__launch_bounds__(), walberla::pystencils::internal_pack_TW::__launch_bounds__(), walberla::pystencils::internal_pack_TW::__launch_bounds__(), walberla::pystencils::internal_pack_W::__launch_bounds__(), walberla::pystencils::internal_pack_W::__launch_bounds__(), walberla::pystencils::internal_reactionkernelbulk_1_double_precision_cuda_reactionkernelbulk_1_double_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_reactionkernelbulk_1_single_precision_cuda_reactionkernelbulk_1_single_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_reactionkernelbulk_2_double_precision_cuda_reactionkernelbulk_2_double_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_reactionkernelbulk_2_single_precision_cuda_reactionkernelbulk_2_single_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_reactionkernelbulk_3_double_precision_cuda_reactionkernelbulk_3_double_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_reactionkernelbulk_3_single_precision_cuda_reactionkernelbulk_3_single_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_reactionkernelbulk_4_double_precision_cuda_reactionkernelbulk_4_double_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_reactionkernelbulk_4_single_precision_cuda_reactionkernelbulk_4_single_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_reactionkernelbulk_5_double_precision_cuda_reactionkernelbulk_5_double_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_reactionkernelbulk_5_single_precision_cuda_reactionkernelbulk_5_single_precision_cuda::__launch_bounds__(), walberla::pystencils::internal_reactionkernelindexed_1_double_precision_cuda_boundary_ReactionKernelIndexed_1_double_precision_CUDA::__launch_bounds__(), walberla::pystencils::internal_reactionkernelindexed_1_single_precision_cuda_boundary_ReactionKernelIndexed_1_single_precision_CUDA::__launch_bounds__(), walberla::pystencils::internal_reactionkernelindexed_2_double_precision_cuda_boundary_ReactionKernelIndexed_2_double_precision_CUDA::__launch_bounds__(), walberla::pystencils::internal_reactionkernelindexed_2_single_precision_cuda_boundary_ReactionKernelIndexed_2_single_precision_CUDA::__launch_bounds__(), walberla::pystencils::internal_reactionkernelindexed_3_double_precision_cuda_boundary_ReactionKernelIndexed_3_double_precision_CUDA::__launch_bounds__(), walberla::pystencils::internal_reactionkernelindexed_3_single_precision_cuda_boundary_ReactionKernelIndexed_3_single_precision_CUDA::__launch_bounds__(), walberla::pystencils::internal_reactionkernelindexed_4_double_precision_cuda_boundary_ReactionKernelIndexed_4_double_precision_CUDA::__launch_bounds__(), walberla::pystencils::internal_reactionkernelindexed_4_single_precision_cuda_boundary_ReactionKernelIndexed_4_single_precision_CUDA::__launch_bounds__(), walberla::pystencils::internal_reactionkernelindexed_5_double_precision_cuda_boundary_ReactionKernelIndexed_5_double_precision_CUDA::__launch_bounds__(), walberla::pystencils::internal_reactionkernelindexed_5_single_precision_cuda_boundary_ReactionKernelIndexed_5_single_precision_CUDA::__launch_bounds__(), walberla::pystencils::internal_streamcollidesweepleesedwardsdoubleprecisioncuda_streamcollidesweepleesedwardsdoubleprecisioncuda::__launch_bounds__(), walberla::pystencils::internal_streamcollidesweepleesedwardssingleprecisioncuda_streamcollidesweepleesedwardssingleprecisioncuda::__launch_bounds__(), walberla::pystencils::internal_streamcollidesweepthermalizeddoubleprecisioncuda_streamcollidesweepthermalizeddoubleprecisioncuda::__launch_bounds__(), walberla::pystencils::internal_streamcollidesweepthermalizedsingleprecisioncuda_streamcollidesweepthermalizedsingleprecisioncuda::__launch_bounds__(), walberla::pystencils::internal_unpack_B::__launch_bounds__(), walberla::pystencils::internal_unpack_B::__launch_bounds__(), walberla::pystencils::internal_unpack_BE::__launch_bounds__(), walberla::pystencils::internal_unpack_BE::__launch_bounds__(), walberla::pystencils::internal_unpack_BN::__launch_bounds__(), walberla::pystencils::internal_unpack_BN::__launch_bounds__(), walberla::pystencils::internal_unpack_BS::__launch_bounds__(), walberla::pystencils::internal_unpack_BS::__launch_bounds__(), walberla::pystencils::internal_unpack_BW::__launch_bounds__(), walberla::pystencils::internal_unpack_BW::__launch_bounds__(), walberla::pystencils::internal_unpack_E::__launch_bounds__(), walberla::pystencils::internal_unpack_E::__launch_bounds__(), walberla::pystencils::internal_unpack_N::__launch_bounds__(), walberla::pystencils::internal_unpack_N::__launch_bounds__(), walberla::pystencils::internal_unpack_NE::__launch_bounds__(), walberla::pystencils::internal_unpack_NE::__launch_bounds__(), walberla::pystencils::internal_unpack_NW::__launch_bounds__(), walberla::pystencils::internal_unpack_NW::__launch_bounds__(), walberla::pystencils::internal_unpack_S::__launch_bounds__(), walberla::pystencils::internal_unpack_S::__launch_bounds__(), walberla::pystencils::internal_unpack_SE::__launch_bounds__(), walberla::pystencils::internal_unpack_SE::__launch_bounds__(), walberla::pystencils::internal_unpack_SW::__launch_bounds__(), walberla::pystencils::internal_unpack_SW::__launch_bounds__(), walberla::pystencils::internal_unpack_SW_BW_W_TW_NW_BS_S_TS_B_C_T_BN_N_TN_SE_BE_E_TE_NE::__launch_bounds__(), walberla::pystencils::internal_unpack_SW_BW_W_TW_NW_BS_S_TS_B_C_T_BN_N_TN_SE_BE_E_TE_NE::__launch_bounds__(), walberla::pystencils::internal_unpack_T::__launch_bounds__(), walberla::pystencils::internal_unpack_T::__launch_bounds__(), walberla::pystencils::internal_unpack_TE::__launch_bounds__(), walberla::pystencils::internal_unpack_TE::__launch_bounds__(), walberla::pystencils::internal_unpack_TN::__launch_bounds__(), walberla::pystencils::internal_unpack_TN::__launch_bounds__(), walberla::pystencils::internal_unpack_TS::__launch_bounds__(), walberla::pystencils::internal_unpack_TS::__launch_bounds__(), walberla::pystencils::internal_unpack_TW::__launch_bounds__(), walberla::pystencils::internal_unpack_TW::__launch_bounds__(), walberla::pystencils::internal_unpack_W::__launch_bounds__(), walberla::pystencils::internal_unpack_W::__launch_bounds__(), walberla::pystencils::internal_updatevelfrompdfdoubleprecisioncuda_updatevelfrompdfdoubleprecisioncuda::__launch_bounds__(), walberla::pystencils::internal_updatevelfrompdfsingleprecisioncuda_updatevelfrompdfsingleprecisioncuda::__launch_bounds__(), _philox4x32bumpkey(), _philox4x32round(), _uniform_double_hq(), math::abs(), math::abs(), Observable_stat::accumulate(), ScriptInterface::Accumulators::AccumulatorBase::AccumulatorBase(), ResourceManager::acquire_lock(), BondBreakage::actions_for_breakage(), BondedInteractionsMap::activate_bond(), DipolarLayerCorrection::adapt_solver(), Utils::NumeratedContainer< T, index_type >::add(), walberla::ek::accessor::Scalar::add(), walberla::ek::accessor::Scalar::add(), walberla::ek::accessor::Scalar::add(), walberla::ek::accessor::Vector::add(), walberla::lbm::accessor::Vector::add(), walberla::ek::accessor::Scalar::add(), walberla::ek::accessor::Vector::add(), walberla::lbm::accessor::Vector::add(), Constraints::Constraints::add(), EK::EKReactions< EKReaction >::add(), EKContainer< EKSpecies >::add(), Utils::NumeratedContainer< T, index_type >::add(), Communication::MpiCallbacks::add(), add_actor(), CollisionDetection::add_bind_centers(), add_bond(), add_bonded_force(), add_bonded_four_body_force(), add_bonded_three_body_force(), add_bonded_two_body_force(), EKContainer< EKSpecies >::add_charge(), walberla::PoissonSolverFFT< FloatType, Architecture >::add_charge_to_field(), add_dip_fld(), Constraints::HomogeneousMagneticField::add_energy(), Constraints::ShapeBasedConstraint::add_energy(), Constraints::ExternalPotential< Coupling, Field >::add_energy(), Constraints::Constraints::add_energy(), add_exclusion(), walberla::lbm::accessor::Interpolation::add_force(), walberla::lbm::accessor::Interpolation::add_force(), DipolarLayerCorrection::add_force_corrections(), LB::Solver::add_force_density(), add_forces_and_torques(), LB::Solver::add_forces_at_pos(), walberla::LBWalberlaImpl< FloatType, Architecture >::add_forces_at_pos(), add_forces_from_recv_buffer(), add_id_to_type_map(), ScriptInterface::Accumulators::AutoUpdateAccumulators::add_in_core(), ScriptInterface::Constraints::Constraints::add_in_core(), ScriptInterface::Shapes::Union::add_in_core(), ScriptInterface::walberla::EKContainer::add_in_core(), ScriptInterface::walberla::EKReactions::add_in_core(), add_kinetic_virials(), CellStructure::add_local_particle(), DipolarDirectSumGpu::add_long_range_forces(), ElectrostaticLayerCorrection::add_long_range_forces(), DipolarDirectSum::add_long_range_forces(), CoulombP3MHeffte< FloatType, Architecture, FFTConfig >::add_long_range_forces(), DipolarP3MHeffte< FloatType, Architecture, FFTConfig >::add_long_range_forces(), CoulombP3MHeffte< FloatType, Architecture, FFTConfig >::add_long_range_forces_gpu(), Observable_stat::add_non_bonded_contribution(), Observable_stat::add_non_bonded_contribution(), add_non_bonded_pair_energy(), add_non_bonded_pair_force(), add_non_bonded_pair_force_with_p(), add_non_bonded_pair_virials(), add_oif_global_forces(), ElectrostaticLayerCorrection::add_pair_force_corrections(), ScriptInterface::AutoParameters< Derived, Base >::add_parameters(), CellStructure::add_particle(), add_PoQ_force(), add_PQ_force(), add_rattle_correction_from_recv_buffer(), ReactionMethods::ReactionAlgorithm::add_reaction(), Communication::MpiCallbacks::add_static(), walberla::ek::accessor::Scalar::add_to_all(), walberla::ek::accessor::Scalar::add_to_all(), walberla::ek::accessor::Vector::add_to_all(), walberla::lbm::accessor::Vector::add_to_all(), walberla::ek::accessor::Scalar::add_to_all(), walberla::ek::accessor::Vector::add_to_all(), walberla::lbm::accessor::Vector::add_to_all(), walberla::ek::accessor::Scalar::add_to_all(), walberla::LBWalberlaImpl< FloatType, Architecture >::add_to_storage(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::add_to_storage(), add_vec(), CustomVerletList< MemorySpace, AlgorithmTag, LayoutTag, BuildTag >::addNeighbor(), CustomVerletList< MemorySpace, AlgorithmTag, LayoutTag, BuildTag >::addNeighborAtomicLB(), CustomVerletList< MemorySpace, AlgorithmTag, LayoutTag, BuildTag >::addNeighborLB(), addscale_vec(), walberla::pystencils::internal_5255e1c780a944d646f270232511968b::advectivefluxkernel_double_precision_advectivefluxkernel_double_precision(), walberla::pystencils::internal_47df4b171f276b8c3a55fc08d45e245e::advectivefluxkernel_single_precision_advectivefluxkernel_single_precision(), Aliasing_sums_ik(), Utils::Mpi::all_compare(), ReactionMethods::ReactionAlgorithm::all_reactant_particles_exist(), fft::allocator< FloatType >::allocate(), math::analytic_cotangent_sum(), Utils::angle_between(), Utils::angle_btw_triangles(), angle_generic_force(), AngleCosineBond::AngleCosineBond(), AngleCossquareBond::AngleCossquareBond(), angular_momentum(), CellStructure::AoSoA_pack::AoSoA_pack(), ComFixed::apply(), apply_diff_op(), apply_influence_function(), walberla::LBWalberlaImpl< FloatType, Architecture >::apply_lees_edwards_interpolation(), Thermostat::are_kT_equal(), Utils::area_triangle(), Utils::AS_erfc_part(), CoulombP3MHeffte< FloatType, Architecture, FFTConfig >::assign_charge(), assign_charge_kernel(), assign_charges(), assign_forces(), assign_forces_kernel(), anonymous_namespace{RegularDecomposition.cpp}::assign_prefetches(), BondedInteractionsMap::at(), Utils::Array< T, N >::at(), Utils::Array< T, N >::at(), ScriptInterface::Interactions::NonBondedInteractionHandle::attach(), ScriptInterface::Interactions::InteractionPotentialInterface< CoreIA >::attach(), ScriptInterface::Particles::ParticleHandle::attach(), ScriptInterface::Particles::ParticleSlice::attach(), ScriptInterface::walberla::VTKHandleBase< Field >::attach_to_lattice(), ScriptInterface::Particles::auto_exclusions(), ScriptInterface::AutoParameter::AutoParameter(), ScriptInterface::AutoParameter::AutoParameter(), ScriptInterface::AutoParameter::AutoParameter(), ScriptInterface::AutoParameter::AutoParameter(), Scafacos::Scafacos::available_methods(), Writer::H5md::backup_file(), P3MFFT< FloatType, FFTConfig >::backward(), fft::fft_data_struct< FloatType >::backward_fft(), Utils::Bag< T >::Bag(), Utils::basis_change(), bd_drag(), bd_drag_rot(), bd_drag_vel(), bd_drag_vel_rot(), bd_random_walk(), bd_random_walk_rot(), bd_random_walk_vel(), bd_random_walk_vel_rot(), Utils::Vector< int, dim >::begin(), benchmark_integration_step(), ScriptInterface::CollisionDetection::Protocol::bind_bonded_ias(), System::Leaf< Class >::bind_system(), Constraints::ShapeBasedConstraint::bind_system(), ScriptInterface::System::Leaf::bind_system(), ScriptInterface::Constraints::ShapeBasedConstraint::bind_system(), ScriptInterface::Particles::bitfield_from_flag(), walberla::BoundaryHandling< FloatType, ValueType, BoundaryClass >::block_dims(), BMHTF_pair_energy(), BMHTF_pair_force_factor(), bond_broken_error(), BondBreakage::bond_handler(), CellStructure::bond_loop(), ScriptInterface::PairCriteria::BondCriterion::BondCriterion(), walberla::BoundaryHandling< FloatType, ValueType, BoundaryClass >::boundary_update(), walberla::BoundaryHandling< FloatType, ValueType, BoundaryClass >::BoundaryHandling(), BoxGeometry::BoxGeometry(), BoxGeometry::BoxGeometry(), Utils::Array< T, N >::broadcast(), Utils::Vector< T, N >::broadcast(), Utils::bspline(), Utils::Interpolation::bspline_3d(), Utils::Interpolation::bspline_3d_accumulate(), Utils::Interpolation::bspline_3d_gradient(), Utils::Interpolation::bspline_3d_gradient_accumulate(), Utils::bspline_d(), buck_energy_r(), buck_force_r(), buck_pair_energy(), buck_pair_force_factor(), Buckingham_Parameters::Buckingham_Parameters(), cabana_short_range(), fft::calc_2d_grid(), DipolarP3MHeffte< FloatType, Architecture, FFTConfig >::calc_average_self_energy_k_space(), calc_bond_pair_force(), calc_bonded_energy(), calc_bonded_four_body_force(), calc_bonded_pressure_tensor(), calc_bonded_three_body_force(), calc_bonded_three_body_pressure_tensor(), calc_bonded_virial_pressure_tensor(), calc_central_radial_force(), Coulomb::calc_charge_excess_ratio(), calc_cosine(), calc_dihedral_angle(), calc_dipole_moment(), Constraints::ShapeBasedConstraint::calc_dist(), DipolarP3MHeffte< FloatType, Architecture, FFTConfig >::calc_energy_correction(), IBMTribend::calc_forces(), OifLocalForcesBond::calc_forces(), IBMTriel::calc_forces(), LatticeWalberla::calc_grid_dimensions(), CoulombP3MHeffte< FloatType, Architecture, FFTConfig >::calc_influence_function_energy(), DipolarP3MHeffte< FloatType, Architecture, FFTConfig >::calc_influence_function_energy(), CoulombP3MHeffte< FloatType, Architecture, FFTConfig >::calc_influence_function_force(), DipolarP3MHeffte< FloatType, Architecture, FFTConfig >::calc_influence_function_force(), calc_linear_momentum(), P3MLocalMesh::calc_local_ca_mesh(), fft::anonymous_namespace{fft.cpp}::calc_local_mesh(), calc_long_range_forces(), calc_mu_max(), calc_non_bonded_pair_energy(), calc_non_central_force(), calc_oif_mesh(), calc_opposing_force(), Utils::calc_orthonormal_vector(), calc_p3m_mesh_shift(), calc_part_distribution(), calc_re(), calc_rg(), calc_rh(), calc_sc_cache(), fft::anonymous_namespace{fft.cpp}::calc_send_block(), calc_slab_dipole(), DipolarP3MHeffte< FloatType, Architecture, FFTConfig >::calc_surface_term(), Galilei::calc_system_cms_position(), Galilei::calc_system_cms_velocity(), calc_total_charge(), calc_transmit_size(), calc_transmit_size(), CoulombTuningAlgorithm< FloatType, Architecture, FFTConfig >::calculate_accuracy(), DipolarTuningAlgorithm< FloatType, Architecture, FFTConfig >::calculate_accuracy(), ScriptInterface::walberla::EKReaction::calculate_bulk_conversion_factor(), calculate_dim_grid(), calculate_dim_grid(), Shapes::NoWhere::calculate_dist(), Shapes::Cylinder::calculate_dist(), Shapes::Ellipsoid::calculate_dist(), Shapes::HollowConicalFrustum::calculate_dist(), Shapes::Rhomboid::calculate_dist(), Shapes::SimplePore::calculate_dist(), Shapes::Slitpore::calculate_dist(), Shapes::Sphere::calculate_dist(), Shapes::SpheroCylinder::calculate_dist(), Shapes::Torus::calculate_dist(), Shapes::Wall::calculate_dist(), Shapes::Union::calculate_dist(), System::System::calculate_energy(), ScriptInterface::ReactionMethods::ReactionAlgorithm::calculate_factorial_expression(), ScriptInterface::ReactionMethods::ConstantpHEnsemble::calculate_factorial_expression(), ReactionMethods::calculate_factorial_expression(), ReactionMethods::calculate_factorial_expression_cpH(), System::System::calculate_forces(), calculate_influence_function_device(), ReactionMethods::WidomInsertion::calculate_particle_insertion_potential_energy(), calculate_positional_correction(), ReactionMethods::ReactionAlgorithm::calculate_potential_energy(), System::System::calculate_pressure(), Observables::CylindricalLBProfileObservable::calculate_sampling_positions(), Observables::LBProfileObservable::calculate_sampling_positions(), calculate_velocity_correction(), calculate_vs_relate_to_params(), walberla::lbm::accessor::Interpolation::calculate_weights(), walberla::lbm::accessor::Interpolation::calculate_weights(), Communication::MpiCallbacks::call(), Communication::MpiCallbacks::call_all(), ScriptInterface::ObjectHandle::call_method(), ScriptInterface::Observables::ProfileObservable< CoreObs >::call_method(), Particle::can_rotate_around(), Utils::Mpi::cart_coords(), Utils::Mpi::cart_create(), Utils::Mpi::cart_get(), Utils::Mpi::cart_neighbors(), Utils::Mpi::cart_rank(), Utils::Mpi::cart_shift(), Utils::cartesian_product(), cell_cell_transfer(), ScriptInterface::CellSystem::CellSystem::CellSystem(), Utils::Array< T, N >::cend(), Utils::Vector< int, dim >::cend(), center_of_mass(), ClusterAnalysis::Cluster::center_of_mass_subcluster(), charge_assign(), CoulombP3MHeffte< FloatType, Architecture, FFTConfig >::charge_assign(), ParticlePropertyRange::charge_range(), BondBreakage::BondBreakage::check_and_handle_breakage(), Coulomb::check_charge_neutrality(), check_convergence(), ScriptInterface::CodeInfo::check_features(), walberla::LBWalberlaImpl< FloatType, Architecture >::check_lebc(), CellStructure::check_particle_index(), CellStructure::check_resort_required(), EK::check_solver(), LB::check_solver(), check_statistics(), ScriptInterface::Analysis::check_topology(), ErrorHandling::RuntimeErrorCollector::clear(), ScriptInterface::ObjectList< ManagedType, BaseType >::clear(), ScriptInterface::ObjectMap< ManagedType, BaseType, KeyType >::clear(), GpuParticleData::clear_energy_on_device(), ReactionMethods::ReactionAlgorithm::clear_old_system_state(), clear_vec(), ScriptInterface::ClusterAnalysis::ClusterStructure::ClusterStructure(), Utils::Matrix< T, Rows, Cols >::col(), ScriptInterface::CollisionDetection::CollisionDetection::CollisionDetection(), ScriptInterface::Galilei::ComFixed::ComFixed(), commit_particle(), walberla::pystencils::PackInfoPdfDoublePrecision::communicateLocal(), walberla::pystencils::PackInfoPdfSinglePrecision::communicateLocal(), walberla::pystencils::PackInfoVecDoublePrecision::communicateLocal(), walberla::pystencils::PackInfoVecSinglePrecision::communicateLocal(), walberla::field::communication::BoundaryPackInfo< GhostLayerField_T, Boundary_T >::communicateLocal(), walberla::pystencils::PackInfoPdfDoublePrecisionCUDA::communicateLocal(), walberla::pystencils::PackInfoPdfSinglePrecisionCUDA::communicateLocal(), walberla::pystencils::PackInfoVecDoublePrecisionCUDA::communicateLocal(), walberla::pystencils::PackInfoVecSinglePrecisionCUDA::communicateLocal(), CommunicationEnvironment::CommunicationEnvironment(), Accumulators::compress_discard1(), Accumulators::compress_discard2(), Accumulators::compress_linear(), compute_correction_vector(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::VTKWriter< Field_T, F_SIZE_ARG, OutputType >::configure(), walberla::PoissonSolverFFT< FloatType, Architecture >::VTKWriter< Field_T, F_SIZE_ARG, OutputType >::configure(), walberla::LBWalberlaImpl< FloatType, Architecture >::VTKWriter< Field_T, F_SIZE_ARG, OutputType >::configure(), walberla::pystencils::DiffusiveFluxKernelThermalized_double_precision::configure(), walberla::pystencils::DiffusiveFluxKernelThermalized_double_precision_CUDA::configure(), walberla::pystencils::DiffusiveFluxKernelThermalized_single_precision::configure(), walberla::pystencils::DiffusiveFluxKernelThermalized_single_precision_CUDA::configure(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_double_precision::configure(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_double_precision_CUDA::configure(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_single_precision::configure(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_single_precision_CUDA::configure(), walberla::pystencils::StreamCollideSweepThermalizedDoublePrecision::configure(), walberla::pystencils::StreamCollideSweepThermalizedDoublePrecisionAVX::configure(), walberla::pystencils::StreamCollideSweepThermalizedDoublePrecisionCUDA::configure(), walberla::pystencils::StreamCollideSweepThermalizedSinglePrecision::configure(), walberla::pystencils::StreamCollideSweepThermalizedSinglePrecisionAVX::configure(), walberla::pystencils::StreamCollideSweepThermalizedSinglePrecisionCUDA::configure(), ScriptInterface::CellSystem::CellSystem::configure(), ScriptInterface::CellSystem::CellSystem::configure(), EK::Solver::connect(), LB::Solver::connect(), connection_vector(), ScriptInterface::ReactionMethods::ConstantpHEnsemble::ConstantpHEnsemble(), constraint_stress(), ScriptInterface::Interactions::FeneBond::construct_bond(), ScriptInterface::Interactions::HarmonicBond::construct_bond(), ScriptInterface::Interactions::QuarticBond::construct_bond(), ScriptInterface::Interactions::BondedCoulomb::construct_bond(), ScriptInterface::Interactions::BondedCoulombSR::construct_bond(), ScriptInterface::Interactions::AngleHarmonicBond::construct_bond(), ScriptInterface::Interactions::AngleCosineBond::construct_bond(), ScriptInterface::Interactions::AngleCossquareBond::construct_bond(), ScriptInterface::Interactions::DihedralBond::construct_bond(), ScriptInterface::Interactions::TabulatedDistanceBond::construct_bond(), ScriptInterface::Interactions::TabulatedAngleBond::construct_bond(), ScriptInterface::Interactions::TabulatedDihedralBond::construct_bond(), ScriptInterface::Interactions::ThermalizedBond::construct_bond(), ScriptInterface::Interactions::RigidBond::construct_bond(), ScriptInterface::Interactions::IBMTriel::construct_bond(), ScriptInterface::Interactions::IBMVolCons::construct_bond(), ScriptInterface::Interactions::IBMTribend::construct_bond(), ScriptInterface::Interactions::OifGlobalForcesBond::construct_bond(), ScriptInterface::Interactions::OifLocalForcesBond::construct_bond(), Accumulators::ContactTimes::ContactTimes(), ScriptInterface::Coulomb::Container::Container(), ScriptInterface::Dipoles::Container::Container(), BondedInteractionsMap::contains(), Utils::contains(), EK::EKReactions< EKReaction >::contains(), EKContainer< EKSpecies >::contains(), ScriptInterface::ContextManager::ContextManager(), walberla::pystencils::internal_5c5e903f8ea7925cf790d7c2318b2c56::continuitykernel_double_precision_continuitykernel_double_precision(), walberla::pystencils::internal_990034b4e4dd57d2802b4bcb5f716e46::continuitykernel_single_precision_continuitykernel_single_precision(), convert_body_to_space(), Utils::convert_director_to_quaternion(), convert_torque_propagate_omega(), convert_vector_body_to_space(), convert_vector_space_to_body(), coord_letter(), walberla::copy_block_buffer(), copy_box_data(), GpuParticleData::copy_dip_fld_to_host(), GpuParticleData::copy_energy_to_host(), GpuParticleData::copy_forces_to_host(), GpuParticleData::Storage::copy_particle_dip_fld_to_host(), GpuParticleData::Storage::copy_particle_forces_to_host(), GpuParticleData::Storage::copy_particle_torques_to_host(), GpuParticleData::Storage::copy_particles_to_device(), copy_vec(), correct_position_shake(), correct_velocity_shake(), Scafacos::Coulomb::Coulomb(), NptIsoParameters::coulomb_dipole_sanity_checks(), CoulombMMM1D::CoulombMMM1D(), ScriptInterface::Coulomb::CoulombP3M< Architecture >::CoulombP3M(), CoulombP3MHeffte< FloatType, Architecture, FFTConfig >::CoulombP3MHeffte(), ScriptInterface::Coulomb::CoulombScafacos::CoulombScafacos(), ErrorHandling::RuntimeErrorCollector::count(), ErrorHandling::RuntimeErrorCollector::count(), CoulombP3MHeffte< FloatType, Architecture, FFTConfig >::count_charged_particles(), DipolarP3MHeffte< FloatType, Architecture, FFTConfig >::count_magnetic_particles(), count_magnetic_particles(), System::System::create(), Writer::H5md::create_chunk_dims(), Writer::H5md::create_dims(), Writer::H5md::create_maxdims(), ReactionMethods::ReactionAlgorithm::create_new_trial_state(), LatticeModel::create_vtk(), cuda_check_device(), cuda_check_errors_exit(), cuda_check_gpu_compute_capability(), cuda_free_host(), cuda_gather_gpus(), cuda_get_device(), cuda_get_device_props(), cuda_get_gpu_name(), cuda_get_n_gpus(), cuda_init(), cuda_malloc_host(), cuda_safe_mem_exit(), cuda_set_device(), cuda_test_device_access(), ScriptInterface::System::CudaInitHandle::CudaInitHandle(), CustomVerletList< MemorySpace, AlgorithmTag, LayoutTag, BuildTag >::CustomVerletList(), TabulatedDistanceBond::cutoff(), Dipoles::Solver::cutoff(), dds_sumReduction(), BondedInteractionsMap::deactivate_bond(), PairCriteria::DistanceCriterion::decide(), PairCriteria::PairCriterion::decide(), PairCriteria::BondCriterion::decide(), PairCriteria::EnergyCriterion::decide(), CellStructure::decomposition(), define_Qdd(), Utils::del_gaussian(), delete_exclusion(), ReactionMethods::ReactionAlgorithm::delete_particle(), ScriptInterface::ObjectHandle::deserialize(), ScriptInterface::ContextManager::deserialize(), ScriptInterface::walberla::EKFieldSerializer::deserialize(), ScriptInterface::walberla::LBFieldSerializer::deserialize(), ScriptInterface::Scafacos::deserialize_parameters(), ScriptInterface::System::Leaf::detach_system(), System::Leaf< Class >::detach_system(), CollisionDetection::CollisionDetection::detect_collision(), CollisionDetection::BindAtPointOfCollision::detect_collision(), CollisionDetection::BindCenters::detect_collision(), CollisionDetection::GlueToSurface::detect_collision(), CollisionDetection::detect_collision_common(), TuningAlgorithm::determine_cao_limits(), CoulombTuningAlgorithm< FloatType, Architecture, FFTConfig >::determine_mesh_limits(), DipolarTuningAlgorithm< FloatType, Architecture, FFTConfig >::determine_mesh_limits(), determine_minrad(), TuningAlgorithm::determine_r_cut_limits(), Utils::Matrix< T, Rows, Cols >::diagonal(), Utils::diagonal_mat(), elc_data::dielectric_layers_contribution(), elc_data::dielectric_layers_contribution(), walberla::pystencils::internal_e5e04d1215f19faa51f3c55db6d456a2::diffusivefluxkernel_double_precision_diffusivefluxkernel_double_precision(), walberla::pystencils::internal_2fab63cfdbacde4ac630f257442231a8::diffusivefluxkernel_single_precision_diffusivefluxkernel_single_precision(), walberla::pystencils::internal_0f4fef9c62f0d4e3c1700727b32f958f::diffusivefluxkernelthermalized_double_precision_diffusivefluxkernelthermalized_double_precision(), walberla::pystencils::internal_13067439141d91943f586adb1c937d5b::diffusivefluxkernelthermalized_single_precision_diffusivefluxkernelthermalized_single_precision(), walberla::pystencils::internal_32fac7f834b08f4a768ccef85dadf7a1::diffusivefluxkernelwithelectrostatic_double_precision_diffusivefluxkernelwithelectrostatic_double_precision(), walberla::pystencils::internal_823ab2463d465630661d5edc8f90930c::diffusivefluxkernelwithelectrostatic_single_precision_diffusivefluxkernelwithelectrostatic_single_precision(), walberla::pystencils::internal_1ba80591fca01bd4852b82a8b7a2ca49::diffusivefluxkernelwithelectrostaticthermalized_double_precision_diffusivefluxkernelwithelectrostaticthermalized_double_precision(), walberla::pystencils::internal_e04f3d5b3f93f09e4de6aba968e70d10::diffusivefluxkernelwithelectrostaticthermalized_single_precision_diffusivefluxkernelwithelectrostaticthermalized_single_precision(), Utils::Mpi::dims_create(), dipolar_energy_correction(), dipolar_force_corrections(), DipolarDirectSum_kernel_energy(), DipolarDirectSum_kernel_force(), DipolarDirectSum_kernel_wrapper_energy(), DipolarDirectSum_kernel_wrapper_force(), ScriptInterface::Dipoles::DipolarP3M< Architecture >::DipolarP3M(), DipolarP3MHeffte< FloatType, Architecture, FFTConfig >::DipolarP3MHeffte(), dipole_field(), DipolarDirectSum::dipole_field_at_part(), dipole_ia_energy(), dipole_ia_force(), walberla::pystencils::Dirichlet_double_precision::Dirichlet_double_precision(), walberla::pystencils::internal_74da74b67a122b7887d3d21c7ea5f414::dirichlet_double_precision_boundary_Dirichlet_double_precision(), walberla::pystencils::Dirichlet_double_precision_CUDA::Dirichlet_double_precision_CUDA(), walberla::pystencils::Dirichlet_single_precision::Dirichlet_single_precision(), walberla::pystencils::internal_43f4eae176e72ad2d9db0f0468064c30::dirichlet_single_precision_boundary_Dirichlet_single_precision(), walberla::pystencils::Dirichlet_single_precision_CUDA::Dirichlet_single_precision_CUDA(), ReactionMethods::ReactionAlgorithm::displacement_mc_move(), Shapes::Cylinder::dist_half_pore(), LeesEdwardsBC::distance(), ScriptInterface::PairCriteria::DistanceCriterion::DistanceCriterion(), distribute(), dlc_data::dlc_data(), ScriptInterface::Writer::H5md::do_call_method(), ScriptInterface::Constraints::ExternalField< Coupling, Field >::do_call_method(), ScriptInterface::Constraints::ExternalPotential< Coupling, Field >::do_call_method(), ScriptInterface::Observables::Observable::do_call_method(), ScriptInterface::Accumulators::AccumulatorBase::do_call_method(), ScriptInterface::Accumulators::ContactTimes::do_call_method(), ScriptInterface::Accumulators::Correlator::do_call_method(), ScriptInterface::Accumulators::MeanVarianceCalculator::do_call_method(), ScriptInterface::Accumulators::TimeSeries::do_call_method(), ScriptInterface::ClusterAnalysis::Cluster::do_call_method(), ScriptInterface::ClusterAnalysis::ClusterStructure::do_call_method(), ScriptInterface::ObjectList< ManagedType, BaseType >::do_call_method(), ScriptInterface::ObjectMap< ManagedType, BaseType, KeyType >::do_call_method(), ScriptInterface::Observables::CylindricalLBProfileObservable< CoreCylLBObs >::do_call_method(), ScriptInterface::Observables::CylindricalPidProfileObservable< CoreObs >::do_call_method(), ScriptInterface::Observables::LBProfileObservable< CoreLBObs >::do_call_method(), ScriptInterface::Observables::PidProfileObservable< CoreObs >::do_call_method(), ScriptInterface::PairCriteria::PairCriterion::do_call_method(), ScriptInterface::Profiler::Caliper::do_call_method(), ScriptInterface::walberla::EKContainer::do_call_method(), ScriptInterface::walberla::EKIndexedReaction::do_call_method(), ScriptInterface::walberla::EKSpecies::do_call_method(), ScriptInterface::Interactions::NonBondedInteractions::do_call_method(), ScriptInterface::walberla::LatticeModel< Method, VTKHandle >::do_call_method(), ScriptInterface::Constraints::ShapeBasedConstraint::do_call_method(), ScriptInterface::Coulomb::ICCStar::do_call_method(), ScriptInterface::Analysis::Analysis::do_call_method(), ScriptInterface::Analysis::ObservableStat::do_call_method(), ScriptInterface::BondBreakage::BreakageSpecs::do_call_method(), ScriptInterface::CodeInfo::CodeInfo::do_call_method(), ScriptInterface::CodeInfo::CodeVersion::do_call_method(), ScriptInterface::MPIIO::MPIIOScript::do_call_method(), ScriptInterface::Particles::Polymer::do_call_method(), ScriptInterface::System::CudaInitHandle::do_call_method(), ScriptInterface::System::System::do_call_method(), ScriptInterface::CellSystem::CellSystem::do_call_method(), ScriptInterface::Coulomb::Actor< SIClass, CoreClass >::do_call_method(), ScriptInterface::Coulomb::CoulombScafacos::do_call_method(), ScriptInterface::Galilei::Galilei::do_call_method(), ScriptInterface::Interactions::BondedInteraction::do_call_method(), ScriptInterface::Interactions::BondedInteractions::do_call_method(), ScriptInterface::Interactions::InteractionPotentialInterface< CoreIA >::do_call_method(), ScriptInterface::Interactions::NonBondedInteractionHandle::do_call_method(), ScriptInterface::LeesEdwards::LeesEdwards::do_call_method(), ScriptInterface::Dipoles::Actor< SIClass, CoreClass >::do_call_method(), ScriptInterface::Particles::ParticleHandle::do_call_method(), ScriptInterface::Particles::ParticleList::do_call_method(), ScriptInterface::Particles::ParticleSlice::do_call_method(), ScriptInterface::ReactionMethods::ReactionAlgorithm::do_call_method(), ScriptInterface::ReactionMethods::WidomInsertion::do_call_method(), ScriptInterface::Shapes::Shape::do_call_method(), ScriptInterface::Thermostat::Thermostat::do_call_method(), ScriptInterface::walberla::EKPoissonSolverNode::do_call_method(), ScriptInterface::walberla::EKPoissonSolverSlice::do_call_method(), ScriptInterface::walberla::EKSpeciesNode::do_call_method(), ScriptInterface::walberla::EKSpeciesSlice::do_call_method(), ScriptInterface::walberla::LBFluid::do_call_method(), ScriptInterface::walberla::LBFluidNode::do_call_method(), ScriptInterface::walberla::LBFluidSlice::do_call_method(), ScriptInterface::Interactions::NonBondedInteractions::do_construct(), ScriptInterface::Accumulators::Correlator::do_construct(), ScriptInterface::Constraints::ExternalField< Coupling, Field >::do_construct(), ScriptInterface::Constraints::ExternalPotential< Coupling, Field >::do_construct(), ScriptInterface::walberla::EKFFT::do_construct(), ScriptInterface::walberla::EKNone::do_construct(), ScriptInterface::walberla::EKReactant::do_construct(), ScriptInterface::walberla::EKBulkReaction::do_construct(), ScriptInterface::walberla::EKIndexedReaction::do_construct(), ScriptInterface::walberla::LatticeWalberla::do_construct(), ScriptInterface::MPIIO::MPIIOScript::do_construct(), ScriptInterface::ObjectHandle::do_construct(), ScriptInterface::Interactions::InteractionPotentialInterface< CoreIA >::do_construct(), ScriptInterface::Accumulators::ContactTimes::do_construct(), ScriptInterface::Accumulators::MeanVarianceCalculator::do_construct(), ScriptInterface::Accumulators::TimeSeries::do_construct(), ScriptInterface::ClusterAnalysis::ClusterStructure::do_construct(), ScriptInterface::Constraints::Constraints::do_construct(), ScriptInterface::Coulomb::CoulombMMM1D::do_construct(), ScriptInterface::Coulomb::CoulombP3M< Architecture >::do_construct(), ScriptInterface::Coulomb::CoulombScafacos::do_construct(), ScriptInterface::Coulomb::DebyeHueckel::do_construct(), ScriptInterface::Coulomb::ElectrostaticLayerCorrection::do_construct(), ScriptInterface::Coulomb::ICCStar::do_construct(), ScriptInterface::Coulomb::ReactionField::do_construct(), ScriptInterface::Galilei::ComFixed::do_construct(), ScriptInterface::Writer::H5md::do_construct(), ScriptInterface::Integrators::SteepestDescent::do_construct(), ScriptInterface::Integrators::StokesianDynamics::do_construct(), ScriptInterface::Integrators::VelocityVerletIsoNPT::do_construct(), ScriptInterface::Interactions::NonBondedInteractionHandle::do_construct(), ScriptInterface::Dipoles::DipolarDirectSum::do_construct(), ScriptInterface::Dipoles::DipolarDirectSumGpu::do_construct(), ScriptInterface::Dipoles::DipolarLayerCorrection::do_construct(), ScriptInterface::Dipoles::DipolarP3M< Architecture >::do_construct(), ScriptInterface::Dipoles::DipolarScafacos::do_construct(), ScriptInterface::Math::CylindricalTransformationParameters::do_construct(), ScriptInterface::ObjectList< ManagedType, BaseType >::do_construct(), ScriptInterface::Observables::CylindricalLBProfileObservable< CoreCylLBObs >::do_construct(), ScriptInterface::Observables::CylindricalPidProfileObservable< CoreObs >::do_construct(), ScriptInterface::Observables::LBProfileObservable< CoreLBObs >::do_construct(), ScriptInterface::Observables::PairwiseDistances< CoreObs >::do_construct(), ScriptInterface::Observables::PidObservable< CorePidObs >::do_construct(), ScriptInterface::Observables::PidProfileObservable< CoreObs >::do_construct(), ScriptInterface::Observables::RDF::do_construct(), ScriptInterface::Particles::ParticleHandle::do_construct(), ScriptInterface::Particles::ParticleModifier::do_construct(), ScriptInterface::Particles::ParticleSlice::do_construct(), ScriptInterface::ReactionMethods::ConstantpHEnsemble::do_construct(), ScriptInterface::ReactionMethods::ReactionEnsemble::do_construct(), ScriptInterface::ReactionMethods::SingleReaction::do_construct(), ScriptInterface::ReactionMethods::WidomInsertion::do_construct(), ScriptInterface::Shapes::HollowConicalFrustum::do_construct(), ScriptInterface::System::System::do_construct(), ScriptInterface::Thermostat::Interface< CoreClass >::do_construct(), ScriptInterface::walberla::EKContainer::do_construct(), ScriptInterface::walberla::EKPoissonSolverNode::do_construct(), ScriptInterface::walberla::EKPoissonSolverSlice::do_construct(), ScriptInterface::walberla::EKSpecies::do_construct(), ScriptInterface::walberla::EKSpeciesNode::do_construct(), ScriptInterface::walberla::EKSpeciesSlice::do_construct(), ScriptInterface::walberla::LBFluid::do_construct(), ScriptInterface::walberla::LBFluidNode::do_construct(), ScriptInterface::walberla::LBFluidSlice::do_construct(), ScriptInterface::walberla::VTKHandleBase< Field >::do_construct(), ScriptInterface::ObjectList< ManagedType, BaseType >::do_destruct(), ScriptInterface::ObjectMap< ManagedType, BaseType, KeyType >::do_destruct(), ScriptInterface::CollisionDetection::BindAtPointOfCollision::do_initialize(), ScriptInterface::CollisionDetection::BindCenters::do_initialize(), ScriptInterface::CollisionDetection::GlueToSurface::do_initialize(), do_nonbonded(), dp3m_k_space_error(), dp3m_real_space_error(), dp3m_rtbisection(), dp3m_tune_aliasing_sums(), dpd_init(), dpd_noise(), dpd_pair_force(), dpd_pair_force(), DPD_Parameters::DPD_Parameters(), dpd_pressure_local(), dpd_stress(), dpd_viscous_stress_local(), draw_polymer_positions(), Mpiio::dump_info(), walberla::lbm::DynamicUBBDoublePrecision::DynamicUBBDoublePrecision(), walberla::lbm::internal_3cfabb7f34e389af9363b890d8729bed::dynamicubbdoubleprecision_boundary_DynamicUBBDoublePrecision(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::DynamicUBBDoublePrecisionCUDA(), walberla::lbm::DynamicUBBSinglePrecision::DynamicUBBSinglePrecision(), walberla::lbm::internal_6cb25260a6784120b7639a911a9d03fd::dynamicubbsingleprecision_boundary_DynamicUBBSinglePrecision(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::DynamicUBBSinglePrecisionCUDA(), Observables::ProfileObservable::edges(), ScriptInterface::walberla::EKBulkReaction::EKBulkReaction(), ScriptInterface::walberla::EKFFT::EKFFT(), ScriptInterface::walberla::EKIndexedReaction::EKIndexedReaction(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::EKinWalberlaImpl(), walberla::EKReactionImplIndexed< Architecture >::EKReactionImplIndexed(), ScriptInterface::walberla::EKSpecies::EKSpecies(), elc_data::elc_data(), ScriptInterface::Shapes::Ellipsoid::Ellipsoid(), GpuParticleData::enable_property(), Utils::Array< T, N >::end(), Utils::Array< T, N >::end(), FieldCoupling::PotentialField< Coupling, Field >::energy(), BondedCoulomb::energy(), BondedCoulombSR::energy(), TabulatedDistanceBond::energy(), FeneBond::energy(), HarmonicBond::energy(), QuarticBond::energy(), TabulatedDihedralBond::energy(), DihedralBond::energy(), AngleCosineBond::energy(), AngleCossquareBond::energy(), AngleHarmonicBond::energy(), TabulatedAngleBond::energy(), DipolarLayerCorrection::energy_correction(), ScriptInterface::PairCriteria::EnergyCriterion::EnergyCriterion(), enumerate_local_particles(), Utils::Bag< T >::erase(), BondedInteractionsMap::erase(), ScriptInterface::ObjectMap< ManagedType, BaseType, KeyType >::erase(), ScriptInterface::BondBreakage::BreakageSpecs::erase_in_core(), ScriptInterface::Interactions::BondedInteractions::erase_in_core(), ErrorHandling::RuntimeErrorCollector::error(), ScriptInterface::Particles::error_msg(), walberla::es2walberla(), walberla::es2walberla(), estimate_max_counts(), Observables::PairwiseDistances::evaluate(), Observables::TotalForce::evaluate(), Observables::BondAngles::evaluate(), Observables::BondDihedrals::evaluate(), Observables::CosPersistenceAngles::evaluate(), Observables::CylindricalDensityProfile::evaluate(), Observables::CylindricalFluxDensityProfile::evaluate(), Observables::CylindricalLBFluxDensityProfileAtParticlePositions::evaluate(), Observables::CylindricalVelocityProfile::evaluate(), Observables::DensityProfile::evaluate(), Observables::FluxDensityProfile::evaluate(), Observables::ForceDensityProfile::evaluate(), Observables::ParticleDistances::evaluate(), Observables::ParticleObservable< ObsType >::evaluate(), Observables::CylindricalLBVelocityProfileAtParticlePositions::evaluate(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::FluxVTKWriter< OutputType >::evaluate(), walberla::LBWalberlaImpl< FloatType, Architecture >::VelocityVTKWriter< OutputType >::evaluate(), walberla::LBWalberlaImpl< FloatType, Architecture >::PressureTensorVTKWriter< OutputType >::evaluate(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::DensityVTKWriter< OutputType >::evaluate(), walberla::PoissonSolverFFT< FloatType, Architecture >::PotentialVTKWriter< OutputType >::evaluate(), walberla::LBWalberlaImpl< FloatType, Architecture >::DensityVTKWriter< OutputType >::evaluate(), evaluateAsTaylorSeriesAt(), BondBreakage::BondBreakage::execute_bond_breakage(), Writer::H5md::extend_dataset(), ScriptInterface::Thermostat::Interface< CoreClass >::extend_parameters(), ScriptInterface::Thermostat::Langevin::extend_parameters(), ScriptInterface::Thermostat::Brownian::extend_parameters(), external_force(), extract_block(), ScriptInterface::Thermostat::Interface< CoreClass >::extract_kT(), ScriptInterface::Thermostat::LBThermostat::extract_kT(), ReactionMethods::factorial_Ni0_divided_by_factorial_Ni0_plus_nu_i(), far_error(), Mpiio::fatal_error(), Mpiio::fatal_error(), Accumulators::fcs_acf(), GatherParticleTraits< T >::fetch(), fetch_particles(), CoulombTuningAlgorithm< FloatType, Architecture, FFTConfig >::fft_decomposition_veto(), fft_on_program_start(), fft_pack_block(), fft_sendrecv(), fft_unpack_block(), FieldCoupling::Fields::Interpolated< T, codim >::field_data_flat(), Writer::H5md::fields_list_to_bitfield(), walberla::fill_3D_scalar_array(), walberla::fill_3D_vector_array(), walberla::pystencils::Dirichlet_double_precision::fillFromFlagField(), walberla::pystencils::Dirichlet_double_precision_CUDA::fillFromFlagField(), walberla::pystencils::Dirichlet_single_precision::fillFromFlagField(), walberla::pystencils::Dirichlet_single_precision_CUDA::fillFromFlagField(), walberla::pystencils::FixedFlux_double_precision::fillFromFlagField(), walberla::pystencils::FixedFlux_double_precision_CUDA::fillFromFlagField(), walberla::pystencils::FixedFlux_single_precision::fillFromFlagField(), walberla::pystencils::FixedFlux_single_precision_CUDA::fillFromFlagField(), walberla::lbm::DynamicUBBDoublePrecision::fillFromFlagField(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::fillFromFlagField(), walberla::lbm::DynamicUBBSinglePrecision::fillFromFlagField(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::fillFromFlagField(), walberla::pystencils::Dirichlet_double_precision::fillFromFlagField(), walberla::pystencils::Dirichlet_double_precision_CUDA::fillFromFlagField(), walberla::pystencils::Dirichlet_single_precision::fillFromFlagField(), walberla::pystencils::Dirichlet_single_precision_CUDA::fillFromFlagField(), walberla::pystencils::FixedFlux_double_precision::fillFromFlagField(), walberla::pystencils::FixedFlux_double_precision_CUDA::fillFromFlagField(), walberla::pystencils::FixedFlux_single_precision::fillFromFlagField(), walberla::pystencils::FixedFlux_single_precision_CUDA::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_1_double_precision::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_1_double_precision_CUDA::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_1_single_precision::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_1_single_precision_CUDA::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_2_double_precision::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_2_double_precision_CUDA::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_2_single_precision::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_2_single_precision_CUDA::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_3_double_precision::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_3_double_precision_CUDA::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_3_single_precision::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_3_single_precision_CUDA::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_4_double_precision::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_4_double_precision_CUDA::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_4_single_precision::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_4_single_precision_CUDA::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_5_double_precision::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_5_double_precision_CUDA::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_5_single_precision::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_5_single_precision_CUDA::fillFromFlagField(), walberla::lbm::DynamicUBBDoublePrecision::fillFromFlagField(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::fillFromFlagField(), walberla::lbm::DynamicUBBSinglePrecision::fillFromFlagField(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_1_double_precision::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_1_double_precision_CUDA::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_1_single_precision::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_1_single_precision_CUDA::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_2_double_precision::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_2_double_precision_CUDA::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_2_single_precision::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_2_single_precision_CUDA::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_3_double_precision::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_3_double_precision_CUDA::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_3_single_precision::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_3_single_precision_CUDA::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_4_double_precision::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_4_double_precision_CUDA::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_4_single_precision::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_4_single_precision_CUDA::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_5_double_precision::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_5_double_precision_CUDA::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_5_single_precision::fillFromFlagField(), walberla::pystencils::ReactionKernelIndexed_5_single_precision_CUDA::fillFromFlagField(), ParticleRange::filter(), Accumulators::Correlator::finalize(), BondedInteractionsMap::find_bond_id(), ScriptInterface::CollisionDetection::Protocol::find_bond_id(), fft::find_comm_groups(), CellStructure::find_current_cell(), FieldCoupling::Fields::Interpolated< T, codim >::fits_in_box(), walberla::pystencils::FixedFlux_double_precision::FixedFlux_double_precision(), walberla::pystencils::internal_bdec58bfeb737088cd218660bd069d85::fixedflux_double_precision_boundary_FixedFlux_double_precision(), walberla::pystencils::FixedFlux_double_precision_CUDA::FixedFlux_double_precision_CUDA(), walberla::pystencils::FixedFlux_single_precision::FixedFlux_single_precision(), walberla::pystencils::internal_11b127eed0b5044a0a655e8444f26034::fixedflux_single_precision_boundary_FixedFlux_single_precision(), walberla::pystencils::FixedFlux_single_precision_CUDA::FixedFlux_single_precision_CUDA(), walberla::LBWalberlaImpl< FloatType, Architecture >::flat_index_to_node(), Utils::flatten(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::FloatType_c(), walberla::LBWalberlaImpl< FloatType, Architecture >::FloatType_c(), ErrorHandling::RuntimeErrorCollector::flush(), BoxGeometry::fold_position(), BoxGeometry::folded_image_box(), BoxGeometry::folded_position(), for_each_3d(), for_each_3d_lin(), for_each_3d_order(), Utils::for_each_cartesian_pair(), Utils::for_each_cartesian_pair(), Utils::for_each_cartesian_pair_if(), Utils::for_each_cartesian_pair_if(), for_each_image(), CellStructure::for_each_local_particle(), Utils::for_each_pair(), Utils::for_each_pair(), FieldCoupling::ForceField< Coupling, Field >::force(), FieldCoupling::PotentialField< Coupling, Field >::force(), Constraints::ExternalField< Coupling, Field >::force(), Constraints::ExternalPotential< Coupling, Field >::force(), Constraints::ShapeBasedConstraint::force(), BondedCoulomb::force(), TabulatedDistanceBond::force(), FeneBond::force(), HarmonicBond::force(), QuarticBond::force(), BondedCoulombSR::force(), force_calc_icc(), force_capping(), ParticlePropertyRange::force_range(), ThermalizedBond::forces(), TabulatedDihedralBond::forces(), DihedralBond::forces(), AngleCosineBond::forces(), AngleCossquareBond::forces(), AngleHarmonicBond::forces(), TabulatedAngleBond::forces(), ErrorHandling::RuntimeError::format(), Utils::Array< T, N >::formatter(), P3MFFT< FloatType, FFTConfig >::forward(), fft::fft_data_struct< FloatType >::forward_fft(), ClusterAnalysis::Cluster::fractal_dimension(), P3MGpuParams::free_device_memory(), free_device_vector(), friction_thermo_langevin(), friction_thermo_langevin_rotation(), walberla::pystencils::internal_828cb3fbc90c26a23ae54639862a1401::frictioncouplingkernel_double_precision_frictioncouplingkernel_double_precision(), walberla::pystencils::internal_910e9429dc8b77dbed969a16d3f227fb::frictioncouplingkernel_single_precision_frictioncouplingkernel_single_precision(), Communicator::full_initialization(), g1_DLC_dip(), g2_DLC_dip(), G_opt(), G_opt_dipolar(), G_opt_dipolar_self_energy(), Galilei::galilei_transform(), ErrorHandling::RuntimeErrorCollector::gather(), Utils::Mpi::gather_buffer(), gather_buffer_map(), CollisionDetection::gather_collision_queue(), BondBreakage::gather_global_queue(), p3m_send_mesh< FloatType >::gather_grid(), ErrorHandling::RuntimeErrorCollector::gather_local(), gather_particle_data(), ScriptInterface::walberla::gather_slices_topology(), gather_traits_for_types(), Utils::Mpi::gatherv(), Utils::Mpi::gatherv(), Utils::Mpi::gatherv(), Utils::gaussian(), gaussian_pair_energy(), gaussian_pair_force_factor(), ForcesKernel::gay_berne_active(), gb_pair_energy(), gb_pair_force(), gb_pair_force(), Utils::get(), Utils::get(), walberla::ek::accessor::Scalar::get(), walberla::ek::accessor::Scalar::get(), walberla::ek::accessor::Scalar::get(), walberla::ek::accessor::Scalar::get(), walberla::ek::accessor::Scalar::get(), walberla::ek::accessor::Vector::get(), walberla::lbm::accessor::Vector::get(), walberla::ek::accessor::Flux::get(), walberla::ek::accessor::Flux::get(), walberla::ek::accessor::Scalar::get(), walberla::lbm::accessor::Population::get(), walberla::lbm::accessor::Population::get(), walberla::lbm::accessor::Density::get(), walberla::lbm::accessor::PressureTensor::get(), walberla::lbm::accessor::Density::get(), walberla::lbm::accessor::PressureTensor::get(), walberla::lbm::accessor::Velocity::get(), walberla::lbm::accessor::Velocity::get(), walberla::ek::accessor::Vector::get(), walberla::lbm::accessor::Vector::get(), walberla::ek::accessor::Scalar::get(), walberla::ek::accessor::Vector::get(), walberla::lbm::accessor::Vector::get(), walberla::ek::accessor::Flux::get(), walberla::ek::accessor::Flux::get(), walberla::ek::accessor::Scalar::get(), walberla::lbm::accessor::Population::get(), walberla::lbm::accessor::Population::get(), walberla::lbm::accessor::Density::get(), walberla::lbm::accessor::PressureTensor::get(), walberla::lbm::accessor::Density::get(), walberla::lbm::accessor::PressureTensor::get(), walberla::lbm::accessor::Velocity::get(), walberla::lbm::accessor::Velocity::get(), walberla::ek::accessor::Vector::get(), walberla::lbm::accessor::Vector::get(), Utils::Cache< Key, Value >::get(), Utils::get(), Utils::get(), get_actor_by_type(), get_actor_by_type(), ScriptInterface::walberla::EKReaction::get_agrid(), math::get_analytic_cotangent_sum_kernel(), LJ_Parameters::get_auto_shift(), LJGen_Parameters::get_auto_shift(), walberla::get_block(), walberla::get_block_and_cell(), LatticeWalberla::get_block_corner(), walberla::get_block_extended(), walberla::get_block_interval(), ScriptInterface::CollisionDetection::Protocol::get_bond_variant_by_id(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_boundary_force(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_boundary_force_from_shape(), ScriptInterface::Accumulators::AccumulatorBase::get_core_system_pointer(), Accumulators::Correlator::get_correlation(), LB::Solver::get_coupling_interpolated_velocities(), LB::Solver::get_coupling_interpolated_velocity(), IBMVolCons::get_current_volume(), Utils::get_cylindrical_sampling_positions(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_densities_at_pos(), LB::LBWalberla::get_density_at_pos(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_density_at_pos(), get_external_field(), ScriptInterface::CodeInfo::get_feature_set(), ScriptInterface::CodeInfo::get_feature_vector(), ComFixed::get_fixed_types(), walberla::BoundaryHandling< FloatType, ValueType, BoundaryClass >::get_force_vector(), ScriptInterface::Particles::get_gamma_safe(), System::System::get_global_ghost_flags(), InteractionsNonBonded::get_ia_param(), InteractionsNonBonded::get_ia_param(), InteractionsNonBonded::get_ia_param_key(), InteractionsNonBonded::get_ia_param_ref_counted(), get_ibm_particle_position(), get_interacting_neighbors(), System::System::get_interaction_range(), Accumulators::Correlator::get_internal_state(), Accumulators::MeanVarianceCalculator::get_internal_state(), Accumulators::TimeSeries::get_internal_state(), ScriptInterface::Interactions::NonBondedInteractions::get_internal_state(), ScriptInterface::ReactionMethods::ReactionAlgorithm::get_internal_state(), ScriptInterface::System::System::get_internal_state(), LB::Solver::get_interpolated_densities(), LB::Solver::get_interpolated_density(), LB::Solver::get_interpolated_velocity(), walberla::get_interval(), ScriptInterface::walberla::EKReaction::get_is_gpu(), ScriptInterface::ObjectMap< ManagedType, BaseType, KeyType >::get_key(), Accumulators::Correlator::get_lag_times(), Utils::get_linear_index(), Utils::get_linear_index(), Utils::get_linear_index(), Utils::get_linear_index(), LatticeWalberla::get_local_domain(), LatticeWalberla::get_local_grid_range(), CellStructure::get_local_particle(), CellStructure::get_local_particle(), CellStructure::get_local_particles(), TuningAlgorithm::get_m_time(), ScriptInterface::LatticeIndices::get_mapped_index(), CustomVerletList< MemorySpace, AlgorithmTag, LayoutTag, BuildTag >::get_max_counts(), CellStructure::get_max_local_particle_id(), TuningAlgorithm::get_mc_time(), ScriptInterface::Thermostat::Interface< CoreClass >::get_member_handle(), CoulombTuningAlgorithm< FloatType, Architecture, FFTConfig >::get_memory_layout(), BoxGeometry::get_mi_coord(), BoxGeometry::get_mi_vector(), BoxGeometry::get_mi_vector(), get_mi_vector_dds(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_momentum(), BondedInteractionsMap::get_n_rigid_bonds(), BondedInteractionsMap::get_n_thermalized_bonds(), Utils::get_n_triangle(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_neighbor_node(), get_neighbor_pids(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_node_boundary_force(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::get_node_density(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_node_density(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::get_node_density_at_boundary(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::get_node_flux_at_boundary(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::get_node_flux_vector(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_node_force_to_be_applied(), walberla::EKReactionImplIndexed< Architecture >::get_node_is_boundary(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::get_node_is_boundary(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_node_is_boundary(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::get_node_is_density_boundary(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::get_node_is_flux_boundary(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_node_last_applied_force(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_node_population(), walberla::PoissonSolverFFT< FloatType, Architecture >::get_node_potential(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_node_pressure_tensor(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_node_velocity(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_node_velocity_at_boundary(), LB::ParticleCoupling::get_noise_term(), Mpiio::get_num_elem(), ScriptInterface::walberla::VTKHandleBase< Field >::get_obs_map(), ReactionMethods::ReactionAlgorithm::get_old_system_state(), CoulombScafacosImpl::get_pair_energy(), CoulombScafacosImpl::get_pair_force(), get_pairs(), get_pairs_filtered(), get_pairs_of_types(), ScriptInterface::ObjectHandle::get_parameters(), CollisionDetection::get_part(), get_particle_data(), get_particle_ids(), get_particle_ids_parallel(), get_particle_node(), get_particle_node_parallel(), ScriptInterface::Particles::get_particles_properties(), get_phi_at_energy_min(), walberla::InterpolateAndShiftAtBoundary< FieldType, FloatType >::get_pos_offset(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_pressure_tensor(), get_ptr(), ScriptInterface::Particles::get_quaternion_safe(), get_random_p_id(), ReactionMethods::ReactionAlgorithm::get_random_position_in_box(), ScriptInterface::ReactionMethods::ReactionAlgorithm::get_reaction_index(), ScriptInterface::Particles::get_real_particle(), get_reference_particle(), ScriptInterface::Thermostat::Interface< CoreClass >::get_required_parameters(), ScriptInterface::Thermostat::Langevin::get_required_parameters(), ScriptInterface::Thermostat::Brownian::get_required_parameters(), ScriptInterface::Thermostat::IsotropicNpt::get_required_parameters(), ScriptInterface::Thermostat::LBThermostat::get_required_parameters(), walberla::lbm::accessor::Interpolation::get_rho(), walberla::lbm::accessor::Interpolation::get_rho(), ScriptInterface::Thermostat::Interface< CoreClass >::get_rng_counter(), ScriptInterface::Thermostat::Interface< CoreClass >::get_rng_seed(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::get_rng_state(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_rng_state(), walberla::InterpolateAndShiftAtBoundary< FieldType, FloatType >::get_shift(), get_short_range_neighbors(), get_simulation_box(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::get_slice_density(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_slice_density(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::get_slice_density_at_boundary(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::get_slice_flux_at_boundary(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::get_slice_flux_vector(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::get_slice_is_boundary(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_slice_is_boundary(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_slice_last_applied_force(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_slice_population(), walberla::PoissonSolverFFT< FloatType, Architecture >::get_slice_potential(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_slice_pressure_tensor(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_slice_velocity(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_slice_velocity_at_boundary(), ScriptInterface::Analysis::get_summary(), System::Leaf< Class >::get_system(), ScriptInterface::System::Leaf::get_system(), System::Leaf< Class >::get_system(), ScriptInterface::System::Leaf::get_system(), CoulombTuningAlgorithm< FloatType, Architecture, FFTConfig >::get_time(), DipolarTuningAlgorithm< FloatType, Architecture, FFTConfig >::get_time(), ScriptInterface::Interactions::BondedInteraction::get_valid_parameters(), ScriptInterface::Interactions::InteractionPotentialInterface< CoreIA >::get_valid_parameters(), ScriptInterface::get_value(), ScriptInterface::get_value_or(), CustomVerletList< MemorySpace, AlgorithmTag, LayoutTag, BuildTag >::get_variance_max_counts(), walberla::ek::accessor::Flux::get_vector(), walberla::ek::accessor::Flux::get_vector(), walberla::ek::accessor::Flux::get_vector(), walberla::ek::accessor::Flux::get_vector(), CellStructure::AoSoA_pack::get_vector_at(), FFTBuffersLegacy< FloatType >::get_vector_mesh(), walberla::lbm::accessor::Interpolation::get_vel(), walberla::lbm::accessor::Interpolation::get_vel(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_velocities_at_pos(), LB::LBWalberla::get_velocity_at_pos(), walberla::LBWalberlaImpl< FloatType, Architecture >::get_velocity_at_pos(), walberla::get_vtk_dependent_resources(), walberla::lbm::DynamicUBBDoublePrecision::ForceVector::getForce(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::ForceVector::getForce(), walberla::lbm::DynamicUBBSinglePrecision::ForceVector::getForce(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::ForceVector::getForce(), walberla::pystencils::Dirichlet_double_precision::getForce(), walberla::pystencils::Dirichlet_double_precision_CUDA::getForce(), walberla::pystencils::Dirichlet_single_precision::getForce(), walberla::pystencils::Dirichlet_single_precision_CUDA::getForce(), walberla::pystencils::FixedFlux_double_precision::getForce(), walberla::pystencils::FixedFlux_double_precision_CUDA::getForce(), walberla::pystencils::FixedFlux_single_precision::getForce(), walberla::pystencils::FixedFlux_single_precision_CUDA::getForce(), walberla::pystencils::ReactionKernelIndexed_1_double_precision::getForce(), walberla::pystencils::ReactionKernelIndexed_1_double_precision_CUDA::getForce(), walberla::pystencils::ReactionKernelIndexed_1_single_precision::getForce(), walberla::pystencils::ReactionKernelIndexed_1_single_precision_CUDA::getForce(), walberla::pystencils::ReactionKernelIndexed_2_double_precision::getForce(), walberla::pystencils::ReactionKernelIndexed_2_double_precision_CUDA::getForce(), walberla::pystencils::ReactionKernelIndexed_2_single_precision::getForce(), walberla::pystencils::ReactionKernelIndexed_2_single_precision_CUDA::getForce(), walberla::pystencils::ReactionKernelIndexed_3_double_precision::getForce(), walberla::pystencils::ReactionKernelIndexed_3_double_precision_CUDA::getForce(), walberla::pystencils::ReactionKernelIndexed_3_single_precision::getForce(), walberla::pystencils::ReactionKernelIndexed_3_single_precision_CUDA::getForce(), walberla::pystencils::ReactionKernelIndexed_4_double_precision::getForce(), walberla::pystencils::ReactionKernelIndexed_4_double_precision_CUDA::getForce(), walberla::pystencils::ReactionKernelIndexed_4_single_precision::getForce(), walberla::pystencils::ReactionKernelIndexed_4_single_precision_CUDA::getForce(), walberla::pystencils::ReactionKernelIndexed_5_double_precision::getForce(), walberla::pystencils::ReactionKernelIndexed_5_double_precision_CUDA::getForce(), walberla::pystencils::ReactionKernelIndexed_5_single_precision::getForce(), walberla::pystencils::ReactionKernelIndexed_5_single_precision_CUDA::getForce(), walberla::lbm::DynamicUBBDoublePrecision::getForce(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::getForce(), walberla::lbm::DynamicUBBSinglePrecision::getForce(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::getForce(), walberla::lbm::DynamicUBBDoublePrecision::getIndexVector(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::getIndexVector(), walberla::lbm::DynamicUBBSinglePrecision::getIndexVector(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::getIndexVector(), walberla::pystencils::Dirichlet_double_precision_CUDA::getInnerSweep(), walberla::pystencils::Dirichlet_single_precision_CUDA::getInnerSweep(), walberla::pystencils::FixedFlux_double_precision_CUDA::getInnerSweep(), walberla::pystencils::FixedFlux_single_precision_CUDA::getInnerSweep(), walberla::pystencils::ReactionKernelIndexed_1_double_precision_CUDA::getInnerSweep(), walberla::pystencils::ReactionKernelIndexed_1_single_precision_CUDA::getInnerSweep(), walberla::pystencils::ReactionKernelIndexed_2_double_precision_CUDA::getInnerSweep(), walberla::pystencils::ReactionKernelIndexed_2_single_precision_CUDA::getInnerSweep(), walberla::pystencils::ReactionKernelIndexed_3_double_precision_CUDA::getInnerSweep(), walberla::pystencils::ReactionKernelIndexed_3_single_precision_CUDA::getInnerSweep(), walberla::pystencils::ReactionKernelIndexed_4_double_precision_CUDA::getInnerSweep(), walberla::pystencils::ReactionKernelIndexed_4_single_precision_CUDA::getInnerSweep(), walberla::pystencils::ReactionKernelIndexed_5_double_precision_CUDA::getInnerSweep(), walberla::pystencils::ReactionKernelIndexed_5_single_precision_CUDA::getInnerSweep(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::getInnerSweep(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::getInnerSweep(), getLinearIndex(), getLinearIndex(), getLinearIndex(), getLinearIndex(), Cabana::NeighborList< CustomVerletList< MemorySpace, AlgorithmTag, Cabana::VerletLayout2D, BuildTag > >::getNeighbor(), walberla::pystencils::Dirichlet_double_precision_CUDA::getOuterSweep(), walberla::pystencils::Dirichlet_single_precision_CUDA::getOuterSweep(), walberla::pystencils::FixedFlux_double_precision_CUDA::getOuterSweep(), walberla::pystencils::FixedFlux_single_precision_CUDA::getOuterSweep(), walberla::pystencils::ReactionKernelIndexed_1_double_precision_CUDA::getOuterSweep(), walberla::pystencils::ReactionKernelIndexed_1_single_precision_CUDA::getOuterSweep(), walberla::pystencils::ReactionKernelIndexed_2_double_precision_CUDA::getOuterSweep(), walberla::pystencils::ReactionKernelIndexed_2_single_precision_CUDA::getOuterSweep(), walberla::pystencils::ReactionKernelIndexed_3_double_precision_CUDA::getOuterSweep(), walberla::pystencils::ReactionKernelIndexed_3_single_precision_CUDA::getOuterSweep(), walberla::pystencils::ReactionKernelIndexed_4_double_precision_CUDA::getOuterSweep(), walberla::pystencils::ReactionKernelIndexed_4_single_precision_CUDA::getOuterSweep(), walberla::pystencils::ReactionKernelIndexed_5_double_precision_CUDA::getOuterSweep(), walberla::pystencils::ReactionKernelIndexed_5_single_precision_CUDA::getOuterSweep(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::getOuterSweep(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::getOuterSweep(), walberla::pystencils::AdvectiveFluxKernel_double_precision_CUDA::getSweep(), walberla::pystencils::AdvectiveFluxKernel_single_precision_CUDA::getSweep(), walberla::pystencils::ContinuityKernel_double_precision_CUDA::getSweep(), walberla::pystencils::ContinuityKernel_single_precision_CUDA::getSweep(), walberla::pystencils::DiffusiveFluxKernel_double_precision_CUDA::getSweep(), walberla::pystencils::DiffusiveFluxKernel_single_precision_CUDA::getSweep(), walberla::pystencils::DiffusiveFluxKernelThermalized_double_precision_CUDA::getSweep(), walberla::pystencils::DiffusiveFluxKernelThermalized_single_precision_CUDA::getSweep(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_double_precision_CUDA::getSweep(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_single_precision_CUDA::getSweep(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_double_precision_CUDA::getSweep(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_single_precision_CUDA::getSweep(), walberla::pystencils::Dirichlet_double_precision_CUDA::getSweep(), walberla::pystencils::Dirichlet_single_precision_CUDA::getSweep(), walberla::pystencils::FixedFlux_double_precision_CUDA::getSweep(), walberla::pystencils::FixedFlux_single_precision_CUDA::getSweep(), walberla::pystencils::FrictionCouplingKernel_double_precision_CUDA::getSweep(), walberla::pystencils::FrictionCouplingKernel_single_precision_CUDA::getSweep(), walberla::pystencils::ReactionKernelBulk_1_double_precision_CUDA::getSweep(), walberla::pystencils::ReactionKernelBulk_1_single_precision_CUDA::getSweep(), walberla::pystencils::ReactionKernelBulk_2_double_precision_CUDA::getSweep(), walberla::pystencils::ReactionKernelBulk_2_single_precision_CUDA::getSweep(), walberla::pystencils::ReactionKernelBulk_3_double_precision_CUDA::getSweep(), walberla::pystencils::ReactionKernelBulk_3_single_precision_CUDA::getSweep(), walberla::pystencils::ReactionKernelBulk_4_double_precision_CUDA::getSweep(), walberla::pystencils::ReactionKernelBulk_4_single_precision_CUDA::getSweep(), walberla::pystencils::ReactionKernelBulk_5_double_precision_CUDA::getSweep(), walberla::pystencils::ReactionKernelBulk_5_single_precision_CUDA::getSweep(), walberla::pystencils::ReactionKernelIndexed_1_double_precision_CUDA::getSweep(), walberla::pystencils::ReactionKernelIndexed_1_single_precision_CUDA::getSweep(), walberla::pystencils::ReactionKernelIndexed_2_double_precision_CUDA::getSweep(), walberla::pystencils::ReactionKernelIndexed_2_single_precision_CUDA::getSweep(), walberla::pystencils::ReactionKernelIndexed_3_double_precision_CUDA::getSweep(), walberla::pystencils::ReactionKernelIndexed_3_single_precision_CUDA::getSweep(), walberla::pystencils::ReactionKernelIndexed_4_double_precision_CUDA::getSweep(), walberla::pystencils::ReactionKernelIndexed_4_single_precision_CUDA::getSweep(), walberla::pystencils::ReactionKernelIndexed_5_double_precision_CUDA::getSweep(), walberla::pystencils::ReactionKernelIndexed_5_single_precision_CUDA::getSweep(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::getSweep(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::getSweep(), walberla::pystencils::InitialPDFsSetterDoublePrecisionCUDA::getSweep(), walberla::pystencils::InitialPDFsSetterSinglePrecisionCUDA::getSweep(), walberla::pystencils::StreamCollideSweepLeesEdwardsDoublePrecisionCUDA::getSweep(), walberla::pystencils::StreamCollideSweepLeesEdwardsSinglePrecisionCUDA::getSweep(), walberla::pystencils::StreamCollideSweepThermalizedDoublePrecisionCUDA::getSweep(), walberla::pystencils::StreamCollideSweepThermalizedSinglePrecisionCUDA::getSweep(), walberla::pystencils::UpdateVelFromPDFDoublePrecisionCUDA::getSweep(), walberla::pystencils::UpdateVelFromPDFSinglePrecisionCUDA::getSweep(), walberla::pystencils::AdvectiveFluxKernel_double_precision::getSweepOnCellInterval(), walberla::pystencils::AdvectiveFluxKernel_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::AdvectiveFluxKernel_single_precision::getSweepOnCellInterval(), walberla::pystencils::AdvectiveFluxKernel_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ContinuityKernel_double_precision::getSweepOnCellInterval(), walberla::pystencils::ContinuityKernel_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ContinuityKernel_single_precision::getSweepOnCellInterval(), walberla::pystencils::ContinuityKernel_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernel_double_precision::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernel_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernel_single_precision::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernel_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelThermalized_double_precision::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelThermalized_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelThermalized_single_precision::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelThermalized_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_double_precision::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_single_precision::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_double_precision::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_single_precision::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::FrictionCouplingKernel_double_precision::getSweepOnCellInterval(), walberla::pystencils::FrictionCouplingKernel_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::FrictionCouplingKernel_single_precision::getSweepOnCellInterval(), walberla::pystencils::FrictionCouplingKernel_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::InitialPDFsSetterDoublePrecision::getSweepOnCellInterval(), walberla::pystencils::InitialPDFsSetterDoublePrecisionCUDA::getSweepOnCellInterval(), walberla::pystencils::InitialPDFsSetterSinglePrecision::getSweepOnCellInterval(), walberla::pystencils::InitialPDFsSetterSinglePrecisionCUDA::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_1_double_precision::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_1_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_1_single_precision::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_1_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_2_double_precision::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_2_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_2_single_precision::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_2_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_3_double_precision::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_3_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_3_single_precision::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_3_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_4_double_precision::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_4_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_4_single_precision::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_4_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_5_double_precision::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_5_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_5_single_precision::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_5_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepLeesEdwardsDoublePrecision::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepLeesEdwardsDoublePrecisionAVX::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepLeesEdwardsDoublePrecisionCUDA::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepLeesEdwardsSinglePrecision::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepLeesEdwardsSinglePrecisionAVX::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepLeesEdwardsSinglePrecisionCUDA::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepThermalizedDoublePrecision::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepThermalizedDoublePrecisionAVX::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepThermalizedDoublePrecisionCUDA::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepThermalizedSinglePrecision::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepThermalizedSinglePrecisionAVX::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepThermalizedSinglePrecisionCUDA::getSweepOnCellInterval(), walberla::pystencils::AdvectiveFluxKernel_double_precision::getSweepOnCellInterval(), walberla::pystencils::AdvectiveFluxKernel_single_precision::getSweepOnCellInterval(), walberla::pystencils::ContinuityKernel_double_precision::getSweepOnCellInterval(), walberla::pystencils::ContinuityKernel_single_precision::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernel_double_precision::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernel_single_precision::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelThermalized_double_precision::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelThermalized_single_precision::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_double_precision::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_single_precision::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_double_precision::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_single_precision::getSweepOnCellInterval(), walberla::pystencils::FrictionCouplingKernel_double_precision::getSweepOnCellInterval(), walberla::pystencils::FrictionCouplingKernel_single_precision::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_1_double_precision::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_1_single_precision::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_2_double_precision::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_2_single_precision::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_3_double_precision::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_3_single_precision::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_4_double_precision::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_4_single_precision::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_5_double_precision::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_5_single_precision::getSweepOnCellInterval(), walberla::pystencils::InitialPDFsSetterDoublePrecision::getSweepOnCellInterval(), walberla::pystencils::InitialPDFsSetterSinglePrecision::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepLeesEdwardsDoublePrecision::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepLeesEdwardsDoublePrecisionAVX::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepLeesEdwardsSinglePrecision::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepLeesEdwardsSinglePrecisionAVX::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepThermalizedDoublePrecision::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepThermalizedDoublePrecisionAVX::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepThermalizedSinglePrecision::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepThermalizedSinglePrecisionAVX::getSweepOnCellInterval(), walberla::pystencils::UpdateVelFromPDFDoublePrecision::getSweepOnCellInterval(), walberla::pystencils::UpdateVelFromPDFDoublePrecisionAVX::getSweepOnCellInterval(), walberla::pystencils::UpdateVelFromPDFSinglePrecision::getSweepOnCellInterval(), walberla::pystencils::UpdateVelFromPDFSinglePrecisionAVX::getSweepOnCellInterval(), walberla::pystencils::AdvectiveFluxKernel_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::AdvectiveFluxKernel_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ContinuityKernel_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ContinuityKernel_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernel_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernel_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelThermalized_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelThermalized_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::FrictionCouplingKernel_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::FrictionCouplingKernel_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_1_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_1_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_2_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_2_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_3_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_3_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_4_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_4_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_5_double_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::ReactionKernelBulk_5_single_precision_CUDA::getSweepOnCellInterval(), walberla::pystencils::InitialPDFsSetterDoublePrecisionCUDA::getSweepOnCellInterval(), walberla::pystencils::InitialPDFsSetterSinglePrecisionCUDA::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepLeesEdwardsDoublePrecisionCUDA::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepLeesEdwardsSinglePrecisionCUDA::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepThermalizedDoublePrecisionCUDA::getSweepOnCellInterval(), walberla::pystencils::StreamCollideSweepThermalizedSinglePrecisionCUDA::getSweepOnCellInterval(), walberla::pystencils::UpdateVelFromPDFDoublePrecisionCUDA::getSweepOnCellInterval(), walberla::pystencils::UpdateVelFromPDFSinglePrecisionCUDA::getSweepOnCellInterval(), walberla::pystencils::UpdateVelFromPDFDoublePrecision::getSweepOnCellInterval(), walberla::pystencils::UpdateVelFromPDFDoublePrecisionAVX::getSweepOnCellInterval(), walberla::pystencils::UpdateVelFromPDFDoublePrecisionCUDA::getSweepOnCellInterval(), walberla::pystencils::UpdateVelFromPDFSinglePrecision::getSweepOnCellInterval(), walberla::pystencils::UpdateVelFromPDFSinglePrecisionAVX::getSweepOnCellInterval(), walberla::pystencils::UpdateVelFromPDFSinglePrecisionCUDA::getSweepOnCellInterval(), walberla::LBWalberlaImpl< FloatType, Architecture >::ghost_communication_laf(), walberla::LBWalberlaImpl< FloatType, Architecture >::ghost_communication_pdf(), walberla::LBWalberlaImpl< FloatType, Architecture >::ghost_communication_vel(), ghost_communicator(), CellStructure::ghosts_update(), ScriptInterface::GlobalContext::GlobalContext(), CollisionDetection::GlueToSurface::glue_to_surface_criterion(), walberla::greens_function(), grid_influence_function(), grid_influence_function_dipolar(), grid_influence_function_self_energy(), gyration_tensor(), Utils::hadamard_division(), Utils::hadamard_product(), CollisionDetection::CollisionDetection::handle_collisions(), CollisionDetection::BindAtPointOfCollision::handle_collisions(), CollisionDetection::BindCenters::handle_collisions(), CollisionDetection::GlueToSurface::handle_collisions(), Thermostat::handle_particle_anisotropy(), Thermostat::handle_particle_gamma(), has_actor_of_type(), has_actor_of_type(), Utils::Factory< T >::has_builder(), System::System::has_collision_detection_enabled(), CellStructure::AoSoA_pack::has_exclusion(), System::System::has_icc_enabled(), ScriptInterface::Accumulators::AutoUpdateAccumulators::has_in_core(), ScriptInterface::Constraints::Constraints::has_in_core(), ScriptInterface::Shapes::Union::has_in_core(), ScriptInterface::walberla::EKContainer::has_in_core(), ScriptInterface::walberla::EKReactions::has_in_core(), System::System::has_npt_enabled(), ScriptInterface::ObjectHandle::has_parameter(), Accumulators::AccumulatorBase::has_same_system_handle(), hat_pair_energy(), hat_pair_force_factor(), Hat_Parameters::Hat_Parameters(), walberla::PoissonSolverFFT< FloatType, Architecture >::heffte_container< ComplexType >::heffte_container(), hertzian_pair_energy(), hertzian_pair_force_factor(), ScriptInterface::Shapes::HollowConicalFrustum::HollowConicalFrustum(), ScriptInterface::Constraints::HomogeneousMagneticField::HomogeneousMagneticField(), HybridDecomposition::HybridDecomposition(), ReactionMethods::ReactionAlgorithm::i_random(), Utils::Mpi::iall_gatherv(), Utils::identity_mat(), walberla::lbm::internal_dynamicubbdoubleprecisioncuda_boundary_DynamicUBBDoublePrecisionCUDA::if(), walberla::lbm::internal_dynamicubbsingleprecisioncuda_boundary_DynamicUBBSinglePrecisionCUDA::if(), image_sum(), in_box(), in_local_domain(), in_local_halo(), influence_function_r2c(), CoulombP3MHeffte< FloatType, Architecture, FFTConfig >::init(), DipolarP3MHeffte< FloatType, Architecture, FFTConfig >::init(), Communicator::init_comm_cart(), CoulombP3MHeffte< FloatType, Architecture, FFTConfig >::init_cpu_kernels(), DipolarP3MHeffte< FloatType, Architecture, FFTConfig >::init_cpu_kernels(), init_forces_and_thermostat(), CoulombP3MHeffte< FloatType, Architecture, FFTConfig >::init_gpu_kernels(), CoulombP3MState< FloatType, FFTConfig >::init_labels(), DipolarP3MState< FloatType, FFTConfig >::init_labels(), FFTBuffersLegacy< FloatType >::init_meshes(), init_type_map(), ImmersedBoundaries::init_volume_conservation(), CollisionDetection::CollisionDetection::initialize(), IBMTribend::initialize(), IBMTriel::initialize(), walberla::ek::accessor::Scalar::initialize(), walberla::ek::accessor::Scalar::initialize(), walberla::ek::accessor::Scalar::initialize(), walberla::ek::accessor::Vector::initialize(), walberla::lbm::accessor::Vector::initialize(), walberla::ek::accessor::Flux::initialize(), walberla::lbm::accessor::Population::initialize(), walberla::ek::accessor::Scalar::initialize(), walberla::ek::accessor::Vector::initialize(), walberla::lbm::accessor::Vector::initialize(), walberla::ek::accessor::Flux::initialize(), walberla::lbm::accessor::Population::initialize(), CollisionDetection::BindAtPointOfCollision::initialize(), CollisionDetection::BindCenters::initialize(), CollisionDetection::GlueToSurface::initialize(), ScriptInterface::Accumulators::initialize(), ScriptInterface::Analysis::initialize(), ScriptInterface::CellSystem::initialize(), ScriptInterface::ClusterAnalysis::initialize(), ScriptInterface::CodeInfo::initialize(), ScriptInterface::CollisionDetection::initialize(), ScriptInterface::Constraints::initialize(), ScriptInterface::Coulomb::initialize(), ScriptInterface::Galilei::initialize(), ScriptInterface::Writer::initialize(), ScriptInterface::Integrators::initialize(), ScriptInterface::Interactions::initialize(), ScriptInterface::LeesEdwards::initialize(), ScriptInterface::Dipoles::initialize(), ScriptInterface::Math::initialize(), ScriptInterface::MPIIO::initialize(), ScriptInterface::PairCriteria::initialize(), ScriptInterface::Particles::initialize(), ScriptInterface::Profiler::initialize(), ScriptInterface::ReactionMethods::initialize(), ScriptInterface::System::initialize(), ScriptInterface::Thermostat::initialize(), ScriptInterface::walberla::initialize(), fft::fft_data_struct< FloatType >::initialize_fft(), CustomVerletList< MemorySpace, AlgorithmTag, LayoutTag, BuildTag >::initializeData(), walberla::pystencils::internal_2df07fce91f5444fc18533f996cd1a79::initialpdfssetterdoubleprecision_initialpdfssetterdoubleprecision(), walberla::pystencils::internal_b8085d63d6b7e842485134abbac511e8::initialpdfssettersingleprecision_initialpdfssettersingleprecision(), walberla::pystencils::Dirichlet_double_precision_CUDA::inner(), walberla::pystencils::Dirichlet_single_precision_CUDA::inner(), walberla::pystencils::FixedFlux_double_precision_CUDA::inner(), walberla::pystencils::FixedFlux_single_precision_CUDA::inner(), walberla::pystencils::ReactionKernelIndexed_1_double_precision_CUDA::inner(), walberla::pystencils::ReactionKernelIndexed_1_single_precision_CUDA::inner(), walberla::pystencils::ReactionKernelIndexed_2_double_precision_CUDA::inner(), walberla::pystencils::ReactionKernelIndexed_2_single_precision_CUDA::inner(), walberla::pystencils::ReactionKernelIndexed_3_double_precision_CUDA::inner(), walberla::pystencils::ReactionKernelIndexed_3_single_precision_CUDA::inner(), walberla::pystencils::ReactionKernelIndexed_4_double_precision_CUDA::inner(), walberla::pystencils::ReactionKernelIndexed_4_single_precision_CUDA::inner(), walberla::pystencils::ReactionKernelIndexed_5_double_precision_CUDA::inner(), walberla::pystencils::ReactionKernelIndexed_5_single_precision_CUDA::inner(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::inner(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::inner(), BondList::insert(), ScriptInterface::ObjectMap< ManagedType, BaseType, KeyType >::insert(), BondedInteractionsMap::insert(), ScriptInterface::ObjectMap< ManagedType, BaseType, KeyType >::insert(), BondedInteractionsMap::insert(), ScriptInterface::BondBreakage::BreakageSpecs::insert_in_core(), ScriptInterface::Interactions::BondedInteractions::insert_in_core(), ScriptInterface::Interactions::BondedInteractions::insert_in_core(), Utils::integral_parameter(), System::System::integrate(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::integrate(), ScriptInterface::Integrators::Integrator::integrate(), ScriptInterface::Integrators::SteepestDescent::integrate(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::integrate_vtk_writers(), walberla::PoissonSolverFFT< FloatType, Architecture >::integrate_vtk_writers(), walberla::LBWalberlaImpl< FloatType, Architecture >::integrate_vtk_writers(), System::System::integrate_with_signal_handler(), integrator_step_1(), integrator_step_2(), ScriptInterface::Integrators::IntegratorHandle::IntegratorHandle(), ScriptInterface::Thermostat::Interface< CoreClass >::Interface(), FieldCoupling::Fields::Interpolated< T, codim >::Interpolated(), ScriptInterface::Thermostat::Interface< CoreClass >::invalid_rng_state(), ScriptInterface::Thermostat::LBThermostat::invalid_rng_state(), Utils::Matrix< T, Rows, Cols >::inversed(), invoke_skip_cuda_exceptions(), Writer::H5md::Specification::is_compliant(), Particle::is_fixed_along(), CoulombP3MHeffte< FloatType, Architecture, FFTConfig >::is_gpu(), DipolarP3MHeffte< FloatType, Architecture, FFTConfig >::is_gpu(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::is_gpu(), walberla::PoissonSolverFFT< FloatType, Architecture >::is_gpu(), walberla::LBWalberlaImpl< FloatType, Architecture >::is_gpu(), ScriptInterface::LatticeIndices::is_index_valid(), Shapes::Shape::is_inside(), is_node_grid_compatible_with_mesh(), ScriptInterface::is_none(), CollisionDetection::CollisionDetection::is_off(), is_poststorable(), is_prefetchable(), EK::Solver::is_ready_for_propagation(), EK::EKWalberla::is_ready_for_propagation(), is_recv_op(), BaseThermostat::is_seed_required(), is_send_op(), EK::is_solver_set(), LB::is_solver_set(), is_valid_position(), is_valid_propagation_combination(), is_vs(), is_vs_rot(), Utils::Mpi::isendrecv(), ICCStar::iteration(), FieldCoupling::Fields::PlaneWave< T, codim >::jacobian(), GatherParticleTraits< T >::join(), Reduction::KokkosReducer< ResultType, Kernel >::join(), LB::ParticleCoupling::kernel(), walberla::ek::accessor::Scalar::kernel_add(), walberla::ek::accessor::Vector::kernel_add(), walberla::lbm::accessor::Vector::kernel_add(), walberla::ek::accessor::Scalar::kernel_add(), walberla::ek::accessor::Vector::kernel_add(), walberla::lbm::accessor::Vector::kernel_add(), walberla::lbm::accessor::Interpolation::kernel_add_force(), walberla::lbm::accessor::Interpolation::kernel_add_force(), walberla::ek::accessor::Flux::kernel_broadcast(), walberla::lbm::accessor::Population::kernel_broadcast(), walberla::ek::accessor::Scalar::kernel_broadcast(), walberla::ek::accessor::Vector::kernel_broadcast(), walberla::lbm::accessor::Vector::kernel_broadcast(), walberla::ek::accessor::Flux::kernel_broadcast(), walberla::lbm::accessor::Population::kernel_broadcast(), walberla::ek::accessor::Scalar::kernel_broadcast(), walberla::ek::accessor::Vector::kernel_broadcast(), walberla::lbm::accessor::Vector::kernel_broadcast(), walberla::ek::accessor::Scalar::kernel_broadcast_add(), walberla::ek::accessor::Vector::kernel_broadcast_add(), walberla::lbm::accessor::Vector::kernel_broadcast_add(), walberla::ek::accessor::Scalar::kernel_broadcast_add(), walberla::ek::accessor::Vector::kernel_broadcast_add(), walberla::lbm::accessor::Vector::kernel_broadcast_add(), walberla::ek::accessor::Flux::kernel_get(), walberla::lbm::accessor::PressureTensor::kernel_get(), walberla::lbm::accessor::Population::kernel_get(), walberla::lbm::accessor::Density::kernel_get(), walberla::lbm::accessor::MomentumDensity::kernel_get(), walberla::lbm::accessor::Velocity::kernel_get(), walberla::ek::accessor::Scalar::kernel_get(), walberla::ek::accessor::Vector::kernel_get(), walberla::lbm::accessor::Vector::kernel_get(), walberla::ek::accessor::Flux::kernel_get(), walberla::lbm::accessor::PressureTensor::kernel_get(), walberla::lbm::accessor::Population::kernel_get(), walberla::lbm::accessor::Density::kernel_get(), walberla::lbm::accessor::MomentumDensity::kernel_get(), walberla::lbm::accessor::Velocity::kernel_get(), walberla::ek::accessor::Scalar::kernel_get(), walberla::ek::accessor::Vector::kernel_get(), walberla::lbm::accessor::Vector::kernel_get(), walberla::lbm::accessor::Interpolation::kernel_get_rho(), walberla::lbm::accessor::Interpolation::kernel_get_rho(), walberla::ek::accessor::Flux::kernel_get_vector(), walberla::ek::accessor::Flux::kernel_get_vector(), walberla::lbm::accessor::Interpolation::kernel_get_vel(), walberla::lbm::accessor::Interpolation::kernel_get_vel(), walberla::lbm::accessor::Population::kernel_set(), walberla::lbm::accessor::Density::kernel_set(), walberla::lbm::accessor::Force::kernel_set(), walberla::lbm::accessor::Velocity::kernel_set(), walberla::ek::accessor::Scalar::kernel_set(), walberla::ek::accessor::Vector::kernel_set(), walberla::lbm::accessor::Vector::kernel_set(), walberla::lbm::accessor::Population::kernel_set(), walberla::lbm::accessor::Density::kernel_set(), walberla::lbm::accessor::Force::kernel_set(), walberla::lbm::accessor::Velocity::kernel_set(), walberla::ek::accessor::Scalar::kernel_set(), walberla::ek::accessor::Vector::kernel_set(), walberla::lbm::accessor::Vector::kernel_set(), walberla::lbm::accessor::Equilibrium::kernel_set_device(), walberla::lbm::accessor::Equilibrium::kernel_set_device(), walberla::lbm::accessor::Vector::kernel_set_from_list(), walberla::lbm::accessor::Vector::kernel_set_from_list(), walberla::lbm::accessor::Population::kernel_set_vel(), walberla::lbm::accessor::Population::kernel_set_vel(), Galilei::kill_particle_forces(), Galilei::kill_particle_motion(), kokkos_parallel_range_for(), LatticeWalberla::LatticeWalberla(), CoulombTuningAlgorithm< FloatType, Architecture, FFTConfig >::layer_correction_veto_r_cut(), System::System::lb_couple_particles(), Thermostat::Thermostat::lb_coupling_deactivate(), LB::lb_coupling_sanity_checks(), lb_drag_force(), lb_drag_force(), lb_handle_particle_anisotropy(), lb_sanity_checks(), lb_tracers_add_particle_force_to_fluid(), lb_tracers_propagate(), ScriptInterface::walberla::LBFluid::LBFluid(), Observables::LBProfileObservable::LBProfileObservable(), ScriptInterface::Thermostat::LBThermostat::LBThermostat(), walberla::LBWalberlaImpl< FloatType, Architecture >::LBWalberlaImpl(), LB::Solver::lebc_sanity_checks(), BoxGeometry::lees_edwards_update(), lees_edwards_vel_shift(), ScriptInterface::LeesEdwards::LeesEdwards::LeesEdwards(), anonymous_namespace{p3m_gpu_cuda.cu}::linear_index_k(), anonymous_namespace{p3m_gpu_cuda.cu}::linear_index_r(), Utils::linear_interpolation(), Algorithm::link_cell(), link_cell_kokkos(), lj_pair_energy(), lj_pair_force_factor(), ljcos2_pair_energy(), ljcos2_pair_force_factor(), LJcos2_Parameters::LJcos2_Parameters(), ljcos_pair_energy(), ljcos_pair_force_factor(), LJcos_Parameters::LJcos_Parameters(), ljgen_pair_energy(), ljgen_pair_force_factor(), LJGen_Parameters::LJGen_Parameters(), boost::serialization::load(), boost::serialization::load(), boost::serialization::load(), boost::serialization::load(), boost::serialization::load(), boost::serialization::load(), Utils::compact_vector< T >::load(), p3m_interpolation_cache::load(), ScriptInterface::walberla::load_checkpoint_common(), ScriptInterface::Particles::local_add_exclusion(), ScriptInterface::Particles::local_remove_exclusion(), local_rotate_particle(), local_rotate_particle_body(), TuningLogger::log_skip(), TuningLogger::log_success(), DipolarDirectSumGpu::long_range_energy(), ElectrostaticLayerCorrection::long_range_energy(), DipolarDirectSum::long_range_energy(), System::System::long_range_interactions_sanity_checks(), CoulombP3MHeffte< FloatType, Architecture, FFTConfig >::long_range_kernel(), DipolarP3MHeffte< FloatType, Architecture, FFTConfig >::long_range_kernel(), CoulombP3MHeffte< FloatType, Architecture, FFTConfig >::long_range_pressure(), ClusterAnalysis::Cluster::longest_distance(), Communication::MpiCallbacks::loop(), Utils::lower_triangular(), Utils::Factory< T >::make(), ScriptInterface::Thermostat::Interface< CoreClass >::make_autogamma(), ScriptInterface::Thermostat::Interface< CoreClass >::make_autoparameter(), ScriptInterface::Thermostat::Thermostat::make_autoparameter(), make_coulomb_scafacos(), make_default_mpi_env(), walberla::LBWalberlaImpl< FloatType, Architecture >::make_density_interpolation_kernel(), make_dipolar_scafacos(), ReactionMethods::ReactionAlgorithm::make_displacement_mc_move_attempt(), DipolarP3MState< FloatType, FFTConfig >::make_fft_instance(), make_flat_set(), walberla::LBWalberlaImpl< FloatType, Architecture >::make_force_interpolation_kernel(), ScriptInterface::walberla::EKFFT::make_instance(), ScriptInterface::walberla::EKFFTGPU::make_instance(), ScriptInterface::walberla::EKReaction::make_instance(), ScriptInterface::walberla::EKSpeciesCPU::make_instance(), ScriptInterface::walberla::EKSpeciesGPU::make_instance(), ScriptInterface::walberla::LBFluidCPU::make_instance(), ScriptInterface::walberla::LBFluidGPU::make_instance(), Reduction::make_kokkos_reducer(), LB::LBWalberla::make_lattice_position_checker(), LB::Solver::make_lattice_position_checker(), walberla::LBWalberlaImpl< FloatType, Architecture >::make_lattice_position_checker(), Utils::make_lin_space(), DipolarP3MState< FloatType, FFTConfig >::make_mesh_instance(), ScriptInterface::Interactions::InteractionWCA::make_new_instance(), ScriptInterface::Interactions::InteractionLJ::make_new_instance(), ScriptInterface::Interactions::InteractionLJGen::make_new_instance(), ScriptInterface::Interactions::InteractionLJcos::make_new_instance(), ScriptInterface::Interactions::InteractionLJcos2::make_new_instance(), ScriptInterface::Interactions::InteractionHertzian::make_new_instance(), ScriptInterface::Interactions::InteractionGaussian::make_new_instance(), ScriptInterface::Interactions::InteractionBMHTF::make_new_instance(), ScriptInterface::Interactions::InteractionMorse::make_new_instance(), ScriptInterface::Interactions::InteractionBuckingham::make_new_instance(), ScriptInterface::Interactions::InteractionSoftSphere::make_new_instance(), ScriptInterface::Interactions::InteractionHat::make_new_instance(), ScriptInterface::Interactions::InteractionGayBerne::make_new_instance(), ScriptInterface::Interactions::InteractionTabulated::make_new_instance(), ScriptInterface::Interactions::InteractionDPD::make_new_instance(), ScriptInterface::Interactions::InteractionThole::make_new_instance(), ScriptInterface::Interactions::InteractionSmoothStep::make_new_instance(), make_new_particle(), ReactionMethods::ReactionAlgorithm::make_new_system_state(), InteractionsNonBonded::make_particle_type_exist(), ReactionMethods::ReactionAlgorithm::make_reaction_attempt(), ReactionMethods::ReactionAlgorithm::make_reaction_mc_move_attempt(), LocalBox::make_regular_decomposition(), ScriptInterface::ContextManager::make_shared(), GpuParticleData::Storage::make_shared(), ScriptInterface::GlobalContext::make_shared(), ScriptInterface::LocalContext::make_shared(), ScriptInterface::make_shared_from_args(), fe_trap::make_shared_scoped(), fe_trap::make_unique_scoped(), walberla::LBWalberlaImpl< FloatType, Architecture >::make_velocity_interpolation_kernel(), fft::map_3don2d_grid(), map_data_parts(), Utils::mask(), Utils::Matrix< T, Rows, Cols >::Matrix(), Utils::Matrix< T, Rows, Cols >::Matrix(), RegularDecomposition::max_cutoff(), Utils::Array< T, N >::max_size(), BondedInteractionsMap::maximal_cutoff(), InteractionsNonBonded::maximal_cutoff(), maybe_insert_particle(), maybe_move_particle(), Utils::Accumulator::mean(), mesh_sendrecv(), ErrorHandling::RuntimeErrorCollector::message(), anonymous_namespace{Correlator.cpp}::min(), Constraints::ShapeBasedConstraint::min_dist(), mindist(), Observables::SanityChecksLB::mismatch(), modify_p3m_sums(), moment_of_inertia_matrix(), morse_pair_energy(), morse_pair_force_factor(), Morse_Parameters::Morse_Parameters(), Mpiio::mpi_calculate_file_offset(), walberla::mpi_deinit(), mpi_get_particles(), mpi_get_particles_local(), walberla::mpi_init(), Mpiio::mpi_mpiio_common_read(), Mpiio::mpi_mpiio_common_write(), Observable_stat::mpi_reduce(), ScriptInterface::mpi_reduce_sum(), mpi_send_particle_data_local(), mpi_who_has_head(), mpi_who_has_local(), Communication::MpiCallbacks::MpiCallbacks(), Mpiio::mpiio_dump_array(), Mpiio::mpiio_read_array(), Random::mt19937(), mulhilo32(), ScriptInterface::GlobalContext::name(), ScriptInterface::LocalContext::name(), nbhood(), Neighbors< CellRef >::Neighbors(), Neighbors< CellRef >::Neighbors(), new_coulomb_p3m_heffte(), new_coulomb_p3m_impl(), new_dipolar_p3m_heffte(), new_dipolar_p3m_impl(), walberla::new_ek_poisson_fft(), walberla::new_ek_poisson_fft_cuda(), walberla::new_ek_poisson_none(), walberla::new_ek_reaction_bulk_cpu(), walberla::new_ek_reaction_bulk_gpu(), walberla::new_ek_reaction_indexed_cpu(), walberla::new_ek_reaction_indexed_gpu(), walberla::new_ek_walberla_cpu(), walberla::new_ek_walberla_gpu(), new_lb_walberla_cpu(), new_lb_walberla_gpu(), Random::noise_gaussian(), Random::noise_uniform(), Observable_stat::non_bonded_inter_contribution(), Observable_stat::non_bonded_intra_contribution(), CellStructure::non_bonded_loop(), CellStructure::non_bonded_loop(), non_bonded_loop_trace(), ScriptInterface::Interactions::NonBondedInteractionHandle::NonBondedInteractionHandle(), Utils::Histogram< T, N, M, U >::normalize(), Utils::Vector< T, N >::normalize(), Utils::CylindricalHistogram< T, N, M, U >::normalize(), ScriptInterface::GlobalContext::notify_call_method(), ScriptInterface::GlobalContext::notify_set_parameter(), NptIsoParameters::NptIsoParameters(), number_of_particles_with_type(), number_of_partners(), Utils::NumeratedContainer< T, index_type >::NumeratedContainer(), Cabana::NeighborList< CustomVerletList< MemorySpace, AlgorithmTag, Cabana::VerletLayout2D, BuildTag > >::numNeighbor(), Observable_stat::Observable_stat(), ICCStar::on_activation(), DipolarDirectSumGpu::on_activation(), CoulombP3MHeffte< FloatType, Architecture, FFTConfig >::on_activation(), ScriptInterface::Coulomb::Container::on_bind_system(), ScriptInterface::Dipoles::Container::on_bind_system(), ScriptInterface::Accumulators::AutoUpdateAccumulators::on_bind_system(), ScriptInterface::BondBreakage::BreakageSpecs::on_bind_system(), ScriptInterface::CellSystem::CellSystem::on_bind_system(), ScriptInterface::CollisionDetection::CollisionDetection::on_bind_system(), ScriptInterface::Constraints::Constraints::on_bind_system(), ScriptInterface::Galilei::ComFixed::on_bind_system(), ScriptInterface::Galilei::Galilei::on_bind_system(), ScriptInterface::Integrators::IntegratorHandle::on_bind_system(), ScriptInterface::Interactions::BondedInteractions::on_bind_system(), ScriptInterface::Interactions::NonBondedInteractions::on_bind_system(), ScriptInterface::LeesEdwards::LeesEdwards::on_bind_system(), ScriptInterface::Thermostat::Interface< CoreClass >::on_bind_system(), ScriptInterface::Thermostat::Thermostat::on_bind_system(), walberla::LBWalberlaImpl< FloatType, Architecture >::on_boundary_add(), System::System::on_boxl_change(), ScriptInterface::Thermostat::Interface< CoreClass >::on_detach_system(), BondedInteractionsMap::on_ia_change(), System::System::on_integration_start(), ScriptInterface::Interactions::NonBondedInteractionHandle::on_non_bonded_ia_change(), Dipoles::Solver::on_observable_calc(), on_particle_type_change(), System::System::on_periodicity_change(), Utils::Vector< T, N >::operator Vector< U, N >(), BondView::operator!=(), Particle::operator!=(), Utils::operator!=(), Utils::operator%(), Communication::MpiCallbacks::CallbackHandle< Args >::operator()(), anonymous_namespace{dp3m_heffte.impl.hpp}::AssignDipole< cao >::operator()(), anonymous_namespace{dp3m_heffte.impl.hpp}::AssignTorques< cao >::operator()(), anonymous_namespace{dp3m_heffte.impl.hpp}::AssignForcesDip< cao >::operator()(), anonymous_namespace{p3m_heffte.impl.hpp}::AssignCharge< cao >::operator()(), anonymous_namespace{p3m_heffte.impl.hpp}::AssignForces< cao >::operator()(), anonymous_namespace{p3m_heffte.impl.hpp}::AssignCharge< cao >::operator()(), anonymous_namespace{p3m_heffte.impl.hpp}::AssignCharge< cao >::operator()(), Observables::Energy::operator()(), Observables::Pressure::operator()(), Observables::PressureTensor::operator()(), Observables::RDF::operator()(), Observables::CylindricalLBVelocityProfile::operator()(), Observables::LBFluidPressureTensor::operator()(), Observables::LBVelocityProfile::operator()(), CompareDevices::operator()(), ScriptInterface::PackVisitor::operator()(), FieldCoupling::Coupling::Mass::operator()(), VerletCriterion< CutoffGetter >::operator()(), ScriptInterface::UnpackVisitor::operator()(), ScriptInterface::PackVisitor::operator()(), ScriptInterface::UnpackVisitor::operator()(), ScriptInterface::PackVisitor::operator()(), FieldCoupling::Fields::PlaneWave< T, codim >::operator()(), walberla::ResetForce< PdfField, ForceField >::operator()(), walberla::pystencils::AdvectiveFluxKernel_double_precision_CUDA::operator()(), walberla::pystencils::AdvectiveFluxKernel_single_precision_CUDA::operator()(), walberla::pystencils::ContinuityKernel_double_precision_CUDA::operator()(), walberla::pystencils::ContinuityKernel_single_precision_CUDA::operator()(), walberla::pystencils::DiffusiveFluxKernel_double_precision_CUDA::operator()(), walberla::pystencils::DiffusiveFluxKernel_single_precision_CUDA::operator()(), walberla::pystencils::DiffusiveFluxKernelThermalized_double_precision_CUDA::operator()(), walberla::pystencils::DiffusiveFluxKernelThermalized_single_precision_CUDA::operator()(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_double_precision_CUDA::operator()(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_single_precision_CUDA::operator()(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_double_precision_CUDA::operator()(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_single_precision_CUDA::operator()(), walberla::pystencils::Dirichlet_double_precision_CUDA::operator()(), walberla::pystencils::Dirichlet_single_precision_CUDA::operator()(), walberla::pystencils::FixedFlux_double_precision_CUDA::operator()(), walberla::pystencils::FixedFlux_single_precision_CUDA::operator()(), walberla::pystencils::FrictionCouplingKernel_double_precision_CUDA::operator()(), walberla::pystencils::FrictionCouplingKernel_single_precision_CUDA::operator()(), walberla::pystencils::ReactionKernelBulk_1_double_precision_CUDA::operator()(), walberla::pystencils::ReactionKernelBulk_1_single_precision_CUDA::operator()(), walberla::pystencils::ReactionKernelBulk_2_double_precision_CUDA::operator()(), walberla::pystencils::ReactionKernelBulk_2_single_precision_CUDA::operator()(), walberla::pystencils::ReactionKernelBulk_3_double_precision_CUDA::operator()(), walberla::pystencils::ReactionKernelBulk_3_single_precision_CUDA::operator()(), walberla::pystencils::ReactionKernelBulk_4_double_precision_CUDA::operator()(), walberla::pystencils::ReactionKernelBulk_4_single_precision_CUDA::operator()(), walberla::pystencils::ReactionKernelBulk_5_double_precision_CUDA::operator()(), walberla::pystencils::ReactionKernelBulk_5_single_precision_CUDA::operator()(), walberla::pystencils::ReactionKernelIndexed_1_double_precision_CUDA::operator()(), walberla::pystencils::ReactionKernelIndexed_1_single_precision_CUDA::operator()(), walberla::pystencils::ReactionKernelIndexed_2_double_precision_CUDA::operator()(), walberla::pystencils::ReactionKernelIndexed_2_single_precision_CUDA::operator()(), walberla::pystencils::ReactionKernelIndexed_3_double_precision_CUDA::operator()(), walberla::pystencils::ReactionKernelIndexed_3_single_precision_CUDA::operator()(), walberla::pystencils::ReactionKernelIndexed_4_double_precision_CUDA::operator()(), walberla::pystencils::ReactionKernelIndexed_4_single_precision_CUDA::operator()(), walberla::pystencils::ReactionKernelIndexed_5_double_precision_CUDA::operator()(), walberla::pystencils::ReactionKernelIndexed_5_single_precision_CUDA::operator()(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::operator()(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::operator()(), walberla::pystencils::InitialPDFsSetterDoublePrecisionCUDA::operator()(), walberla::pystencils::InitialPDFsSetterSinglePrecisionCUDA::operator()(), walberla::pystencils::StreamCollideSweepLeesEdwardsDoublePrecisionCUDA::operator()(), walberla::pystencils::StreamCollideSweepLeesEdwardsSinglePrecisionCUDA::operator()(), walberla::pystencils::StreamCollideSweepThermalizedDoublePrecisionCUDA::operator()(), walberla::pystencils::StreamCollideSweepThermalizedSinglePrecisionCUDA::operator()(), walberla::pystencils::UpdateVelFromPDFDoublePrecisionCUDA::operator()(), walberla::pystencils::UpdateVelFromPDFSinglePrecisionCUDA::operator()(), GetNonbondedCutoff::operator()(), EK::FieldsConnector::operator()(), anonymous_namespace{CellStructure.cpp}::UpdateParticleIndexVisitor::operator()(), LeesEdwards::Push::operator()(), ParticleObservables::WeightedSum< ValueOp, WeightOp >::operator()(), ParticleObservables::Sum< ValueOp >::operator()(), ParticleObservables::WeightedAverage< ValueOp, WeightOp >::operator()(), ParticleObservables::Average< ValueOp >::operator()(), ParticleObservables::Map< ValueOp >::operator()(), anonymous_namespace{CellStructure.cpp}::UpdateParticleIndexVisitor::operator()(), ScriptInterface::Scafacos::GetParameterList::operator()(), ScriptInterface::Scafacos::ConvertToStringVector::operator()(), Coulomb::ShortRangeEnergyKernel::operator()(), Dipoles::ShortRangeForceKernel::operator()(), Dipoles::ShortRangeEnergyKernel::operator()(), Coulomb::ShortRangeForceCorrectionsKernel::operator()(), Coulomb::ShortRangeEnergyKernel::operator()(), GetActorByType< Actor >::operator()(), HasActorOfType< Actor >::operator()(), Coulomb::ShortRangeForceKernel::operator()(), Coulomb::ShortRangePressureKernel::operator()(), Coulomb::ShortRangeEnergyKernel::operator()(), ForcesKernel::operator()(), Utils::Matrix< T, Rows, Cols >::operator()(), Utils::Matrix< T, Rows, Cols >::operator()(), ScriptInterface::Scafacos::ConvertToStringVector::operator()(), ScriptInterface::Scafacos::GetParameterList::operator()(), ScriptInterface::Particles::SetParticleParametersVisitor::operator()(), ScriptInterface::Particles::SetParticleParametersVisitor::operator()(), ScriptInterface::Scafacos::ConvertToStringVector::operator()(), ScriptInterface::PackVisitor::operator()(), ScriptInterface::UnpackVisitor::operator()(), ParticleObservables::WeightedSum< ValueOp, WeightOp >::operator()(), ParticleObservables::Sum< ValueOp >::operator()(), ParticleObservables::WeightedAverage< ValueOp, WeightOp >::operator()(), ParticleObservables::Average< ValueOp >::operator()(), ScriptInterface::Scafacos::GetParameterList::operator()(), ScriptInterface::Scafacos::ConvertToStringVector::operator()(), Utils::operator*(), Utils::operator*(), Utils::operator*(), ParticleForce::operator+=(), ParticleRattle::operator+=(), Utils::operator-(), Utils::operator/(), Utils::operator/(), operator<<(), BondList::operator=(), BondList::operator=(), FieldCoupling::Fields::Interpolated< T, codim >::operator=(), Neighbors< CellRef >::operator=(), Communication::MpiCallbacks::operator=(), ScriptInterface::Interactions::BondedInteraction::operator==(), BondView::operator==(), walberla::lbm::DynamicUBBDoublePrecision::ForceStruct::operator==(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::ForceStruct::operator==(), walberla::lbm::DynamicUBBSinglePrecision::ForceStruct::operator==(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::ForceStruct::operator==(), walberla::pystencils::Dirichlet_double_precision::IndexInfo::operator==(), walberla::pystencils::Dirichlet_double_precision_CUDA::IndexInfo::operator==(), walberla::pystencils::Dirichlet_single_precision::IndexInfo::operator==(), walberla::pystencils::Dirichlet_single_precision_CUDA::IndexInfo::operator==(), walberla::pystencils::FixedFlux_double_precision::IndexInfo::operator==(), walberla::pystencils::FixedFlux_double_precision_CUDA::IndexInfo::operator==(), walberla::pystencils::FixedFlux_single_precision::IndexInfo::operator==(), walberla::pystencils::FixedFlux_single_precision_CUDA::IndexInfo::operator==(), walberla::pystencils::ReactionKernelIndexed_1_double_precision::IndexInfo::operator==(), walberla::pystencils::ReactionKernelIndexed_1_double_precision_CUDA::IndexInfo::operator==(), walberla::pystencils::ReactionKernelIndexed_1_single_precision::IndexInfo::operator==(), walberla::pystencils::ReactionKernelIndexed_1_single_precision_CUDA::IndexInfo::operator==(), walberla::pystencils::ReactionKernelIndexed_2_double_precision::IndexInfo::operator==(), walberla::pystencils::ReactionKernelIndexed_2_double_precision_CUDA::IndexInfo::operator==(), walberla::pystencils::ReactionKernelIndexed_2_single_precision::IndexInfo::operator==(), walberla::pystencils::ReactionKernelIndexed_2_single_precision_CUDA::IndexInfo::operator==(), walberla::pystencils::ReactionKernelIndexed_3_double_precision::IndexInfo::operator==(), walberla::pystencils::ReactionKernelIndexed_3_double_precision_CUDA::IndexInfo::operator==(), walberla::pystencils::ReactionKernelIndexed_3_single_precision::IndexInfo::operator==(), walberla::pystencils::ReactionKernelIndexed_3_single_precision_CUDA::IndexInfo::operator==(), walberla::pystencils::ReactionKernelIndexed_4_double_precision::IndexInfo::operator==(), walberla::pystencils::ReactionKernelIndexed_4_double_precision_CUDA::IndexInfo::operator==(), walberla::pystencils::ReactionKernelIndexed_4_single_precision::IndexInfo::operator==(), walberla::pystencils::ReactionKernelIndexed_4_single_precision_CUDA::IndexInfo::operator==(), walberla::pystencils::ReactionKernelIndexed_5_double_precision::IndexInfo::operator==(), walberla::pystencils::ReactionKernelIndexed_5_double_precision_CUDA::IndexInfo::operator==(), walberla::pystencils::ReactionKernelIndexed_5_single_precision::IndexInfo::operator==(), walberla::pystencils::ReactionKernelIndexed_5_single_precision_CUDA::IndexInfo::operator==(), walberla::lbm::DynamicUBBDoublePrecision::IndexInfo::operator==(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::IndexInfo::operator==(), walberla::lbm::DynamicUBBSinglePrecision::IndexInfo::operator==(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::IndexInfo::operator==(), walberla::lbm::DynamicUBBDoublePrecision::ForceVector::operator==(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::ForceVector::operator==(), walberla::lbm::DynamicUBBSinglePrecision::ForceVector::operator==(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::ForceVector::operator==(), walberla::pystencils::Dirichlet_double_precision::IndexVectors::operator==(), walberla::pystencils::Dirichlet_double_precision_CUDA::IndexVectors::operator==(), walberla::pystencils::Dirichlet_single_precision::IndexVectors::operator==(), walberla::pystencils::Dirichlet_single_precision_CUDA::IndexVectors::operator==(), walberla::pystencils::FixedFlux_double_precision::IndexVectors::operator==(), walberla::pystencils::FixedFlux_double_precision_CUDA::IndexVectors::operator==(), walberla::pystencils::FixedFlux_single_precision::IndexVectors::operator==(), walberla::pystencils::FixedFlux_single_precision_CUDA::IndexVectors::operator==(), walberla::pystencils::ReactionKernelIndexed_1_double_precision::IndexVectors::operator==(), walberla::pystencils::ReactionKernelIndexed_1_double_precision_CUDA::IndexVectors::operator==(), walberla::pystencils::ReactionKernelIndexed_1_single_precision::IndexVectors::operator==(), walberla::pystencils::ReactionKernelIndexed_1_single_precision_CUDA::IndexVectors::operator==(), walberla::pystencils::ReactionKernelIndexed_2_double_precision::IndexVectors::operator==(), walberla::pystencils::ReactionKernelIndexed_2_double_precision_CUDA::IndexVectors::operator==(), walberla::pystencils::ReactionKernelIndexed_2_single_precision::IndexVectors::operator==(), walberla::pystencils::ReactionKernelIndexed_2_single_precision_CUDA::IndexVectors::operator==(), walberla::pystencils::ReactionKernelIndexed_3_double_precision::IndexVectors::operator==(), walberla::pystencils::ReactionKernelIndexed_3_double_precision_CUDA::IndexVectors::operator==(), walberla::pystencils::ReactionKernelIndexed_3_single_precision::IndexVectors::operator==(), walberla::pystencils::ReactionKernelIndexed_3_single_precision_CUDA::IndexVectors::operator==(), walberla::pystencils::ReactionKernelIndexed_4_double_precision::IndexVectors::operator==(), walberla::pystencils::ReactionKernelIndexed_4_double_precision_CUDA::IndexVectors::operator==(), walberla::pystencils::ReactionKernelIndexed_4_single_precision::IndexVectors::operator==(), walberla::pystencils::ReactionKernelIndexed_4_single_precision_CUDA::IndexVectors::operator==(), walberla::pystencils::ReactionKernelIndexed_5_double_precision::IndexVectors::operator==(), walberla::pystencils::ReactionKernelIndexed_5_double_precision_CUDA::IndexVectors::operator==(), walberla::pystencils::ReactionKernelIndexed_5_single_precision::IndexVectors::operator==(), walberla::pystencils::ReactionKernelIndexed_5_single_precision_CUDA::IndexVectors::operator==(), walberla::lbm::DynamicUBBDoublePrecision::IndexVectors::operator==(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::IndexVectors::operator==(), walberla::lbm::DynamicUBBSinglePrecision::IndexVectors::operator==(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::IndexVectors::operator==(), Particle::operator==(), Utils::Array< T, N >::operator[](), Utils::Array< T, N >::operator[](), walberla::pystencils::Dirichlet_double_precision_CUDA::outer(), walberla::pystencils::Dirichlet_single_precision_CUDA::outer(), walberla::pystencils::FixedFlux_double_precision_CUDA::outer(), walberla::pystencils::FixedFlux_single_precision_CUDA::outer(), walberla::pystencils::ReactionKernelIndexed_1_double_precision_CUDA::outer(), walberla::pystencils::ReactionKernelIndexed_1_single_precision_CUDA::outer(), walberla::pystencils::ReactionKernelIndexed_2_double_precision_CUDA::outer(), walberla::pystencils::ReactionKernelIndexed_2_single_precision_CUDA::outer(), walberla::pystencils::ReactionKernelIndexed_3_double_precision_CUDA::outer(), walberla::pystencils::ReactionKernelIndexed_3_single_precision_CUDA::outer(), walberla::pystencils::ReactionKernelIndexed_4_double_precision_CUDA::outer(), walberla::pystencils::ReactionKernelIndexed_4_single_precision_CUDA::outer(), walberla::pystencils::ReactionKernelIndexed_5_double_precision_CUDA::outer(), walberla::pystencils::ReactionKernelIndexed_5_single_precision_CUDA::outer(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::outer(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::outer(), Accumulators::AccumulatorBase::override_system_handle(), p3m_add_block(), p3m_calc_blocks(), p3m_calculate_interpolation_weights(), p3m_gpu_add_farfield_force(), p3m_gpu_init(), p3m_interpolate(), p3m_k_space_error(), p3m_k_space_error_gpu(), p3m_k_space_error_gpu_kernel_ik(), p3m_make_grid(), p3m_real_space_error(), p3m_tune_aliasing_sums(), P3MFFT< FloatType, FFTConfig >::P3MFFT(), P3MParameters::P3MParameters(), ScriptInterface::pack(), walberla::pystencils::PackInfoPdfDoublePrecision::pack(), walberla::pystencils::PackInfoPdfSinglePrecision::pack(), walberla::pystencils::PackInfoVecDoublePrecision::pack(), walberla::pystencils::PackInfoVecSinglePrecision::pack(), walberla::pystencils::PackInfoPdfDoublePrecisionCUDA::pack(), walberla::pystencils::PackInfoPdfSinglePrecisionCUDA::pack(), walberla::pystencils::PackInfoVecDoublePrecisionCUDA::pack(), walberla::pystencils::PackInfoVecSinglePrecisionCUDA::pack(), Utils::pack(), walberla::pystencils::internal_pack_B::pack_B(), walberla::pystencils::internal_pack_B::pack_B(), walberla::pystencils::internal_pack_BE::pack_BE(), walberla::pystencils::internal_pack_BE::pack_BE(), fft::anonymous_namespace{fft.cpp}::pack_block_permute1(), fft::anonymous_namespace{fft.cpp}::pack_block_permute2(), walberla::pystencils::internal_pack_BN::pack_BN(), walberla::pystencils::internal_pack_BN::pack_BN(), walberla::pystencils::internal_pack_BS::pack_BS(), walberla::pystencils::internal_pack_BS::pack_BS(), walberla::pystencils::internal_pack_BW::pack_BW(), walberla::pystencils::internal_pack_BW::pack_BW(), walberla::pystencils::internal_pack_E::pack_E(), walberla::pystencils::internal_pack_E::pack_E(), walberla::pystencils::internal_pack_N::pack_N(), walberla::pystencils::internal_pack_N::pack_N(), walberla::pystencils::internal_pack_NE::pack_NE(), walberla::pystencils::internal_pack_NE::pack_NE(), walberla::pystencils::internal_pack_NW::pack_NW(), walberla::pystencils::internal_pack_NW::pack_NW(), pack_particles(), walberla::pystencils::internal_pack_S::pack_S(), walberla::pystencils::internal_pack_S::pack_S(), walberla::pystencils::internal_pack_SE::pack_SE(), walberla::pystencils::internal_pack_SE::pack_SE(), walberla::pystencils::internal_pack_SW::pack_SW(), walberla::pystencils::internal_pack_SW::pack_SW(), walberla::pystencils::internal_05a1eb9a7382e5e7047cdb22e28b6556::pack_SW_BW_W_TW_NW_BS_S_TS_B_C_T_BN_N_TN_SE_BE_E_TE_NE(), walberla::pystencils::internal_05a1eb9a7382e5e7047cdb22e28b6556::pack_SW_BW_W_TW_NW_BS_S_TS_B_C_T_BN_N_TN_SE_BE_E_TE_NE(), walberla::pystencils::internal_pack_T::pack_T(), walberla::pystencils::internal_pack_T::pack_T(), walberla::pystencils::internal_pack_TE::pack_TE(), walberla::pystencils::internal_pack_TE::pack_TE(), walberla::pystencils::internal_pack_TN::pack_TN(), walberla::pystencils::internal_pack_TN::pack_TN(), walberla::pystencils::internal_pack_TS::pack_TS(), walberla::pystencils::internal_pack_TS::pack_TS(), walberla::pystencils::internal_pack_TW::pack_TW(), walberla::pystencils::internal_pack_TW::pack_TW(), walberla::pystencils::internal_pack_W::pack_W(), walberla::pystencils::internal_pack_W::pack_W(), walberla::pystencils::PackInfoPdfDoublePrecision::packDataImpl(), walberla::pystencils::PackInfoPdfSinglePrecision::packDataImpl(), walberla::pystencils::PackInfoVecDoublePrecision::packDataImpl(), walberla::pystencils::PackInfoVecSinglePrecision::packDataImpl(), walberla::field::communication::BoundaryPackInfo< GhostLayerField_T, Boundary_T >::packDataImpl(), pad_with_zeros_discard_imag(), BondedInteractionsMap::pair_bond_exists_between(), pair_bond_exists_on(), BondedInteractionsMap::pair_bond_exists_on(), DebyeHueckel::pair_energy(), ReactionField::pair_energy(), Scafacos::Coulomb::pair_energy(), CoulombP3M::pair_energy(), CoulombScafacos::pair_energy(), CoulombMMM1D::pair_energy(), DipolarP3M::pair_energy(), ElectrostaticLayerCorrection::pair_energy_correction(), ElectrostaticLayerCorrection::pair_energy_correction(), Coulomb::Solver::pair_energy_kernel(), Dipoles::Solver::pair_energy_kernel(), DebyeHueckel::pair_force(), ReactionField::pair_force(), DipolarP3M::pair_force(), Scafacos::Coulomb::pair_force(), CoulombMMM1D::pair_force(), CoulombP3M::pair_force(), CoulombScafacos::pair_force(), pair_force(), Coulomb::Solver::pair_force_elc_kernel(), Coulomb::Solver::pair_force_kernel(), Dipoles::Solver::pair_force_kernel(), pair_potential(), Coulomb::Solver::pair_pressure_kernel(), ScriptInterface::ParallelExceptionHandler::parallel_try_catch(), ScriptInterface::GlobalContext::parallel_try_catch(), ScriptInterface::LocalContext::parallel_try_catch(), System::System::particle_bond_energy(), ScriptInterface::Particles::particle_checks(), ScriptInterface::Particles::particle_exclusion_sanity_checks(), particle_exists(), System::System::particle_short_range_energy_contribution(), LB::ParticleCoupling::ParticleCoupling(), ScriptInterface::Particles::ParticleHandle::ParticleHandle(), Cells::particles(), walberla::EKReactionImplBulk< Architecture >::perform_reaction(), walberla::EKReactionImplIndexed< Architecture >::perform_reaction(), EK::EKWalberla::perform_reactions(), FFTBuffersLegacy< FloatType >::perform_vector_halo_gather(), FFTBuffersLegacy< FloatType >::perform_vector_halo_spread(), BoxGeometry::periodic(), Algorithm::periodic_fold(), Utils::permute_ifield(), phi_objective(), Random::philox_4_uint64s(), philox_double2(), philox_float4(), CollisionDetection::place_vs_and_relate_to_particle(), walberla::lbm::DynamicUBBDoublePrecision::ForceVector::pointerCpu(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::ForceVector::pointerCpu(), walberla::lbm::DynamicUBBSinglePrecision::ForceVector::pointerCpu(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::ForceVector::pointerCpu(), walberla::pystencils::Dirichlet_double_precision::IndexVectors::pointerCpu(), walberla::pystencils::Dirichlet_double_precision_CUDA::IndexVectors::pointerCpu(), walberla::pystencils::Dirichlet_single_precision::IndexVectors::pointerCpu(), walberla::pystencils::Dirichlet_single_precision_CUDA::IndexVectors::pointerCpu(), walberla::pystencils::FixedFlux_double_precision::IndexVectors::pointerCpu(), walberla::pystencils::FixedFlux_double_precision_CUDA::IndexVectors::pointerCpu(), walberla::pystencils::FixedFlux_single_precision::IndexVectors::pointerCpu(), walberla::pystencils::FixedFlux_single_precision_CUDA::IndexVectors::pointerCpu(), walberla::pystencils::ReactionKernelIndexed_1_double_precision::IndexVectors::pointerCpu(), walberla::pystencils::ReactionKernelIndexed_1_double_precision_CUDA::IndexVectors::pointerCpu(), walberla::pystencils::ReactionKernelIndexed_1_single_precision::IndexVectors::pointerCpu(), walberla::pystencils::ReactionKernelIndexed_1_single_precision_CUDA::IndexVectors::pointerCpu(), walberla::pystencils::ReactionKernelIndexed_2_double_precision::IndexVectors::pointerCpu(), walberla::pystencils::ReactionKernelIndexed_2_double_precision_CUDA::IndexVectors::pointerCpu(), walberla::pystencils::ReactionKernelIndexed_2_single_precision::IndexVectors::pointerCpu(), walberla::pystencils::ReactionKernelIndexed_2_single_precision_CUDA::IndexVectors::pointerCpu(), walberla::pystencils::ReactionKernelIndexed_3_double_precision::IndexVectors::pointerCpu(), walberla::pystencils::ReactionKernelIndexed_3_double_precision_CUDA::IndexVectors::pointerCpu(), walberla::pystencils::ReactionKernelIndexed_3_single_precision::IndexVectors::pointerCpu(), walberla::pystencils::ReactionKernelIndexed_3_single_precision_CUDA::IndexVectors::pointerCpu(), walberla::pystencils::ReactionKernelIndexed_4_double_precision::IndexVectors::pointerCpu(), walberla::pystencils::ReactionKernelIndexed_4_double_precision_CUDA::IndexVectors::pointerCpu(), walberla::pystencils::ReactionKernelIndexed_4_single_precision::IndexVectors::pointerCpu(), walberla::pystencils::ReactionKernelIndexed_4_single_precision_CUDA::IndexVectors::pointerCpu(), walberla::pystencils::ReactionKernelIndexed_5_double_precision::IndexVectors::pointerCpu(), walberla::pystencils::ReactionKernelIndexed_5_double_precision_CUDA::IndexVectors::pointerCpu(), walberla::pystencils::ReactionKernelIndexed_5_single_precision::IndexVectors::pointerCpu(), walberla::pystencils::ReactionKernelIndexed_5_single_precision_CUDA::IndexVectors::pointerCpu(), walberla::lbm::DynamicUBBDoublePrecision::IndexVectors::pointerCpu(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::IndexVectors::pointerCpu(), walberla::lbm::DynamicUBBSinglePrecision::IndexVectors::pointerCpu(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::IndexVectors::pointerCpu(), walberla::PoissonSolverFFT< FloatType, Architecture >::PoissonSolverFFT(), PoQ_energy(), ParticlePropertyRange::pos_range(), positions_in_halo(), positions_in_halo_impl(), PQ_energy(), prefetch_particle_data(), CoulombP3MHeffte< FloatType, Architecture, FFTConfig >::prepare_fft_mesh(), prepare_recv_buffer(), prepare_sc_cache(), prepare_send_buffer(), CellStructure::prepare_verlet_list_cabana(), preparePolygammaEven(), preparePolygammaOdd(), BondBreakage::BondBreakage::process_queue(), ScriptInterface::Observables::ProfileObservable< CoreObs >::ProfileObservable(), Observables::ProfileObservable::ProfileObservable(), EK::EKWalberla::propagate(), propagate_omega_quat_particle(), propagate_therm0_nptiso(), propagate_vel_pos_sd(), propagation_bitmask_to_string(), propagation_flags_map(), ResourceCleanup::push(), Utils::Cache< Key, Value >::put(), Utils::Cache< Key, Value >::put(), put_recv_buffer(), Scafacos::Coulomb::r_cut(), ClusterAnalysis::Cluster::radius_of_gyration_subcluster(), random_position(), random_unit_vector(), Utils::raster(), Shapes::Shape::rasterize(), raw_data_pointer(), ScriptInterface::ReactionMethods::ReactionAlgorithm::ReactionAlgorithm(), walberla::pystencils::internal_a94c3c474646ee6905a4b90e8ccc47e6::reactionkernelbulk_1_double_precision_reactionkernelbulk_1_double_precision(), walberla::pystencils::internal_2510542a202e1c11a0d58a7e565459bb::reactionkernelbulk_1_single_precision_reactionkernelbulk_1_single_precision(), walberla::pystencils::internal_2cb10021ef8890fa965cb94996ae1510::reactionkernelbulk_2_double_precision_reactionkernelbulk_2_double_precision(), walberla::pystencils::internal_6de92b64acc501777cd14903620af26b::reactionkernelbulk_2_single_precision_reactionkernelbulk_2_single_precision(), walberla::pystencils::internal_d3ec035b42efecb474f5d17499de6537::reactionkernelbulk_3_double_precision_reactionkernelbulk_3_double_precision(), walberla::pystencils::internal_54fb5dcfe8687c5ab8c7b22acb6d285f::reactionkernelbulk_3_single_precision_reactionkernelbulk_3_single_precision(), walberla::pystencils::internal_49f1aaa6789b7fa16fb103a21ce6fe12::reactionkernelbulk_4_double_precision_reactionkernelbulk_4_double_precision(), walberla::pystencils::internal_716e8e56e191f2f523734cd5e32cecbb::reactionkernelbulk_4_single_precision_reactionkernelbulk_4_single_precision(), walberla::pystencils::internal_5119d69793e3096feaaca816d627c080::reactionkernelbulk_5_double_precision_reactionkernelbulk_5_double_precision(), walberla::pystencils::internal_737d6904f7c65dcfc320d619f189641b::reactionkernelbulk_5_single_precision_reactionkernelbulk_5_single_precision(), walberla::pystencils::ReactionKernelIndexed_1_double_precision::ReactionKernelIndexed_1_double_precision(), walberla::pystencils::internal_8dfd6fd44211225f575bfd4fd9f8b4cc::reactionkernelindexed_1_double_precision_boundary_ReactionKernelIndexed_1_double_precision(), walberla::pystencils::ReactionKernelIndexed_1_double_precision_CUDA::ReactionKernelIndexed_1_double_precision_CUDA(), walberla::pystencils::ReactionKernelIndexed_1_single_precision::ReactionKernelIndexed_1_single_precision(), walberla::pystencils::internal_6780d252234f1c174ca455eaed762815::reactionkernelindexed_1_single_precision_boundary_ReactionKernelIndexed_1_single_precision(), walberla::pystencils::ReactionKernelIndexed_1_single_precision_CUDA::ReactionKernelIndexed_1_single_precision_CUDA(), walberla::pystencils::ReactionKernelIndexed_2_double_precision::ReactionKernelIndexed_2_double_precision(), walberla::pystencils::internal_1955c52e82759b23ee69574de97d7a03::reactionkernelindexed_2_double_precision_boundary_ReactionKernelIndexed_2_double_precision(), walberla::pystencils::ReactionKernelIndexed_2_double_precision_CUDA::ReactionKernelIndexed_2_double_precision_CUDA(), walberla::pystencils::ReactionKernelIndexed_2_single_precision::ReactionKernelIndexed_2_single_precision(), walberla::pystencils::internal_65f3f69877a34020919311605a374bf2::reactionkernelindexed_2_single_precision_boundary_ReactionKernelIndexed_2_single_precision(), walberla::pystencils::ReactionKernelIndexed_2_single_precision_CUDA::ReactionKernelIndexed_2_single_precision_CUDA(), walberla::pystencils::ReactionKernelIndexed_3_double_precision::ReactionKernelIndexed_3_double_precision(), walberla::pystencils::internal_8edace03832e2e7c5856c1019b5b9697::reactionkernelindexed_3_double_precision_boundary_ReactionKernelIndexed_3_double_precision(), walberla::pystencils::ReactionKernelIndexed_3_double_precision_CUDA::ReactionKernelIndexed_3_double_precision_CUDA(), walberla::pystencils::ReactionKernelIndexed_3_single_precision::ReactionKernelIndexed_3_single_precision(), walberla::pystencils::internal_a841832271ac54f2c38b03966a739283::reactionkernelindexed_3_single_precision_boundary_ReactionKernelIndexed_3_single_precision(), walberla::pystencils::ReactionKernelIndexed_3_single_precision_CUDA::ReactionKernelIndexed_3_single_precision_CUDA(), walberla::pystencils::ReactionKernelIndexed_4_double_precision::ReactionKernelIndexed_4_double_precision(), walberla::pystencils::internal_7ded543b40ca402e5e3102728843f000::reactionkernelindexed_4_double_precision_boundary_ReactionKernelIndexed_4_double_precision(), walberla::pystencils::ReactionKernelIndexed_4_double_precision_CUDA::ReactionKernelIndexed_4_double_precision_CUDA(), walberla::pystencils::ReactionKernelIndexed_4_single_precision::ReactionKernelIndexed_4_single_precision(), walberla::pystencils::internal_62195c7636fc531694c87493561447d7::reactionkernelindexed_4_single_precision_boundary_ReactionKernelIndexed_4_single_precision(), walberla::pystencils::ReactionKernelIndexed_4_single_precision_CUDA::ReactionKernelIndexed_4_single_precision_CUDA(), walberla::pystencils::ReactionKernelIndexed_5_double_precision::ReactionKernelIndexed_5_double_precision(), walberla::pystencils::internal_714956d26e6eb81c5dec60e7ab7da8ab::reactionkernelindexed_5_double_precision_boundary_ReactionKernelIndexed_5_double_precision(), walberla::pystencils::ReactionKernelIndexed_5_double_precision_CUDA::ReactionKernelIndexed_5_double_precision_CUDA(), walberla::pystencils::ReactionKernelIndexed_5_single_precision::ReactionKernelIndexed_5_single_precision(), walberla::pystencils::internal_c656da8359b8f47f0007107280d91a58::reactionkernelindexed_5_single_precision_boundary_ReactionKernelIndexed_5_single_precision(), walberla::pystencils::ReactionKernelIndexed_5_single_precision_CUDA::ReactionKernelIndexed_5_single_precision_CUDA(), boost::qvm::vec_traits<::Utils::Vector< T, N > >::read_element(), boost::qvm::mat_traits< Utils::Matrix< T, Rows, Cols > >::read_element(), boost::qvm::quat_traits< Utils::Quaternion< T > >::read_element(), boost::qvm::quat_traits< Utils::Quaternion< T > >::read_element_idx(), boost::qvm::mat_traits< Utils::Matrix< T, Rows, Cols > >::read_element_idx(), Mpiio::read_head(), Mpiio::read_prefs(), GpuParticleData::Storage::realloc_device_memory(), CustomVerletList< MemorySpace, AlgorithmTag, LayoutTag, BuildTag >::reallocData(), System::System::rebuild_aosoa(), CellStructure::rebuild_local_properties(), rebuild_needed(), CellStructure::rebuild_verlet_list_cabana(), P3MParameters::recalc_a_ai_cao_cut(), DipolarLayerCorrection::recalc_box_h(), P3MLocalMesh::recalc_ld_pos(), recalc_maximal_cutoff(), IsotropicNptThermostat::recalc_prefactors(), ThermalizedBondThermostat::recalc_prefactors(), walberla::lbm::accessor::PressureTensor::reduce(), walberla::lbm::accessor::MomentumDensity::reduce(), walberla::lbm::accessor::PressureTensor::reduce(), walberla::lbm::accessor::MomentumDensity::reduce(), Utils::Mpi::reduce_optional(), reduce_over_local_particles(), register_integrator(), register_integrator(), Utils::Factory< T >::register_new(), ImmersedBoundaries::register_softID(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::register_vtk_field_filters(), walberla::LBWalberlaImpl< FloatType, Architecture >::register_vtk_field_filters(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::register_vtk_field_writers(), walberla::PoissonSolverFFT< FloatType, Architecture >::register_vtk_field_writers(), walberla::LBWalberlaImpl< FloatType, Architecture >::register_vtk_field_writers(), Communication::RegisterCallback::RegisterCallback(), RegularDecomposition::RegularDecomposition(), ScriptInterface::Thermostat::Interface< CoreClass >::release_lock(), Utils::NumeratedContainer< T, index_type >::remove(), Constraints::Constraints::remove(), EK::EKReactions< EKReaction >::remove(), EKContainer< EKSpecies >::remove(), ScriptInterface::ObjectList< ManagedType, BaseType >::remove(), BondBreakage::remove_bond(), remove_id_from_map(), ScriptInterface::Accumulators::AutoUpdateAccumulators::remove_in_core(), ScriptInterface::Constraints::Constraints::remove_in_core(), ScriptInterface::Shapes::Union::remove_in_core(), ScriptInterface::walberla::EKContainer::remove_in_core(), ScriptInterface::walberla::EKReactions::remove_in_core(), walberla::BoundaryHandling< FloatType, ValueType, BoundaryClass >::remove_node_from_boundary(), walberla::LBWalberlaImpl< FloatType, Architecture >::remove_node_from_boundary(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::remove_node_from_density_boundary(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::remove_node_from_flux_boundary(), BondBreakage::remove_pair_bonds_to(), CellStructure::remove_particle(), remove_particle(), CoulombP3MHeffte< FloatType, Architecture, FFTConfig >::request_gpu(), Utils::Bag< T >::reserve(), p3m_interpolation_cache::reset(), walberla::PoissonSolverFFT< FloatType, Architecture >::reset_charge_field(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::reset_density_boundary_handling(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::reset_flux_boundary_handling(), CellStructure::reset_local_force(), CellStructure::reset_local_properties(), TuningAlgorithm::reset_n_trials(), p3m_send_mesh< FloatType >::resize(), CellStructure::AoSoA_pack::resize(), resize_or_replace(), CellStructure::resolve_bond_partners(), HybridDecomposition::resort(), RegularDecomposition::resort(), AtomDecomposition::resort(), CellStructure::resort_particles(), resort_particles_if_needed(), ScriptInterface::ObjectMap< ManagedType, BaseType, KeyType >::restore_from_checkpoint(), ReactionMethods::ReactionAlgorithm::restore_old_system_state(), ScriptInterface::System::rotate_system(), anonymous_namespace{ibm_triel.cpp}::RotateForces(), Utils::rotation_matrix(), rotational_kinetic_energy(), Utils::Matrix< T, Rows, Cols >::row(), walberla::pystencils::AdvectiveFluxKernel_double_precision::run(), walberla::pystencils::AdvectiveFluxKernel_single_precision::run(), walberla::pystencils::ContinuityKernel_double_precision::run(), walberla::pystencils::ContinuityKernel_single_precision::run(), walberla::pystencils::DiffusiveFluxKernel_double_precision::run(), walberla::pystencils::DiffusiveFluxKernel_single_precision::run(), walberla::pystencils::DiffusiveFluxKernelThermalized_double_precision::run(), walberla::pystencils::DiffusiveFluxKernelThermalized_single_precision::run(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_double_precision::run(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_single_precision::run(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_double_precision::run(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_single_precision::run(), walberla::pystencils::FrictionCouplingKernel_double_precision::run(), walberla::pystencils::FrictionCouplingKernel_single_precision::run(), walberla::pystencils::ReactionKernelBulk_1_double_precision::run(), walberla::pystencils::ReactionKernelBulk_1_single_precision::run(), walberla::pystencils::ReactionKernelBulk_2_double_precision::run(), walberla::pystencils::ReactionKernelBulk_2_single_precision::run(), walberla::pystencils::ReactionKernelBulk_3_double_precision::run(), walberla::pystencils::ReactionKernelBulk_3_single_precision::run(), walberla::pystencils::ReactionKernelBulk_4_double_precision::run(), walberla::pystencils::ReactionKernelBulk_4_single_precision::run(), walberla::pystencils::ReactionKernelBulk_5_double_precision::run(), walberla::pystencils::ReactionKernelBulk_5_single_precision::run(), walberla::pystencils::InitialPDFsSetterDoublePrecision::run(), walberla::pystencils::InitialPDFsSetterSinglePrecision::run(), walberla::pystencils::StreamCollideSweepLeesEdwardsDoublePrecision::run(), walberla::pystencils::StreamCollideSweepLeesEdwardsDoublePrecisionAVX::run(), walberla::pystencils::StreamCollideSweepLeesEdwardsSinglePrecision::run(), walberla::pystencils::StreamCollideSweepLeesEdwardsSinglePrecisionAVX::run(), walberla::pystencils::StreamCollideSweepThermalizedDoublePrecision::run(), walberla::pystencils::StreamCollideSweepThermalizedDoublePrecisionAVX::run(), walberla::pystencils::StreamCollideSweepThermalizedSinglePrecision::run(), walberla::pystencils::StreamCollideSweepThermalizedSinglePrecisionAVX::run(), walberla::pystencils::UpdateVelFromPDFDoublePrecision::run(), walberla::pystencils::UpdateVelFromPDFDoublePrecisionAVX::run(), walberla::pystencils::UpdateVelFromPDFSinglePrecision::run(), walberla::pystencils::UpdateVelFromPDFSinglePrecisionAVX::run(), walberla::pystencils::AdvectiveFluxKernel_double_precision_CUDA::run(), walberla::pystencils::AdvectiveFluxKernel_single_precision_CUDA::run(), walberla::pystencils::ContinuityKernel_double_precision_CUDA::run(), walberla::pystencils::ContinuityKernel_single_precision_CUDA::run(), walberla::pystencils::DiffusiveFluxKernel_double_precision_CUDA::run(), walberla::pystencils::DiffusiveFluxKernel_single_precision_CUDA::run(), walberla::pystencils::DiffusiveFluxKernelThermalized_double_precision_CUDA::run(), walberla::pystencils::DiffusiveFluxKernelThermalized_single_precision_CUDA::run(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_double_precision_CUDA::run(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_single_precision_CUDA::run(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_double_precision_CUDA::run(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_single_precision_CUDA::run(), walberla::pystencils::Dirichlet_double_precision_CUDA::run(), walberla::pystencils::Dirichlet_single_precision_CUDA::run(), walberla::pystencils::FixedFlux_double_precision_CUDA::run(), walberla::pystencils::FixedFlux_single_precision_CUDA::run(), walberla::pystencils::FrictionCouplingKernel_double_precision_CUDA::run(), walberla::pystencils::FrictionCouplingKernel_single_precision_CUDA::run(), walberla::pystencils::ReactionKernelBulk_1_double_precision_CUDA::run(), walberla::pystencils::ReactionKernelBulk_1_single_precision_CUDA::run(), walberla::pystencils::ReactionKernelBulk_2_double_precision_CUDA::run(), walberla::pystencils::ReactionKernelBulk_2_single_precision_CUDA::run(), walberla::pystencils::ReactionKernelBulk_3_double_precision_CUDA::run(), walberla::pystencils::ReactionKernelBulk_3_single_precision_CUDA::run(), walberla::pystencils::ReactionKernelBulk_4_double_precision_CUDA::run(), walberla::pystencils::ReactionKernelBulk_4_single_precision_CUDA::run(), walberla::pystencils::ReactionKernelBulk_5_double_precision_CUDA::run(), walberla::pystencils::ReactionKernelBulk_5_single_precision_CUDA::run(), walberla::pystencils::ReactionKernelIndexed_1_double_precision_CUDA::run(), walberla::pystencils::ReactionKernelIndexed_1_single_precision_CUDA::run(), walberla::pystencils::ReactionKernelIndexed_2_double_precision_CUDA::run(), walberla::pystencils::ReactionKernelIndexed_2_single_precision_CUDA::run(), walberla::pystencils::ReactionKernelIndexed_3_double_precision_CUDA::run(), walberla::pystencils::ReactionKernelIndexed_3_single_precision_CUDA::run(), walberla::pystencils::ReactionKernelIndexed_4_double_precision_CUDA::run(), walberla::pystencils::ReactionKernelIndexed_4_single_precision_CUDA::run(), walberla::pystencils::ReactionKernelIndexed_5_double_precision_CUDA::run(), walberla::pystencils::ReactionKernelIndexed_5_single_precision_CUDA::run(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::run(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::run(), walberla::pystencils::InitialPDFsSetterDoublePrecisionCUDA::run(), walberla::pystencils::InitialPDFsSetterSinglePrecisionCUDA::run(), walberla::pystencils::StreamCollideSweepLeesEdwardsDoublePrecisionCUDA::run(), walberla::pystencils::StreamCollideSweepLeesEdwardsSinglePrecisionCUDA::run(), walberla::pystencils::StreamCollideSweepThermalizedDoublePrecisionCUDA::run(), walberla::pystencils::StreamCollideSweepThermalizedSinglePrecisionCUDA::run(), walberla::pystencils::UpdateVelFromPDFDoublePrecisionCUDA::run(), walberla::pystencils::UpdateVelFromPDFSinglePrecisionCUDA::run(), Scafacos::Coulomb::run(), ClusterAnalysis::ClusterStructure::run_for_all_pairs(), ClusterAnalysis::ClusterStructure::run_for_bonded_particles(), run_full_force_calc(), run_magnetodynamics(), CellStructure::run_on_particle_short_range_neighbors(), walberla::pystencils::AdvectiveFluxKernel_double_precision::runOnCellInterval(), walberla::pystencils::AdvectiveFluxKernel_single_precision::runOnCellInterval(), walberla::pystencils::ContinuityKernel_double_precision::runOnCellInterval(), walberla::pystencils::ContinuityKernel_single_precision::runOnCellInterval(), walberla::pystencils::DiffusiveFluxKernel_double_precision::runOnCellInterval(), walberla::pystencils::DiffusiveFluxKernel_single_precision::runOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelThermalized_double_precision::runOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelThermalized_single_precision::runOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_double_precision::runOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_single_precision::runOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_double_precision::runOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_single_precision::runOnCellInterval(), walberla::pystencils::FrictionCouplingKernel_double_precision::runOnCellInterval(), walberla::pystencils::FrictionCouplingKernel_single_precision::runOnCellInterval(), walberla::pystencils::ReactionKernelBulk_1_double_precision::runOnCellInterval(), walberla::pystencils::ReactionKernelBulk_1_single_precision::runOnCellInterval(), walberla::pystencils::ReactionKernelBulk_2_double_precision::runOnCellInterval(), walberla::pystencils::ReactionKernelBulk_2_single_precision::runOnCellInterval(), walberla::pystencils::ReactionKernelBulk_3_double_precision::runOnCellInterval(), walberla::pystencils::ReactionKernelBulk_3_single_precision::runOnCellInterval(), walberla::pystencils::ReactionKernelBulk_4_double_precision::runOnCellInterval(), walberla::pystencils::ReactionKernelBulk_4_single_precision::runOnCellInterval(), walberla::pystencils::ReactionKernelBulk_5_double_precision::runOnCellInterval(), walberla::pystencils::ReactionKernelBulk_5_single_precision::runOnCellInterval(), walberla::pystencils::InitialPDFsSetterDoublePrecision::runOnCellInterval(), walberla::pystencils::InitialPDFsSetterSinglePrecision::runOnCellInterval(), walberla::pystencils::StreamCollideSweepLeesEdwardsDoublePrecision::runOnCellInterval(), walberla::pystencils::StreamCollideSweepLeesEdwardsDoublePrecisionAVX::runOnCellInterval(), walberla::pystencils::StreamCollideSweepLeesEdwardsSinglePrecision::runOnCellInterval(), walberla::pystencils::StreamCollideSweepLeesEdwardsSinglePrecisionAVX::runOnCellInterval(), walberla::pystencils::StreamCollideSweepThermalizedDoublePrecision::runOnCellInterval(), walberla::pystencils::StreamCollideSweepThermalizedDoublePrecisionAVX::runOnCellInterval(), walberla::pystencils::StreamCollideSweepThermalizedSinglePrecision::runOnCellInterval(), walberla::pystencils::StreamCollideSweepThermalizedSinglePrecisionAVX::runOnCellInterval(), walberla::pystencils::UpdateVelFromPDFDoublePrecision::runOnCellInterval(), walberla::pystencils::UpdateVelFromPDFDoublePrecisionAVX::runOnCellInterval(), walberla::pystencils::UpdateVelFromPDFSinglePrecision::runOnCellInterval(), walberla::pystencils::UpdateVelFromPDFSinglePrecisionAVX::runOnCellInterval(), walberla::pystencils::AdvectiveFluxKernel_double_precision_CUDA::runOnCellInterval(), walberla::pystencils::AdvectiveFluxKernel_single_precision_CUDA::runOnCellInterval(), walberla::pystencils::ContinuityKernel_double_precision_CUDA::runOnCellInterval(), walberla::pystencils::ContinuityKernel_single_precision_CUDA::runOnCellInterval(), walberla::pystencils::DiffusiveFluxKernel_double_precision_CUDA::runOnCellInterval(), walberla::pystencils::DiffusiveFluxKernel_single_precision_CUDA::runOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelThermalized_double_precision_CUDA::runOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelThermalized_single_precision_CUDA::runOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_double_precision_CUDA::runOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_single_precision_CUDA::runOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_double_precision_CUDA::runOnCellInterval(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_single_precision_CUDA::runOnCellInterval(), walberla::pystencils::FrictionCouplingKernel_double_precision_CUDA::runOnCellInterval(), walberla::pystencils::FrictionCouplingKernel_single_precision_CUDA::runOnCellInterval(), walberla::pystencils::ReactionKernelBulk_1_double_precision_CUDA::runOnCellInterval(), walberla::pystencils::ReactionKernelBulk_1_single_precision_CUDA::runOnCellInterval(), walberla::pystencils::ReactionKernelBulk_2_double_precision_CUDA::runOnCellInterval(), walberla::pystencils::ReactionKernelBulk_2_single_precision_CUDA::runOnCellInterval(), walberla::pystencils::ReactionKernelBulk_3_double_precision_CUDA::runOnCellInterval(), walberla::pystencils::ReactionKernelBulk_3_single_precision_CUDA::runOnCellInterval(), walberla::pystencils::ReactionKernelBulk_4_double_precision_CUDA::runOnCellInterval(), walberla::pystencils::ReactionKernelBulk_4_single_precision_CUDA::runOnCellInterval(), walberla::pystencils::ReactionKernelBulk_5_double_precision_CUDA::runOnCellInterval(), walberla::pystencils::ReactionKernelBulk_5_single_precision_CUDA::runOnCellInterval(), walberla::pystencils::InitialPDFsSetterDoublePrecisionCUDA::runOnCellInterval(), walberla::pystencils::InitialPDFsSetterSinglePrecisionCUDA::runOnCellInterval(), walberla::pystencils::StreamCollideSweepLeesEdwardsDoublePrecisionCUDA::runOnCellInterval(), walberla::pystencils::StreamCollideSweepLeesEdwardsSinglePrecisionCUDA::runOnCellInterval(), walberla::pystencils::StreamCollideSweepThermalizedDoublePrecisionCUDA::runOnCellInterval(), walberla::pystencils::StreamCollideSweepThermalizedSinglePrecisionCUDA::runOnCellInterval(), walberla::pystencils::UpdateVelFromPDFDoublePrecisionCUDA::runOnCellInterval(), walberla::pystencils::UpdateVelFromPDFSinglePrecisionCUDA::runOnCellInterval(), ErrorHandling::RuntimeErrorStream::RuntimeErrorStream(), ScafacosContextBase::sanity_check_method(), EK::Solver::sanity_checks(), icc_data::sanity_checks(), LB::Solver::sanity_checks(), EK::EKWalberla::sanity_checks(), LB::LBWalberla::sanity_checks(), ICCStar::sanity_checks_active_solver(), CoulombP3M::sanity_checks_boxl(), DipolarP3M::sanity_checks_boxl(), CoulombP3M::sanity_checks_cell_structure(), DipolarP3M::sanity_checks_cell_structure(), DipolarP3M::sanity_checks_node_grid(), CoulombP3M::sanity_checks_periodicity(), DipolarP3M::sanity_checks_periodicity(), ScriptInterface::Thermostat::Interface< CoreClass >::sanity_checks_positive(), ScriptInterface::Particles::sanity_checks_rotation(), boost::serialization::save(), boost::serialization::save(), boost::serialization::save(), boost::serialization::save(), boost::serialization::save(), boost::serialization::save(), Utils::compact_vector< T >::save(), ScriptInterface::walberla::save_checkpoint_common(), save_old_position(), Scafacos::Scafacos::Scafacos(), scale_vec(), ScriptInterface::walberla::LatticeSlice< FieldSerializer >::scatter_3d(), Utils::Mpi::scatter_buffer(), sd_update_locally(), Utils::Mpi::sendrecv(), ScriptInterface::ObjectHandle::serialize(), boost::serialization::serialize(), PosMom::serialize(), ParticleParametersSwimming::serialize(), ThermalStonerWohlfarthParameters::serialize(), ParticleProperties::VirtualSitesRelativeParameters::serialize(), ParticleProperties::VirtualSitesCenterOfMassParameters::serialize(), ParticleProperties::serialize(), ParticlePosition::serialize(), ParticleForce::serialize(), ParticleMomentum::serialize(), ParticleLocal::serialize(), ParticleRattle::serialize(), SD_particle_data::serialize(), ScriptInterface::ObjectState::serialize(), boost::serialization::serialize(), boost::serialization::serialize(), boost::serialization::serialize(), boost::serialization::serialize(), boost::serialization::serialize(), boost::serialization::serialize(), boost::serialization::serialize(), boost::serialization::serialize(), Utils::compact_vector< T >::serialize(), ComInfo::serialize(), BondBreakage::QueueEntry::serialize(), ScriptInterface::ContextManager::serialize(), ScriptInterface::walberla::EKFieldSerializer::serialize(), ScriptInterface::walberla::LBFieldSerializer::serialize(), serialize_and_reduce(), ScriptInterface::AutoParameters< Derived, Base >::serialize_parameters(), ScriptInterface::Scafacos::serialize_parameters(), walberla::ek::accessor::Scalar::set(), walberla::ek::accessor::Scalar::set(), walberla::ek::accessor::Scalar::set(), walberla::ek::accessor::Scalar::set(), walberla::ek::accessor::Scalar::set(), walberla::ek::accessor::Scalar::set(), walberla::ek::accessor::Vector::set(), walberla::lbm::accessor::Vector::set(), walberla::lbm::accessor::Density::set(), walberla::lbm::accessor::Population::set(), walberla::lbm::accessor::Population::set(), walberla::lbm::accessor::Velocity::set(), walberla::lbm::accessor::Velocity::set(), walberla::lbm::accessor::Population::set(), walberla::lbm::accessor::Population::set(), walberla::lbm::accessor::Density::set(), walberla::ek::accessor::Vector::set(), walberla::lbm::accessor::Vector::set(), walberla::lbm::accessor::Force::set(), walberla::lbm::accessor::Force::set(), walberla::ek::accessor::Scalar::set(), walberla::ek::accessor::Scalar::set(), walberla::ek::accessor::Vector::set(), walberla::lbm::accessor::Vector::set(), walberla::lbm::accessor::Density::set(), walberla::lbm::accessor::Population::set(), walberla::lbm::accessor::Population::set(), walberla::lbm::accessor::Velocity::set(), walberla::lbm::accessor::Velocity::set(), walberla::lbm::accessor::Population::set(), walberla::lbm::accessor::Population::set(), walberla::lbm::accessor::Density::set(), walberla::ek::accessor::Vector::set(), walberla::lbm::accessor::Vector::set(), walberla::lbm::accessor::Force::set(), walberla::lbm::accessor::Force::set(), EK::Solver::set(), EK::Solver::set(), LB::Solver::set(), LB::Solver::set(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::set_advection(), CellStructure::set_atom_decomposition(), ScriptInterface::System::set_bonds(), walberla::set_boundary_from_grid(), System::System::set_box_l(), Particle::set_can_rotate_all_axes(), Particle::set_can_rotate_around(), Particle::set_cannot_rotate_all_axes(), System::System::set_cell_structure_topology(), ScriptInterface::Coulomb::Actor< SIClass, CoreClass >::set_charge_neutrality_tolerance(), walberla::EKReactionBase::set_coefficient(), walberla::LBWalberlaImpl< FloatType, Architecture >::set_collision_model(), walberla::LBWalberlaImpl< FloatType, Architecture >::set_collision_model(), ScriptInterface::Context::set_context(), Accumulators::Correlator::set_correlation_args(), ReactionMethods::ReactionAlgorithm::set_cyl_constraint(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::set_diffusion(), ReactionMethods::ReactionAlgorithm::set_exclusion_radius_per_type(), walberla::ResetForce< PdfField, ForceField >::set_ext_force(), Particle::set_fixed_along(), ComFixed::set_fixed_types(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::set_friction_coupling(), ScriptInterface::set_from_args(), walberla::lbm::accessor::Vector::set_from_list(), walberla::lbm::accessor::Vector::set_from_list(), Particle::set_ghost(), CellStructure::AoSoA_pack::set_has_exclusion(), CellStructure::set_hybrid_decomposition(), InteractionsNonBonded::set_ia_param(), CellStructure::set_index_map(), Accumulators::ContactTimes::set_internal_state(), Accumulators::Correlator::set_internal_state(), Accumulators::MeanVarianceCalculator::set_internal_state(), Accumulators::TimeSeries::set_internal_state(), ScriptInterface::Accumulators::AccumulatorBase::set_internal_state(), ScriptInterface::Interactions::NonBondedInteractions::set_internal_state(), ScriptInterface::System::System::set_internal_state(), CellStructure::set_kokkos_handle(), BoxGeometry::set_lees_edwards_bc(), BoxGeometry::set_length(), Scafacos::Coulomb::set_near_field_delegation(), CoulombScafacosImpl::set_near_field_delegation(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::set_node_density(), walberla::LBWalberlaImpl< FloatType, Architecture >::set_node_density(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::set_node_density_boundary(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::set_node_flux_boundary(), walberla::EKReactionImplIndexed< Architecture >::set_node_is_boundary(), walberla::LBWalberlaImpl< FloatType, Architecture >::set_node_last_applied_force(), walberla::LBWalberlaImpl< FloatType, Architecture >::set_node_population(), walberla::BoundaryHandling< FloatType, ValueType, BoundaryClass >::set_node_value_at_boundary(), walberla::LBWalberlaImpl< FloatType, Architecture >::set_node_velocity(), walberla::LBWalberlaImpl< FloatType, Architecture >::set_node_velocity_at_boundary(), walberla::EKReactant::set_order(), ScriptInterface::ObjectHandle::set_parameter(), ScriptInterface::ClusterAnalysis::Cluster::set_particle_list(), set_particle_pos(), ScriptInterface::Particles::set_particles_bonds(), ScriptInterface::Particles::set_particles_charges(), ScriptInterface::Particles::set_particles_exclusions(), ScriptInterface::Particles::set_particles_positions(), ScriptInterface::Particles::set_particles_types(), BoxGeometry::set_periodic(), walberla::PoissonSolver::set_permittivity(), ScriptInterface::Particles::ParticleModifier::set_pid(), EKContainer< EKSpecies >::set_poisson_solver(), Coulomb::Actor< Class >::set_prefactor(), Dipoles::Actor< Class >::set_prefactor(), LeesEdwards::LeesEdwards::set_protocol(), Scafacos::Coulomb::set_r_cut(), CellStructure::set_regular_decomposition(), CellStructure::set_resort_particles(), BaseThermostat::set_rng_counter(), ScriptInterface::Thermostat::Interface< CoreClass >::set_rng_counter(), ScriptInterface::Thermostat::Interface< CoreClass >::set_rng_seed(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::set_rng_state(), walberla::LBWalberlaImpl< FloatType, Architecture >::set_rng_state(), Scafacos::Coulomb::set_runtime_parameters(), Scafacos::Scafacos::set_runtime_parameters(), ReactionMethods::ReactionAlgorithm::set_slab_constraint(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::set_slice_density(), walberla::LBWalberlaImpl< FloatType, Architecture >::set_slice_density(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::set_slice_density_boundary(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::set_slice_flux_boundary(), walberla::LBWalberlaImpl< FloatType, Architecture >::set_slice_last_applied_force(), walberla::LBWalberlaImpl< FloatType, Architecture >::set_slice_population(), walberla::LBWalberlaImpl< FloatType, Architecture >::set_slice_velocity(), walberla::LBWalberlaImpl< FloatType, Architecture >::set_slice_velocity_at_boundary(), walberla::EKReactant::set_species(), walberla::EKReactant::set_stoech_coefficient(), System::set_system(), cuda_fatal_error::set_terminate(), Shapes::Torus::set_tube_radius(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::set_valency(), CellStructure::AoSoA_pack::set_vector_at(), CellStructure::set_verlet_skin(), CellStructure::set_verlet_skin_heuristic(), ReactionMethods::ReactionAlgorithm::set_volume(), IBMVolCons::set_volumes_view(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_double_precision::setPhiID(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_double_precision_CUDA::setPhiID(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_single_precision::setPhiID(), walberla::pystencils::DiffusiveFluxKernelWithElectrostatic_single_precision_CUDA::setPhiID(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_double_precision::setPhiID(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_double_precision_CUDA::setPhiID(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_single_precision::setPhiID(), walberla::pystencils::DiffusiveFluxKernelWithElectrostaticThermalized_single_precision_CUDA::setPhiID(), ReactionMethods::ReactionAlgorithm::setup_bookkeeping_of_empty_pids(), walberla::PoissonSolverFFT< FloatType, Architecture >::setup_fft(), CoulombTuningAlgorithm< FloatType, Architecture, FFTConfig >::setup_logger(), DipolarTuningAlgorithm< FloatType, Architecture, FFTConfig >::setup_logger(), setup_PoQ(), setup_PQ(), walberla::LBWalberlaImpl< FloatType, Architecture >::setup_streaming_communicator(), ScriptInterface::Thermostat::Thermostat::setup_thermostat(), Utils::sgn(), Utils::Matrix< T, Rows, Cols >::shape(), Accumulators::TimeSeries::shape(), Observables::BondAngles::shape(), Observables::BondDihedrals::shape(), Observables::CosPersistenceAngles::shape(), Observables::ParticleDistances::shape(), Observables::ParticleObservable< ObsType >::shape(), ScriptInterface::Constraints::ShapeBasedConstraint::ShapeBasedConstraint(), LB::CouplingBookkeeping::should_be_coupled(), Propagation::should_propagate_with(), BrownianThermostat::sigma(), IsotropicNptThermostat::sigma(), LangevinThermostat::sigma(), BrownianThermostat::sigma(), SignalHandler::SignalHandler(), math::sinc(), ParticleRange::size(), Utils::Array< T, N >::size(), Utils::Vector< int, dim >::size(), walberla::pystencils::PackInfoPdfDoublePrecision::size(), walberla::pystencils::PackInfoPdfSinglePrecision::size(), walberla::pystencils::PackInfoVecDoublePrecision::size(), walberla::pystencils::PackInfoVecSinglePrecision::size(), walberla::pystencils::PackInfoPdfDoublePrecisionCUDA::size(), walberla::pystencils::PackInfoPdfSinglePrecisionCUDA::size(), walberla::pystencils::PackInfoVecDoublePrecisionCUDA::size(), walberla::pystencils::PackInfoVecSinglePrecisionCUDA::size(), SmSt_pair_energy(), SmSt_pair_force_factor(), soft_pair_energy(), soft_pair_force_factor(), walberla::PoissonSolverFFT< FloatType, Architecture >::solve(), ClusterAnalysis::sort_indices(), Writer::H5md::Specification::Specification(), split_kernel_dip(), split_kernel_q(), split_kernel_r(), split_kernel_rq(), GpuParticleData::Storage::split_particle_struct(), p3m_send_mesh< FloatType >::spread_grid(), Utils::sqrt(), Utils::Accumulator::std_error(), steepest_descent_step(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::stencil_size(), stokesian_dynamics_step_1(), StokesianDynamicsParameters::StokesianDynamicsParameters(), StokesianThermostat::StokesianThermostat(), stoner_wohlfarth_main(), stoner_wohlfarth_no_field(), p3m_interpolation_cache::store(), p3m_interpolation_cache::store_at(), walberla::pystencils::internal_1215ae06312aaf63d726636be94fdda3::streamcollidesweepleesedwardsdoubleprecision_streamcollidesweepleesedwardsdoubleprecision(), walberla::pystencils::internal_08be08b6e7ea45132a735524ef494de6::streamcollidesweepleesedwardsdoubleprecisionavx_streamcollidesweepleesedwardsdoubleprecisionavx(), walberla::pystencils::internal_a263151a09bd9903959d48e17aef88f9::streamcollidesweepleesedwardssingleprecision_streamcollidesweepleesedwardssingleprecision(), walberla::pystencils::internal_c275fa5bef4a1b9f30058dc82d50d3cf::streamcollidesweepleesedwardssingleprecisionavx_streamcollidesweepleesedwardssingleprecisionavx(), walberla::pystencils::internal_fa53b6994358d65dbc792fd71884c2e7::streamcollidesweepthermalizeddoubleprecision_streamcollidesweepthermalizeddoubleprecision(), walberla::pystencils::internal_b312c2da0affb0ff73dd81300a784e62::streamcollidesweepthermalizeddoubleprecisionavx_streamcollidesweepthermalizeddoubleprecisionavx(), walberla::pystencils::internal_117eb60e8d249794b47e39bf52c9e4fe::streamcollidesweepthermalizedsingleprecision_streamcollidesweepthermalizedsingleprecision(), walberla::pystencils::internal_482af0085ade5d86c474548ac4b32084::streamcollidesweepthermalizedsingleprecisionavx_streamcollidesweepthermalizedsingleprecisionavx(), ScriptInterface::Scafacos::string_to_number(), structure_factor(), Utils::Vector< T, N >::swap(), LatticeModel::switch_vtk(), symplectic_euler_propagator_1(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::ForceVector::syncCPU(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::ForceVector::syncCPU(), walberla::pystencils::Dirichlet_double_precision_CUDA::IndexVectors::syncGPU(), walberla::pystencils::Dirichlet_single_precision_CUDA::IndexVectors::syncGPU(), walberla::pystencils::FixedFlux_double_precision_CUDA::IndexVectors::syncGPU(), walberla::pystencils::FixedFlux_single_precision_CUDA::IndexVectors::syncGPU(), walberla::pystencils::ReactionKernelIndexed_1_double_precision_CUDA::IndexVectors::syncGPU(), walberla::pystencils::ReactionKernelIndexed_1_single_precision_CUDA::IndexVectors::syncGPU(), walberla::pystencils::ReactionKernelIndexed_2_double_precision_CUDA::IndexVectors::syncGPU(), walberla::pystencils::ReactionKernelIndexed_2_single_precision_CUDA::IndexVectors::syncGPU(), walberla::pystencils::ReactionKernelIndexed_3_double_precision_CUDA::IndexVectors::syncGPU(), walberla::pystencils::ReactionKernelIndexed_3_single_precision_CUDA::IndexVectors::syncGPU(), walberla::pystencils::ReactionKernelIndexed_4_double_precision_CUDA::IndexVectors::syncGPU(), walberla::pystencils::ReactionKernelIndexed_4_single_precision_CUDA::IndexVectors::syncGPU(), walberla::pystencils::ReactionKernelIndexed_5_double_precision_CUDA::IndexVectors::syncGPU(), walberla::pystencils::ReactionKernelIndexed_5_single_precision_CUDA::IndexVectors::syncGPU(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::IndexVectors::syncGPU(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::ForceVector::syncGPU(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::IndexVectors::syncGPU(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::ForceVector::syncGPU(), ScriptInterface::System::System::System(), tabulated_pair_energy(), tabulated_pair_force_factor(), TabulatedPotential::TabulatedPotential(), Accumulators::tensor_product(), cuda_fatal_error::terminate(), ForcesKernel::thole_active(), thole_pair_energy(), thole_pair_force(), ScriptInterface::LatticeIndices::throw_invalid_index(), time_calc(), walberla::to_array(), walberla::to_cell(), walberla::to_vector3(), walberla::to_vector3d(), walberla::to_vector9d(), Constraints::ShapeBasedConstraint::total_force(), Constraints::ShapeBasedConstraint::total_normal_force(), Cabana::NeighborList< CustomVerletList< MemorySpace, AlgorithmTag, Cabana::VerletLayout2D, BuildTag > >::totalNeighbor(), Utils::transform_coordinate_cartesian_to_cylinder(), Utils::transform_coordinate_cartesian_to_cylinder(), Utils::transform_coordinate_cylinder_to_cartesian(), Utils::transform_coordinate_cylinder_to_cartesian(), Utils::transform_vector_cartesian_to_cylinder(), CoulombMMM1D::tune(), CoulombScafacos::tune(), TuningAlgorithm::tune(), CoulombP3MHeffte< FloatType, Architecture, FFTConfig >::tune(), DipolarP3MHeffte< FloatType, Architecture, FFTConfig >::tune(), Scafacos::Coulomb::tune(), CoulombScafacosImpl::tune_impl(), System::System::tune_verlet_skin(), TuningLogger::tuning_goals(), ScriptInterface::Thermostat::Thermostat::turn_thermostat_off(), Utils::Factory< T >::type_name(), Utils::u32_to_u64(), Utils::u64_to_u32(), ParticlePropertyRange::unfolded_pos_range(), Utils::uniform(), ScriptInterface::walberla::unit_test_handle(), Utils::unit_vector(), ScriptInterface::unpack(), Utils::unpack(), walberla::pystencils::PackInfoPdfDoublePrecision::unpack(), walberla::pystencils::PackInfoPdfSinglePrecision::unpack(), walberla::pystencils::PackInfoVecDoublePrecision::unpack(), walberla::pystencils::PackInfoVecSinglePrecision::unpack(), walberla::pystencils::PackInfoPdfDoublePrecisionCUDA::unpack(), walberla::pystencils::PackInfoPdfSinglePrecisionCUDA::unpack(), walberla::pystencils::PackInfoVecDoublePrecisionCUDA::unpack(), walberla::pystencils::PackInfoVecSinglePrecisionCUDA::unpack(), walberla::pystencils::internal_unpack_B::unpack_B(), walberla::pystencils::internal_unpack_B::unpack_B(), walberla::pystencils::internal_unpack_BE::unpack_BE(), walberla::pystencils::internal_unpack_BE::unpack_BE(), walberla::pystencils::internal_unpack_BN::unpack_BN(), walberla::pystencils::internal_unpack_BN::unpack_BN(), walberla::pystencils::internal_unpack_BS::unpack_BS(), walberla::pystencils::internal_unpack_BS::unpack_BS(), walberla::pystencils::internal_unpack_BW::unpack_BW(), walberla::pystencils::internal_unpack_BW::unpack_BW(), walberla::pystencils::internal_unpack_E::unpack_E(), walberla::pystencils::internal_unpack_E::unpack_E(), walberla::pystencils::internal_unpack_N::unpack_N(), walberla::pystencils::internal_unpack_N::unpack_N(), walberla::pystencils::internal_unpack_NE::unpack_NE(), walberla::pystencils::internal_unpack_NE::unpack_NE(), walberla::pystencils::internal_unpack_NW::unpack_NW(), walberla::pystencils::internal_unpack_NW::unpack_NW(), walberla::pystencils::internal_unpack_S::unpack_S(), walberla::pystencils::internal_unpack_S::unpack_S(), walberla::pystencils::internal_unpack_SE::unpack_SE(), walberla::pystencils::internal_unpack_SE::unpack_SE(), walberla::pystencils::internal_unpack_SW::unpack_SW(), walberla::pystencils::internal_unpack_SW::unpack_SW(), walberla::pystencils::internal_1ccccad4ca561e07a0934cadb07d0fc1::unpack_SW_BW_W_TW_NW_BS_S_TS_B_C_T_BN_N_TN_SE_BE_E_TE_NE(), walberla::pystencils::internal_1ccccad4ca561e07a0934cadb07d0fc1::unpack_SW_BW_W_TW_NW_BS_S_TS_B_C_T_BN_N_TN_SE_BE_E_TE_NE(), walberla::pystencils::internal_unpack_T::unpack_T(), walberla::pystencils::internal_unpack_T::unpack_T(), walberla::pystencils::internal_unpack_TE::unpack_TE(), walberla::pystencils::internal_unpack_TE::unpack_TE(), walberla::pystencils::internal_unpack_TN::unpack_TN(), walberla::pystencils::internal_unpack_TN::unpack_TN(), walberla::pystencils::internal_unpack_TS::unpack_TS(), walberla::pystencils::internal_unpack_TS::unpack_TS(), walberla::pystencils::internal_unpack_TW::unpack_TW(), walberla::pystencils::internal_unpack_TW::unpack_TW(), walberla::pystencils::internal_unpack_W::unpack_W(), walberla::pystencils::internal_unpack_W::unpack_W(), walberla::field::communication::BoundaryPackInfo< GhostLayerField_T, Boundary_T >::unpackData(), walberla::pystencils::PackInfoPdfDoublePrecision::unpackData(), walberla::pystencils::PackInfoPdfSinglePrecision::unpackData(), walberla::pystencils::PackInfoVecDoublePrecision::unpackData(), walberla::pystencils::PackInfoVecSinglePrecision::unpackData(), CollisionDetection::CollisionDetection::unset_protocol(), LeesEdwards::LeesEdwards::unset_protocol(), GpuParticleData::update(), Accumulators::Correlator::update(), Utils::Histogram< T, N, M, U >::update(), ScriptInterface::Thermostat::Interface< CoreClass >::update_and_bind(), update_aosoa_charges(), walberla::LBWalberlaImpl< FloatType, Architecture >::update_boundary_from_shape(), LeesEdwards::LeesEdwards::update_box_params(), update_cabana_state(), LB::LBWalberla::update_collision_model(), LB::LBWalberla::update_collision_model(), ScriptInterface::Interactions::InteractionPotentialInterface< CoreIA >::update_core(), Propagation::update_default_propagation(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::update_density_boundary_from_shape(), walberla::EKinWalberlaImpl< FluxCount, FloatType, Architecture >::update_flux_boundary_from_shape(), CellStructure::update_ghosts_and_resort_particle(), ScriptInterface::Thermostat::Thermostat::update_global_kT(), System::System::update_icc_particles(), DipolarP3MState< FloatType, FFTConfig >::update_mesh_views(), FFTBuffersLegacy< FloatType >::update_mesh_views(), CoulombScafacosImpl::update_particle_data(), DipolarScafacosImpl::update_particle_data(), CoulombScafacosImpl::update_particle_forces(), DipolarScafacosImpl::update_particle_forces(), CellStructure::update_particle_index(), CellStructure::update_verlet_stats(), walberla::pystencils::internal_de8af14df5055eb4add5a44e06cbe9b5::updatevelfrompdfdoubleprecision_updatevelfrompdfdoubleprecision(), walberla::pystencils::internal_fb7a198ee8d4b87d3091e088a14673a2::updatevelfrompdfdoubleprecisionavx_updatevelfrompdfdoubleprecisionavx(), walberla::pystencils::internal_01ae0f7ae02292b7985da3bf4f45d4c4::updatevelfrompdfsingleprecision_updatevelfrompdfsingleprecision(), walberla::pystencils::internal_9f3cf46adc24d4ebfb8e08168d5e7562::updatevelfrompdfsingleprecisionavx_updatevelfrompdfsingleprecisionavx(), Writer::H5md::File::valid_fields(), ScriptInterface::AutoParameters< Derived, Base >::valid_parameters(), Utils::Accumulator::variance(), Utils::vec_rotate(), Utils::Vector< T, N >::Vector(), Utils::Vector< T, N >::Vector(), Utils::Vector< T, N >::Vector(), vector_product(), velocity(), BoxGeometry::velocity_difference(), LeesEdwards::velocity_shift(), velocity_verlet_npt_Andersen_step_1(), velocity_verlet_npt_Andersen_step_2(), velocity_verlet_npt_finalize_p_inst(), velocity_verlet_npt_MTK_step_1(), velocity_verlet_npt_MTK_step_2(), velocity_verlet_npt_propagate_AVOVA_And(), velocity_verlet_npt_propagate_AVOVA_MTK(), velocity_verlet_npt_propagate_p_eps(), velocity_verlet_npt_propagate_pos(), velocity_verlet_npt_propagate_pos_MTK(), velocity_verlet_npt_propagate_vel(), velocity_verlet_npt_propagate_vel_final(), velocity_verlet_npt_propagate_vel_MTK(), velocity_verlet_propagator_1(), velocity_verlet_propagator_2(), LeesEdwards::verlet_list_offset(), Constraints::Constraints::veto_boxl_change(), System::System::veto_boxl_change(), EK::EKWalberla::veto_kT(), LB::LBWalberla::veto_kT(), ElectrostaticLayerCorrection::veto_r_cut(), visit_try_catch(), vol_cons_parameters(), vs_com_back_transfer_forces_and_torques(), vs_com_update_particles(), vs_relate_to(), vs_relative_back_transfer_forces_and_torques(), vs_relative_pressure_tensor(), vs_relative_update_particles(), walberla_agrid_sanity_checks(), walberla_tau_sanity_checks(), ScriptInterface::Shapes::Wall::Wall(), ErrorHandling::RuntimeErrorCollector::warning(), wca_pair_energy(), wca_pair_force_factor(), weight(), Writer::H5md::File::write(), Writer::H5md::write_attributes(), Writer::H5md::write_box(), Writer::H5md::write_dataset(), Writer::H5md::write_dataset(), boost::qvm::vec_traits<::Utils::Vector< T, N > >::write_element(), boost::qvm::mat_traits< Utils::Matrix< T, Rows, Cols > >::write_element(), boost::qvm::quat_traits< Utils::Quaternion< T > >::write_element(), boost::qvm::quat_traits< Utils::Quaternion< T > >::write_element_idx(), boost::qvm::mat_traits< Utils::Matrix< T, Rows, Cols > >::write_element_idx(), Writer::H5md::write_le_dir(), Writer::H5md::write_le_normal(), Writer::H5md::write_le_off(), Writer::H5md::write_script(), Writer::H5md::write_td_particle_property(), LatticeModel::write_vtk(), walberla::LBWalberlaImpl< FloatType, Architecture >::zero_centered_to_lb(), walberla::LBWalberlaImpl< FloatType, Architecture >::zero_centered_to_md(), walberla::LBWalberlaImpl< FloatType, Architecture >::zero_centered_transform_impl(), p3m_interpolation_cache::zfill(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::ForceVector::~ForceVector(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::ForceVector::~ForceVector(), ScriptInterface::Writer::H5md::~H5md(), walberla::pystencils::Dirichlet_double_precision_CUDA::IndexVectors::~IndexVectors(), walberla::pystencils::Dirichlet_single_precision_CUDA::IndexVectors::~IndexVectors(), walberla::pystencils::FixedFlux_double_precision_CUDA::IndexVectors::~IndexVectors(), walberla::pystencils::FixedFlux_single_precision_CUDA::IndexVectors::~IndexVectors(), walberla::pystencils::ReactionKernelIndexed_1_double_precision_CUDA::IndexVectors::~IndexVectors(), walberla::pystencils::ReactionKernelIndexed_1_single_precision_CUDA::IndexVectors::~IndexVectors(), walberla::pystencils::ReactionKernelIndexed_2_double_precision_CUDA::IndexVectors::~IndexVectors(), walberla::pystencils::ReactionKernelIndexed_2_single_precision_CUDA::IndexVectors::~IndexVectors(), walberla::pystencils::ReactionKernelIndexed_3_double_precision_CUDA::IndexVectors::~IndexVectors(), walberla::pystencils::ReactionKernelIndexed_3_single_precision_CUDA::IndexVectors::~IndexVectors(), walberla::pystencils::ReactionKernelIndexed_4_double_precision_CUDA::IndexVectors::~IndexVectors(), walberla::pystencils::ReactionKernelIndexed_4_single_precision_CUDA::IndexVectors::~IndexVectors(), walberla::pystencils::ReactionKernelIndexed_5_double_precision_CUDA::IndexVectors::~IndexVectors(), walberla::pystencils::ReactionKernelIndexed_5_single_precision_CUDA::IndexVectors::~IndexVectors(), walberla::lbm::DynamicUBBDoublePrecisionCUDA::IndexVectors::~IndexVectors(), walberla::lbm::DynamicUBBSinglePrecisionCUDA::IndexVectors::~IndexVectors(), ScriptInterface::ObjectList< ManagedType, BaseType >::~ObjectList(), ScriptInterface::ObjectMap< ManagedType, BaseType, KeyType >::~ObjectMap(), ResourceCleanup::~ResourceCleanup(), ResourceManager::~ResourceManager(), Scafacos::Scafacos::~Scafacos(), and SignalHandler::~SignalHandler().