apply clang-format to some pair style headers
This commit is contained in:
@ -26,7 +26,7 @@ namespace LAMMPS_NS {
|
|||||||
|
|
||||||
class PairLJSFDipoleSF : public Pair {
|
class PairLJSFDipoleSF : public Pair {
|
||||||
public:
|
public:
|
||||||
PairLJSFDipoleSF(class LAMMPS *_lmp) : Pair(_lmp){};
|
PairLJSFDipoleSF(class LAMMPS *_lmp) : Pair(_lmp) {};
|
||||||
~PairLJSFDipoleSF() override;
|
~PairLJSFDipoleSF() override;
|
||||||
void compute(int, int) override;
|
void compute(int, int) override;
|
||||||
void settings(int, char **) override;
|
void settings(int, char **) override;
|
||||||
|
|||||||
@ -64,8 +64,7 @@ class PairAmoebaGPU : public PairAmoeba {
|
|||||||
|
|
||||||
void udirect2b_cpu();
|
void udirect2b_cpu();
|
||||||
|
|
||||||
template<class numtyp>
|
template <class numtyp> void compute_force_from_torque(const numtyp *, double **, double *);
|
||||||
void compute_force_from_torque(const numtyp*, double**, double*);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
} // namespace LAMMPS_NS
|
} // namespace LAMMPS_NS
|
||||||
|
|||||||
@ -65,8 +65,7 @@ class PairHippoGPU : public PairAmoeba {
|
|||||||
|
|
||||||
void udirect2b_cpu();
|
void udirect2b_cpu();
|
||||||
|
|
||||||
template<class numtyp>
|
template <class numtyp> void compute_force_from_torque(const numtyp *, double **, double *);
|
||||||
void compute_force_from_torque(const numtyp*, double**, double*);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
} // namespace LAMMPS_NS
|
} // namespace LAMMPS_NS
|
||||||
|
|||||||
@ -75,7 +75,7 @@ class PairGranular : public Pair {
|
|||||||
|
|
||||||
// granular models
|
// granular models
|
||||||
int nmodels, maxmodels;
|
int nmodels, maxmodels;
|
||||||
class Granular_NS::GranularModel** models_list;
|
class Granular_NS::GranularModel **models_list;
|
||||||
int **types_indices;
|
int **types_indices;
|
||||||
|
|
||||||
// optional user-specified global cutoff, per-type user-specified cutoffs
|
// optional user-specified global cutoff, per-type user-specified cutoffs
|
||||||
|
|||||||
@ -30,7 +30,6 @@ class PairAIPWATER2DM : virtual public PairILPTMD {
|
|||||||
|
|
||||||
protected:
|
protected:
|
||||||
void settings(int, char **) override;
|
void settings(int, char **) override;
|
||||||
|
|
||||||
};
|
};
|
||||||
|
|
||||||
} // namespace LAMMPS_NS
|
} // namespace LAMMPS_NS
|
||||||
|
|||||||
@ -39,7 +39,12 @@ class PairILPGrapheneHBN : public Pair {
|
|||||||
|
|
||||||
static constexpr int NPARAMS_PER_LINE = 13;
|
static constexpr int NPARAMS_PER_LINE = 13;
|
||||||
|
|
||||||
enum { ILP_GrhBN, ILP_TMD, SAIP_METAL, AIP_WATER_2DM }; // for telling class variants apart in shared code
|
enum {
|
||||||
|
ILP_GrhBN,
|
||||||
|
ILP_TMD,
|
||||||
|
SAIP_METAL,
|
||||||
|
AIP_WATER_2DM
|
||||||
|
}; // for telling class variants apart in shared code
|
||||||
|
|
||||||
protected:
|
protected:
|
||||||
int me;
|
int me;
|
||||||
|
|||||||
@ -27,8 +27,8 @@ namespace LAMMPS_NS {
|
|||||||
|
|
||||||
class PairLeptonCoul : public PairLepton {
|
class PairLeptonCoul : public PairLepton {
|
||||||
public:
|
public:
|
||||||
PairLeptonCoul(class LAMMPS *_lmp) : PairLepton(_lmp){};
|
PairLeptonCoul(class LAMMPS *_lmp) : PairLepton(_lmp) {};
|
||||||
~PairLeptonCoul() override{};
|
~PairLeptonCoul() override {};
|
||||||
void compute(int, int) override;
|
void compute(int, int) override;
|
||||||
void settings(int, char **) override;
|
void settings(int, char **) override;
|
||||||
void init_style() override;
|
void init_style() override;
|
||||||
|
|||||||
@ -27,7 +27,7 @@ namespace LAMMPS_NS {
|
|||||||
|
|
||||||
class PairLeptonSphere : public PairLepton {
|
class PairLeptonSphere : public PairLepton {
|
||||||
public:
|
public:
|
||||||
PairLeptonSphere(class LAMMPS *_lmp) : PairLepton(_lmp){};
|
PairLeptonSphere(class LAMMPS *_lmp) : PairLepton(_lmp) {};
|
||||||
|
|
||||||
void compute(int, int) override;
|
void compute(int, int) override;
|
||||||
void settings(int, char **) override;
|
void settings(int, char **) override;
|
||||||
|
|||||||
@ -57,18 +57,18 @@ class PairBOP : public Pair {
|
|||||||
struct PairList1 {
|
struct PairList1 {
|
||||||
double r, dis[3];
|
double r, dis[3];
|
||||||
double betaS, dBetaS, betaP, dBetaP, rep, dRep;
|
double betaS, dBetaS, betaP, dBetaP, rep, dRep;
|
||||||
PairList1(){};
|
PairList1() {};
|
||||||
};
|
};
|
||||||
|
|
||||||
struct PairList2 {
|
struct PairList2 {
|
||||||
double r, dis[3];
|
double r, dis[3];
|
||||||
double rep, dRep;
|
double rep, dRep;
|
||||||
PairList2(){};
|
PairList2() {};
|
||||||
};
|
};
|
||||||
|
|
||||||
struct TripleList {
|
struct TripleList {
|
||||||
double G, dG, cosAng, dCosAngi[3], dCosAngj[3], dCosAngk[3];
|
double G, dG, cosAng, dCosAngi[3], dCosAngj[3], dCosAngk[3];
|
||||||
TripleList(){};
|
TripleList() {};
|
||||||
};
|
};
|
||||||
|
|
||||||
struct B_SG {
|
struct B_SG {
|
||||||
|
|||||||
@ -197,16 +197,10 @@ class PairMEAMSpline : public Pair {
|
|||||||
}
|
}
|
||||||
|
|
||||||
/// Returns the number of bytes used by this function object.
|
/// Returns the number of bytes used by this function object.
|
||||||
double memory_usage() const
|
double memory_usage() const { return sizeof(*this) + sizeof(X[0]) * N * 3; }
|
||||||
{
|
|
||||||
return sizeof(*this) + sizeof(X[0]) * N * 3;
|
|
||||||
}
|
|
||||||
|
|
||||||
/// Returns the cutoff radius of this function.
|
/// Returns the cutoff radius of this function.
|
||||||
double cutoff() const
|
double cutoff() const { return X[N - 1]; }
|
||||||
{
|
|
||||||
return X[N - 1];
|
|
||||||
}
|
|
||||||
|
|
||||||
/// Writes a Gnuplot script that plots the spline function.
|
/// Writes a Gnuplot script that plots the spline function.
|
||||||
void writeGnuplot(const char *filename, const char *title = nullptr) const;
|
void writeGnuplot(const char *filename, const char *title = nullptr) const;
|
||||||
|
|||||||
@ -187,16 +187,10 @@ class PairMEAMSWSpline : public Pair {
|
|||||||
}
|
}
|
||||||
|
|
||||||
/// Returns the number of bytes used by this function object.
|
/// Returns the number of bytes used by this function object.
|
||||||
double memory_usage() const
|
double memory_usage() const { return sizeof(*this) + sizeof(X[0]) * N * 3; }
|
||||||
{
|
|
||||||
return sizeof(*this) + sizeof(X[0]) * N * 3;
|
|
||||||
}
|
|
||||||
|
|
||||||
/// Returns the cutoff radius of this function.
|
/// Returns the cutoff radius of this function.
|
||||||
double cutoff() const
|
double cutoff() const { return X[N - 1]; }
|
||||||
{
|
|
||||||
return X[N - 1];
|
|
||||||
}
|
|
||||||
|
|
||||||
/// Writes a Gnuplot script that plots the spline function.
|
/// Writes a Gnuplot script that plots the spline function.
|
||||||
void writeGnuplot(const char *filename, const char *title = nullptr) const;
|
void writeGnuplot(const char *filename, const char *title = nullptr) const;
|
||||||
|
|||||||
@ -49,7 +49,7 @@ class PairREBOMoS : public Pair {
|
|||||||
int *REBO_numneigh; // # of pair neighbors for each atom
|
int *REBO_numneigh; // # of pair neighbors for each atom
|
||||||
int **REBO_firstneigh; // ptr to 1st neighbor of each atom
|
int **REBO_firstneigh; // ptr to 1st neighbor of each atom
|
||||||
|
|
||||||
double *nM, *nS; // sum of weighting fns with REBO neighs
|
double *nM, *nS; // sum of weighting fns with REBO neighs
|
||||||
|
|
||||||
double rcmin[2][2], rcmax[2][2], rcmaxsq[2][2], rcmaxp[2][2];
|
double rcmin[2][2], rcmax[2][2], rcmaxsq[2][2], rcmaxp[2][2];
|
||||||
double Q[2][2], alpha[2][2], A[2][2], BIJc[2][2], Beta[2][2];
|
double Q[2][2], alpha[2][2], A[2][2], BIJc[2][2], Beta[2][2];
|
||||||
|
|||||||
@ -26,7 +26,7 @@ namespace LAMMPS_NS {
|
|||||||
|
|
||||||
class PairTersoffMODC : public PairTersoffMOD {
|
class PairTersoffMODC : public PairTersoffMOD {
|
||||||
public:
|
public:
|
||||||
PairTersoffMODC(class LAMMPS *lmp) : PairTersoffMOD(lmp){};
|
PairTersoffMODC(class LAMMPS *lmp) : PairTersoffMOD(lmp) {};
|
||||||
|
|
||||||
static constexpr int NPARAMS_PER_LINE = 21;
|
static constexpr int NPARAMS_PER_LINE = 21;
|
||||||
|
|
||||||
|
|||||||
@ -55,7 +55,7 @@ class PairPACE : public Pair {
|
|||||||
int nmax_corerep;
|
int nmax_corerep;
|
||||||
|
|
||||||
virtual void allocate();
|
virtual void allocate();
|
||||||
double *corerep_factor; //per-atom core-rep factor (= 1 - fcut)
|
double *corerep_factor; //per-atom core-rep factor (= 1 - fcut)
|
||||||
int flag_corerep_factor;
|
int flag_corerep_factor;
|
||||||
|
|
||||||
double **scale;
|
double **scale;
|
||||||
|
|||||||
@ -43,8 +43,10 @@ class PairQUIP : public Pair {
|
|||||||
double init_one(int, int) override;
|
double init_one(int, int) override;
|
||||||
void allocate();
|
void allocate();
|
||||||
void *extract(const char *, int &);
|
void *extract(const char *, int &);
|
||||||
|
|
||||||
protected:
|
protected:
|
||||||
double scale;
|
double scale;
|
||||||
|
|
||||||
private:
|
private:
|
||||||
double cutoff;
|
double cutoff;
|
||||||
int *quip_potential;
|
int *quip_potential;
|
||||||
|
|||||||
@ -1,4 +1,4 @@
|
|||||||
/* -*- c++ -*- ----------------------------------------------------------
|
/* -*- c++ -*- ----------------------------------------------------------
|
||||||
LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator
|
LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator
|
||||||
https://www.lammps.org/, Sandia National Laboratories
|
https://www.lammps.org/, Sandia National Laboratories
|
||||||
LAMMPS development team: developers@lammps.org
|
LAMMPS development team: developers@lammps.org
|
||||||
@ -20,8 +20,8 @@ PairStyle(aip/water/2dm/opt,PairAIPWATER2DMOpt);
|
|||||||
#ifndef LMP_PAIR_AIP_WATER_2DM_OPT_H
|
#ifndef LMP_PAIR_AIP_WATER_2DM_OPT_H
|
||||||
#define LMP_PAIR_AIP_WATER_2DM_OPT_H
|
#define LMP_PAIR_AIP_WATER_2DM_OPT_H
|
||||||
|
|
||||||
#include "pair_ilp_graphene_hbn_opt.h"
|
|
||||||
#include "pair_aip_water_2dm.h"
|
#include "pair_aip_water_2dm.h"
|
||||||
|
#include "pair_ilp_graphene_hbn_opt.h"
|
||||||
|
|
||||||
namespace LAMMPS_NS {
|
namespace LAMMPS_NS {
|
||||||
|
|
||||||
|
|||||||
@ -35,8 +35,8 @@ class PairILPGrapheneHBNOpt : virtual public PairILPGrapheneHBN {
|
|||||||
protected:
|
protected:
|
||||||
void update_internal_list();
|
void update_internal_list();
|
||||||
template <int MAX_NNEIGH>
|
template <int MAX_NNEIGH>
|
||||||
void calc_atom_normal(int i, int itype, int *ILP_neigh, int nneigh, double *normal, double (*dnormdri)[3],
|
void calc_atom_normal(int i, int itype, int *ILP_neigh, int nneigh, double *normal,
|
||||||
double (*dnormdrk)[3][3]);
|
double (*dnormdri)[3], double (*dnormdrk)[3][3]);
|
||||||
template <int MAX_NNEIGH, int EFLAG, int VFLAG_EITHER, int TAP_FLAG, int VARIANT = ILP_GrhBN>
|
template <int MAX_NNEIGH, int EFLAG, int VFLAG_EITHER, int TAP_FLAG, int VARIANT = ILP_GrhBN>
|
||||||
void eval();
|
void eval();
|
||||||
int *layered_neigh;
|
int *layered_neigh;
|
||||||
@ -51,7 +51,6 @@ class PairILPGrapheneHBNOpt : virtual public PairILPGrapheneHBN {
|
|||||||
SAIP_BNCH,
|
SAIP_BNCH,
|
||||||
WATER,
|
WATER,
|
||||||
};
|
};
|
||||||
|
|
||||||
};
|
};
|
||||||
|
|
||||||
} // namespace LAMMPS_NS
|
} // namespace LAMMPS_NS
|
||||||
|
|||||||
Reference in New Issue
Block a user