diff --git a/src/KOKKOS/Install.sh b/src/KOKKOS/Install.sh index 95ffdb5ab9eb43fbc9f3b7c37fe15bf22d22ce7f..93adf58ef5c2aa8ca3a561e28f3be715fb426c4a 100644 --- a/src/KOKKOS/Install.sh +++ b/src/KOKKOS/Install.sh @@ -169,6 +169,8 @@ action pair_reax_c_kokkos.cpp pair_reax_c.cpp action pair_reax_c_kokkos.h pair_reax_c.h action pair_sw_kokkos.cpp pair_sw.cpp action pair_sw_kokkos.h pair_sw.h +action pair_vashishta_kokkos.cpp pair_vashishta.cpp +action pair_vashishta_kokkos.h pair_vashishta.h action pair_table_kokkos.cpp action pair_table_kokkos.h action pair_tersoff_kokkos.cpp pair_tersoff.cpp diff --git a/src/KOKKOS/pair_vashishta_kokkos.cpp b/src/KOKKOS/pair_vashishta_kokkos.cpp new file mode 100644 index 0000000000000000000000000000000000000000..73e4e04f9890a119b5d20b5e9c5e3ffe7cf86398 --- /dev/null +++ b/src/KOKKOS/pair_vashishta_kokkos.cpp @@ -0,0 +1,961 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing author: Stan Moore (SNL) + Anders Hafreager (UiO), andershaf@gmail.com +------------------------------------------------------------------------- */ + +#include <math.h> +#include <stdio.h> +#include <stdlib.h> +#include <string.h> +#include "pair_vashishta_kokkos.h" +#include "kokkos.h" +#include "pair_kokkos.h" +#include "atom_kokkos.h" +#include "neighbor.h" +#include "neigh_request.h" +#include "force.h" +#include "comm.h" +#include "memory.h" +#include "neighbor.h" +#include "neigh_list_kokkos.h" +#include "memory.h" +#include "error.h" +#include "atom_masks.h" +#include "math_const.h" + +using namespace LAMMPS_NS; +using namespace MathConst; + +#define MAXLINE 1024 +#define DELTA 4 + +/* ---------------------------------------------------------------------- */ + +template<class DeviceType> +PairVashishtaKokkos<DeviceType>::PairVashishtaKokkos(LAMMPS *lmp) : PairVashishta(lmp) +{ + respa_enable = 0; + + atomKK = (AtomKokkos *) atom; + execution_space = ExecutionSpaceFromDevice<DeviceType>::space; + datamask_read = X_MASK | F_MASK | TAG_MASK | TYPE_MASK | ENERGY_MASK | VIRIAL_MASK; + datamask_modify = F_MASK | ENERGY_MASK | VIRIAL_MASK; +} + +/* ---------------------------------------------------------------------- + check if allocated, since class can be destructed when incomplete +------------------------------------------------------------------------- */ + +template<class DeviceType> +PairVashishtaKokkos<DeviceType>::~PairVashishtaKokkos() +{ + if (!copymode) { + memory->destroy_kokkos(k_eatom,eatom); + memory->destroy_kokkos(k_vatom,vatom); + eatom = NULL; + vatom = NULL; + } +} + +/* ---------------------------------------------------------------------- */ + +template<class DeviceType> +void PairVashishtaKokkos<DeviceType>::compute(int eflag_in, int vflag_in) +{ + eflag = eflag_in; + vflag = vflag_in; + + if (neighflag == FULL) no_virial_fdotr_compute = 1; + + if (eflag || vflag) ev_setup(eflag,vflag); + else evflag = vflag_fdotr = 0; + + // reallocate per-atom arrays if necessary + + if (eflag_atom) { + memory->destroy_kokkos(k_eatom,eatom); + memory->create_kokkos(k_eatom,eatom,maxeatom,"pair:eatom"); + d_eatom = k_eatom.d_view; + } + if (vflag_atom) { + memory->destroy_kokkos(k_vatom,vatom); + memory->create_kokkos(k_vatom,vatom,maxvatom,6,"pair:vatom"); + d_vatom = k_vatom.d_view; + } + + atomKK->sync(execution_space,datamask_read); + if (eflag || vflag) atomKK->modified(execution_space,datamask_modify); + else atomKK->modified(execution_space,F_MASK); + + x = atomKK->k_x.view<DeviceType>(); + f = atomKK->k_f.view<DeviceType>(); + tag = atomKK->k_tag.view<DeviceType>(); + type = atomKK->k_type.view<DeviceType>(); + nlocal = atom->nlocal; + newton_pair = force->newton_pair; + nall = atom->nlocal + atom->nghost; + + inum = list->inum; + const int ignum = inum + list->gnum; + NeighListKokkos<DeviceType>* k_list = static_cast<NeighListKokkos<DeviceType>*>(list); + d_ilist = k_list->d_ilist; + d_numneigh = k_list->d_numneigh; + d_neighbors = k_list->d_neighbors; + + k_list->clean_copy(); + copymode = 1; + + EV_FLOAT ev; + EV_FLOAT ev_all; + + int max_neighs = d_neighbors.dimension_1(); + + if ((d_neighbors_short_2body.dimension_1() != max_neighs) || + (d_neighbors_short_2body.dimension_0() != ignum)) { + d_neighbors_short_2body = Kokkos::View<int**,DeviceType>("Vashishta::neighbors_short_2body",ignum,max_neighs); + } + if (d_numneigh_short_2body.dimension_0()!=ignum) { + d_numneigh_short_2body = Kokkos::View<int*,DeviceType>("Vashishta::numneighs_short_2body",ignum); + } + + if ((d_neighbors_short_3body.dimension_1() != max_neighs) || + (d_neighbors_short_3body.dimension_0() != ignum)) { + d_neighbors_short_3body = Kokkos::View<int**,DeviceType>("Vashishta::neighbors_short_3body",ignum,max_neighs); + } + + if (d_numneigh_short_3body.dimension_0()!=ignum) { + d_numneigh_short_3body = Kokkos::View<int*,DeviceType>("Vashishta::numneighs_short_3body",ignum); + } + + Kokkos::parallel_for(Kokkos::RangePolicy<DeviceType,TagPairVashishtaComputeShortNeigh>(0,neighflag==FULL?ignum:inum), *this); + + + + // loop over neighbor list of my atoms + + if (neighflag == HALF) { + if (evflag) + Kokkos::parallel_reduce(Kokkos::RangePolicy<DeviceType, TagPairVashishtaComputeHalf<HALF,1> >(0,inum),*this,ev); + else + Kokkos::parallel_for(Kokkos::RangePolicy<DeviceType, TagPairVashishtaComputeHalf<HALF,0> >(0,inum),*this); + ev_all += ev; + } else if (neighflag == HALFTHREAD) { + if (evflag) + Kokkos::parallel_reduce(Kokkos::RangePolicy<DeviceType, TagPairVashishtaComputeHalf<HALFTHREAD,1> >(0,inum),*this,ev); + else + Kokkos::parallel_for(Kokkos::RangePolicy<DeviceType, TagPairVashishtaComputeHalf<HALFTHREAD,0> >(0,inum),*this); + ev_all += ev; + } else if (neighflag == FULL) { + if (evflag) + Kokkos::parallel_reduce(Kokkos::RangePolicy<DeviceType, TagPairVashishtaComputeFullA<FULL,1> >(0,inum),*this,ev); + else + Kokkos::parallel_for(Kokkos::RangePolicy<DeviceType, TagPairVashishtaComputeFullA<FULL,0> >(0,inum),*this); + ev_all += ev; + + if (evflag) + Kokkos::parallel_reduce(Kokkos::RangePolicy<DeviceType, TagPairVashishtaComputeFullB<FULL,1> >(0,ignum),*this,ev); + else + Kokkos::parallel_for(Kokkos::RangePolicy<DeviceType, TagPairVashishtaComputeFullB<FULL,0> >(0,ignum),*this); + ev_all += ev; + } + + if (eflag_global) eng_vdwl += ev_all.evdwl; + if (vflag_global) { + virial[0] += ev_all.v[0]; + virial[1] += ev_all.v[1]; + virial[2] += ev_all.v[2]; + virial[3] += ev_all.v[3]; + virial[4] += ev_all.v[4]; + virial[5] += ev_all.v[5]; + } + + if (vflag_fdotr) pair_virial_fdotr_compute(this); + + if (eflag_atom) { + k_eatom.template modify<DeviceType>(); + k_eatom.template sync<LMPHostType>(); + } + + if (vflag_atom) { + k_vatom.template modify<DeviceType>(); + k_vatom.template sync<LMPHostType>(); + } + + copymode = 0; +} + +template<class DeviceType> +KOKKOS_INLINE_FUNCTION +void PairVashishtaKokkos<DeviceType>::operator()(TagPairVashishtaComputeShortNeigh, const int& ii) const { + const int i = d_ilist[ii]; + const int itype = d_map[type[i]]; + const X_FLOAT xtmp = x(i,0); + const X_FLOAT ytmp = x(i,1); + const X_FLOAT ztmp = x(i,2); + + const int jnum = d_numneigh[i]; + int inside_2body = 0; + int inside_3body = 0; + for (int jj = 0; jj < jnum; jj++) { + int j = d_neighbors(i,jj); + j &= NEIGHMASK; + const int jtype = d_map[type[j]]; + const int ijparam = d_elem2param(itype,jtype,jtype); + + const X_FLOAT delx = xtmp - x(j,0); + const X_FLOAT dely = ytmp - x(j,1); + const X_FLOAT delz = ztmp - x(j,2); + const F_FLOAT rsq = delx*delx + dely*dely + delz*delz; + + if (rsq < d_params[ijparam].cutsq) { + d_neighbors_short_2body(i,inside_2body) = j; + inside_2body++; + } + + if (rsq < d_params[ijparam].cutsq2) { + d_neighbors_short_3body(i,inside_3body) = j; + inside_3body++; + } + } + d_numneigh_short_2body(i) = inside_2body; + d_numneigh_short_3body(i) = inside_3body; +} + +template<class DeviceType> +template<int NEIGHFLAG, int EVFLAG> +KOKKOS_INLINE_FUNCTION +void PairVashishtaKokkos<DeviceType>::operator()(TagPairVashishtaComputeHalf<NEIGHFLAG,EVFLAG>, const int &ii, EV_FLOAT& ev) const { + + // The f array is atomic + + Kokkos::View<F_FLOAT*[3], typename DAT::t_f_array::array_layout,DeviceType,Kokkos::MemoryTraits<AtomicF<NEIGHFLAG>::value> > a_f = f; + + F_FLOAT delr1[3],delr2[3],fj[3],fk[3]; + F_FLOAT evdwl = 0.0; + F_FLOAT fpair = 0.0; + + const int i = d_ilist[ii]; + const tagint itag = tag[i]; + const int itype = d_map[type[i]]; + const X_FLOAT xtmp = x(i,0); + const X_FLOAT ytmp = x(i,1); + const X_FLOAT ztmp = x(i,2); + + // two-body interactions, skip half of them + + const int jnum = d_numneigh_short_2body[i]; + + F_FLOAT fxtmpi = 0.0; + F_FLOAT fytmpi = 0.0; + F_FLOAT fztmpi = 0.0; + + for (int jj = 0; jj < jnum; jj++) { + int j = d_neighbors_short_2body(i,jj); + j &= NEIGHMASK; + const tagint jtag = tag[j]; + + if (itag > jtag) { + if ((itag+jtag) % 2 == 0) continue; + } else if (itag < jtag) { + if ((itag+jtag) % 2 == 1) continue; + } else { + if (x(j,2) < ztmp) continue; + if (x(j,2) == ztmp && x(j,1) < ytmp) continue; + if (x(j,2) == ztmp && x(j,1) == ytmp && x(j,0) < xtmp) continue; + } + + const int jtype = d_map[type[j]]; + + const X_FLOAT delx = xtmp - x(j,0); + const X_FLOAT dely = ytmp - x(j,1); + const X_FLOAT delz = ztmp - x(j,2); + const F_FLOAT rsq = delx*delx + dely*dely + delz*delz; + + const int ijparam = d_elem2param(itype,jtype,jtype); + + twobody(d_params[ijparam],rsq,fpair,eflag,evdwl); + + fxtmpi += delx*fpair; + fytmpi += dely*fpair; + fztmpi += delz*fpair; + a_f(j,0) -= delx*fpair; + a_f(j,1) -= dely*fpair; + a_f(j,2) -= delz*fpair; + + if (EVFLAG) { + if (eflag) ev.evdwl += evdwl; + if (vflag_either || eflag_atom) this->template ev_tally<NEIGHFLAG>(ev,i,j,evdwl,fpair,delx,dely,delz); + } + } + + const int jnumm1 = d_numneigh_short_3body[i]; + + for (int jj = 0; jj < jnumm1-1; jj++) { + int j = d_neighbors_short_3body(i,jj); + j &= NEIGHMASK; + const int jtype = d_map[type[j]]; + const int ijparam = d_elem2param(itype,jtype,jtype); + delr1[0] = x(j,0) - xtmp; + delr1[1] = x(j,1) - ytmp; + delr1[2] = x(j,2) - ztmp; + const F_FLOAT rsq1 = delr1[0]*delr1[0] + delr1[1]*delr1[1] + delr1[2]*delr1[2]; + + F_FLOAT fxtmpj = 0.0; + F_FLOAT fytmpj = 0.0; + F_FLOAT fztmpj = 0.0; + + for (int kk = jj+1; kk < jnumm1; kk++) { + int k = d_neighbors_short_3body(i,kk); + k &= NEIGHMASK; + const int ktype = d_map[type[k]]; + const int ikparam = d_elem2param(itype,ktype,ktype); + const int ijkparam = d_elem2param(itype,jtype,ktype); + + delr2[0] = x(k,0) - xtmp; + delr2[1] = x(k,1) - ytmp; + delr2[2] = x(k,2) - ztmp; + const F_FLOAT rsq2 = delr2[0]*delr2[0] + delr2[1]*delr2[1] + delr2[2]*delr2[2]; + + threebody(d_params[ijparam],d_params[ikparam],d_params[ijkparam], + rsq1,rsq2,delr1,delr2,fj,fk,eflag,evdwl); + + fxtmpi -= fj[0] + fk[0]; + fytmpi -= fj[1] + fk[1]; + fztmpi -= fj[2] + fk[2]; + fxtmpj += fj[0]; + fytmpj += fj[1]; + fztmpj += fj[2]; + a_f(k,0) += fk[0]; + a_f(k,1) += fk[1]; + a_f(k,2) += fk[2]; + + if (EVFLAG) { + if (eflag) ev.evdwl += evdwl; + if (vflag_either || eflag_atom) this->template ev_tally3<NEIGHFLAG>(ev,i,j,k,evdwl,0.0,fj,fk,delr1,delr2); + } + } + + a_f(j,0) += fxtmpj; + a_f(j,1) += fytmpj; + a_f(j,2) += fztmpj; + } + + a_f(i,0) += fxtmpi; + a_f(i,1) += fytmpi; + a_f(i,2) += fztmpi; +} + +template<class DeviceType> +template<int NEIGHFLAG, int EVFLAG> +KOKKOS_INLINE_FUNCTION +void PairVashishtaKokkos<DeviceType>::operator()(TagPairVashishtaComputeHalf<NEIGHFLAG,EVFLAG>, const int &ii) const { + EV_FLOAT ev; + this->template operator()<NEIGHFLAG,EVFLAG>(TagPairVashishtaComputeHalf<NEIGHFLAG,EVFLAG>(), ii, ev); +} + +/* ---------------------------------------------------------------------- */ + +template<class DeviceType> +template<int NEIGHFLAG, int EVFLAG> +KOKKOS_INLINE_FUNCTION +void PairVashishtaKokkos<DeviceType>::operator()(TagPairVashishtaComputeFullA<NEIGHFLAG,EVFLAG>, const int &ii, EV_FLOAT& ev) const { + + F_FLOAT delr1[3],delr2[3],fj[3],fk[3]; + F_FLOAT evdwl = 0.0; + F_FLOAT fpair = 0.0; + + const int i = d_ilist[ii]; + + const tagint itag = tag[i]; + const int itype = d_map[type[i]]; + const X_FLOAT xtmp = x(i,0); + const X_FLOAT ytmp = x(i,1); + const X_FLOAT ztmp = x(i,2); + + // two-body interactions + + const int jnum = d_numneigh_short_2body[i]; + + F_FLOAT fxtmpi = 0.0; + F_FLOAT fytmpi = 0.0; + F_FLOAT fztmpi = 0.0; + + for (int jj = 0; jj < jnum; jj++) { + int j = d_neighbors_short_2body(i,jj); + j &= NEIGHMASK; + const tagint jtag = tag[j]; + + const int jtype = d_map[type[j]]; + + const X_FLOAT delx = xtmp - x(j,0); + const X_FLOAT dely = ytmp - x(j,1); + const X_FLOAT delz = ztmp - x(j,2); + const F_FLOAT rsq = delx*delx + dely*dely + delz*delz; + + const int ijparam = d_elem2param(itype,jtype,jtype); + + twobody(d_params[ijparam],rsq,fpair,eflag,evdwl); + + fxtmpi += delx*fpair; + fytmpi += dely*fpair; + fztmpi += delz*fpair; + + if (EVFLAG) { + if (eflag) ev.evdwl += 0.5*evdwl; + if (vflag_either || eflag_atom) this->template ev_tally<NEIGHFLAG>(ev,i,j,evdwl,fpair,delx,dely,delz); + } + } + + const int jnumm1 = d_numneigh_short_3body[i]; + + for (int jj = 0; jj < jnumm1-1; jj++) { + int j = d_neighbors_short_3body(i,jj); + j &= NEIGHMASK; + const int jtype = d_map[type[j]]; + const int ijparam = d_elem2param(itype,jtype,jtype); + delr1[0] = x(j,0) - xtmp; + delr1[1] = x(j,1) - ytmp; + delr1[2] = x(j,2) - ztmp; + const F_FLOAT rsq1 = delr1[0]*delr1[0] + delr1[1]*delr1[1] + delr1[2]*delr1[2]; + + for (int kk = jj+1; kk < jnumm1; kk++) { + int k = d_neighbors_short_3body(i,kk); + k &= NEIGHMASK; + const int ktype = d_map[type[k]]; + const int ikparam = d_elem2param(itype,ktype,ktype); + const int ijkparam = d_elem2param(itype,jtype,ktype); + + delr2[0] = x(k,0) - xtmp; + delr2[1] = x(k,1) - ytmp; + delr2[2] = x(k,2) - ztmp; + const F_FLOAT rsq2 = delr2[0]*delr2[0] + delr2[1]*delr2[1] + delr2[2]*delr2[2]; + + threebody(d_params[ijparam],d_params[ikparam],d_params[ijkparam], + rsq1,rsq2,delr1,delr2,fj,fk,eflag,evdwl); + + fxtmpi -= fj[0] + fk[0]; + fytmpi -= fj[1] + fk[1]; + fztmpi -= fj[2] + fk[2]; + + if (EVFLAG) { + if (eflag) ev.evdwl += evdwl; + if (vflag_either || eflag_atom) this->template ev_tally3<NEIGHFLAG>(ev,i,j,k,evdwl,0.0,fj,fk,delr1,delr2); + } + } + } + + f(i,0) += fxtmpi; + f(i,1) += fytmpi; + f(i,2) += fztmpi; +} + +template<class DeviceType> +template<int NEIGHFLAG, int EVFLAG> +KOKKOS_INLINE_FUNCTION +void PairVashishtaKokkos<DeviceType>::operator()(TagPairVashishtaComputeFullA<NEIGHFLAG,EVFLAG>, const int &ii) const { + EV_FLOAT ev; + this->template operator()<NEIGHFLAG,EVFLAG>(TagPairVashishtaComputeFullA<NEIGHFLAG,EVFLAG>(), ii, ev); +} + +/* ---------------------------------------------------------------------- */ + +template<class DeviceType> +template<int NEIGHFLAG, int EVFLAG> +KOKKOS_INLINE_FUNCTION +void PairVashishtaKokkos<DeviceType>::operator()(TagPairVashishtaComputeFullB<NEIGHFLAG,EVFLAG>, const int &ii, EV_FLOAT& ev) const { + + F_FLOAT delr1[3],delr2[3],fj[3],fk[3]; + F_FLOAT evdwl = 0.0; + F_FLOAT fpair = 0.0; + + const int i = d_ilist[ii]; + + const int itype = d_map[type[i]]; + const X_FLOAT xtmpi = x(i,0); + const X_FLOAT ytmpi = x(i,1); + const X_FLOAT ztmpi = x(i,2); + + const int jnum = d_numneigh_short_3body[i]; + + F_FLOAT fxtmpi = 0.0; + F_FLOAT fytmpi = 0.0; + F_FLOAT fztmpi = 0.0; + + for (int jj = 0; jj < jnum; jj++) { + int j = d_neighbors_short_3body(i,jj); + j &= NEIGHMASK; + if (j >= nlocal) continue; + const int jtype = d_map[type[j]]; + const int jiparam = d_elem2param(jtype,itype,itype); + const X_FLOAT xtmpj = x(j,0); + const X_FLOAT ytmpj = x(j,1); + const X_FLOAT ztmpj = x(j,2); + + delr1[0] = xtmpi - xtmpj; + delr1[1] = ytmpi - ytmpj; + delr1[2] = ztmpi - ztmpj; + const F_FLOAT rsq1 = delr1[0]*delr1[0] + delr1[1]*delr1[1] + delr1[2]*delr1[2]; + + const int j_jnum = d_numneigh_short_3body[j]; + + for (int kk = 0; kk < j_jnum; kk++) { + int k = d_neighbors_short_3body(j,kk); + k &= NEIGHMASK; + if (k == i) continue; + const int ktype = d_map[type[k]]; + const int jkparam = d_elem2param(jtype,ktype,ktype); + const int jikparam = d_elem2param(jtype,itype,ktype); + + delr2[0] = x(k,0) - xtmpj; + delr2[1] = x(k,1) - ytmpj; + delr2[2] = x(k,2) - ztmpj; + const F_FLOAT rsq2 = delr2[0]*delr2[0] + delr2[1]*delr2[1] + delr2[2]*delr2[2]; + + if (vflag_atom) + threebody(d_params[jiparam],d_params[jkparam],d_params[jikparam], + rsq1,rsq2,delr1,delr2,fj,fk,eflag,evdwl); + else + threebodyj(d_params[jiparam],d_params[jkparam],d_params[jikparam], + rsq1,rsq2,delr1,delr2,fj); + + fxtmpi += fj[0]; + fytmpi += fj[1]; + fztmpi += fj[2]; + + if (EVFLAG) + if (vflag_atom || eflag_atom) ev_tally3_atom(ev,i,evdwl,0.0,fj,fk,delr1,delr2); + } + } + + f(i,0) += fxtmpi; + f(i,1) += fytmpi; + f(i,2) += fztmpi; +} + +template<class DeviceType> +template<int NEIGHFLAG, int EVFLAG> +KOKKOS_INLINE_FUNCTION +void PairVashishtaKokkos<DeviceType>::operator()(TagPairVashishtaComputeFullB<NEIGHFLAG,EVFLAG>, const int &ii) const { + EV_FLOAT ev; + this->template operator()<NEIGHFLAG,EVFLAG>(TagPairVashishtaComputeFullB<NEIGHFLAG,EVFLAG>(), ii, ev); +} + +/* ---------------------------------------------------------------------- + set coeffs for one or more type pairs +------------------------------------------------------------------------- */ + +template<class DeviceType> +void PairVashishtaKokkos<DeviceType>::coeff(int narg, char **arg) +{ + PairVashishta::coeff(narg,arg); + + // sync map + + int n = atom->ntypes; + + DAT::tdual_int_1d k_map = DAT::tdual_int_1d("pair:map",n+1); + HAT::t_int_1d h_map = k_map.h_view; + + for (int i = 1; i <= n; i++) + h_map[i] = map[i]; + + k_map.template modify<LMPHostType>(); + k_map.template sync<DeviceType>(); + + d_map = k_map.d_view; +} + +/* ---------------------------------------------------------------------- + init specific to this pair style +------------------------------------------------------------------------- */ + +template<class DeviceType> +void PairVashishtaKokkos<DeviceType>::init_style() +{ + PairVashishta::init_style(); + + // irequest = neigh request made by parent class + + neighflag = lmp->kokkos->neighflag; + int irequest = neighbor->nrequest - 1; + + neighbor->requests[irequest]-> + kokkos_host = Kokkos::Impl::is_same<DeviceType,LMPHostType>::value && + !Kokkos::Impl::is_same<DeviceType,LMPDeviceType>::value; + neighbor->requests[irequest]-> + kokkos_device = Kokkos::Impl::is_same<DeviceType,LMPDeviceType>::value; + + // always request a full neighbor list + + if (neighflag == FULL || neighflag == HALF || neighflag == HALFTHREAD) { + neighbor->requests[irequest]->full = 1; + neighbor->requests[irequest]->half = 0; + neighbor->requests[irequest]->full_cluster = 0; + if (neighflag == FULL) + neighbor->requests[irequest]->ghost = 1; + else + neighbor->requests[irequest]->ghost = 0; + } else { + error->all(FLERR,"Cannot use chosen neighbor list style with pair vashishta/kk"); + } +} + +/* ---------------------------------------------------------------------- */ + +template<class DeviceType> +void PairVashishtaKokkos<DeviceType>::setup_params() +{ + PairVashishta::setup_params(); + + // sync elem2param and params + + tdual_int_3d k_elem2param = tdual_int_3d("pair:elem2param",nelements,nelements,nelements); + t_host_int_3d h_elem2param = k_elem2param.h_view; + + tdual_param_1d k_params = tdual_param_1d("pair:params",nparams); + t_host_param_1d h_params = k_params.h_view; + + for (int i = 0; i < nelements; i++) + for (int j = 0; j < nelements; j++) + for (int k = 0; k < nelements; k++) + h_elem2param(i,j,k) = elem2param[i][j][k]; + + for (int m = 0; m < nparams; m++) + h_params[m] = params[m]; + + k_elem2param.template modify<LMPHostType>(); + k_elem2param.template sync<DeviceType>(); + k_params.template modify<LMPHostType>(); + k_params.template sync<DeviceType>(); + + d_elem2param = k_elem2param.d_view; + d_params = k_params.d_view; +} + +/* ---------------------------------------------------------------------- */ + +template<class DeviceType> +KOKKOS_INLINE_FUNCTION +void PairVashishtaKokkos<DeviceType>::twobody(const Param& param, const F_FLOAT& rsq, F_FLOAT& fforce, + const int& eflag, F_FLOAT& eng) const +{ + F_FLOAT r,rinvsq,r4inv,r6inv,reta,lam1r,lam4r,vc2,vc3; + r = sqrt(rsq); + rinvsq = 1.0/rsq; + r4inv = rinvsq*rinvsq; + r6inv = rinvsq*r4inv; + reta = pow(r,-param.eta); + lam1r = r*param.lam1inv; + lam4r = r*param.lam4inv; + vc2 = param.zizj * exp(-lam1r)/r; + vc3 = param.mbigd * r4inv*exp(-lam4r); + + fforce = (param.dvrc*r + - (4.0*vc3 + lam4r*vc3+param.big6w*r6inv + - param.heta*reta - vc2 - lam1r*vc2) + ) * rinvsq; + + if (eflag) eng = param.bigh*reta + vc2 - vc3 - param.bigw*r6inv - r*param.dvrc + param.c0; +} + +/* ---------------------------------------------------------------------- */ + +template<class DeviceType> +KOKKOS_INLINE_FUNCTION +void PairVashishtaKokkos<DeviceType>::threebody(const Param& paramij, const Param& paramik, const Param& paramijk, + const F_FLOAT& rsq1, const F_FLOAT& rsq2, + F_FLOAT *delr1, F_FLOAT *delr2, + F_FLOAT *fj, F_FLOAT *fk, const int& eflag, F_FLOAT& eng) const +{ + F_FLOAT r1,rinvsq1,rainv1,gsrainv1,gsrainvsq1,expgsrainv1; + F_FLOAT r2,rinvsq2,rainv2,gsrainv2,gsrainvsq2,expgsrainv2; + F_FLOAT rinv12,cs,delcs,delcssq,facexp,facrad,frad1,frad2,pcsinv,pcsinvsq,pcs; + F_FLOAT facang,facang12,csfacang,csfac1,csfac2; + + r1 = sqrt(rsq1); + rinvsq1 = 1.0/rsq1; + rainv1 = 1.0/(r1 - paramij.r0); + gsrainv1 = paramij.gamma * rainv1; + gsrainvsq1 = gsrainv1*rainv1/r1; + expgsrainv1 = exp(gsrainv1); + + r2 = sqrt(rsq2); + rinvsq2 = 1.0/rsq2; + rainv2 = 1.0/(r2 - paramik.r0); + gsrainv2 = paramik.gamma * rainv2; + gsrainvsq2 = gsrainv2*rainv2/r2; + expgsrainv2 = exp(gsrainv2); + + rinv12 = 1.0/(r1*r2); + cs = (delr1[0]*delr2[0] + delr1[1]*delr2[1] + delr1[2]*delr2[2]) * rinv12; + delcs = cs - paramijk.costheta; + delcssq = delcs*delcs; + pcsinv = paramijk.bigc*delcssq + 1.0; + pcsinvsq = pcsinv*pcsinv; + pcs = delcssq/pcsinv; + + facexp = expgsrainv1*expgsrainv2; + + facrad = paramijk.bigb * facexp * pcs; + frad1 = facrad*gsrainvsq1; + frad2 = facrad*gsrainvsq2; + facang = paramijk.big2b * facexp * delcs/pcsinvsq; + facang12 = rinv12*facang; + csfacang = cs*facang; + csfac1 = rinvsq1*csfacang; + + fj[0] = delr1[0]*(frad1+csfac1)-delr2[0]*facang12; + fj[1] = delr1[1]*(frad1+csfac1)-delr2[1]*facang12; + fj[2] = delr1[2]*(frad1+csfac1)-delr2[2]*facang12; + + csfac2 = rinvsq2*csfacang; + + fk[0] = delr2[0]*(frad2+csfac2)-delr1[0]*facang12; + fk[1] = delr2[1]*(frad2+csfac2)-delr1[1]*facang12; + fk[2] = delr2[2]*(frad2+csfac2)-delr1[2]*facang12; + + if (eflag) eng = facrad; +} + +/* ---------------------------------------------------------------------- */ + +template<class DeviceType> +KOKKOS_INLINE_FUNCTION +void PairVashishtaKokkos<DeviceType>::threebodyj(const Param& paramij, const Param& paramik, const Param& paramijk, + const F_FLOAT& rsq1, const F_FLOAT& rsq2, F_FLOAT *delr1, F_FLOAT *delr2, F_FLOAT *fj) const +{ + F_FLOAT r1,rinvsq1,rainv1,gsrainv1,gsrainvsq1,expgsrainv1; + F_FLOAT r2,rinvsq2,rainv2,gsrainv2,gsrainvsq2,expgsrainv2; + F_FLOAT rinv12,cs,delcs,delcssq,facexp,facrad,frad1,frad2,pcsinv,pcsinvsq,pcs; + F_FLOAT facang,facang12,csfacang,csfac1,csfac2; + + r1 = sqrt(rsq1); + rinvsq1 = 1.0/rsq1; + rainv1 = 1.0/(r1 - paramij.r0); + gsrainv1 = paramij.gamma * rainv1; + gsrainvsq1 = gsrainv1*rainv1/r1; + expgsrainv1 = exp(gsrainv1); + + r2 = sqrt(rsq2); + rinvsq2 = 1.0/rsq2; + rainv2 = 1.0/(r2 - paramik.r0); + gsrainv2 = paramik.gamma * rainv2; + gsrainvsq2 = gsrainv2*rainv2/r2; + expgsrainv2 = exp(gsrainv2); + + rinv12 = 1.0/(r1*r2); + cs = (delr1[0]*delr2[0] + delr1[1]*delr2[1] + delr1[2]*delr2[2]) * rinv12; + delcs = cs - paramijk.costheta; + delcssq = delcs*delcs; + pcsinv = paramijk.bigc*delcssq + 1.0; + pcsinvsq = pcsinv*pcsinv; + pcs = delcssq/pcsinv; + + facexp = expgsrainv1*expgsrainv2; + + facrad = paramijk.bigb * facexp * pcs; + frad1 = facrad*gsrainvsq1; + frad2 = facrad*gsrainvsq2; + facang = paramijk.big2b * facexp * delcs/pcsinvsq; + facang12 = rinv12*facang; + csfacang = cs*facang; + csfac1 = rinvsq1*csfacang; + + fj[0] = delr1[0]*(frad1+csfac1)-delr2[0]*facang12; + fj[1] = delr1[1]*(frad1+csfac1)-delr2[1]*facang12; + fj[2] = delr1[2]*(frad1+csfac1)-delr2[2]*facang12; +} + +/* ---------------------------------------------------------------------- */ + +template<class DeviceType> +template<int NEIGHFLAG> +KOKKOS_INLINE_FUNCTION +void PairVashishtaKokkos<DeviceType>::ev_tally(EV_FLOAT &ev, const int &i, const int &j, + const F_FLOAT &epair, const F_FLOAT &fpair, const F_FLOAT &delx, + const F_FLOAT &dely, const F_FLOAT &delz) const +{ + const int VFLAG = vflag_either; + + // The eatom and vatom arrays are atomic for half/thread neighbor list + + Kokkos::View<E_FLOAT*, typename DAT::t_efloat_1d::array_layout,DeviceType,Kokkos::MemoryTraits<AtomicF<NEIGHFLAG>::value> > v_eatom = k_eatom.view<DeviceType>(); + Kokkos::View<F_FLOAT*[6], typename DAT::t_virial_array::array_layout,DeviceType,Kokkos::MemoryTraits<AtomicF<NEIGHFLAG>::value> > v_vatom = k_vatom.view<DeviceType>(); + + + if (eflag_atom) { + const E_FLOAT epairhalf = 0.5 * epair; + v_eatom[i] += epairhalf; + if (NEIGHFLAG != FULL) + v_eatom[j] += epairhalf; + } + + if (VFLAG) { + const E_FLOAT v0 = delx*delx*fpair; + const E_FLOAT v1 = dely*dely*fpair; + const E_FLOAT v2 = delz*delz*fpair; + const E_FLOAT v3 = delx*dely*fpair; + const E_FLOAT v4 = delx*delz*fpair; + const E_FLOAT v5 = dely*delz*fpair; + + if (vflag_global) { + if (NEIGHFLAG != FULL) { + ev.v[0] += v0; + ev.v[1] += v1; + ev.v[2] += v2; + ev.v[3] += v3; + ev.v[4] += v4; + ev.v[5] += v5; + } else { + ev.v[0] += 0.5*v0; + ev.v[1] += 0.5*v1; + ev.v[2] += 0.5*v2; + ev.v[3] += 0.5*v3; + ev.v[4] += 0.5*v4; + ev.v[5] += 0.5*v5; + } + } + + if (vflag_atom) { + v_vatom(i,0) += 0.5*v0; + v_vatom(i,1) += 0.5*v1; + v_vatom(i,2) += 0.5*v2; + v_vatom(i,3) += 0.5*v3; + v_vatom(i,4) += 0.5*v4; + v_vatom(i,5) += 0.5*v5; + + if (NEIGHFLAG != FULL) { + v_vatom(j,0) += 0.5*v0; + v_vatom(j,1) += 0.5*v1; + v_vatom(j,2) += 0.5*v2; + v_vatom(j,3) += 0.5*v3; + v_vatom(j,4) += 0.5*v4; + v_vatom(j,5) += 0.5*v5; + } + } + } +} + +/* ---------------------------------------------------------------------- + tally eng_vdwl and virial into global and per-atom accumulators + called by SW and hbond potentials, newton_pair is always on + virial = riFi + rjFj + rkFk = (rj-ri) Fj + (rk-ri) Fk = drji*fj + drki*fk + ------------------------------------------------------------------------- */ + +template<class DeviceType> +template<int NEIGHFLAG> +KOKKOS_INLINE_FUNCTION +void PairVashishtaKokkos<DeviceType>::ev_tally3(EV_FLOAT &ev, const int &i, const int &j, int &k, + const F_FLOAT &evdwl, const F_FLOAT &ecoul, + F_FLOAT *fj, F_FLOAT *fk, F_FLOAT *drji, F_FLOAT *drki) const +{ + F_FLOAT epairthird,v[6]; + + const int VFLAG = vflag_either; + +// The eatom and vatom arrays are atomic for half/thread neighbor list + + Kokkos::View<E_FLOAT*, typename DAT::t_efloat_1d::array_layout,DeviceType,Kokkos::MemoryTraits<AtomicF<NEIGHFLAG>::value> > v_eatom = k_eatom.view<DeviceType>(); + Kokkos::View<F_FLOAT*[6], typename DAT::t_virial_array::array_layout,DeviceType,Kokkos::MemoryTraits<AtomicF<NEIGHFLAG>::value> > v_vatom = k_vatom.view<DeviceType>(); + + if (eflag_atom) { + epairthird = THIRD * (evdwl + ecoul); + v_eatom[i] += epairthird; + if (NEIGHFLAG != FULL) { + v_eatom[j] += epairthird; + v_eatom[k] += epairthird; + } + } + + if (VFLAG) { + v[0] = drji[0]*fj[0] + drki[0]*fk[0]; + v[1] = drji[1]*fj[1] + drki[1]*fk[1]; + v[2] = drji[2]*fj[2] + drki[2]*fk[2]; + v[3] = drji[0]*fj[1] + drki[0]*fk[1]; + v[4] = drji[0]*fj[2] + drki[0]*fk[2]; + v[5] = drji[1]*fj[2] + drki[1]*fk[2]; + + if (vflag_global) { + ev.v[0] += v[0]; + ev.v[1] += v[1]; + ev.v[2] += v[2]; + ev.v[3] += v[3]; + ev.v[4] += v[4]; + ev.v[5] += v[5]; + } + + if (vflag_atom) { + v_vatom(i,0) += THIRD*v[0]; v_vatom(i,1) += THIRD*v[1]; + v_vatom(i,2) += THIRD*v[2]; v_vatom(i,3) += THIRD*v[3]; + v_vatom(i,4) += THIRD*v[4]; v_vatom(i,5) += THIRD*v[5]; + + if (NEIGHFLAG != FULL) { + v_vatom(j,0) += THIRD*v[0]; v_vatom(j,1) += THIRD*v[1]; + v_vatom(j,2) += THIRD*v[2]; v_vatom(j,3) += THIRD*v[3]; + v_vatom(j,4) += THIRD*v[4]; v_vatom(j,5) += THIRD*v[5]; + + v_vatom(k,0) += THIRD*v[0]; v_vatom(k,1) += THIRD*v[1]; + v_vatom(k,2) += THIRD*v[2]; v_vatom(k,3) += THIRD*v[3]; + v_vatom(k,4) += THIRD*v[4]; v_vatom(k,5) += THIRD*v[5]; + } + } + } +} + +/* ---------------------------------------------------------------------- + tally eng_vdwl and virial into global and per-atom accumulators + called by SW and hbond potentials, newton_pair is always on + virial = riFi + rjFj + rkFk = (rj-ri) Fj + (rk-ri) Fk = drji*fj + drki*fk + ------------------------------------------------------------------------- */ + +template<class DeviceType> +KOKKOS_INLINE_FUNCTION +void PairVashishtaKokkos<DeviceType>::ev_tally3_atom(EV_FLOAT &ev, const int &i, + const F_FLOAT &evdwl, const F_FLOAT &ecoul, + F_FLOAT *fj, F_FLOAT *fk, F_FLOAT *drji, F_FLOAT *drki) const +{ + F_FLOAT epairthird,v[6]; + + const int VFLAG = vflag_either; + + if (eflag_atom) { + epairthird = THIRD * (evdwl + ecoul); + d_eatom[i] += epairthird; + } + + if (VFLAG) { + v[0] = drji[0]*fj[0] + drki[0]*fk[0]; + v[1] = drji[1]*fj[1] + drki[1]*fk[1]; + v[2] = drji[2]*fj[2] + drki[2]*fk[2]; + v[3] = drji[0]*fj[1] + drki[0]*fk[1]; + v[4] = drji[0]*fj[2] + drki[0]*fk[2]; + v[5] = drji[1]*fj[2] + drki[1]*fk[2]; + + if (vflag_atom) { + d_vatom(i,0) += THIRD*v[0]; d_vatom(i,1) += THIRD*v[1]; + d_vatom(i,2) += THIRD*v[2]; d_vatom(i,3) += THIRD*v[3]; + d_vatom(i,4) += THIRD*v[4]; d_vatom(i,5) += THIRD*v[5]; + } + } +} + +namespace LAMMPS_NS { +template class PairVashishtaKokkos<LMPDeviceType>; +#ifdef KOKKOS_HAVE_CUDA +template class PairVashishtaKokkos<LMPHostType>; +#endif +} + diff --git a/src/KOKKOS/pair_vashishta_kokkos.h b/src/KOKKOS/pair_vashishta_kokkos.h new file mode 100644 index 0000000000000000000000000000000000000000..8bc4d621c2b878c4aa27a1ae29c4081559db4154 --- /dev/null +++ b/src/KOKKOS/pair_vashishta_kokkos.h @@ -0,0 +1,162 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef PAIR_CLASS + +PairStyle(vashishta/kk,PairVashishtaKokkos<LMPDeviceType>) +PairStyle(vashishta/kk/device,PairVashishtaKokkos<LMPDeviceType>) +PairStyle(vashishta/kk/host,PairVashishtaKokkos<LMPHostType>) + +#else + +#ifndef LMP_PAIR_VASHISHTA_KOKKOS_H +#define LMP_PAIR_VASHISHTA_KOKKOS_H + +#include "pair_vashishta.h" +#include "pair_kokkos.h" + +template<int NEIGHFLAG, int EVFLAG> +struct TagPairVashishtaComputeHalf{}; + +template<int NEIGHFLAG, int EVFLAG> +struct TagPairVashishtaComputeFullA{}; + +template<int NEIGHFLAG, int EVFLAG> +struct TagPairVashishtaComputeFullB{}; + +struct TagPairVashishtaComputeShortNeigh{}; + +namespace LAMMPS_NS { + +template<class DeviceType> +class PairVashishtaKokkos : public PairVashishta { + public: + enum {EnabledNeighFlags=FULL}; + enum {COUL_FLAG=0}; + typedef DeviceType device_type; + typedef ArrayTypes<DeviceType> AT; + typedef EV_FLOAT value_type; + + PairVashishtaKokkos(class LAMMPS *); + virtual ~PairVashishtaKokkos(); + virtual void compute(int, int); + virtual void coeff(int, char **); + virtual void init_style(); + + template<int NEIGHFLAG, int EVFLAG> + KOKKOS_INLINE_FUNCTION + void operator()(TagPairVashishtaComputeHalf<NEIGHFLAG,EVFLAG>, const int&, EV_FLOAT&) const; + + template<int NEIGHFLAG, int EVFLAG> + KOKKOS_INLINE_FUNCTION + void operator()(TagPairVashishtaComputeHalf<NEIGHFLAG,EVFLAG>, const int&) const; + + template<int NEIGHFLAG, int EVFLAG> + KOKKOS_INLINE_FUNCTION + void operator()(TagPairVashishtaComputeFullA<NEIGHFLAG,EVFLAG>, const int&, EV_FLOAT&) const; + + template<int NEIGHFLAG, int EVFLAG> + KOKKOS_INLINE_FUNCTION + void operator()(TagPairVashishtaComputeFullA<NEIGHFLAG,EVFLAG>, const int&) const; + + template<int NEIGHFLAG, int EVFLAG> + KOKKOS_INLINE_FUNCTION + void operator()(TagPairVashishtaComputeFullB<NEIGHFLAG,EVFLAG>, const int&, EV_FLOAT&) const; + + template<int NEIGHFLAG, int EVFLAG> + KOKKOS_INLINE_FUNCTION + void operator()(TagPairVashishtaComputeFullB<NEIGHFLAG,EVFLAG>, const int&) const; + + KOKKOS_INLINE_FUNCTION + void operator()(TagPairVashishtaComputeShortNeigh, const int&) const; + + template<int NEIGHFLAG> + KOKKOS_INLINE_FUNCTION + void ev_tally(EV_FLOAT &ev, const int &i, const int &j, + const F_FLOAT &epair, const F_FLOAT &fpair, const F_FLOAT &delx, + const F_FLOAT &dely, const F_FLOAT &delz) const; + + template<int NEIGHFLAG> + KOKKOS_INLINE_FUNCTION + void ev_tally3(EV_FLOAT &ev, const int &i, const int &j, int &k, + const F_FLOAT &evdwl, const F_FLOAT &ecoul, + F_FLOAT *fj, F_FLOAT *fk, F_FLOAT *drji, F_FLOAT *drki) const; + + KOKKOS_INLINE_FUNCTION + void ev_tally3_atom(EV_FLOAT &ev, const int &i, + const F_FLOAT &evdwl, const F_FLOAT &ecoul, + F_FLOAT *fj, F_FLOAT *fk, F_FLOAT *drji, F_FLOAT *drki) const; + + protected: + typedef Kokkos::DualView<int***,DeviceType> tdual_int_3d; + typedef typename tdual_int_3d::t_dev_const_randomread t_int_3d_randomread; + typedef typename tdual_int_3d::t_host t_host_int_3d; + + t_int_3d_randomread d_elem2param; + DAT::t_int_1d_randomread d_map; + + typedef Kokkos::DualView<Param*,DeviceType> tdual_param_1d; + typedef typename tdual_param_1d::t_dev t_param_1d; + typedef typename tdual_param_1d::t_host t_host_param_1d; + + t_param_1d d_params; + + virtual void setup_params(); + void twobody(const Param&, const F_FLOAT&, F_FLOAT&, const int&, F_FLOAT&) const; + void threebody(const Param&, const Param&, const Param&, const F_FLOAT&, const F_FLOAT&, F_FLOAT *, F_FLOAT *, + F_FLOAT *, F_FLOAT *, const int&, F_FLOAT&) const; + void threebodyj(const Param&, const Param&, const Param&, const F_FLOAT&, const F_FLOAT&, F_FLOAT *, F_FLOAT *, + F_FLOAT *) const; + + typename ArrayTypes<DeviceType>::t_x_array_randomread x; + typename ArrayTypes<DeviceType>::t_f_array f; + typename ArrayTypes<DeviceType>::t_tagint_1d tag; + typename ArrayTypes<DeviceType>::t_int_1d_randomread type; + + DAT::tdual_efloat_1d k_eatom; + DAT::tdual_virial_array k_vatom; + DAT::t_efloat_1d d_eatom; + DAT::t_virial_array d_vatom; + + DAT::t_int_1d_randomread d_type2frho; + DAT::t_int_2d_randomread d_type2rhor; + DAT::t_int_2d_randomread d_type2z2r; + + typename ArrayTypes<DeviceType>::t_neighbors_2d d_neighbors; + typename ArrayTypes<DeviceType>::t_int_1d_randomread d_ilist; + typename ArrayTypes<DeviceType>::t_int_1d_randomread d_numneigh; + //NeighListKokkos<DeviceType> k_list; + + int neighflag,newton_pair; + int nlocal,nall,eflag,vflag; + + int inum; + Kokkos::View<int**,DeviceType> d_neighbors_short_2body; + Kokkos::View<int*,DeviceType> d_numneigh_short_2body; + Kokkos::View<int**,DeviceType> d_neighbors_short_3body; + Kokkos::View<int*,DeviceType> d_numneigh_short_3body; + friend void pair_virial_fdotr_compute<PairVashishtaKokkos>(PairVashishtaKokkos*); +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Cannot use chosen neighbor list style with pair vashishta/kk + +Self-explanatory. + +*/ diff --git a/src/MANYBODY/pair_vashishta.cpp b/src/MANYBODY/pair_vashishta.cpp index 6c5cc253351d9ea656aab7a17ab15398c788e1f4..2b867bc04640e27f7a79cff14a17d8888466d3ba 100644 --- a/src/MANYBODY/pair_vashishta.cpp +++ b/src/MANYBODY/pair_vashishta.cpp @@ -64,6 +64,8 @@ PairVashishta::PairVashishta(LAMMPS *lmp) : Pair(lmp) PairVashishta::~PairVashishta() { + if (copymode) return; + if (elements) for (int i = 0; i < nelements; i++) delete [] elements[i]; delete [] elements; diff --git a/src/MANYBODY/pair_vashishta.h b/src/MANYBODY/pair_vashishta.h index b6d9c574a51cc9e399827e1aa9ee9c3374a0be09..5ec47cf92de86a89cf49874e45093368809b887f 100644 --- a/src/MANYBODY/pair_vashishta.h +++ b/src/MANYBODY/pair_vashishta.h @@ -34,7 +34,6 @@ class PairVashishta : public Pair { double init_one(int, int); void init_style(); - protected: struct Param { double bigb,gamma,r0,bigc,costheta; double bigh,eta,zi,zj; @@ -45,7 +44,7 @@ class PairVashishta : public Pair { double lam1rc,lam4rc,vrcc2,vrcc3,vrc,dvrc,c0; int ielement,jelement,kelement; }; - + protected: double cutmax; // max cutoff for all elements int nelements; // # of unique elements char **elements; // names of unique elements