forked from lijiext/lammps
Commit Julien 2 08/23/17
- reorganized includes - start work on magneto-mechanic potential (adding function) - renamed fix_nve_spin into fix_integration_spin
This commit is contained in:
parent
f5ff30df83
commit
3de0cf5ab4
|
@ -84,11 +84,11 @@ fix 1 all force/spin zeeman 10.0 0.0 0.0 1.0
|
||||||
#Fix Langevin spins (merging damping and temperature)
|
#Fix Langevin spins (merging damping and temperature)
|
||||||
#Temp | Alpha_trans | Alpha_long | Seed
|
#Temp | Alpha_trans | Alpha_long | Seed
|
||||||
#fix 2 all langevin/spin 0.0 0.1 0.0 21
|
#fix 2 all langevin/spin 0.0 0.1 0.0 21
|
||||||
fix 2 all langevin/spin 1.0 0.1 0.0 21
|
#fix 2 all langevin/spin 1.0 0.1 0.0 21
|
||||||
#fix 2 all langevin/spin 0.0 0.0 0.0 21
|
fix 2 all langevin/spin 0.0 0.0 0.0 21
|
||||||
|
|
||||||
#Magnetic integration fix
|
#Magnetic integration fix
|
||||||
fix 3 all nve/spin mpi
|
fix 3 all integration/spin mpi
|
||||||
|
|
||||||
#compute real time, total magnetization, magnetic energy, and spin temperature
|
#compute real time, total magnetization, magnetic energy, and spin temperature
|
||||||
#Iteration | Time | Mx | My | Mz | |M| | Em | Tm
|
#Iteration | Time | Mx | My | Mz | |M| | Em | Tm
|
||||||
|
@ -96,7 +96,7 @@ compute mag all compute/spin
|
||||||
fix outmag all ave/time 1 1 10 c_mag[1] c_mag[2] c_mag[3] c_mag[4] c_mag[5] c_mag[6] c_mag[7] file mag_Co_nodamp.dat format %20.16g
|
fix outmag all ave/time 1 1 10 c_mag[1] c_mag[2] c_mag[3] c_mag[4] c_mag[5] c_mag[6] c_mag[7] file mag_Co_nodamp.dat format %20.16g
|
||||||
|
|
||||||
#Setting the timestep for the simulation (in ps)
|
#Setting the timestep for the simulation (in ps)
|
||||||
timestep 0.00001
|
timestep 0.0001
|
||||||
|
|
||||||
##################
|
##################
|
||||||
#######run########
|
#######run########
|
||||||
|
@ -106,6 +106,6 @@ timestep 0.00001
|
||||||
dump 1 all custom 100 dump_spin_MM.lammpstrj type x y z spx spy spz
|
dump 1 all custom 100 dump_spin_MM.lammpstrj type x y z spx spy spz
|
||||||
|
|
||||||
#Running the simulations for N timesteps
|
#Running the simulations for N timesteps
|
||||||
run 10000
|
run 100000
|
||||||
#run 1
|
#run 1
|
||||||
|
|
||||||
|
|
|
@ -14,14 +14,14 @@
|
||||||
#include <math.h>
|
#include <math.h>
|
||||||
#include <stdlib.h>
|
#include <stdlib.h>
|
||||||
#include <string.h>
|
#include <string.h>
|
||||||
#include "atom_vec_spin.h"
|
|
||||||
#include "atom.h"
|
#include "atom.h"
|
||||||
|
#include "atom_vec_spin.h"
|
||||||
#include "comm.h"
|
#include "comm.h"
|
||||||
#include "domain.h"
|
#include "domain.h"
|
||||||
#include "modify.h"
|
#include "error.h"
|
||||||
#include "fix.h"
|
#include "fix.h"
|
||||||
#include "memory.h"
|
#include "memory.h"
|
||||||
#include "error.h"
|
#include "modify.h"
|
||||||
|
|
||||||
using namespace LAMMPS_NS;
|
using namespace LAMMPS_NS;
|
||||||
|
|
||||||
|
|
|
@ -13,16 +13,16 @@
|
||||||
|
|
||||||
#include <mpi.h>
|
#include <mpi.h>
|
||||||
#include <string.h>
|
#include <string.h>
|
||||||
#include "compute_spin.h"
|
|
||||||
#include "atom.h"
|
#include "atom.h"
|
||||||
#include "update.h"
|
#include "compute_spin.h"
|
||||||
#include "modify.h"
|
|
||||||
#include "domain.h"
|
#include "domain.h"
|
||||||
#include "memory.h"
|
|
||||||
#include "error.h"
|
#include "error.h"
|
||||||
|
#include "force.h"
|
||||||
#include "math_special.h"
|
#include "math_special.h"
|
||||||
#include "math_const.h"
|
#include "math_const.h"
|
||||||
#include "force.h"
|
#include "memory.h"
|
||||||
|
#include "modify.h"
|
||||||
|
#include "update.h"
|
||||||
|
|
||||||
using namespace LAMMPS_NS;
|
using namespace LAMMPS_NS;
|
||||||
using namespace MathSpecial;
|
using namespace MathSpecial;
|
||||||
|
|
|
@ -15,18 +15,19 @@
|
||||||
#include <stdio.h>
|
#include <stdio.h>
|
||||||
#include <stdlib.h>
|
#include <stdlib.h>
|
||||||
#include <string.h>
|
#include <string.h>
|
||||||
#include "fix_force_spin.h"
|
|
||||||
#include "atom.h"
|
#include "atom.h"
|
||||||
#include "update.h"
|
|
||||||
#include "domain.h"
|
#include "domain.h"
|
||||||
#include "respa.h"
|
|
||||||
#include "modify.h"
|
|
||||||
#include "input.h"
|
|
||||||
#include "variable.h"
|
|
||||||
#include "math_const.h"
|
|
||||||
#include "error.h"
|
#include "error.h"
|
||||||
|
#include "fix_force_spin.h"
|
||||||
#include "force.h"
|
#include "force.h"
|
||||||
|
#include "input.h"
|
||||||
|
#include "math_const.h"
|
||||||
#include "memory.h"
|
#include "memory.h"
|
||||||
|
#include "modify.h"
|
||||||
|
#include "respa.h"
|
||||||
|
#include "update.h"
|
||||||
|
#include "variable.h"
|
||||||
|
|
||||||
using namespace LAMMPS_NS;
|
using namespace LAMMPS_NS;
|
||||||
using namespace FixConst;
|
using namespace FixConst;
|
||||||
|
|
|
@ -14,27 +14,26 @@
|
||||||
#include <math.h>
|
#include <math.h>
|
||||||
#include <stdio.h>
|
#include <stdio.h>
|
||||||
#include <string.h>
|
#include <string.h>
|
||||||
#include "fix_nve_spin.h"
|
|
||||||
#include "atom.h"
|
#include "atom.h"
|
||||||
#include "atom_vec.h"
|
#include "atom_vec.h"
|
||||||
#include "update.h"
|
|
||||||
#include "respa.h"
|
|
||||||
#include "force.h"
|
|
||||||
#include "error.h"
|
#include "error.h"
|
||||||
|
#include "fix_force_spin.h"
|
||||||
|
#include "fix_integration_spin.h"
|
||||||
|
#include "fix_langevin_spin.h"
|
||||||
|
#include "force.h"
|
||||||
#include "math_vector.h"
|
#include "math_vector.h"
|
||||||
#include "math_extra.h"
|
#include "math_extra.h"
|
||||||
#include "math_const.h"
|
#include "math_const.h"
|
||||||
|
#include "memory.h"
|
||||||
#include "modify.h"
|
#include "modify.h"
|
||||||
|
|
||||||
//Add headers (see delete later)
|
|
||||||
#include "neighbor.h"
|
#include "neighbor.h"
|
||||||
#include "neigh_list.h"
|
#include "neigh_list.h"
|
||||||
#include "pair.h"
|
#include "pair.h"
|
||||||
#include "pair_spin.h"
|
|
||||||
#include "memory.h"
|
|
||||||
#include "fix_force_spin.h"
|
|
||||||
#include "fix_langevin_spin.h"
|
|
||||||
#include "pair_hybrid.h"
|
#include "pair_hybrid.h"
|
||||||
|
#include "pair_spin.h"
|
||||||
|
#include "respa.h"
|
||||||
|
#include "update.h"
|
||||||
|
|
||||||
using namespace LAMMPS_NS;
|
using namespace LAMMPS_NS;
|
||||||
using namespace FixConst;
|
using namespace FixConst;
|
||||||
|
@ -45,11 +44,11 @@ enum{NONE,SPIN};
|
||||||
|
|
||||||
/* ---------------------------------------------------------------------- */
|
/* ---------------------------------------------------------------------- */
|
||||||
|
|
||||||
FixNVESpin::FixNVESpin(LAMMPS *lmp, int narg, char **arg) :
|
FixIntegrationSpin::FixIntegrationSpin(LAMMPS *lmp, int narg, char **arg) :
|
||||||
FixNVE(lmp, narg, arg)
|
FixNVE(lmp, narg, arg)
|
||||||
{
|
{
|
||||||
|
|
||||||
if (narg != 4) error->all(FLERR,"Illegal fix nve/spin command");
|
if (narg != 4) error->all(FLERR,"Illegal fix integration/spin command");
|
||||||
|
|
||||||
time_integrate = 1;
|
time_integrate = 1;
|
||||||
|
|
||||||
|
@ -57,18 +56,18 @@ FixNVESpin::FixNVESpin(LAMMPS *lmp, int narg, char **arg) :
|
||||||
mpi_flag = NONE;
|
mpi_flag = NONE;
|
||||||
|
|
||||||
int iarg = 2;
|
int iarg = 2;
|
||||||
if (strcmp(arg[iarg],"nve/spin") == 0) {
|
if (strcmp(arg[iarg],"integration/spin") == 0) {
|
||||||
extra = SPIN;
|
extra = SPIN;
|
||||||
if (strcmp(arg[iarg+1],"serial") == 0){
|
if (strcmp(arg[iarg+1],"serial") == 0){
|
||||||
mpi_flag = 0;
|
mpi_flag = 0;
|
||||||
} else if (strcmp(arg[iarg+1],"mpi") == 0) {
|
} else if (strcmp(arg[iarg+1],"mpi") == 0) {
|
||||||
mpi_flag = 1;
|
mpi_flag = 1;
|
||||||
} else error->all(FLERR,"Illegal fix nve/spin command");
|
} else error->all(FLERR,"Illegal fix integration/spin command");
|
||||||
} else error->all(FLERR,"Illegal fix nve/spin command");
|
} else error->all(FLERR,"Illegal fix integration/spin command");
|
||||||
|
|
||||||
// error checks
|
// error checks
|
||||||
if (extra == SPIN && !atom->mumag_flag)
|
if (extra == SPIN && !atom->mumag_flag)
|
||||||
error->all(FLERR,"Fix nve/spin requires spin attribute mumag");
|
error->all(FLERR,"Fix integration/spin requires spin attribute mumag");
|
||||||
|
|
||||||
exch_flag = dmi_flag = me_flag = 0;
|
exch_flag = dmi_flag = me_flag = 0;
|
||||||
zeeman_flag = aniso_flag = 0;
|
zeeman_flag = aniso_flag = 0;
|
||||||
|
@ -80,7 +79,7 @@ FixNVESpin::FixNVESpin(LAMMPS *lmp, int narg, char **arg) :
|
||||||
}
|
}
|
||||||
|
|
||||||
/* ---------------------------------------------------------------------- */
|
/* ---------------------------------------------------------------------- */
|
||||||
FixNVESpin::~FixNVESpin(){
|
FixIntegrationSpin::~FixIntegrationSpin(){
|
||||||
//delete lockpairspin;
|
//delete lockpairspin;
|
||||||
//delete lockforcespin;
|
//delete lockforcespin;
|
||||||
memory->destroy(xi);
|
memory->destroy(xi);
|
||||||
|
@ -89,9 +88,6 @@ FixNVESpin::~FixNVESpin(){
|
||||||
memory->destroy(rsec);
|
memory->destroy(rsec);
|
||||||
memory->destroy(seci);
|
memory->destroy(seci);
|
||||||
|
|
||||||
#if defined SECTOR_PRINT
|
|
||||||
fclose(file_sect);
|
|
||||||
#endif
|
|
||||||
memory->destroy(spi);
|
memory->destroy(spi);
|
||||||
memory->destroy(spj);
|
memory->destroy(spj);
|
||||||
memory->destroy(fmi);
|
memory->destroy(fmi);
|
||||||
|
@ -100,20 +96,20 @@ FixNVESpin::~FixNVESpin(){
|
||||||
|
|
||||||
/* ---------------------------------------------------------------------- */
|
/* ---------------------------------------------------------------------- */
|
||||||
|
|
||||||
void FixNVESpin::init()
|
void FixIntegrationSpin::init()
|
||||||
{
|
{
|
||||||
FixNVE::init();
|
FixNVE::init();
|
||||||
|
|
||||||
dts = update->dt;
|
dts = update->dt;
|
||||||
memory->create(xi,3,"nves:xi");
|
memory->create(xi,3,"integrations:xi");
|
||||||
memory->create(sec,3,"nves:sec");
|
memory->create(sec,3,"integrations:sec");
|
||||||
memory->create(rsec,3,"nves:rsec");
|
memory->create(rsec,3,"integrations:rsec");
|
||||||
memory->create(seci,3,"nves:seci");
|
memory->create(seci,3,"integrations:seci");
|
||||||
|
|
||||||
memory->create(spi,3,"nves:spi");
|
memory->create(spi,3,"integrations:spi");
|
||||||
memory->create(spj,3,"nves:spj");
|
memory->create(spj,3,"integrations:spj");
|
||||||
memory->create(fmi,3,"nves:fmi");
|
memory->create(fmi,3,"integrations:fmi");
|
||||||
memory->create(fmj,3,"nves:fmj");
|
memory->create(fmj,3,"integrations:fmj");
|
||||||
|
|
||||||
|
|
||||||
if (strstr(force->pair_style,"pair/spin")) {
|
if (strstr(force->pair_style,"pair/spin")) {
|
||||||
|
@ -127,7 +123,7 @@ void FixNVESpin::init()
|
||||||
lockpairspin = (PairSpin *) lockhybrid->styles[ipair];
|
lockpairspin = (PairSpin *) lockhybrid->styles[ipair];
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
} else error->all(FLERR,"Illegal fix nve/spin command");
|
} else error->all(FLERR,"Illegal fix integration/spin command");
|
||||||
|
|
||||||
// check errors, and handle simple hybrid (not overlay)
|
// check errors, and handle simple hybrid (not overlay)
|
||||||
|
|
||||||
|
@ -168,24 +164,11 @@ void FixNVESpin::init()
|
||||||
sectoring();
|
sectoring();
|
||||||
}
|
}
|
||||||
|
|
||||||
#if defined SECTOR_PRINT
|
|
||||||
file_sect=fopen("sectoring.lammpstrj", "w");
|
|
||||||
fprintf(file_sect,"ITEM: TIMESTEP\n");
|
|
||||||
fprintf(file_sect,"%g\n",0.0);
|
|
||||||
fprintf(file_sect,"ITEM: NUMBER OF ATOMS\n");
|
|
||||||
//int natoms = atom->natoms;
|
|
||||||
int natoms = atom->nlocal;
|
|
||||||
fprintf(file_sect,"%d\n",natoms);
|
|
||||||
fprintf(file_sect,"ITEM: BOX BOUNDS\n");
|
|
||||||
for(int d=0; d<3; d++) fprintf(file_sect,"%lf %lf\n",domain->boxlo[d],domain->boxhi[d]);
|
|
||||||
fprintf(file_sect,"ITEM: ATOMS type x y z vx vy vz\n");
|
|
||||||
#endif
|
|
||||||
|
|
||||||
}
|
}
|
||||||
|
|
||||||
/* ---------------------------------------------------------------------- */
|
/* ---------------------------------------------------------------------- */
|
||||||
|
|
||||||
void FixNVESpin::initial_integrate(int vflag)
|
void FixIntegrationSpin::initial_integrate(int vflag)
|
||||||
{
|
{
|
||||||
double dtfm,msq,scale,fm2,fmsq,sp2,spsq,energy;
|
double dtfm,msq,scale,fm2,fmsq,sp2,spsq,energy;
|
||||||
double cp[3],g[3];
|
double cp[3],g[3];
|
||||||
|
@ -260,7 +243,7 @@ void FixNVESpin::initial_integrate(int vflag)
|
||||||
ComputeInteractionsSpin(i);
|
ComputeInteractionsSpin(i);
|
||||||
AdvanceSingleSpin(i,0.5*dts,sp,fm);
|
AdvanceSingleSpin(i,0.5*dts,sp,fm);
|
||||||
}
|
}
|
||||||
} else error->all(FLERR,"Illegal fix nve/spin command");
|
} else error->all(FLERR,"Illegal fix integration/spin command");
|
||||||
}
|
}
|
||||||
|
|
||||||
// update half x for all particles
|
// update half x for all particles
|
||||||
|
@ -272,28 +255,24 @@ void FixNVESpin::initial_integrate(int vflag)
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
|
}
|
||||||
|
|
||||||
|
/* ---------------------------------------------------------------------- */
|
||||||
|
void FixIntegrationSpin::ComputeMMforce()
|
||||||
|
{
|
||||||
|
const int nlocal = atom->nlocal;
|
||||||
|
int i,j,jj,inum,jnum,itype,jtype;
|
||||||
|
int *ilist,*jlist,*numneigh,**firstneigh;
|
||||||
|
double **x = atom->x;
|
||||||
|
double **f = atom->f;
|
||||||
|
double **sp = atom->sp;
|
||||||
|
const int newton_pair = force->newton_pair;
|
||||||
|
|
||||||
#if defined SECTOR_PRINT
|
|
||||||
int my_rank;
|
|
||||||
MPI_Comm_rank(world, &my_rank);
|
|
||||||
if (my_rank == 0) {
|
|
||||||
for (int j = 0; j < nsectors; j++) {
|
|
||||||
for (int i = 0; i < nlocal; i++) {
|
|
||||||
xi[0] = x[i][0];
|
|
||||||
xi[1] = x[i][1];
|
|
||||||
xi[2] = x[i][2];
|
|
||||||
nseci = coords2sector(xi);
|
|
||||||
if (j != nseci) continue;
|
|
||||||
fprintf(file_sect,"%d %lf %lf %lf %lf %lf %lf\n",j,xi[0],xi[1],xi[2],0.0,0.0,1.0);
|
|
||||||
}
|
|
||||||
}
|
|
||||||
}
|
|
||||||
#endif
|
|
||||||
|
|
||||||
}
|
}
|
||||||
|
|
||||||
/* ---------------------------------------------------------------------- */
|
/* ---------------------------------------------------------------------- */
|
||||||
void FixNVESpin::ComputeInteractionsSpin(int ii)
|
void FixIntegrationSpin::ComputeInteractionsSpin(int ii)
|
||||||
{
|
{
|
||||||
const int nlocal = atom->nlocal;
|
const int nlocal = atom->nlocal;
|
||||||
|
|
||||||
|
@ -403,7 +382,7 @@ void FixNVESpin::ComputeInteractionsSpin(int ii)
|
||||||
locklangevinspin->add_temperature(fmi);
|
locklangevinspin->add_temperature(fmi);
|
||||||
}
|
}
|
||||||
|
|
||||||
// replace the force by its new value
|
// replace the magnetic force by its new value
|
||||||
fm[i][0] = fmi[0];
|
fm[i][0] = fmi[0];
|
||||||
fm[i][1] = fmi[1];
|
fm[i][1] = fmi[1];
|
||||||
fm[i][2] = fmi[2];
|
fm[i][2] = fmi[2];
|
||||||
|
@ -411,7 +390,7 @@ void FixNVESpin::ComputeInteractionsSpin(int ii)
|
||||||
}
|
}
|
||||||
|
|
||||||
/* ---------------------------------------------------------------------- */
|
/* ---------------------------------------------------------------------- */
|
||||||
void FixNVESpin::sectoring()
|
void FixIntegrationSpin::sectoring()
|
||||||
{
|
{
|
||||||
double sublo[3],subhi[3];
|
double sublo[3],subhi[3];
|
||||||
double* sublotmp = domain->sublo;
|
double* sublotmp = domain->sublo;
|
||||||
|
@ -464,7 +443,7 @@ void FixNVESpin::sectoring()
|
||||||
}
|
}
|
||||||
|
|
||||||
/* ---------------------------------------------------------------------- */
|
/* ---------------------------------------------------------------------- */
|
||||||
int FixNVESpin::coords2sector(double *xi)
|
int FixIntegrationSpin::coords2sector(double *xi)
|
||||||
{
|
{
|
||||||
int nseci;
|
int nseci;
|
||||||
double sublo[3];
|
double sublo[3];
|
||||||
|
@ -489,7 +468,7 @@ int FixNVESpin::coords2sector(double *xi)
|
||||||
|
|
||||||
/* ---------------------------------------------------------------------- */
|
/* ---------------------------------------------------------------------- */
|
||||||
|
|
||||||
void FixNVESpin::AdvanceSingleSpin(int i, double dts, double **sp, double **fm)
|
void FixIntegrationSpin::AdvanceSingleSpin(int i, double dts, double **sp, double **fm)
|
||||||
{
|
{
|
||||||
double dtfm,msq,scale,fm2,fmsq,sp2,spsq,energy;
|
double dtfm,msq,scale,fm2,fmsq,sp2,spsq,energy;
|
||||||
double cp[3],g[3];
|
double cp[3],g[3];
|
||||||
|
@ -530,7 +509,7 @@ void FixNVESpin::AdvanceSingleSpin(int i, double dts, double **sp, double **fm)
|
||||||
|
|
||||||
/* ---------------------------------------------------------------------- */
|
/* ---------------------------------------------------------------------- */
|
||||||
|
|
||||||
void FixNVESpin::final_integrate()
|
void FixIntegrationSpin::final_integrate()
|
||||||
{
|
{
|
||||||
double dtfm,msq,scale,fm2,fmsq,energy;
|
double dtfm,msq,scale,fm2,fmsq,energy;
|
||||||
double cp[3],g[3];
|
double cp[3],g[3];
|
|
@ -13,7 +13,7 @@
|
||||||
|
|
||||||
#ifdef FIX_CLASS
|
#ifdef FIX_CLASS
|
||||||
|
|
||||||
FixStyle(nve/spin,FixNVESpin)
|
FixStyle(integration/spin,FixIntegrationSpin)
|
||||||
|
|
||||||
#else
|
#else
|
||||||
|
|
||||||
|
@ -24,18 +24,18 @@ FixStyle(nve/spin,FixNVESpin)
|
||||||
|
|
||||||
namespace LAMMPS_NS {
|
namespace LAMMPS_NS {
|
||||||
|
|
||||||
class FixNVESpin : public FixNVE {
|
class FixIntegrationSpin : public FixNVE {
|
||||||
|
|
||||||
public:
|
public:
|
||||||
FixNVESpin(class LAMMPS *, int, char **);
|
FixIntegrationSpin(class LAMMPS *, int, char **);
|
||||||
virtual ~FixNVESpin();
|
virtual ~FixIntegrationSpin();
|
||||||
void init();
|
void init();
|
||||||
virtual void initial_integrate(int);
|
virtual void initial_integrate(int);
|
||||||
void AdvanceSingleSpin(int, double, double **, double **);
|
void AdvanceSingleSpin(int, double, double **, double **);
|
||||||
virtual void final_integrate();
|
virtual void final_integrate();
|
||||||
void ComputeSpinInteractions();
|
|
||||||
void ComputeInteractionsSpin(int);
|
void ComputeInteractionsSpin(int);
|
||||||
|
void ComputeMMforce();
|
||||||
|
|
||||||
void sectoring();
|
void sectoring();
|
||||||
int coords2sector(double *);
|
int coords2sector(double *);
|
||||||
|
|
||||||
|
@ -59,10 +59,6 @@ class FixNVESpin : public FixNVE {
|
||||||
int *sec, *seci;
|
int *sec, *seci;
|
||||||
double *rsec;
|
double *rsec;
|
||||||
|
|
||||||
//#define SECTOR_PRINT
|
|
||||||
#if defined SECTOR_PRINT
|
|
||||||
FILE* file_sect=NULL;
|
|
||||||
#endif
|
|
||||||
};
|
};
|
||||||
|
|
||||||
}
|
}
|
|
@ -20,26 +20,27 @@
|
||||||
#include <math.h>
|
#include <math.h>
|
||||||
#include <string.h>
|
#include <string.h>
|
||||||
#include <stdlib.h>
|
#include <stdlib.h>
|
||||||
#include "fix_langevin_spin.h"
|
|
||||||
#include "math_extra.h"
|
|
||||||
#include "atom.h"
|
#include "atom.h"
|
||||||
#include "atom_vec_ellipsoid.h"
|
#include "atom_vec_ellipsoid.h"
|
||||||
#include "force.h"
|
#include "comm.h"
|
||||||
#include "update.h"
|
|
||||||
#include "modify.h"
|
|
||||||
#include "compute.h"
|
#include "compute.h"
|
||||||
#include "domain.h"
|
#include "domain.h"
|
||||||
|
#include "error.h"
|
||||||
|
#include "fix_langevin_spin.h"
|
||||||
|
#include "force.h"
|
||||||
|
#include "group.h"
|
||||||
|
#include "input.h"
|
||||||
|
#include "math_const.h"
|
||||||
|
#include "math_extra.h"
|
||||||
|
#include "memory.h"
|
||||||
|
#include "modify.h"
|
||||||
|
#include "random_mars.h"
|
||||||
|
#include "random_park.h"
|
||||||
#include "region.h"
|
#include "region.h"
|
||||||
#include "respa.h"
|
#include "respa.h"
|
||||||
#include "comm.h"
|
#include "update.h"
|
||||||
#include "input.h"
|
|
||||||
#include "variable.h"
|
#include "variable.h"
|
||||||
#include "random_mars.h"
|
|
||||||
#include "memory.h"
|
|
||||||
#include "error.h"
|
|
||||||
#include "group.h"
|
|
||||||
#include "math_const.h"
|
|
||||||
#include "random_park.h"
|
|
||||||
|
|
||||||
using namespace LAMMPS_NS;
|
using namespace LAMMPS_NS;
|
||||||
using namespace FixConst;
|
using namespace FixConst;
|
||||||
|
|
|
@ -13,20 +13,19 @@
|
||||||
|
|
||||||
#include <math.h>
|
#include <math.h>
|
||||||
#include <stdlib.h>
|
#include <stdlib.h>
|
||||||
#include "pair_spin.h"
|
|
||||||
#include "atom.h"
|
|
||||||
#include "neighbor.h"
|
|
||||||
#include "neigh_list.h"
|
|
||||||
#include "comm.h"
|
|
||||||
#include "force.h"
|
|
||||||
#include "memory.h"
|
|
||||||
#include "math_const.h"
|
|
||||||
#include "error.h"
|
|
||||||
#include "update.h"
|
|
||||||
#include <string.h>
|
#include <string.h>
|
||||||
|
|
||||||
//Add. lib. for full neighb. list
|
#include "atom.h"
|
||||||
|
#include "comm.h"
|
||||||
|
#include "error.h"
|
||||||
|
#include "force.h"
|
||||||
|
#include "neighbor.h"
|
||||||
|
#include "neigh_list.h"
|
||||||
#include "neigh_request.h"
|
#include "neigh_request.h"
|
||||||
|
#include "math_const.h"
|
||||||
|
#include "memory.h"
|
||||||
|
#include "pair_spin.h"
|
||||||
|
#include "update.h"
|
||||||
|
|
||||||
using namespace LAMMPS_NS;
|
using namespace LAMMPS_NS;
|
||||||
using namespace MathConst;
|
using namespace MathConst;
|
||||||
|
|
|
@ -31,7 +31,7 @@ class PairHybrid : public Pair {
|
||||||
friend class FixOMP;
|
friend class FixOMP;
|
||||||
friend class Force;
|
friend class Force;
|
||||||
friend class Respa;
|
friend class Respa;
|
||||||
friend class FixNVESpin;
|
friend class FixIntegrationSpin;
|
||||||
friend class Info;
|
friend class Info;
|
||||||
public:
|
public:
|
||||||
PairHybrid(class LAMMPS *);
|
PairHybrid(class LAMMPS *);
|
||||||
|
|
Loading…
Reference in New Issue