Updated and added third order kokkos
This commit is contained in:
@ -112,6 +112,7 @@ endif()
|
||||
|
||||
if(PKG_PHONON)
|
||||
list(APPEND KOKKOS_PKG_SOURCES ${KOKKOS_PKG_SOURCES_DIR}/dynamical_matrix_kokkos.cpp)
|
||||
list(APPEND KOKKOS_PKG_SOURCES ${KOKKOS_PKG_SOURCES_DIR}/third_order_kokkos.cpp)
|
||||
endif()
|
||||
|
||||
set_property(GLOBAL PROPERTY "KOKKOS_PKG_SOURCES" "${KOKKOS_PKG_SOURCES}")
|
||||
|
||||
@ -117,7 +117,7 @@ An alphabetic list of all general LAMMPS commands.
|
||||
* :doc:`thermo <thermo>`
|
||||
* :doc:`thermo_modify <thermo_modify>`
|
||||
* :doc:`thermo_style <thermo_style>`
|
||||
* :doc:`third_order <third_order>`
|
||||
* :doc:`third_order (k) <third_order>`
|
||||
* :doc:`timer <timer>`
|
||||
* :doc:`timestep <timestep>`
|
||||
* :doc:`uncompute <uncompute>`
|
||||
|
||||
@ -1,8 +1,11 @@
|
||||
.. index:: third_order
|
||||
.. index:: third_order/kk
|
||||
|
||||
third_order command
|
||||
===================
|
||||
|
||||
Accelerator Variants: third_order/kk
|
||||
|
||||
Syntax
|
||||
""""""
|
||||
|
||||
@ -49,6 +52,12 @@ If the style eskm is selected, the tensor will be using energy units of 10 J/mol
|
||||
These units conform to eskm style from the dynamical_matrix command, which
|
||||
will simplify operations using dynamical matrices with third order tensors.
|
||||
|
||||
----------
|
||||
|
||||
.. include:: accel_styles.rst
|
||||
|
||||
----------
|
||||
|
||||
Restrictions
|
||||
""""""""""""
|
||||
|
||||
|
||||
@ -312,6 +312,8 @@ action remap_kokkos.cpp remap.cpp
|
||||
action remap_kokkos.h remap.h
|
||||
action sna_kokkos.h sna.h
|
||||
action sna_kokkos_impl.h sna.cpp
|
||||
action third_order_kokkos.cpp dynamical_matrix.cpp
|
||||
action third_order_kokkos.h dynamical_matrix.h
|
||||
action verlet_kokkos.cpp
|
||||
action verlet_kokkos.h
|
||||
|
||||
|
||||
349
src/KOKKOS/third_order_kokkos.cpp
Normal file
349
src/KOKKOS/third_order_kokkos.cpp
Normal file
@ -0,0 +1,349 @@
|
||||
// clang-format off
|
||||
/* ----------------------------------------------------------------------
|
||||
LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator
|
||||
https://www.lammps.org/, 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: Charlie Sievers UC Davis (charliesievers at cox.net)
|
||||
//
|
||||
|
||||
#include "third_order_kokkos.h"
|
||||
|
||||
#include "angle.h"
|
||||
#include "atom_kokkos.h"
|
||||
#include "atom_masks.h"
|
||||
#include "bond.h"
|
||||
#include "comm.h"
|
||||
#include "compute.h"
|
||||
#include "dihedral.h"
|
||||
#include "domain.h"
|
||||
#include "error.h"
|
||||
#include "finish.h"
|
||||
#include "force.h"
|
||||
#include "group.h"
|
||||
#include "improper.h"
|
||||
#include "kokkos.h"
|
||||
#include "kspace.h"
|
||||
#include "memory.h"
|
||||
#include "modify.h"
|
||||
#include "neighbor.h"
|
||||
#include "pair.h"
|
||||
#include "timer.h"
|
||||
#include "update.h"
|
||||
|
||||
#include <cmath>
|
||||
#include <cstring>
|
||||
#include <algorithm>
|
||||
|
||||
using namespace LAMMPS_NS;
|
||||
enum{REGULAR,ESKM};
|
||||
|
||||
template<class ViewA, class ViewB>
|
||||
struct ForceAdder {
|
||||
ViewA a;
|
||||
ViewB b;
|
||||
ForceAdder(const ViewA& a_, const ViewB& b_):a(a_),b(b_) {}
|
||||
KOKKOS_INLINE_FUNCTION
|
||||
void operator() (const int& i) const {
|
||||
a(i,0) += b(i,0);
|
||||
a(i,1) += b(i,1);
|
||||
a(i,2) += b(i,2);
|
||||
}
|
||||
};
|
||||
|
||||
/* ---------------------------------------------------------------------- */
|
||||
|
||||
template<class View>
|
||||
struct Zero {
|
||||
View v;
|
||||
Zero(const View &v_):v(v_) {}
|
||||
KOKKOS_INLINE_FUNCTION
|
||||
void operator()(const int &i) const {
|
||||
v(i,0) = 0;
|
||||
v(i,1) = 0;
|
||||
v(i,2) = 0;
|
||||
}
|
||||
};
|
||||
|
||||
/* ---------------------------------------------------------------------- */
|
||||
|
||||
ThirdOrderKokkos::ThirdOrderKokkos(LAMMPS *lmp) : ThirdOrder(lmp)
|
||||
{
|
||||
atomKK = (AtomKokkos *) atom;
|
||||
}
|
||||
|
||||
/* ---------------------------------------------------------------------- */
|
||||
|
||||
ThirdOrderKokkos::~ThirdOrderKokkos()
|
||||
{
|
||||
|
||||
}
|
||||
|
||||
/* ---------------------------------------------------------------------- */
|
||||
|
||||
void ThirdOrderKokkos::command(int narg, char **arg)
|
||||
{
|
||||
atomKK->sync(Host, X_MASK|RMASS_MASK|TYPE_MASK);
|
||||
ThirdOrder::command(narg, arg);
|
||||
}
|
||||
|
||||
/* ----------------------------------------------------------------------
|
||||
setup without output or one-time post-init setup
|
||||
flag = 0 = just force calculation
|
||||
flag = 1 = reneighbor and force calculation
|
||||
------------------------------------------------------------------------- */
|
||||
|
||||
void ThirdOrderKokkos::setup()
|
||||
{
|
||||
lmp->kokkos->auto_sync = 1;
|
||||
|
||||
// setup domain, communication and neighboring
|
||||
// acquire ghosts
|
||||
// build neighbor lists
|
||||
if (triclinic) domain->x2lamda(atom->nlocal);
|
||||
domain->pbc();
|
||||
domain->reset_box();
|
||||
if (neighbor->style) neighbor->setup_bins();
|
||||
comm->exchange();
|
||||
comm->borders();
|
||||
if (triclinic) domain->lamda2x(atom->nlocal+atom->nghost);
|
||||
domain->image_check();
|
||||
domain->box_too_small_check();
|
||||
neighbor->build(1);
|
||||
|
||||
// compute all forces
|
||||
if (!modify->get_fix_by_id("package_omp")) external_force_clear = 1;
|
||||
eflag=0;
|
||||
vflag=0;
|
||||
update_force();
|
||||
|
||||
if (pair_compute_flag) {
|
||||
atomKK->sync(force->pair->execution_space,force->pair->datamask_read);
|
||||
force->pair->compute(eflag,vflag);
|
||||
atomKK->modified(force->pair->execution_space,force->pair->datamask_modify);
|
||||
}
|
||||
else if (force->pair) force->pair->compute_dummy(eflag,vflag);
|
||||
update->setupflag = 0;
|
||||
|
||||
lmp->kokkos->auto_sync = 0;
|
||||
|
||||
//if all then skip communication groupmap population
|
||||
if (gcount == atom->natoms)
|
||||
for (bigint i=0; i<atom->natoms; i++)
|
||||
groupmap[i] = i;
|
||||
else
|
||||
create_groupmap();
|
||||
|
||||
}
|
||||
|
||||
/* ----------------------------------------------------------------------
|
||||
evaluate potential energy and forces
|
||||
may migrate atoms due to reneighboring
|
||||
return new energy, which should include nextra_global dof
|
||||
return negative gradient stored in atom->f
|
||||
return negative gradient for nextra_global dof in fextra
|
||||
------------------------------------------------------------------------- */
|
||||
|
||||
void ThirdOrderKokkos::update_force()
|
||||
{
|
||||
int n_pre_force = modify->n_pre_force;
|
||||
int n_pre_reverse = modify->n_pre_reverse;
|
||||
int n_post_force = modify->n_post_force;
|
||||
|
||||
lmp->kokkos->auto_sync = 0;
|
||||
|
||||
f_merge_copy = DAT::t_f_array("ThirdOrderKokkos::f_merge_copy",atomKK->k_f.extent(0));
|
||||
|
||||
atomKK->modified(Host,X_MASK);
|
||||
atomKK->sync(Device,X_MASK);
|
||||
|
||||
force_clear();
|
||||
|
||||
neighbor->decide(); // needed for intel potentials to work
|
||||
|
||||
|
||||
if (n_pre_force) {
|
||||
modify->pre_force(vflag);
|
||||
timer->stamp(Timer::MODIFY);
|
||||
}
|
||||
|
||||
bool execute_on_host = false;
|
||||
unsigned int datamask_read_device = 0;
|
||||
unsigned int datamask_modify_device = 0;
|
||||
unsigned int datamask_read_host = 0;
|
||||
|
||||
if (pair_compute_flag) {
|
||||
if (force->pair->execution_space==Host) {
|
||||
execute_on_host = true;
|
||||
datamask_read_host |= force->pair->datamask_read;
|
||||
datamask_modify_device |= force->pair->datamask_modify;
|
||||
} else {
|
||||
datamask_read_device |= force->pair->datamask_read;
|
||||
datamask_modify_device |= force->pair->datamask_modify;
|
||||
}
|
||||
}
|
||||
if (atomKK->molecular && force->bond) {
|
||||
if (force->bond->execution_space==Host) {
|
||||
execute_on_host = true;
|
||||
datamask_read_host |= force->bond->datamask_read;
|
||||
datamask_modify_device |= force->bond->datamask_modify;
|
||||
} else {
|
||||
datamask_read_device |= force->bond->datamask_read;
|
||||
datamask_modify_device |= force->bond->datamask_modify;
|
||||
}
|
||||
}
|
||||
if (atomKK->molecular && force->angle) {
|
||||
if (force->angle->execution_space==Host) {
|
||||
execute_on_host = true;
|
||||
datamask_read_host |= force->angle->datamask_read;
|
||||
datamask_modify_device |= force->angle->datamask_modify;
|
||||
} else {
|
||||
datamask_read_device |= force->angle->datamask_read;
|
||||
datamask_modify_device |= force->angle->datamask_modify;
|
||||
}
|
||||
}
|
||||
if (atomKK->molecular && force->dihedral) {
|
||||
if (force->dihedral->execution_space==Host) {
|
||||
execute_on_host = true;
|
||||
datamask_read_host |= force->dihedral->datamask_read;
|
||||
datamask_modify_device |= force->dihedral->datamask_modify;
|
||||
} else {
|
||||
datamask_read_device |= force->dihedral->datamask_read;
|
||||
datamask_modify_device |= force->dihedral->datamask_modify;
|
||||
}
|
||||
}
|
||||
if (atomKK->molecular && force->improper) {
|
||||
if (force->improper->execution_space==Host) {
|
||||
execute_on_host = true;
|
||||
datamask_read_host |= force->improper->datamask_read;
|
||||
datamask_modify_device |= force->improper->datamask_modify;
|
||||
} else {
|
||||
datamask_read_device |= force->improper->datamask_read;
|
||||
datamask_modify_device |= force->improper->datamask_modify;
|
||||
}
|
||||
}
|
||||
if (kspace_compute_flag) {
|
||||
if (force->kspace->execution_space==Host) {
|
||||
execute_on_host = true;
|
||||
datamask_read_host |= force->kspace->datamask_read;
|
||||
datamask_modify_device |= force->kspace->datamask_modify;
|
||||
} else {
|
||||
datamask_read_device |= force->kspace->datamask_read;
|
||||
datamask_modify_device |= force->kspace->datamask_modify;
|
||||
}
|
||||
}
|
||||
|
||||
|
||||
if (pair_compute_flag) {
|
||||
atomKK->sync(force->pair->execution_space,force->pair->datamask_read);
|
||||
atomKK->sync(force->pair->execution_space,~(~force->pair->datamask_read|(F_MASK | ENERGY_MASK | VIRIAL_MASK)));
|
||||
Kokkos::Timer ktimer;
|
||||
force->pair->compute(eflag,vflag);
|
||||
atomKK->modified(force->pair->execution_space,force->pair->datamask_modify);
|
||||
atomKK->modified(force->pair->execution_space,~(~force->pair->datamask_modify|(F_MASK | ENERGY_MASK | VIRIAL_MASK)));
|
||||
timer->stamp(Timer::PAIR);
|
||||
}
|
||||
|
||||
if (execute_on_host) {
|
||||
if (pair_compute_flag && force->pair->datamask_modify!=(F_MASK | ENERGY_MASK | VIRIAL_MASK))
|
||||
Kokkos::fence();
|
||||
atomKK->sync_overlapping_device(Host,~(~datamask_read_host|(F_MASK | ENERGY_MASK | VIRIAL_MASK)));
|
||||
if (pair_compute_flag && force->pair->execution_space!=Host) {
|
||||
Kokkos::deep_copy(LMPHostType(),atomKK->k_f.h_view,0.0);
|
||||
}
|
||||
}
|
||||
|
||||
if (atomKK->molecular) {
|
||||
if (force->bond) {
|
||||
atomKK->sync(force->bond->execution_space,~(~force->bond->datamask_read|(F_MASK | ENERGY_MASK | VIRIAL_MASK)));
|
||||
force->bond->compute(eflag,vflag);
|
||||
atomKK->modified(force->bond->execution_space,~(~force->bond->datamask_modify|(F_MASK | ENERGY_MASK | VIRIAL_MASK)));
|
||||
}
|
||||
if (force->angle) {
|
||||
atomKK->sync(force->angle->execution_space,~(~force->angle->datamask_read|(F_MASK | ENERGY_MASK | VIRIAL_MASK)));
|
||||
force->angle->compute(eflag,vflag);
|
||||
atomKK->modified(force->angle->execution_space,~(~force->angle->datamask_modify|(F_MASK | ENERGY_MASK | VIRIAL_MASK)));
|
||||
}
|
||||
if (force->dihedral) {
|
||||
atomKK->sync(force->dihedral->execution_space,~(~force->dihedral->datamask_read|(F_MASK | ENERGY_MASK | VIRIAL_MASK)));
|
||||
force->dihedral->compute(eflag,vflag);
|
||||
atomKK->modified(force->dihedral->execution_space,~(~force->dihedral->datamask_modify|(F_MASK | ENERGY_MASK | VIRIAL_MASK)));
|
||||
}
|
||||
if (force->improper) {
|
||||
atomKK->sync(force->improper->execution_space,~(~force->improper->datamask_read|(F_MASK | ENERGY_MASK | VIRIAL_MASK)));
|
||||
force->improper->compute(eflag,vflag);
|
||||
atomKK->modified(force->improper->execution_space,~(~force->improper->datamask_modify|(F_MASK | ENERGY_MASK | VIRIAL_MASK)));
|
||||
}
|
||||
timer->stamp(Timer::BOND);
|
||||
}
|
||||
|
||||
if (kspace_compute_flag) {
|
||||
atomKK->sync(force->kspace->execution_space,~(~force->kspace->datamask_read|(F_MASK | ENERGY_MASK | VIRIAL_MASK)));
|
||||
force->kspace->compute(eflag,vflag);
|
||||
atomKK->modified(force->kspace->execution_space,~(~force->kspace->datamask_modify|(F_MASK | ENERGY_MASK | VIRIAL_MASK)));
|
||||
timer->stamp(Timer::KSPACE);
|
||||
}
|
||||
|
||||
if (execute_on_host && !std::is_same<LMPHostType,LMPDeviceType>::value) {
|
||||
if (f_merge_copy.extent(0)<atomKK->k_f.extent(0)) {
|
||||
f_merge_copy = DAT::t_f_array("ThirdOrderKokkos::f_merge_copy",atomKK->k_f.extent(0));
|
||||
}
|
||||
f = atomKK->k_f.d_view;
|
||||
Kokkos::deep_copy(LMPHostType(),f_merge_copy,atomKK->k_f.h_view);
|
||||
Kokkos::parallel_for(atomKK->k_f.extent(0),
|
||||
ForceAdder<DAT::t_f_array,DAT::t_f_array>(atomKK->k_f.d_view,f_merge_copy));
|
||||
atomKK->k_f.clear_sync_state(); // special case
|
||||
atomKK->k_f.modify<LMPDeviceType>();
|
||||
}
|
||||
if (n_pre_reverse) {
|
||||
modify->pre_reverse(eflag,vflag);
|
||||
timer->stamp(Timer::MODIFY);
|
||||
}
|
||||
if (force->newton) {
|
||||
comm->reverse_comm();
|
||||
timer->stamp(Timer::COMM);
|
||||
}
|
||||
// force modifications
|
||||
|
||||
if (n_post_force) {
|
||||
modify->post_force(vflag);
|
||||
timer->stamp(Timer::MODIFY);
|
||||
}
|
||||
|
||||
atomKK->sync(Host,F_MASK);
|
||||
lmp->kokkos->auto_sync = 1;
|
||||
|
||||
++ update->nsteps;
|
||||
}
|
||||
|
||||
/* ----------------------------------------------------------------------
|
||||
clear force on own & ghost atoms
|
||||
clear other arrays as needed
|
||||
------------------------------------------------------------------------- */
|
||||
|
||||
void ThirdOrderKokkos::force_clear()
|
||||
{
|
||||
if (external_force_clear) return;
|
||||
|
||||
atomKK->k_f.clear_sync_state(); // ignore host forces/torques since device views
|
||||
|
||||
// clear force on all particles
|
||||
// if either newton flag is set, also include ghosts
|
||||
// when using threads always clear all forces.
|
||||
|
||||
int nall = atomKK->nlocal;
|
||||
if (force->newton) nall += atomKK->nghost;
|
||||
|
||||
Kokkos::parallel_for(nall, Zero<typename ArrayTypes<LMPDeviceType>::t_f_array>(atomKK->k_f.view<LMPDeviceType>()));
|
||||
atomKK->modified(Device,F_MASK);
|
||||
|
||||
}
|
||||
54
src/KOKKOS/third_order_kokkos.h
Normal file
54
src/KOKKOS/third_order_kokkos.h
Normal file
@ -0,0 +1,54 @@
|
||||
/* -*- c++ -*- ----------------------------------------------------------
|
||||
LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator
|
||||
https://www.lammps.org/, 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 COMMAND_CLASS
|
||||
// clang-format off
|
||||
CommandStyle(third_order/kk,ThirdOrderKokkos);
|
||||
CommandStyle(third_order/kk/device,ThirdOrderKokkos);
|
||||
CommandStyle(third_order/kk/host,ThirdOrderKokkos);
|
||||
// clang-format on
|
||||
#else
|
||||
|
||||
#ifndef LMP_THIRD_ORDER_KOKKOS_H
|
||||
#define LMP_THIRD_ORDER_KOKKOS_H
|
||||
|
||||
#include "third_order.h"
|
||||
#include "kokkos_type.h"
|
||||
|
||||
namespace LAMMPS_NS {
|
||||
|
||||
class ThirdOrderKokkos : public ThirdOrder {
|
||||
public:
|
||||
ThirdOrderKokkos(class LAMMPS *);
|
||||
virtual ~ThirdOrderKokkos();
|
||||
void command(int, char **);
|
||||
void setup();
|
||||
|
||||
KOKKOS_INLINE_FUNCTION
|
||||
void operator() (const int& i) const {
|
||||
f(i,0) += f_merge_copy(i,0);
|
||||
f(i,1) += f_merge_copy(i,1);
|
||||
f(i,2) += f_merge_copy(i,2);
|
||||
}
|
||||
|
||||
protected:
|
||||
void update_force();
|
||||
void force_clear();
|
||||
DAT::t_f_array f_merge_copy,f;
|
||||
|
||||
|
||||
};
|
||||
} // namespace LAMMPS_NS
|
||||
|
||||
#endif //LMP_THIRD_ORDER_KOKKOS_H
|
||||
#endif
|
||||
@ -498,8 +498,16 @@ void ThirdOrder::displace_atom(int local_idx, int direction, int magnitude)
|
||||
|
||||
void ThirdOrder::update_force()
|
||||
{
|
||||
neighbor->decide(); // needed for intel potentials to work
|
||||
force_clear();
|
||||
int n_post_force = modify->n_post_force;
|
||||
int n_pre_force = modify->n_pre_force;
|
||||
int n_pre_reverse = modify->n_pre_reverse;
|
||||
|
||||
if (n_pre_force) {
|
||||
modify->pre_force(vflag);
|
||||
timer->stamp(Timer::MODIFY);
|
||||
}
|
||||
|
||||
if (pair_compute_flag) {
|
||||
force->pair->compute(eflag,vflag);
|
||||
@ -516,6 +524,10 @@ void ThirdOrder::update_force()
|
||||
force->kspace->compute(eflag,vflag);
|
||||
timer->stamp(Timer::KSPACE);
|
||||
}
|
||||
if (n_pre_reverse) {
|
||||
modify->pre_reverse(eflag,vflag);
|
||||
timer->stamp(Timer::MODIFY);
|
||||
}
|
||||
if (force->newton) {
|
||||
comm->reverse_comm();
|
||||
timer->stamp(Timer::COMM);
|
||||
@ -523,8 +535,10 @@ void ThirdOrder::update_force()
|
||||
|
||||
// force modifications
|
||||
|
||||
if (n_post_force) modify->post_force(vflag);
|
||||
timer->stamp(Timer::MODIFY);
|
||||
if (n_post_force) {
|
||||
modify->post_force(vflag);
|
||||
timer->stamp(Timer::MODIFY);
|
||||
}
|
||||
|
||||
++ update->nsteps;
|
||||
}
|
||||
|
||||
@ -19,8 +19,8 @@ class ThirdOrder : public Command {
|
||||
public:
|
||||
ThirdOrder(class LAMMPS *);
|
||||
virtual ~ThirdOrder();
|
||||
void command(int, char **);
|
||||
void setup();
|
||||
virtual void command(int, char **);
|
||||
virtual void setup();
|
||||
|
||||
protected:
|
||||
int eflag,vflag; // flags for energy/virial computation
|
||||
@ -35,12 +35,12 @@ class ThirdOrder : public Command {
|
||||
|
||||
int nvec; // local atomic dof = length of xvec
|
||||
|
||||
void update_force();
|
||||
void force_clear();
|
||||
virtual void update_force();
|
||||
virtual void force_clear();
|
||||
virtual void openfile(const char* filename);
|
||||
|
||||
|
||||
private:
|
||||
protected:
|
||||
void options(int, char **);
|
||||
void create_groupmap();
|
||||
void calculateMatrix();
|
||||
|
||||
Reference in New Issue
Block a user