86#ifdef ESPRESSO_LENNARD_JONES
96#ifdef ESPRESSO_LENNARD_JONES_GENERIC
101#ifdef ESPRESSO_SMOOTH_STEP
106#ifdef ESPRESSO_HERTZIAN
111#ifdef ESPRESSO_GAUSSIAN
116#ifdef ESPRESSO_BMHTF_NACL
126#ifdef ESPRESSO_BUCKINGHAM
131#ifdef ESPRESSO_SOFT_SPHERE
141#ifdef ESPRESSO_LJCOS2
152#ifdef ESPRESSO_TABULATED
162#ifdef ESPRESSO_GAY_BERNE
186 double const dist,
double const dist2,
IA_parameters const &ia_params,
193#ifdef ESPRESSO_EXCLUSIONS
199 coulomb, coulomb_kernel));
201#ifdef ESPRESSO_ELECTROSTATICS
202 if (!obs_energy.
coulomb.empty() and coulomb_kernel !=
nullptr) {
203 auto const q1q2 = p1.
q() * p2.
q();
205 (*coulomb_kernel)(p1.
pos(), p2.
pos(), q1q2, d, dist);
209#ifdef ESPRESSO_DIPOLES
210 if (!obs_energy.
dipolar.empty() and dipoles_kernel !=
nullptr)
211 obs_energy.
dipolar[0] += (*dipoles_kernel)(p1, p2, d, dist, dist2);
215inline std::optional<double>
217 std::span<Particle *> partners,
BoxGeometry const &box_geo,
219 auto const n_partners =
static_cast<int>(partners.size());
221 auto p2 = (n_partners > 0) ? partners[0] :
nullptr;
222 auto p3 = (n_partners > 1) ? partners[1] :
nullptr;
223 auto p4 = (n_partners > 2) ? partners[2] :
nullptr;
225 if (n_partners == 1) {
227 if (
auto const *iap = std::get_if<FeneBond>(&iaparams)) {
228 return iap->energy(dx);
230 if (
auto const *iap = std::get_if<HarmonicBond>(&iaparams)) {
231 return iap->energy(dx);
233 if (
auto const *iap = std::get_if<QuarticBond>(&iaparams)) {
234 return iap->energy(dx);
236#ifdef ESPRESSO_ELECTROSTATICS
237 if (
auto const *iap = std::get_if<BondedCoulomb>(&iaparams)) {
238 return iap->energy(p1.
q() * p2->q(), dx);
240 if (
auto const *iap = std::get_if<BondedCoulombSR>(&iaparams)) {
241 return iap->energy(p1, *p2, dx, *kernel);
244#ifdef ESPRESSO_BOND_CONSTRAINT
245 if (std::get_if<RigidBond>(&iaparams)) {
249#ifdef ESPRESSO_TABULATED
250 if (
auto const *iap = std::get_if<TabulatedDistanceBond>(&iaparams)) {
251 return iap->energy(dx);
254 if (std::get_if<VirtualBond>(&iaparams)) {
259 if (n_partners == 2) {
262 if (
auto const *iap = std::get_if<AngleHarmonicBond>(&iaparams)) {
263 return iap->energy(vec1, vec2);
265 if (
auto const *iap = std::get_if<AngleCosineBond>(&iaparams)) {
266 return iap->energy(vec1, vec2);
268 if (
auto const *iap = std::get_if<AngleCossquareBond>(&iaparams)) {
269 return iap->energy(vec1, vec2);
271 if (
auto const *iap = std::get_if<TabulatedAngleBond>(&iaparams)) {
272 return iap->energy(vec1, vec2);
274 if (std::get_if<IBMTriel>(&iaparams)) {
276 std::to_string(iaparams.index()) +
277 " in energy calculation.";
282 if (n_partners == 3) {
286 auto const v34 = box_geo.
get_mi_vector(p4->pos(), p3->pos());
287 if (
auto const *iap = std::get_if<DihedralBond>(&iaparams)) {
288 return iap->energy(v12, v23, v34);
290 if (
auto const *iap = std::get_if<TabulatedDihedralBond>(&iaparams)) {
291 return iap->energy(v12, v23, v34);
293 if (std::get_if<IBMTribend>(&iaparams)) {
295 std::to_string(iaparams.index()) +
296 " in energy calculation.";
301 if (n_partners == 0) {
319#ifdef ESPRESSO_ROTATION
320 return (p.can_rotate() and not p.is_virtual())
321 ? 0.5 * (hadamard_product(p.omega(), p.omega()) * p.rinertia())
Vector implementation and trait types for boost qvm interoperability.
Routines to calculate the Born-Meyer-Huggins-Tosi-Fumi potential between particle pairs.
double BMHTF_pair_energy(IA_parameters const &ia_params, double dist)
Calculate BMHTF potential energy.
Data structures for bonded interactions.
std::variant< NoneBond, FeneBond, HarmonicBond, QuarticBond, BondedCoulomb, BondedCoulombSR, AngleHarmonicBond, AngleCosineBond, AngleCossquareBond, DihedralBond, TabulatedDistanceBond, TabulatedAngleBond, TabulatedDihedralBond, ThermalizedBond, RigidBond, IBMTriel, IBMVolCons, IBMTribend, OifGlobalForcesBond, OifLocalForcesBond, VirtualBond > Bonded_IA_Parameters
Variant in which to store the parameters of an individual bonded interaction.
Routines to calculate the Buckingham potential between particle pairs.
double buck_pair_energy(IA_parameters const &ia_params, double dist)
Calculate Buckingham energy.
container for bonded interactions.
ESPRESSO_ATTR_ALWAYS_INLINE Utils::Vector< T, 3 > get_mi_vector(const Utils::Vector< T, 3 > &a, const Utils::Vector< T, 3 > &b) const
Get the minimum-image vector between two coordinates.
Observable for the pressure and energy.
std::span< double > coulomb
Contribution(s) from Coulomb interactions.
void add_non_bonded_contribution(int type1, int type2, int molid1, int molid2, std::span< const double > data)
std::span< double > dipolar
Contribution(s) from dipolar interactions.
Routines to calculate the Gaussian potential between particle pairs.
double gaussian_pair_energy(IA_parameters const &ia_params, double dist)
Calculate Gaussian energy.
void add_non_bonded_pair_energy(Particle const &p1, Particle const &p2, Utils::Vector3d const &d, double const dist, double const dist2, IA_parameters const &ia_params, BondedInteractionsMap const &bonded_ias, Coulomb::Solver const &coulomb, Coulomb::ShortRangeEnergyKernel::kernel_type const *coulomb_kernel, Dipoles::ShortRangeEnergyKernel::kernel_type const *dipoles_kernel, Observable_stat &obs_energy)
Add non-bonded and short-range Coulomb energies between a pair of particles to the energy observable.
std::optional< double > calc_bonded_energy(Bonded_IA_Parameters const &iaparams, Particle const &p1, std::span< Particle * > partners, BoxGeometry const &box_geo, Coulomb::ShortRangeEnergyKernel::kernel_type const *kernel)
double translational_kinetic_energy(Particle const &p)
Calculate kinetic energies from translation for one particle.
double rotational_kinetic_energy(Particle const &p)
Calculate kinetic energies from rotation for one particle.
double calc_non_bonded_pair_energy(Particle const &p1, Particle const &p2, IA_parameters const &ia_params, Utils::Vector3d const &d, double const dist, BondedInteractionsMap const &bonded_ias, Coulomb::Solver const &coulomb, Coulomb::ShortRangeEnergyKernel::kernel_type const *coulomb_kernel)
Calculate non-bonded energies between a pair of particles.
This file contains the errorhandling code for severe errors, like a broken bond or illegal parameter ...
#define runtimeWarningMsg()
bool do_nonbonded(Particle const &p1, Particle const &p2)
Determine if the non-bonded interactions between p1 and p2 should be calculated.
Routines to calculate the Gay-Berne potential between particle pairs.
double gb_pair_energy(Utils::Quaternion< double > const &qi, Utils::Quaternion< double > const &qj, IA_parameters const &ia_params, Utils::Vector3d const &d, double dist)
Calculate Gay-Berne energy.
Routines to calculate the hat potential between particle pairs.
double hat_pair_energy(IA_parameters const &ia_params, double dist)
Calculate hat energy.
Routines to calculate the Hertzian potential between particle pairs.
double hertzian_pair_energy(IA_parameters const &ia_params, double dist)
Calculate Hertzian energy.
Routines to calculate the Lennard-Jones potential between particle pairs.
double lj_pair_energy(IA_parameters const &ia_params, double dist)
Calculate Lennard-Jones energy.
Routines to calculate the Lennard-Jones with cosine tail potential between particle pairs.
double ljcos2_pair_energy(IA_parameters const &ia_params, double dist)
Calculate Lennard-Jones cosine squared energy.
Routines to calculate the Lennard-Jones+cosine potential between particle pairs.
double ljcos_pair_energy(IA_parameters const &ia_params, double dist)
Calculate Lennard-Jones cosine energy.
Routines to calculate the generalized Lennard-Jones potential between particle pairs.
double ljgen_pair_energy(IA_parameters const &ia_params, double dist)
Calculate Lennard-Jones energy.
Routines to calculate the Morse potential between particle pairs.
double morse_pair_energy(IA_parameters const &ia_params, double dist)
Calculate Morse energy.
Various procedures concerning interactions between particles.
Routines to calculate the energy and/or force for particle pairs via interpolation of lookup tables.
double tabulated_pair_energy(IA_parameters const &ia_params, double dist)
Calculate a non-bonded pair energy by linear interpolation from a table.
Routines to calculate the smooth step potential between particle pairs.
double SmSt_pair_energy(IA_parameters const &ia_params, double dist)
Calculate smooth step energy.
Routines to calculate the soft-sphere potential between particle pairs.
double soft_pair_energy(IA_parameters const &ia_params, double dist)
Calculate soft-sphere energy.
Exception indicating that a bond with an unexpected number of partners was encountered.
Exception indicating that a bond type was unknown.
Solver::ShortRangeEnergyKernel kernel_type
Solver::ShortRangeEnergyKernel kernel_type
Parameters for non-bonded interactions.
Struct holding all information for one particle.
auto const & mass() const
auto const & quat() const
auto const & type() const
auto const & mol_id() const
Routines to calculate the Thole damping potential between particle pairs.
double thole_pair_energy(Particle const &p1, Particle const &p2, IA_parameters const &ia_params, Utils::Vector3d const &d, double dist, BondedInteractionsMap const &bonded_ias, Coulomb::Solver const &coulomb, Coulomb::ShortRangeEnergyKernel::kernel_type const *kernel)
Calculate Thole energy.
Routines to calculate the Weeks-Chandler-Andersen potential between particle pairs.
double wca_pair_energy(IA_parameters const &ia_params, double dist)
Calculate WCA energy.