diff --git a/src/STUBS/mpi.cpp b/src/STUBS/mpi.cpp index e4f8d82fa..5087707d5 100644 --- a/src/STUBS/mpi.cpp +++ b/src/STUBS/mpi.cpp @@ -1,413 +1,413 @@ /* ----------------------------------------------------------------------- LAMMPS 2003 (July 31) - Molecular Dynamics Simulator Sandia National Laboratories, www.cs.sandia.gov/~sjplimp/lammps.html 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. ------------------------------------------------------------------------ */ /* Single-processor "stub" versions of MPI routines */ #include "stdlib.h" #include "string.h" #include "stdio.h" #include "stdint.h" #include <sys/time.h> #include "mpi.h" /* lo-level function prototypes */ void mpi_copy_int(void *, void *, int); void mpi_copy_float(void *, void *, int); void mpi_copy_double(void *, void *, int); void mpi_copy_char(void *, void *, int); void mpi_copy_byte(void *, void *, int); /* lo-level data structure */ struct { double value; int proc; } double_int; /* ---------------------------------------------------------------------- */ /* MPI Functions */ /* ---------------------------------------------------------------------- */ int MPI_Init(int *argc, char ***argv) {return 0;} /* ---------------------------------------------------------------------- */ int MPI_Initialized(int *flag) { *flag = 1; return 0; } /* ---------------------------------------------------------------------- */ int MPI_Comm_rank(MPI_Comm comm, int *me) { *me = 0; return 0; } /* ---------------------------------------------------------------------- */ int MPI_Comm_size(MPI_Comm comm, int *nprocs) { *nprocs = 1; return 0; } /* ---------------------------------------------------------------------- */ int MPI_Abort(MPI_Comm comm, int errorcode) { exit(1); return 0; } /* ---------------------------------------------------------------------- */ int MPI_Finalize() {return 0;} /* ---------------------------------------------------------------------- */ double MPI_Wtime() { double time; struct timeval tv; gettimeofday(&tv,NULL); time = 1.0 * tv.tv_sec + 1.0e-6 * tv.tv_usec; return time; } /* ---------------------------------------------------------------------- */ int MPI_Type_size(MPI_Datatype datatype, int *size) { if (datatype == MPI_INT) *size = sizeof(int); else if (datatype == MPI_FLOAT) *size = sizeof(float); else if (datatype == MPI_DOUBLE) *size = sizeof(double); else if (datatype == MPI_CHAR) *size = sizeof(char); else if (datatype == MPI_BYTE) *size = sizeof(char); - else if (datatype == MPI_UNSIGNED_LONG) *size = sizeof(uint64_t); + else if (datatype == MPI_UNSIGNED_LONG_LONG) *size = sizeof(uint64_t); else if (datatype == MPI_DOUBLE_INT) *size = sizeof(double_int); } /* ---------------------------------------------------------------------- */ int MPI_Send(void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm) { printf("MPI Stub WARNING: Should not send message to self\n"); return 0; } /* ---------------------------------------------------------------------- */ int MPI_Rsend(void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm) { printf("MPI Stub WARNING: Should not rsend message to self\n"); return 0; } /* ---------------------------------------------------------------------- */ int MPI_Recv(void *buf, int count, MPI_Datatype datatype, int source, int tag, MPI_Comm comm, MPI_Status *status) { printf("MPI Stub WARNING: Should not recv message from self\n"); return 0; } /* ---------------------------------------------------------------------- */ int MPI_Irecv(void *buf, int count, MPI_Datatype datatype, int source, int tag, MPI_Comm comm, MPI_Request *request) { printf("MPI Stub WARNING: Should not recv message from self\n"); return 0; } /* ---------------------------------------------------------------------- */ int MPI_Wait(MPI_Request *request, MPI_Status *status) { printf("MPI Stub WARNING: Should not wait on message from self\n"); return 0; } /* ---------------------------------------------------------------------- */ int MPI_Waitall(int n, MPI_Request *request, MPI_Status *status) { printf("MPI Stub WARNING: Should not wait on message from self\n"); return 0; } /* ---------------------------------------------------------------------- */ int MPI_Waitany(int count, MPI_Request *request, int *index, MPI_Status *status) { printf("MPI Stub WARNING: Should not wait on message from self\n"); return 0; } /* ---------------------------------------------------------------------- */ int MPI_Sendrecv(void *sbuf, int scount, MPI_Datatype sdatatype, int dest, int stag, void *rbuf, int rcount, MPI_Datatype rdatatype, int source, int rtag, MPI_Comm comm, MPI_Status *status) { printf("MPI Stub WARNING: Should not send message to self\n"); return 0; } /* ---------------------------------------------------------------------- */ int MPI_Get_count(MPI_Status *status, MPI_Datatype datatype, int *count) { printf("MPI Stub WARNING: Should not get count of message to self\n"); return 0; } /* ---------------------------------------------------------------------- */ int MPI_Comm_split(MPI_Comm comm, int color, int key, MPI_Comm *comm_out) { *comm_out = comm; return 0; } /* ---------------------------------------------------------------------- */ int MPI_Comm_dup(MPI_Comm comm, MPI_Comm *comm_out) { *comm_out = comm; return 0; } /* ---------------------------------------------------------------------- */ int MPI_Comm_free(MPI_Comm *comm) {return 0;} /* ---------------------------------------------------------------------- */ int MPI_Cart_create(MPI_Comm comm_old, int ndims, int *dims, int *periods, int reorder, MPI_Comm *comm_cart) { *comm_cart = comm_old; return 0; } /* ---------------------------------------------------------------------- */ int MPI_Cart_get(MPI_Comm comm, int maxdims, int *dims, int *periods, int *coords) { dims[0] = dims[1] = dims[2] = 1; periods[0] = periods[1] = periods[2] = 1; coords[0] = coords[1] = coords[2] = 0; return 0; } /* ---------------------------------------------------------------------- */ int MPI_Cart_shift(MPI_Comm comm, int direction, int displ, int *source, int *dest) { *source = *dest = 0; return 0; } /* ---------------------------------------------------------------------- */ int MPI_Cart_rank(MPI_Comm comm, int *coords, int *rank) { *rank = 0; return 0; } /* ---------------------------------------------------------------------- */ int MPI_Barrier(MPI_Comm comm) {return 0;} /* ---------------------------------------------------------------------- */ int MPI_Bcast(void *buf, int count, MPI_Datatype datatype, int root, MPI_Comm comm) {return 0;} /* ---------------------------------------------------------------------- */ /* copy values from data1 to data2 */ int MPI_Allreduce(void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) { int n; if (datatype == MPI_INT) n = count*sizeof(int); else if (datatype == MPI_FLOAT) n = count*sizeof(float); else if (datatype == MPI_DOUBLE) n = count*sizeof(double); else if (datatype == MPI_CHAR) n = count*sizeof(char); else if (datatype == MPI_BYTE) n = count*sizeof(char); - else if (datatype == MPI_UNSIGNED_LONG) n = count*sizeof(uint64_t); + else if (datatype == MPI_UNSIGNED_LONG_LONG) n = count*sizeof(uint64_t); else if (datatype == MPI_DOUBLE_INT) n = count*sizeof(double_int); memcpy(recvbuf,sendbuf,n); return 0; } /* ---------------------------------------------------------------------- */ /* copy values from data1 to data2 */ int MPI_Reduce(void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, int root, MPI_Comm comm) { int n; if (datatype == MPI_INT) n = count*sizeof(int); else if (datatype == MPI_FLOAT) n = count*sizeof(float); else if (datatype == MPI_DOUBLE) n = count*sizeof(double); else if (datatype == MPI_CHAR) n = count*sizeof(char); else if (datatype == MPI_BYTE) n = count*sizeof(char); - else if (datatype == MPI_UNSIGNED_LONG) n = count*sizeof(uint64_t); + else if (datatype == MPI_UNSIGNED_LONG_LONG) n = count*sizeof(uint64_t); else if (datatype == MPI_DOUBLE_INT) n = count*sizeof(double_int); memcpy(recvbuf,sendbuf,n); return 0; } /* ---------------------------------------------------------------------- */ int MPI_Scan(void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) { int n; if (datatype == MPI_INT) n = count*sizeof(int); else if (datatype == MPI_FLOAT) n = count*sizeof(float); else if (datatype == MPI_DOUBLE) n = count*sizeof(double); else if (datatype == MPI_CHAR) n = count*sizeof(char); else if (datatype == MPI_BYTE) n = count*sizeof(char); - else if (datatype == MPI_UNSIGNED_LONG) n = count*sizeof(uint64_t); + else if (datatype == MPI_UNSIGNED_LONG_LONG) n = count*sizeof(uint64_t); else if (datatype == MPI_DOUBLE_INT) n = count*sizeof(double_int); memcpy(recvbuf,sendbuf,n); return 0; } /* ---------------------------------------------------------------------- */ /* copy values from data1 to data2 */ int MPI_Allgather(void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm) { int n; if (sendtype == MPI_INT) n = sendcount*sizeof(int); else if (sendtype == MPI_FLOAT) n = sendcount*sizeof(float); else if (sendtype == MPI_DOUBLE) n = sendcount*sizeof(double); else if (sendtype == MPI_CHAR) n = sendcount*sizeof(char); else if (sendtype == MPI_BYTE) n = sendcount*sizeof(char); - else if (sendtype == MPI_UNSIGNED_LONG) n = sendcount*sizeof(uint64_t); + else if (sendtype == MPI_UNSIGNED_LONG_LONG) n = sendcount*sizeof(uint64_t); else if (sendtype == MPI_DOUBLE_INT) n = sendcount*sizeof(double_int); memcpy(recvbuf,sendbuf,n); return 0; } /* ---------------------------------------------------------------------- */ /* copy values from data1 to data2 */ int MPI_Allgatherv(void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int *recvcounts, int *displs, MPI_Datatype recvtype, MPI_Comm comm) { int n; if (sendtype == MPI_INT) n = sendcount*sizeof(int); else if (sendtype == MPI_FLOAT) n = sendcount*sizeof(float); else if (sendtype == MPI_DOUBLE) n = sendcount*sizeof(double); else if (sendtype == MPI_CHAR) n = sendcount*sizeof(char); else if (sendtype == MPI_BYTE) n = sendcount*sizeof(char); - else if (sendtype == MPI_UNSIGNED_LONG) n = sendcount*sizeof(uint64_t); + else if (sendtype == MPI_UNSIGNED_LONG_LONG) n = sendcount*sizeof(uint64_t); else if (sendtype == MPI_DOUBLE_INT) n = sendcount*sizeof(double_int); memcpy(recvbuf,sendbuf,n); return 0; } /* ---------------------------------------------------------------------- */ /* copy values from data1 to data2 */ int MPI_Reduce_scatter(void *sendbuf, void *recvbuf, int *recvcounts, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) { int n; if (datatype == MPI_INT) n = *recvcounts*sizeof(int); else if (datatype == MPI_FLOAT) n = *recvcounts*sizeof(float); else if (datatype == MPI_DOUBLE) n = *recvcounts*sizeof(double); else if (datatype == MPI_CHAR) n = *recvcounts*sizeof(char); else if (datatype == MPI_BYTE) n = *recvcounts*sizeof(char); - else if (datatype == MPI_UNSIGNED_LONG) n = *recvcounts*sizeof(uint64_t); + else if (datatype == MPI_UNSIGNED_LONG_LONG) n = *recvcounts*sizeof(uint64_t); else if (datatype == MPI_DOUBLE_INT) n = *recvcounts*sizeof(double_int); memcpy(recvbuf,sendbuf,n); return 0; } /* ---------------------------------------------------------------------- */ /* copy values from data1 to data2 */ int MPI_Gather(void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm) { int n; if (sendtype == MPI_INT) n = sendcount*sizeof(int); else if (sendtype == MPI_FLOAT) n = sendcount*sizeof(float); else if (sendtype == MPI_DOUBLE) n = sendcount*sizeof(double); else if (sendtype == MPI_CHAR) n = sendcount*sizeof(char); else if (sendtype == MPI_BYTE) n = sendcount*sizeof(char); - else if (sendtype == MPI_UNSIGNED_LONG) n = sendcount*sizeof(uint64_t); + else if (sendtype == MPI_UNSIGNED_LONG_LONG) n = sendcount*sizeof(uint64_t); else if (sendtype == MPI_DOUBLE_INT) n = sendcount*sizeof(double_int); memcpy(recvbuf,sendbuf,n); return 0; } /* ---------------------------------------------------------------------- */ /* copy values from data1 to data2 */ int MPI_Gatherv(void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int *recvcounts, int *displs, MPI_Datatype recvtype, int root, MPI_Comm comm) { int n; if (sendtype == MPI_INT) n = sendcount*sizeof(int); else if (sendtype == MPI_FLOAT) n = sendcount*sizeof(float); else if (sendtype == MPI_DOUBLE) n = sendcount*sizeof(double); else if (sendtype == MPI_CHAR) n = sendcount*sizeof(char); else if (sendtype == MPI_BYTE) n = sendcount*sizeof(char); - else if (sendtype == MPI_UNSIGNED_LONG) n = sendcount*sizeof(uint64_t); + else if (sendtype == MPI_UNSIGNED_LONG_LONG) n = sendcount*sizeof(uint64_t); else if (sendtype == MPI_DOUBLE_INT) n = sendcount*sizeof(double_int); memcpy(recvbuf,sendbuf,n); return 0; } diff --git a/src/STUBS/mpi.h b/src/STUBS/mpi.h index d9874d79e..8c70c9f0f 100644 --- a/src/STUBS/mpi.h +++ b/src/STUBS/mpi.h @@ -1,117 +1,117 @@ /* ----------------------------------------------------------------------- LAMMPS 2003 (July 31) - Molecular Dynamics Simulator Sandia National Laboratories, www.cs.sandia.gov/~sjplimp/lammps.html 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. ------------------------------------------------------------------------ */ #ifndef MPI_STUBS #define MPI_STUBS /* Dummy defs for MPI stubs */ #define MPI_COMM_WORLD 0 #define MPI_SUCCESS 0 #define MPI_INT 1 #define MPI_FLOAT 2 #define MPI_DOUBLE 3 #define MPI_CHAR 4 #define MPI_BYTE 5 -#define MPI_UNSIGNED_LONG 6 +#define MPI_UNSIGNED_LONG_LONG 6 #define MPI_DOUBLE_INT 7 #define MPI_SUM 1 #define MPI_MAX 2 #define MPI_MIN 3 #define MPI_MAXLOC 4 #define MPI_MINLOC 5 #define MPI_LOR 6 #define MPI_ANY_SOURCE -1 #define MPI_Comm int #define MPI_Request int #define MPI_Datatype int #define MPI_Op int /* MPI data structs */ struct MPI_Status { int MPI_SOURCE; }; /* Function prototypes for MPI stubs */ int MPI_Init(int *argc, char ***argv); int MPI_Initialized(int *flag); int MPI_Comm_rank(MPI_Comm comm, int *me); int MPI_Comm_size(MPI_Comm comm, int *nprocs); int MPI_Abort(MPI_Comm comm, int errorcode); int MPI_Finalize(); double MPI_Wtime(); int MPI_Type_size(int, int *); int MPI_Send(void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm); int MPI_Rsend(void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm); int MPI_Recv(void *buf, int count, MPI_Datatype datatype, int source, int tag, MPI_Comm comm, MPI_Status *status); int MPI_Irecv(void *buf, int count, MPI_Datatype datatype, int source, int tag, MPI_Comm comm, MPI_Request *request); int MPI_Wait(MPI_Request *request, MPI_Status *status); int MPI_Waitall(int n, MPI_Request *request, MPI_Status *status); int MPI_Waitany(int count, MPI_Request *request, int *index, MPI_Status *status); int MPI_Sendrecv(void *sbuf, int scount, MPI_Datatype sdatatype, int dest, int stag, void *rbuf, int rcount, MPI_Datatype rdatatype, int source, int rtag, MPI_Comm comm, MPI_Status *status); int MPI_Get_count(MPI_Status *status, MPI_Datatype datatype, int *count); int MPI_Comm_split(MPI_Comm comm, int color, int key, MPI_Comm *comm_out); int MPI_Comm_dup(MPI_Comm comm, MPI_Comm *comm_out); int MPI_Comm_free(MPI_Comm *comm); int MPI_Cart_create(MPI_Comm comm_old, int ndims, int *dims, int *periods, int reorder, MPI_Comm *comm_cart); int MPI_Cart_get(MPI_Comm comm, int maxdims, int *dims, int *periods, int *coords); int MPI_Cart_shift(MPI_Comm comm, int direction, int displ, int *source, int *dest); int MPI_Cart_rank(MPI_Comm comm, int *coords, int *rank); int MPI_Barrier(MPI_Comm comm); int MPI_Bcast(void *buf, int count, MPI_Datatype datatype, int root, MPI_Comm comm); int MPI_Allreduce(void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm); int MPI_Reduce(void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, int root, MPI_Comm comm); int MPI_Scan(void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm); int MPI_Allgather(void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm); int MPI_Allgatherv(void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int *recvcounts, int *displs, MPI_Datatype recvtype, MPI_Comm comm); int MPI_Reduce_scatter(void *sendbuf, void *recvbuf, int *recvcounts, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm); int MPI_Gather(void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm); int MPI_Gatherv(void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int *recvcounts, int *displs, MPI_Datatype recvtype, int root, MPI_Comm comm); #endif diff --git a/src/compute_reduce.cpp b/src/compute_reduce.cpp index 0e07f95dd..db9c3b6a6 100644 --- a/src/compute_reduce.cpp +++ b/src/compute_reduce.cpp @@ -1,656 +1,656 @@ /* ---------------------------------------------------------------------- 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. ------------------------------------------------------------------------- */ #include "string.h" #include "stdlib.h" #include "compute_reduce.h" #include "lmptype.h" #include "atom.h" #include "update.h" #include "domain.h" #include "modify.h" #include "fix.h" #include "force.h" #include "comm.h" #include "group.h" #include "input.h" #include "variable.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; enum{SUM,MINN,MAXX,AVE}; enum{X,V,F,COMPUTE,FIX,VARIABLE}; enum{PERATOM,LOCAL}; #define INVOKED_VECTOR 2 #define INVOKED_ARRAY 4 #define INVOKED_PERATOM 8 #define INVOKED_LOCAL 16 #define MIN(A,B) ((A) < (B)) ? (A) : (B) #define MAX(A,B) ((A) > (B)) ? (A) : (B) #define BIG 1.0e20 /* ---------------------------------------------------------------------- */ ComputeReduce::ComputeReduce(LAMMPS *lmp, int narg, char **arg) : Compute(lmp, narg, arg) { int iarg; if (strcmp(style,"reduce") == 0) { if (narg < 5) error->all("Illegal compute reduce command"); idregion = NULL; iarg = 3; } else if (strcmp(style,"reduce/region") == 0) { if (narg < 6) error->all("Illegal compute reduce/region command"); iregion = domain->find_region(arg[3]); if (iregion == -1) error->all("Region ID for compute reduce/region does not exist"); int n = strlen(arg[3]) + 1; idregion = new char[n]; strcpy(idregion,arg[3]); iarg = 4; } if (strcmp(arg[iarg],"sum") == 0) mode = SUM; else if (strcmp(arg[iarg],"min") == 0) mode = MINN; else if (strcmp(arg[iarg],"max") == 0) mode = MAXX; else if (strcmp(arg[iarg],"ave") == 0) mode = AVE; else error->all("Illegal compute reduce command"); iarg++; MPI_Comm_rank(world,&me); // parse remaining values until one isn't recognized which = new int[narg-4]; argindex = new int[narg-4]; flavor = new int[narg-4]; ids = new char*[narg-4]; value2index = new int[narg-4]; nvalues = 0; while (iarg < narg) { ids[nvalues] = NULL; if (strcmp(arg[iarg],"x") == 0) { which[nvalues] = X; argindex[nvalues++] = 0; } else if (strcmp(arg[iarg],"y") == 0) { which[nvalues] = X; argindex[nvalues++] = 1; } else if (strcmp(arg[iarg],"z") == 0) { which[nvalues] = X; argindex[nvalues++] = 2; } else if (strcmp(arg[iarg],"vx") == 0) { which[nvalues] = V; argindex[nvalues++] = 0; } else if (strcmp(arg[iarg],"vy") == 0) { which[nvalues] = V; argindex[nvalues++] = 1; } else if (strcmp(arg[iarg],"vz") == 0) { which[nvalues] = V; argindex[nvalues++] = 2; } else if (strcmp(arg[iarg],"fx") == 0) { which[nvalues] = F; argindex[nvalues++] = 0; } else if (strcmp(arg[iarg],"fy") == 0) { which[nvalues] = F; argindex[nvalues++] = 1; } else if (strcmp(arg[iarg],"fz") == 0) { which[nvalues] = F; argindex[nvalues++] = 2; } else if (strncmp(arg[iarg],"c_",2) == 0 || strncmp(arg[iarg],"f_",2) == 0 || strncmp(arg[iarg],"v_",2) == 0) { if (arg[iarg][0] == 'c') which[nvalues] = COMPUTE; else if (arg[iarg][0] == 'f') which[nvalues] = FIX; else if (arg[iarg][0] == 'v') which[nvalues] = VARIABLE; int n = strlen(arg[iarg]); char *suffix = new char[n]; strcpy(suffix,&arg[iarg][2]); char *ptr = strchr(suffix,'['); if (ptr) { if (suffix[strlen(suffix)-1] != ']') error->all("Illegal compute reduce command"); argindex[nvalues] = atoi(ptr+1); *ptr = '\0'; } else argindex[nvalues] = 0; n = strlen(suffix) + 1; ids[nvalues] = new char[n]; strcpy(ids[nvalues],suffix); nvalues++; delete [] suffix; } else break; iarg++; } // optional args replace = new int[nvalues]; for (int i = 0; i < nvalues; i++) replace[i] = -1; while (iarg < narg) { if (strcmp(arg[iarg],"replace") == 0) { if (iarg+3 > narg) error->all("Illegal compute reduce command"); if (mode != MINN && mode != MAXX) error->all("Compute reduce replace requires min or max mode"); int col1 = atoi(arg[iarg+1]) - 1; int col2 = atoi(arg[iarg+2]) - 1; if (col1 < 0 || col1 >= nvalues || col2 < 0 || col2 >= nvalues) error->all("Illegal compute reduce command"); if (col1 == col2) error->all("Illegal compute reduce command"); if (replace[col1] >= 0 || replace[col2] >= 0) error->all("Invalid replace values in compute reduce"); replace[col1] = col2; iarg += 3; } else error->all("Illegal compute reduce command"); } // delete replace if not set int flag = 0; for (int i = 0; i < nvalues; i++) if (replace[i] >= 0) flag = 1; if (!flag) { delete [] replace; replace = NULL; } // setup and error check for (int i = 0; i < nvalues; i++) { if (which[i] == X || which[i] == V || which[i] == F) flavor[i] = PERATOM; else if (which[i] == COMPUTE) { int icompute = modify->find_compute(ids[i]); if (icompute < 0) error->all("Compute ID for compute reduce does not exist"); if (modify->compute[icompute]->peratom_flag) { flavor[i] = PERATOM; if (argindex[i] == 0 && modify->compute[icompute]->size_peratom_cols != 0) error->all("Compute reduce compute does not " "calculate a per-atom vector"); if (argindex[i] && modify->compute[icompute]->size_peratom_cols == 0) error->all("Compute reduce compute does not " "calculate a per-atom array"); if (argindex[i] && argindex[i] > modify->compute[icompute]->size_peratom_cols) error->all("Compute reduce compute array is accessed out-of-range"); } else if (modify->compute[icompute]->local_flag) { flavor[i] = LOCAL; if (argindex[i] == 0 && modify->compute[icompute]->size_local_cols != 0) error->all("Compute reduce compute does not " "calculate a local vector"); if (argindex[i] && modify->compute[icompute]->size_local_cols == 0) error->all("Compute reduce compute does not " "calculate a local array"); if (argindex[i] && argindex[i] > modify->compute[icompute]->size_local_cols) error->all("Compute reduce compute array is accessed out-of-range"); } else error->all("Compute reduce compute calculates global values"); } else if (which[i] == FIX) { int ifix = modify->find_fix(ids[i]); if (ifix < 0) error->all("Fix ID for compute reduce does not exist"); if (modify->fix[ifix]->peratom_flag) { flavor[i] = PERATOM; if (argindex[i] == 0 && modify->fix[ifix]->size_peratom_cols != 0) error->all("Compute reduce fix does not " "calculate a per-atom vector"); if (argindex[i] && modify->fix[ifix]->size_peratom_cols == 0) error->all("Compute reduce fix does not " "calculate a per-atom array"); if (argindex[i] && argindex[i] > modify->fix[ifix]->size_peratom_cols) error->all("Compute reduce fix array is accessed out-of-range"); } else if (modify->fix[ifix]->local_flag) { flavor[i] = LOCAL; if (argindex[i] == 0 && modify->fix[ifix]->size_local_cols != 0) error->all("Compute reduce fix does not " "calculate a local vector"); if (argindex[i] && modify->fix[ifix]->size_local_cols == 0) error->all("Compute reduce fix does not " "calculate a local array"); if (argindex[i] && argindex[i] > modify->fix[ifix]->size_local_cols) error->all("Compute reduce fix array is accessed out-of-range"); } else error->all("Compute reduce fix calculates global values"); } else if (which[i] == VARIABLE) { int ivariable = input->variable->find(ids[i]); if (ivariable < 0) error->all("Variable name for compute reduce does not exist"); if (input->variable->atomstyle(ivariable) == 0) error->all("Compute reduce variable is not atom-style variable"); flavor[i] = PERATOM; } } // this compute produces either a scalar or vector if (nvalues == 1) { scalar_flag = 1; if (mode == SUM) extscalar = 1; else extscalar = 0; vector = onevec = NULL; indices = owner = NULL; } else { vector_flag = 1; size_vector = nvalues; if (mode == SUM) extvector = 1; else extvector = 0; vector = new double[size_vector]; onevec = new double[size_vector]; indices = new int[size_vector]; owner = new int[size_vector]; } maxatom = 0; varatom = NULL; } /* ---------------------------------------------------------------------- */ ComputeReduce::~ComputeReduce() { delete [] which; delete [] argindex; delete [] flavor; for (int m = 0; m < nvalues; m++) delete [] ids[m]; delete [] ids; delete [] value2index; delete [] replace; delete [] idregion; delete [] vector; delete [] onevec; delete [] indices; delete [] owner; memory->sfree(varatom); } /* ---------------------------------------------------------------------- */ void ComputeReduce::init() { // set indices and check validity of all computes,fixes,variables for (int m = 0; m < nvalues; m++) { if (which[m] == COMPUTE) { int icompute = modify->find_compute(ids[m]); if (icompute < 0) error->all("Compute ID for compute reduce does not exist"); value2index[m] = icompute; } else if (which[m] == FIX) { int ifix = modify->find_fix(ids[m]); if (ifix < 0) error->all("Fix ID for compute reduce does not exist"); value2index[m] = ifix; } else if (which[m] == VARIABLE) { int ivariable = input->variable->find(ids[m]); if (ivariable < 0) error->all("Variable name for compute reduce does not exist"); value2index[m] = ivariable; } else value2index[m] = -1; } // set index and check validity of region if (idregion) { iregion = domain->find_region(idregion); if (iregion == -1) error->all("Region ID for compute reduce/region does not exist"); } } /* ---------------------------------------------------------------------- */ double ComputeReduce::compute_scalar() { invoked_scalar = update->ntimestep; double one = compute_one(0,-1); if (mode == SUM) { MPI_Allreduce(&one,&scalar,1,MPI_DOUBLE,MPI_SUM,world); } else if (mode == MINN) { MPI_Allreduce(&one,&scalar,1,MPI_DOUBLE,MPI_MIN,world); } else if (mode == MAXX) { MPI_Allreduce(&one,&scalar,1,MPI_DOUBLE,MPI_MAX,world); } else if (mode == AVE) { MPI_Allreduce(&one,&scalar,1,MPI_DOUBLE,MPI_SUM,world); scalar /= count(0); } return scalar; } /* ---------------------------------------------------------------------- */ void ComputeReduce::compute_vector() { invoked_vector = update->ntimestep; for (int m = 0; m < nvalues; m++) if (!replace || replace[m] < 0) { onevec[m] = compute_one(m,-1); indices[m] = index; } if (mode == SUM) { for (int m = 0; m < nvalues; m++) MPI_Allreduce(&onevec[m],&vector[m],1,MPI_DOUBLE,MPI_SUM,world); } else if (mode == MINN) { if (!replace) { for (int m = 0; m < nvalues; m++) MPI_Allreduce(&onevec[m],&vector[m],1,MPI_DOUBLE,MPI_MIN,world); } else { for (int m = 0; m < nvalues; m++) if (replace[m] < 0) { pairme.value = onevec[m]; pairme.proc = me; MPI_Allreduce(&pairme,&pairall,1,MPI_DOUBLE_INT,MPI_MINLOC,world); vector[m] = pairall.value; owner[m] = pairall.proc; } for (int m = 0; m < nvalues; m++) if (replace[m] >= 0) { if (me == owner[replace[m]]) vector[m] = compute_one(m,indices[replace[m]]); MPI_Bcast(&vector[m],1,MPI_DOUBLE,owner[replace[m]],world); } } } else if (mode == MAXX) { if (!replace) { for (int m = 0; m < nvalues; m++) MPI_Allreduce(&onevec[m],&vector[m],1,MPI_DOUBLE,MPI_MAX,world); } else { for (int m = 0; m < nvalues; m++) if (replace[m] < 0) { pairme.value = onevec[m]; pairme.proc = me; MPI_Allreduce(&pairme,&pairall,1,MPI_DOUBLE_INT,MPI_MAXLOC,world); vector[m] = pairall.value; owner[m] = pairall.proc; } for (int m = 0; m < nvalues; m++) if (replace[m] >= 0) { if (me == owner[replace[m]]) vector[m] = compute_one(m,indices[replace[m]]); MPI_Bcast(&vector[m],1,MPI_DOUBLE,owner[replace[m]],world); } } } else if (mode == AVE) { for (int m = 0; m < nvalues; m++) { MPI_Allreduce(&onevec[m],&vector[m],1,MPI_DOUBLE,MPI_SUM,world); vector[m] /= count(m); } } } /* ---------------------------------------------------------------------- calculate reduced value for one input M and return it if flag = -1: sum/min/max/ave all values in vector for per-atom quantities, limit to atoms in group if mode = MIN or MAX, also set index to which vector value wins if flag >= 0: simply return vector[flag] ------------------------------------------------------------------------- */ double ComputeReduce::compute_one(int m, int flag) { int i; // invoke the appropriate attribute,compute,fix,variable // for flag = -1, compute scalar quantity by scanning over atom properties // only include atoms in group for atom properties and per-atom quantities index = -1; int vidx = value2index[m]; int aidx = argindex[m]; int *mask = atom->mask; int nlocal = atom->nlocal; double one; if (mode == SUM) one = 0.0; else if (mode == MINN) one = BIG; else if (mode == MAXX) one = -BIG; else if (mode == AVE) one = 0.0; if (which[m] == X) { double **x = atom->x; if (flag < 0) { for (i = 0; i < nlocal; i++) if (mask[i] & groupbit) combine(one,x[i][aidx],i); } else one = x[flag][aidx]; } else if (which[m] == V) { double **v = atom->v; if (flag < 0) { for (i = 0; i < nlocal; i++) if (mask[i] & groupbit) combine(one,v[i][aidx],i); } else one = v[flag][aidx]; } else if (which[m] == F) { double **f = atom->f; if (flag < 0) { for (i = 0; i < nlocal; i++) if (mask[i] & groupbit) combine(one,f[i][aidx],i); } else one = f[flag][aidx]; // invoke compute if not previously invoked } else if (which[m] == COMPUTE) { Compute *compute = modify->compute[vidx]; if (flavor[m] == PERATOM) { if (!(compute->invoked_flag & INVOKED_PERATOM)) { compute->compute_peratom(); compute->invoked_flag |= INVOKED_PERATOM; } if (aidx == 0) { double *comp_vec = compute->vector_atom; int n = nlocal; if (flag < 0) { for (i = 0; i < n; i++) if (mask[i] & groupbit) combine(one,comp_vec[i],i); } else one = comp_vec[flag]; } else { double **carray_atom = compute->array_atom; int n = nlocal; int aidxm1 = aidx - 1; if (flag < 0) { for (i = 0; i < n; i++) if (mask[i] & groupbit) combine(one,carray_atom[i][aidxm1],i); } else one = carray_atom[flag][aidxm1]; } } else if (flavor[m] == LOCAL) { if (!(compute->invoked_flag & INVOKED_LOCAL)) { compute->compute_local(); compute->invoked_flag |= INVOKED_LOCAL; } if (aidx == 0) { double *comp_vec = compute->vector_local; int n = compute->size_local_rows; if (flag < 0) for (i = 0; i < n; i++) combine(one,comp_vec[i],i); else one = comp_vec[flag]; } else { double **carray_local = compute->array_local; int n = compute->size_local_rows; int aidxm1 = aidx - 1; if (flag < 0) for (i = 0; i < n; i++) combine(one,carray_local[i][aidxm1],i); else one = carray_local[flag][aidxm1]; } } // access fix fields, check if fix frequency is a match } else if (which[m] == FIX) { if (update->ntimestep % modify->fix[vidx]->peratom_freq) error->all("Fix used in compute reduce not computed at compatible time"); Fix *fix = modify->fix[vidx]; if (flavor[m] == PERATOM) { if (aidx == 0) { double *fix_vector = fix->vector_atom; int n = nlocal; if (flag < 0) { for (i = 0; i < n; i++) if (mask[i] & groupbit) combine(one,fix_vector[i],i); } else one = fix_vector[flag]; } else { double **fix_array = fix->array_atom; int aidxm1 = aidx - 1; if (flag < 0) { for (i = 0; i < nlocal; i++) if (mask[i] & groupbit) combine(one,fix_array[i][aidxm1],i); } else one = fix_array[flag][aidxm1]; } } else if (flavor[m] == LOCAL) { if (aidx == 0) { double *fix_vector = fix->vector_local; int n = fix->size_local_rows; if (flag < 0) for (i = 0; i < n; i++) combine(one,fix_vector[i],i); else one = fix_vector[flag]; } else { double **fix_array = fix->array_local; int n = fix->size_local_rows; int aidxm1 = aidx - 1; if (flag < 0) for (i = 0; i < n; i++) combine(one,fix_array[i][aidxm1],i); else one = fix_array[flag][aidxm1]; } } // evaluate atom-style variable } else if (which[m] == VARIABLE) { if (nlocal > maxatom) { maxatom = atom->nmax; memory->sfree(varatom); varatom = (double *) memory->smalloc(maxatom*sizeof(double),"reduce:varatom"); } input->variable->compute_atom(vidx,igroup,varatom,1,0); if (flag < 0) { for (i = 0; i < nlocal; i++) if (mask[i] & groupbit) combine(one,varatom[i],i); } else one = varatom[flag]; } return one; } /* ---------------------------------------------------------------------- */ bigint ComputeReduce::count(int m) { int vidx = value2index[m]; int aidx = argindex[m]; if (which[m] == X || which[m] == V || which[m] == F) return group->count(igroup); else if (which[m] == COMPUTE) { Compute *compute = modify->compute[vidx]; if (flavor[m] == PERATOM) { return group->count(igroup); } else if (flavor[m] == LOCAL) { bigint ncount = compute->size_local_rows; bigint ncountall; - MPI_Allreduce(&ncount,&ncountall,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&ncount,&ncountall,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); return ncountall; } } else if (which[m] == FIX) { Fix *fix = modify->fix[vidx]; if (flavor[m] == PERATOM) { return group->count(igroup); } else if (flavor[m] == LOCAL) { bigint ncount = fix->size_local_rows; bigint ncountall; - MPI_Allreduce(&ncount,&ncountall,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&ncount,&ncountall,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); return ncountall; } } else if (which[m] == VARIABLE) return group->count(igroup); bigint dummy = 0; return dummy; } /* ---------------------------------------------------------------------- combine two values according to reduction mode for MIN/MAX, also update index with winner ------------------------------------------------------------------------- */ void ComputeReduce::combine(double &one, double two, int i) { if (mode == SUM || mode == AVE) one += two; else if (mode == MINN) { if (two < one) { one = two; index = i; } } else if (mode == MAXX) { if (two > one) { one = two; index = i; } } } /* ---------------------------------------------------------------------- memory usage of varatom ------------------------------------------------------------------------- */ double ComputeReduce::memory_usage() { double bytes = maxatom * sizeof(double); return bytes; } diff --git a/src/create_atoms.cpp b/src/create_atoms.cpp index 5f54d8fe8..e895c6853 100644 --- a/src/create_atoms.cpp +++ b/src/create_atoms.cpp @@ -1,483 +1,483 @@ /* ---------------------------------------------------------------------- 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. ------------------------------------------------------------------------- */ #include "math.h" #include "stdlib.h" #include "string.h" #include "create_atoms.h" #include "lmptype.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" #include "modify.h" #include "fix.h" #include "domain.h" #include "lattice.h" #include "region.h" #include "random_park.h" #include "error.h" using namespace LAMMPS_NS; #define BIG 1.0e30 #define EPSILON 1.0e-6 enum{BOX,REGION,SINGLE,RANDOM}; #define MIN(a,b) ((a) < (b) ? (a) : (b)) #define MAX(a,b) ((a) > (b) ? (a) : (b)) /* ---------------------------------------------------------------------- */ CreateAtoms::CreateAtoms(LAMMPS *lmp) : Pointers(lmp) {} /* ---------------------------------------------------------------------- */ void CreateAtoms::command(int narg, char **arg) { if (domain->box_exist == 0) error->all("Create_atoms command before simulation box is defined"); if (modify->nfix_restart_peratom) error->all("Cannot create_atoms after " "reading restart file with per-atom info"); // parse arguments if (narg < 2) error->all("Illegal create_atoms command"); itype = atoi(arg[0]); if (itype <= 0 || itype > atom->ntypes) error->all("Invalid atom type in create_atoms command"); int iarg; if (strcmp(arg[1],"box") == 0) { style = BOX; iarg = 2; } else if (strcmp(arg[1],"region") == 0) { style = REGION; if (narg < 3) error->all("Illegal create_atoms command"); nregion = domain->find_region(arg[2]); if (nregion == -1) error->all("Create_atoms region ID does not exist"); iarg = 3;; } else if (strcmp(arg[1],"single") == 0) { style = SINGLE; if (narg < 5) error->all("Illegal create_atoms command"); xone[0] = atof(arg[2]); xone[1] = atof(arg[3]); xone[2] = atof(arg[4]); iarg = 5; } else if (strcmp(arg[1],"random") == 0) { style = RANDOM; if (narg < 5) error->all("Illegal create_atoms command"); nrandom = atoi(arg[2]); seed = atoi(arg[3]); if (strcmp(arg[4],"NULL") == 0) nregion = -1; else { nregion = domain->find_region(arg[4]); if (nregion == -1) error->all("Create_atoms region ID does not exist"); } iarg = 5; } else error->all("Illegal create_atoms command"); // process optional keywords int scaleflag = 1; if (domain->lattice) { nbasis = domain->lattice->nbasis; basistype = new int[nbasis]; for (int i = 0; i < nbasis; i++) basistype[i] = itype; } while (iarg < narg) { if (strcmp(arg[iarg],"basis") == 0) { if (iarg+3 > narg) error->all("Illegal create_atoms command"); if (domain->lattice == NULL) error->all("Cannot create atoms with undefined lattice"); int ibasis = atoi(arg[iarg+1]); itype = atoi(arg[iarg+2]); if (ibasis <= 0 || ibasis > nbasis || itype <= 0 || itype > atom->ntypes) error->all("Illegal create_atoms command"); basistype[ibasis-1] = itype; iarg += 3; } else if (strcmp(arg[iarg],"units") == 0) { if (iarg+2 > narg) error->all("Illegal create_atoms command"); if (strcmp(arg[iarg+1],"box") == 0) scaleflag = 0; else if (strcmp(arg[iarg+1],"lattice") == 0) scaleflag = 1; else error->all("Illegal create_atoms command"); iarg += 2; } else error->all("Illegal create_atoms command"); } // error checks if (style == RANDOM) { if (nrandom < 0) error->all("Illegal create_atoms command"); if (seed <= 0) error->all("Illegal create_atoms command"); } // demand lattice be defined // else setup scaling for single atom // could use domain->lattice->lattice2box() to do conversion of // lattice to box, but not consistent with other uses of units=lattice // triclinic remapping occurs in add_single() if (style == BOX || style == REGION) { if (domain->lattice == NULL) error->all("Cannot create atoms with undefined lattice"); } else if (scaleflag == 1) { if (domain->lattice == NULL) error->all("Cannot create atoms with undefined lattice"); xone[0] *= domain->lattice->xlattice; xone[1] *= domain->lattice->ylattice; xone[2] *= domain->lattice->zlattice; } // add atoms bigint natoms_previous = atom->natoms; int nlocal_previous = atom->nlocal; if (style == SINGLE) add_single(); else if (style == RANDOM) add_random(); else add_lattice(); // invoke set_arrays() for fixes that need initialization of new atoms int nlocal = atom->nlocal; for (int m = 0; m < modify->nfix; m++) { Fix *fix = modify->fix[m]; if (fix->create_attribute) for (int i = nlocal_previous; i < nlocal; i++) fix->set_arrays(i); } // clean up if (domain->lattice) delete [] basistype; // new total # of atoms bigint nblocal = atom->nlocal; - MPI_Allreduce(&nblocal,&atom->natoms,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&nblocal,&atom->natoms,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); // print status if (comm->me == 0) { if (screen) fprintf(screen,"Created %lu atoms\n",atom->natoms-natoms_previous); if (logfile) fprintf(logfile,"Created %lu atoms\n",atom->natoms-natoms_previous); } // reset simulation now that more atoms are defined // add tags for newly created atoms if possible // if global map exists, reset it // if a molecular system, set nspecial to 0 for new atoms if (atom->natoms > MAXINT32) atom->tag_enable = 0; if (atom->natoms <= MAXINT32) atom->tag_extend(); if (atom->map_style) { atom->nghost = 0; atom->map_init(); atom->map_set(); } if (atom->molecular) { int **nspecial = atom->nspecial; for (int i = nlocal_previous; i < atom->nlocal; i++) { nspecial[i][0] = 0; nspecial[i][1] = 0; nspecial[i][2] = 0; } } } /* ---------------------------------------------------------------------- add single atom with coords at xone if it's in my sub-box if triclinic, xone is in lamda coords ------------------------------------------------------------------------- */ void CreateAtoms::add_single() { double *sublo,*subhi; // sub-domain bounding box, in lamda units if triclinic if (domain->triclinic == 0) { sublo = domain->sublo; subhi = domain->subhi; } else { sublo = domain->sublo_lamda; subhi = domain->subhi_lamda; } // if triclinic, convert to lamda coords (0-1) double lamda[3],*coord; if (domain->triclinic) { domain->x2lamda(xone,lamda); coord = lamda; } else coord = xone; // if atom is in my subbox, create it if (coord[0] >= sublo[0] && coord[0] < subhi[0] && coord[1] >= sublo[1] && coord[1] < subhi[1] && coord[2] >= sublo[2] && coord[2] < subhi[2]) atom->avec->create_atom(itype,xone); } /* ---------------------------------------------------------------------- add Nrandom atoms at random locations ------------------------------------------------------------------------- */ void CreateAtoms::add_random() { double xlo,ylo,zlo,xhi,yhi,zhi,zmid; double lamda[3],*coord; double *sublo,*subhi,*boxlo,*boxhi; // random number generator, same for all procs RanPark *random = new RanPark(lmp,seed); // bounding box for atom creation // in real units, even if triclinic // only limit bbox by region if its bboxflag is set (interior region) if (domain->triclinic == 0) { xlo = domain->boxlo[0]; xhi = domain->boxhi[0]; ylo = domain->boxlo[1]; yhi = domain->boxhi[1]; zlo = domain->boxlo[2]; zhi = domain->boxhi[2]; zmid = zlo + 0.5*(zhi-zlo); } else { xlo = domain->boxlo_bound[0]; xhi = domain->boxhi_bound[0]; ylo = domain->boxlo_bound[1]; yhi = domain->boxhi_bound[1]; zlo = domain->boxlo_bound[2]; zhi = domain->boxhi_bound[2]; zmid = zlo + 0.5*(zhi-zlo); } if (nregion >= 0 && domain->regions[nregion]->bboxflag) { xlo = MAX(xlo,domain->regions[nregion]->extent_xlo); xhi = MIN(xhi,domain->regions[nregion]->extent_xhi); ylo = MAX(ylo,domain->regions[nregion]->extent_ylo); yhi = MIN(yhi,domain->regions[nregion]->extent_yhi); zlo = MAX(zlo,domain->regions[nregion]->extent_zlo); zhi = MIN(zhi,domain->regions[nregion]->extent_zhi); } // sub-domain bounding box, in lamda units if triclinic if (domain->triclinic == 0) { sublo = domain->sublo; subhi = domain->subhi; } else { sublo = domain->sublo_lamda; subhi = domain->subhi_lamda; boxlo = domain->boxlo_lamda; boxhi = domain->boxhi_lamda; } // generate random positions for each new atom within bounding box // iterate until atom is within region and triclinic simulation box // if final atom position is in my subbox, create it int valid; for (int i = 0; i < nrandom; i++) { while (1) { xone[0] = xlo + random->uniform() * (xhi-xlo); xone[1] = ylo + random->uniform() * (yhi-ylo); xone[2] = zlo + random->uniform() * (zhi-zlo); if (domain->dimension == 2) xone[2] = zmid; valid = 1; if (nregion >= 0 && domain->regions[nregion]->match(xone[0],xone[1],xone[2]) == 0) valid = 0; if (domain->triclinic) { domain->x2lamda(xone,lamda); coord = lamda; if (coord[0] < boxlo[0] || coord[0] >= boxhi[0] || coord[1] < boxlo[1] || coord[1] >= boxhi[1] || coord[2] < boxlo[2] || coord[2] >= boxhi[2]) valid = 0; } else coord = xone; if (valid) break; } // if triclinic, coord is now in lamda units if (coord[0] >= sublo[0] && coord[0] < subhi[0] && coord[1] >= sublo[1] && coord[1] < subhi[1] && coord[2] >= sublo[2] && coord[2] < subhi[2]) atom->avec->create_atom(itype,xone); } // clean-up delete random; } /* ---------------------------------------------------------------------- add many atoms by looping over lattice ------------------------------------------------------------------------- */ void CreateAtoms::add_lattice() { // convert 8 corners of my subdomain from box coords to lattice coords // for orthogonal, use corner pts of my subbox // for triclinic, use bounding box of my subbox // xyz min to max = bounding box around the domain corners in lattice space int triclinic = domain->triclinic; double bboxlo[3],bboxhi[3]; if (triclinic == 0) { bboxlo[0] = domain->sublo[0]; bboxhi[0] = domain->subhi[0]; bboxlo[1] = domain->sublo[1]; bboxhi[1] = domain->subhi[1]; bboxlo[2] = domain->sublo[2]; bboxhi[2] = domain->subhi[2]; } else domain->bbox(domain->sublo_lamda,domain->subhi_lamda,bboxlo,bboxhi); double xmin,ymin,zmin,xmax,ymax,zmax; xmin = ymin = zmin = BIG; xmax = ymax = zmax = -BIG; domain->lattice->bbox(1,bboxlo[0],bboxlo[1],bboxlo[2], xmin,ymin,zmin,xmax,ymax,zmax); domain->lattice->bbox(1,bboxhi[0],bboxlo[1],bboxlo[2], xmin,ymin,zmin,xmax,ymax,zmax); domain->lattice->bbox(1,bboxlo[0],bboxhi[1],bboxlo[2], xmin,ymin,zmin,xmax,ymax,zmax); domain->lattice->bbox(1,bboxhi[0],bboxhi[1],bboxlo[2], xmin,ymin,zmin,xmax,ymax,zmax); domain->lattice->bbox(1,bboxlo[0],bboxlo[1],bboxhi[2], xmin,ymin,zmin,xmax,ymax,zmax); domain->lattice->bbox(1,bboxhi[0],bboxlo[1],bboxhi[2], xmin,ymin,zmin,xmax,ymax,zmax); domain->lattice->bbox(1,bboxlo[0],bboxhi[1],bboxhi[2], xmin,ymin,zmin,xmax,ymax,zmax); domain->lattice->bbox(1,bboxhi[0],bboxhi[1],bboxhi[2], xmin,ymin,zmin,xmax,ymax,zmax); // ilo:ihi,jlo:jhi,klo:khi = loop bounds for lattice overlap of my subbox // overlap = any part of a unit cell (face,edge,pt) in common with my subbox // in lattice space, subbox is a tilted box // but bbox of subbox is aligned with lattice axes // so ilo:khi unit cells should completely tile bounding box // decrement lo, increment hi to avoid round-off issues in lattice->bbox(), // which can lead to missing atoms in rare cases // extra decrement of lo if min < 0, since static_cast(-1.5) = -1 int ilo,ihi,jlo,jhi,klo,khi; ilo = static_cast<int> (xmin) - 1; jlo = static_cast<int> (ymin) - 1; klo = static_cast<int> (zmin) - 1; ihi = static_cast<int> (xmax) + 1; jhi = static_cast<int> (ymax) + 1; khi = static_cast<int> (zmax) + 1; if (xmin < 0.0) ilo--; if (ymin < 0.0) jlo--; if (zmin < 0.0) klo--; // set bounds for my proc // if periodic: // should create exactly 1 atom when 2 images are both "on" the boundary // either image may be slightly inside/outside true box due to round-off // if I am lo proc, decrement lower bound by EPSILON // this will insure lo image is created // if I am hi proc, decrement upper bound by 2.0*EPSILON // this will insure hi image is not created // thus insertion box is EPSILON smaller than true box // and is shifted away from true boundary // which is where atoms are likely to be generated double epsilon[3]; if (triclinic) epsilon[0] = epsilon[1] = epsilon[2] = EPSILON; else { epsilon[0] = domain->prd[0] * EPSILON; epsilon[1] = domain->prd[1] * EPSILON; epsilon[2] = domain->prd[2] * EPSILON; } double sublo[3],subhi[3]; if (triclinic == 0) { sublo[0] = domain->sublo[0]; subhi[0] = domain->subhi[0]; sublo[1] = domain->sublo[1]; subhi[1] = domain->subhi[1]; sublo[2] = domain->sublo[2]; subhi[2] = domain->subhi[2]; } else { sublo[0] = domain->sublo_lamda[0]; subhi[0] = domain->subhi_lamda[0]; sublo[1] = domain->sublo_lamda[1]; subhi[1] = domain->subhi_lamda[1]; sublo[2] = domain->sublo_lamda[2]; subhi[2] = domain->subhi_lamda[2]; } if (domain->xperiodic) { if (comm->myloc[0] == 0) sublo[0] -= epsilon[0]; if (comm->myloc[0] == comm->procgrid[0]-1) subhi[0] -= 2.0*epsilon[0]; } if (domain->yperiodic) { if (comm->myloc[1] == 0) sublo[1] -= epsilon[1]; if (comm->myloc[1] == comm->procgrid[1]-1) subhi[1] -= 2.0*epsilon[1]; } if (domain->zperiodic) { if (comm->myloc[2] == 0) sublo[2] -= epsilon[2]; if (comm->myloc[2] == comm->procgrid[2]-1) subhi[2] -= 2.0*epsilon[2]; } // iterate on 3d periodic lattice of unit cells using loop bounds // iterate on nbasis atoms in each unit cell // convert lattice coords to box coords // add atom if it meets all criteria double **basis = domain->lattice->basis; double x[3],lamda[3]; double *coord; int i,j,k,m; for (k = klo; k <= khi; k++) for (j = jlo; j <= jhi; j++) for (i = ilo; i <= ihi; i++) for (m = 0; m < nbasis; m++) { x[0] = i + basis[m][0]; x[1] = j + basis[m][1]; x[2] = k + basis[m][2]; // convert from lattice coords to box coords domain->lattice->lattice2box(x[0],x[1],x[2]); // if a region was specified, test if atom is in it if (style == REGION) if (!domain->regions[nregion]->match(x[0],x[1],x[2])) continue; // test if atom is in my subbox if (triclinic) { domain->x2lamda(x,lamda); coord = lamda; } else coord = x; if (coord[0] < sublo[0] || coord[0] >= subhi[0] || coord[1] < sublo[1] || coord[1] >= subhi[1] || coord[2] < sublo[2] || coord[2] >= subhi[2]) continue; // add the atom to my list of atoms atom->avec->create_atom(basistype[m],x); } } diff --git a/src/delete_atoms.cpp b/src/delete_atoms.cpp index b2fec4e2a..1fcf224b0 100644 --- a/src/delete_atoms.cpp +++ b/src/delete_atoms.cpp @@ -1,362 +1,362 @@ /* ---------------------------------------------------------------------- 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. ------------------------------------------------------------------------- */ #include "stdlib.h" #include "string.h" #include "delete_atoms.h" #include "lmptype.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" #include "domain.h" #include "force.h" #include "group.h" #include "region.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "random_mars.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; #define MIN(a,b) ((a) < (b) ? (a) : (b)) #define MAX(a,b) ((a) > (b) ? (a) : (b)) /* ---------------------------------------------------------------------- */ DeleteAtoms::DeleteAtoms(LAMMPS *lmp) : Pointers(lmp) {} /* ---------------------------------------------------------------------- */ void DeleteAtoms::command(int narg, char **arg) { if (domain->box_exist == 0) error->all("Delete_atoms command before simulation box is defined"); if (narg < 1) error->all("Illegal delete_atoms command"); if (atom->tag_enable == 0) error->all("Cannot use delete_atoms unless atoms have IDs"); // store state before delete bigint natoms_previous = atom->natoms; // delete the atoms if (strcmp(arg[0],"group") == 0) delete_group(narg,arg); else if (strcmp(arg[0],"region") == 0) delete_region(narg,arg); else if (strcmp(arg[0],"overlap") == 0) delete_overlap(narg,arg); else if (strcmp(arg[0],"porosity") == 0) delete_porosity(narg,arg); else error->all("Illegal delete_atoms command"); // delete local atoms flagged in dlist // reset nlocal AtomVec *avec = atom->avec; int nlocal = atom->nlocal; int i = 0; while (i < nlocal) { if (dlist[i]) { avec->copy(nlocal-1,i); dlist[i] = dlist[nlocal-1]; nlocal--; } else i++; } atom->nlocal = nlocal; memory->sfree(dlist); // if non-molecular system and compress flag set, // reset atom tags to be contiguous // set all atom IDs to 0, call tag_extend() if (atom->molecular == 0 && compress_flag) { int *tag = atom->tag; for (i = 0; i < nlocal; i++) tag[i] = 0; atom->tag_extend(); } // reset atom->natoms // reset atom->map if it exists // set nghost to 0 so old ghosts of deleted atoms won't be mapped bigint nblocal = atom->nlocal; - MPI_Allreduce(&nblocal,&atom->natoms,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&nblocal,&atom->natoms,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); if (atom->map_style) { atom->nghost = 0; atom->map_init(); atom->map_set(); } // print before and after atom count bigint ndelete = natoms_previous - atom->natoms; if (comm->me == 0) { if (screen) fprintf(screen,"Deleted %lu atoms, new total = %lu\n", ndelete,atom->natoms); if (logfile) fprintf(logfile,"Deleted %lu atoms, new total = %lu\n", ndelete,atom->natoms); } } /* ---------------------------------------------------------------------- delete all atoms in group group will still exist ------------------------------------------------------------------------- */ void DeleteAtoms::delete_group(int narg, char **arg) { if (narg < 2) error->all("Illegal delete_atoms command"); int igroup = group->find(arg[1]); if (igroup == -1) error->all("Could not find delete_atoms group ID"); options(narg-2,&arg[2]); // allocate and initialize deletion list int nlocal = atom->nlocal; dlist = (int *) memory->smalloc(nlocal*sizeof(int),"delete_atoms:dlist"); for (int i = 0; i < nlocal; i++) dlist[i] = 0; int *mask = atom->mask; int groupbit = group->bitmask[igroup]; for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) dlist[i] = 1; } /* ---------------------------------------------------------------------- delete all atoms in region ------------------------------------------------------------------------- */ void DeleteAtoms::delete_region(int narg, char **arg) { if (narg < 2) error->all("Illegal delete_atoms command"); int iregion = domain->find_region(arg[1]); if (iregion == -1) error->all("Could not find delete_atoms region ID"); options(narg-2,&arg[2]); // allocate and initialize deletion list int nlocal = atom->nlocal; dlist = (int *) memory->smalloc(nlocal*sizeof(int),"delete_atoms:dlist"); for (int i = 0; i < nlocal; i++) dlist[i] = 0; double **x = atom->x; for (int i = 0; i < nlocal; i++) if (domain->regions[iregion]->match(x[i][0],x[i][1],x[i][2])) dlist[i] = 1; } /* ---------------------------------------------------------------------- delete atoms so there are no pairs within cutoff which atoms are deleted depends on ordering of atoms within proc deletions can vary with processor count no guarantee that minimium number of atoms will be deleted ------------------------------------------------------------------------- */ void DeleteAtoms::delete_overlap(int narg, char **arg) { if (narg < 4) error->all("Illegal delete_atoms command"); // read args double cut = atof(arg[1]); double cutsq = cut*cut; int igroup1 = group->find(arg[2]); int igroup2 = group->find(arg[3]); if (igroup1 < 0 || igroup2 < 0) error->all("Could not find delete_atoms group ID"); options(narg-4,&arg[4]); int group1bit = group->bitmask[igroup1]; int group2bit = group->bitmask[igroup2]; if (comm->me == 0 && screen) fprintf(screen,"System init for delete_atoms ...\n"); // request a full neighbor list for use by this command int irequest = neighbor->request((void *) this); neighbor->requests[irequest]->pair = 0; neighbor->requests[irequest]->command = 1; neighbor->requests[irequest]->half = 0; neighbor->requests[irequest]->full = 1; neighbor->requests[irequest]->occasional = 1; // init entire system since comm->borders and neighbor->build is done // comm::init needs neighbor::init needs pair::init needs kspace::init, etc lmp->init(); // error check on cutoff // if no pair style, neighbor list will be empty if (force->pair == NULL) error->all("Delete_atoms requires a pair style be defined"); if (cut > neighbor->cutneighmax) error->all("Delete_atoms cutoff > neighbor cutoff"); // setup domain, communication and neighboring // acquire ghosts // build neighbor list based on earlier request if (domain->triclinic) domain->x2lamda(atom->nlocal); domain->pbc(); domain->reset_box(); comm->setup(); if (neighbor->style) neighbor->setup_bins(); comm->exchange(); comm->borders(); if (domain->triclinic) domain->lamda2x(atom->nlocal+atom->nghost); NeighList *list = neighbor->lists[irequest]; neighbor->build_one(irequest); // allocate and initialize deletion list // must be after exchange potentially changes nlocal int nlocal = atom->nlocal; dlist = (int *) memory->smalloc(nlocal*sizeof(int),"delete_atoms:dlist"); for (int i = 0; i < nlocal; i++) dlist[i] = 0; // double loop over owned atoms and their full neighbor list // at end of loop, there are no more overlaps // only ever delete owned atom I, never J even if owned int *tag = atom->tag; int *mask = atom->mask; double **x = atom->x; int nall = atom->nlocal + atom->nghost; double *special_coul = force->special_coul; double *special_lj = force->special_lj; int i,j,ii,jj,inum,jnum; double xtmp,ytmp,ztmp,delx,dely,delz,rsq; int *ilist,*jlist,*numneigh,**firstneigh; inum = list->inum; ilist = list->ilist; numneigh = list->numneigh; firstneigh = list->firstneigh; for (ii = 0; ii < inum; ii++) { i = ilist[ii]; xtmp = x[i][0]; ytmp = x[i][1]; ztmp = x[i][2]; jlist = firstneigh[i]; jnum = numneigh[i]; for (jj = 0; jj < jnum; jj++) { j = jlist[jj]; // if weighting factors are 0, skip this pair // could be 0 and still be in neigh list for long-range Coulombics // want consistency with non-charged pairs which wouldn't be in list if (j >= nall) { if (special_coul[j/nall] == 0.0 && special_lj[j/nall] == 0.0) continue; j %= nall; } // only consider deletion if I,J distance < cutoff delx = xtmp - x[j][0]; dely = ytmp - x[j][1]; delz = ztmp - x[j][2]; rsq = delx*delx + dely*dely + delz*delz; if (rsq >= cutsq) continue; // only consider deletion if I,J are in groups 1,2 respectively // true whether J is owned or ghost atom if (!(mask[i] & group1bit)) continue; if (!(mask[j] & group2bit)) continue; // J is owned atom: // delete atom I if atom J has not already been deleted // J is ghost atom: // delete atom I if J,I is not a candidate deletion pair // due to being in groups 1,2 respectively // if they are candidate pair, then either: // another proc owns J and could delete J // J is a ghost of another of my owned atoms, and I could delete J // test on tags of I,J insures that only I or J is deleted if (j < nlocal) { if (dlist[j]) continue; } else if ((mask[i] & group2bit) && (mask[j] & group1bit)) { if (tag[i] > tag[j]) continue; } dlist[i] = 1; break; } } } /* ---------------------------------------------------------------------- create porosity by deleting atoms in a specified region ------------------------------------------------------------------------- */ void DeleteAtoms::delete_porosity(int narg, char **arg) { if (narg < 4) error->all("Illegal delete_atoms command"); int iregion = domain->find_region(arg[1]); if (iregion == -1) error->all("Could not find delete_atoms region ID"); double porosity_fraction = atof(arg[2]); int seed = atoi(arg[3]); options(narg-4,&arg[4]); RanMars *random = new RanMars(lmp,seed + comm->me); // allocate and initialize deletion list int nlocal = atom->nlocal; dlist = (int *) memory->smalloc(nlocal*sizeof(int),"delete_atoms:dlist"); for (int i = 0; i < nlocal; i++) dlist[i] = 0; double **x = atom->x; for (int i = 0; i < nlocal; i++) if (domain->regions[iregion]->match(x[i][0],x[i][1],x[i][2])) if (random->uniform() <= porosity_fraction) dlist[i] = 1; } /* ---------------------------------------------------------------------- process command options ------------------------------------------------------------------------- */ void DeleteAtoms::options(int narg, char **arg) { compress_flag = 1; int iarg = 0; while (iarg < narg) { if (strcmp(arg[iarg],"compress") == 0) { if (iarg+2 > narg) error->all("Illegal delete_bonds command"); if (strcmp(arg[iarg+1],"yes") == 0) compress_flag = 1; else if (strcmp(arg[iarg+1],"no") == 0) compress_flag = 0; else error->all("Illegal delete_bonds command"); iarg += 2; } else error->all("Illegal delete_bonds command"); } } diff --git a/src/delete_bonds.cpp b/src/delete_bonds.cpp index 424e39750..3b8d7da8f 100644 --- a/src/delete_bonds.cpp +++ b/src/delete_bonds.cpp @@ -1,484 +1,484 @@ /* ---------------------------------------------------------------------- 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. ------------------------------------------------------------------------- */ #include "mpi.h" #include "stdlib.h" #include "string.h" #include "delete_bonds.h" #include "atom.h" #include "atom_vec.h" #include "domain.h" #include "neighbor.h" #include "comm.h" #include "force.h" #include "group.h" #include "special.h" #include "error.h" using namespace LAMMPS_NS; enum{MULTI,ATOM,BOND,ANGLE,DIHEDRAL,IMPROPER,STATS}; /* ---------------------------------------------------------------------- */ DeleteBonds::DeleteBonds(LAMMPS *lmp) : Pointers(lmp) {} /* ---------------------------------------------------------------------- */ void DeleteBonds::command(int narg, char **arg) { if (domain->box_exist == 0) error->all("Delete_bonds command before simulation box is defined"); if (atom->natoms == 0) error->all("Delete_bonds command with no atoms existing"); if (atom->molecular == 0) error->all("Cannot use delete_bonds with non-molecular system"); if (narg < 2) error->all("Illegal delete_bonds command"); // init entire system since comm->borders is done // comm::init needs neighbor::init needs pair::init needs kspace::init, etc if (comm->me == 0 && screen) fprintf(screen,"System init for delete_bonds ...\n"); lmp->init(); if (comm->me == 0 && screen) fprintf(screen,"Deleting bonds ...\n"); // identify group int igroup = group->find(arg[0]); if (igroup == -1) error->all("Cannot find delete_bonds group ID"); int groupbit = group->bitmask[igroup]; // set style and which = type value int style; if (strcmp(arg[1],"multi") == 0) style = MULTI; else if (strcmp(arg[1],"atom") == 0) style = ATOM; else if (strcmp(arg[1],"bond") == 0) style = BOND; else if (strcmp(arg[1],"angle") == 0) style = ANGLE; else if (strcmp(arg[1],"dihedral") == 0) style = DIHEDRAL; else if (strcmp(arg[1],"improper") == 0) style = IMPROPER; else if (strcmp(arg[1],"stats") == 0) style = STATS; else error->all("Illegal delete_bonds command"); int iarg = 2; int which; if (style != MULTI && style != STATS) { if (narg < 3) error->all("Illegal delete_bonds command"); which = atoi(arg[2]); iarg++; } // grab optional keywords int undo_flag = 0; int remove_flag = 0; int special_flag = 0; while (iarg < narg) { if (strcmp(arg[iarg],"undo") == 0) undo_flag = 1; else if (strcmp(arg[iarg],"remove") == 0) remove_flag = 1; else if (strcmp(arg[iarg],"special") == 0) special_flag = 1; else error->all("Illegal delete_bonds command"); iarg++; } // border swap to insure type and mask is current for off-proc atoms // enforce PBC before in case atoms are outside box if (domain->triclinic) domain->x2lamda(atom->nlocal); domain->pbc(); domain->reset_box(); comm->setup(); comm->exchange(); comm->borders(); if (domain->triclinic) domain->lamda2x(atom->nlocal+atom->nghost); // set topology interactions either off or on // criteria for an interaction to potentially be changed (set flag = 1) // all atoms in interaction must be in group // for style = MULTI, no other criteria // for style = ATOM, at least one atom is specified type // for style = BOND/ANGLE/DIHEDRAL/IMPROPER, interaction is specified type // for style = STATS only compute stats, flag is always 0 // if flag = 1 // set interaction type negative if undo_flag = 0 // set interaction type positive if undo_flag = 1 int *mask = atom->mask; int *type = atom->type; int nlocal = atom->nlocal; int i,m,n,flag; int atom1,atom2,atom3,atom4; if (atom->avec->bonds_allow) { int *num_bond = atom->num_bond; int **bond_type = atom->bond_type; for (i = 0; i < nlocal; i++) { for (m = 0; m < num_bond[i]; m++) { atom1 = atom->map(atom->bond_atom[i][m]); if (atom1 == -1) error->one("Bond atom missing in delete_bonds"); if (mask[i] & groupbit && mask[atom1] & groupbit) { flag = 0; if (style == MULTI) flag = 1; if (style == ATOM && (type[i] == which || type[atom1] == which)) flag = 1; if (style == BOND && (bond_type[i][m] == which)) flag = 1; if (flag) { if (undo_flag == 0 && bond_type[i][m] > 0) bond_type[i][m] = -bond_type[i][m]; if (undo_flag == 1 && bond_type[i][m] < 0) bond_type[i][m] = -bond_type[i][m]; } } } } } if (atom->avec->angles_allow) { int *num_angle = atom->num_angle; int **angle_type = atom->angle_type; for (i = 0; i < nlocal; i++) { for (m = 0; m < num_angle[i]; m++) { atom1 = atom->map(atom->angle_atom1[i][m]); atom2 = atom->map(atom->angle_atom2[i][m]); atom3 = atom->map(atom->angle_atom3[i][m]); if (atom1 == -1 || atom2 == -1 || atom3 == -1) error->one("Angle atom missing in delete_bonds"); if (mask[atom1] & groupbit && mask[atom2] & groupbit && mask[atom3] & groupbit) { flag = 0; if (style == MULTI) flag = 1; if (style == ATOM && (type[atom1] == which || type[atom2] == which || type[atom3] == which)) flag = 1; if (style == ANGLE && (angle_type[i][m] == which)) flag = 1; if (flag) { if (undo_flag == 0 && angle_type[i][m] > 0) angle_type[i][m] = -angle_type[i][m]; if (undo_flag == 1 && angle_type[i][m] < 0) angle_type[i][m] = -angle_type[i][m]; } } } } } if (atom->avec->dihedrals_allow) { int *num_dihedral = atom->num_dihedral; int **dihedral_type = atom->dihedral_type; for (i = 0; i < nlocal; i++) { for (m = 0; m < num_dihedral[i]; m++) { atom1 = atom->map(atom->dihedral_atom1[i][m]); atom2 = atom->map(atom->dihedral_atom2[i][m]); atom3 = atom->map(atom->dihedral_atom3[i][m]); atom4 = atom->map(atom->dihedral_atom4[i][m]); if (atom1 == -1 || atom2 == -1 || atom3 == -1 || atom4 == -1) error->one("Dihedral atom missing in delete_bonds"); if (mask[atom1] & groupbit && mask[atom2] & groupbit && mask[atom3] & groupbit && mask[atom4] & groupbit) { flag = 0; if (style == MULTI) flag = 1; if (style == ATOM && (type[atom1] == which || type[atom2] == which || type[atom3] == which || type[atom4] == which)) flag = 1; if (style == DIHEDRAL && (dihedral_type[i][m] == which)) flag = 1; if (flag) { if (undo_flag == 0 && dihedral_type[i][m] > 0) dihedral_type[i][m] = -dihedral_type[i][m]; if (undo_flag == 1 && dihedral_type[i][m] < 0) dihedral_type[i][m] = -dihedral_type[i][m]; } } } } } if (atom->avec->impropers_allow) { int *num_improper = atom->num_improper; int **improper_type = atom->improper_type; for (i = 0; i < nlocal; i++) { for (m = 0; m < num_improper[i]; m++) { atom1 = atom->map(atom->improper_atom1[i][m]); atom2 = atom->map(atom->improper_atom2[i][m]); atom3 = atom->map(atom->improper_atom3[i][m]); atom4 = atom->map(atom->improper_atom4[i][m]); if (atom1 == -1 || atom2 == -1 || atom3 == -1 || atom4 == -1) error->one("Improper atom missing in delete_bonds"); if (mask[atom1] & groupbit && mask[atom2] & groupbit && mask[atom3] & groupbit && mask[atom4] & groupbit) { flag = 0; if (style == MULTI) flag = 1; if (style == ATOM && (type[atom1] == which || type[atom2] == which || type[atom3] == which || type[atom4] == which)) flag = 1; if (style == IMPROPER && (improper_type[i][m] == which)) flag = 1; if (flag) { if (undo_flag == 0 && improper_type[i][m] > 0) improper_type[i][m] = -improper_type[i][m]; if (undo_flag == 1 && improper_type[i][m] < 0) improper_type[i][m] = -improper_type[i][m]; } } } } } // remove interactions if requested // only if all atoms in bond, angle, etc are in the delete_bonds group if (remove_flag) { if (atom->avec->bonds_allow) { for (i = 0; i < nlocal; i++) { m = 0; while (m < atom->num_bond[i]) { if (atom->bond_type[i][m] <= 0) { atom1 = atom->map(atom->bond_atom[i][m]); if (mask[i] & groupbit && mask[atom1] & groupbit) { n = atom->num_bond[i]; atom->bond_type[i][m] = atom->bond_type[i][n-1]; atom->bond_atom[i][m] = atom->bond_atom[i][n-1]; atom->num_bond[i]--; } else m++; } else m++; } } } if (atom->avec->angles_allow) { for (i = 0; i < nlocal; i++) { m = 0; while (m < atom->num_angle[i]) { if (atom->angle_type[i][m] <= 0) { atom1 = atom->map(atom->angle_atom1[i][m]); atom2 = atom->map(atom->angle_atom2[i][m]); atom3 = atom->map(atom->angle_atom3[i][m]); if (mask[atom1] & groupbit && mask[atom2] & groupbit && mask[atom3] & groupbit) { n = atom->num_angle[i]; atom->angle_type[i][m] = atom->angle_type[i][n-1]; atom->angle_atom1[i][m] = atom->angle_atom1[i][n-1]; atom->angle_atom2[i][m] = atom->angle_atom2[i][n-1]; atom->angle_atom3[i][m] = atom->angle_atom3[i][n-1]; atom->num_angle[i]--; } else m++; } else m++; } } } if (atom->avec->dihedrals_allow) { for (i = 0; i < nlocal; i++) { m = 0; while (m < atom->num_dihedral[i]) { if (atom->dihedral_type[i][m] <= 0) { atom1 = atom->map(atom->dihedral_atom1[i][m]); atom2 = atom->map(atom->dihedral_atom2[i][m]); atom3 = atom->map(atom->dihedral_atom3[i][m]); atom4 = atom->map(atom->dihedral_atom4[i][m]); if (mask[atom1] & groupbit && mask[atom2] & groupbit && mask[atom3] & groupbit && mask[atom4] & groupbit) { n = atom->num_dihedral[i]; atom->dihedral_type[i][m] = atom->dihedral_type[i][n-1]; atom->dihedral_atom1[i][m] = atom->dihedral_atom1[i][n-1]; atom->dihedral_atom2[i][m] = atom->dihedral_atom2[i][n-1]; atom->dihedral_atom3[i][m] = atom->dihedral_atom3[i][n-1]; atom->dihedral_atom4[i][m] = atom->dihedral_atom4[i][n-1]; atom->num_dihedral[i]--; } else m++; } else m++; } } } if (atom->avec->impropers_allow) { for (i = 0; i < nlocal; i++) { m = 0; while (m < atom->num_improper[i]) { if (atom->improper_type[i][m] <= 0) { atom1 = atom->map(atom->improper_atom1[i][m]); atom2 = atom->map(atom->improper_atom2[i][m]); atom3 = atom->map(atom->improper_atom3[i][m]); atom4 = atom->map(atom->improper_atom4[i][m]); if (mask[atom1] & groupbit && mask[atom2] & groupbit && mask[atom3] & groupbit && mask[atom4] & groupbit) { n = atom->num_improper[i]; atom->improper_type[i][m] = atom->improper_type[i][n-1]; atom->improper_atom1[i][m] = atom->improper_atom1[i][n-1]; atom->improper_atom2[i][m] = atom->improper_atom2[i][n-1]; atom->improper_atom3[i][m] = atom->improper_atom3[i][n-1]; atom->improper_atom4[i][m] = atom->improper_atom4[i][n-1]; atom->num_improper[i]--; } else m++; } else m++; } } } } // if interactions were removed, recompute global counts if (remove_flag) { if (atom->avec->bonds_allow) { bigint nbonds = 0; for (i = 0; i < nlocal; i++) nbonds += atom->num_bond[i]; - MPI_Allreduce(&nbonds,&atom->nbonds,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&nbonds,&atom->nbonds,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); if (force->newton_bond == 0) atom->nbonds /= 2; } if (atom->avec->angles_allow) { bigint nangles = 0; for (i = 0; i < nlocal; i++) nangles += atom->num_angle[i]; - MPI_Allreduce(&nangles,&atom->nangles,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&nangles,&atom->nangles,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); if (force->newton_bond == 0) atom->nangles /= 3; } if (atom->avec->dihedrals_allow) { bigint ndihedrals = 0; for (i = 0; i < nlocal; i++) ndihedrals += atom->num_dihedral[i]; MPI_Allreduce(&ndihedrals,&atom->ndihedrals, - 1,MPI_UNSIGNED_LONG,MPI_SUM,world); + 1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); if (force->newton_bond == 0) atom->ndihedrals /= 4; } if (atom->avec->impropers_allow) { bigint nimpropers = 0; for (i = 0; i < nlocal; i++) nimpropers += atom->num_improper[i]; MPI_Allreduce(&nimpropers,&atom->nimpropers, - 1,MPI_UNSIGNED_LONG,MPI_SUM,world); + 1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); if (force->newton_bond == 0) atom->nimpropers /= 4; } } // compute and print stats bigint tmp; bigint bond_on,bond_off; bigint angle_on,angle_off; bigint dihedral_on,dihedral_off; bigint improper_on,improper_off; if (atom->avec->bonds_allow) { bond_on = bond_off = 0; for (i = 0; i < nlocal; i++) for (m = 0; m < atom->num_bond[i]; m++) if (atom->bond_type[i][m] > 0) bond_on++; else bond_off++; - MPI_Allreduce(&bond_on,&tmp,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&bond_on,&tmp,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); bond_on = tmp; - MPI_Allreduce(&bond_off,&tmp,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&bond_off,&tmp,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); bond_off = tmp; if (force->newton_bond == 0) { bond_on /= 2; bond_off /= 2; } } if (atom->avec->angles_allow) { angle_on = angle_off = 0; for (i = 0; i < nlocal; i++) for (m = 0; m < atom->num_angle[i]; m++) if (atom->angle_type[i][m] > 0) angle_on++; else angle_off++; - MPI_Allreduce(&angle_on,&tmp,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&angle_on,&tmp,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); angle_on = tmp; - MPI_Allreduce(&angle_off,&tmp,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&angle_off,&tmp,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); angle_off = tmp; if (force->newton_bond == 0) { angle_on /= 3; angle_off /= 3; } } if (atom->avec->dihedrals_allow) { dihedral_on = dihedral_off = 0; for (i = 0; i < nlocal; i++) for (m = 0; m < atom->num_dihedral[i]; m++) if (atom->dihedral_type[i][m] > 0) dihedral_on++; else dihedral_off++; - MPI_Allreduce(&dihedral_on,&tmp,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&dihedral_on,&tmp,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); dihedral_on = tmp; - MPI_Allreduce(&dihedral_off,&tmp,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&dihedral_off,&tmp,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); dihedral_off = tmp; if (force->newton_bond == 0) { dihedral_on /= 4; dihedral_off /= 4; } } if (atom->avec->impropers_allow) { improper_on = improper_off = 0; for (i = 0; i < nlocal; i++) for (m = 0; m < atom->num_improper[i]; m++) if (atom->improper_type[i][m] > 0) improper_on++; else improper_off++; - MPI_Allreduce(&improper_on,&tmp,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&improper_on,&tmp,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); improper_on = tmp; - MPI_Allreduce(&improper_off,&tmp,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&improper_off,&tmp,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); improper_off = tmp; if (force->newton_bond == 0) { improper_on /= 4; improper_off /= 4; } } if (comm->me == 0) { if (screen) { if (atom->avec->bonds_allow) fprintf(screen," %lu total bonds, %lu turned on, %lu turned off\n", atom->nbonds,bond_on,bond_off); if (atom->avec->angles_allow) fprintf(screen," %lu total angles, %lu turned on, %lu turned off\n", atom->nangles,angle_on,angle_off); if (atom->avec->dihedrals_allow) fprintf(screen," %lu total dihedrals, %lu turned on, %lu turned off\n", atom->ndihedrals,dihedral_on,dihedral_off); if (atom->avec->impropers_allow) fprintf(screen," %lu total impropers, %lu turned on, %lu turned off\n", atom->nimpropers,improper_on,improper_off); } if (logfile) { if (atom->avec->bonds_allow) fprintf(logfile," %lu total bonds, %lu turned on, %lu turned off\n", atom->nbonds,bond_on,bond_off); if (atom->avec->angles_allow) fprintf(logfile," %lu total angles, %lu turned on, %lu turned off\n", atom->nangles,angle_on,angle_off); if (atom->avec->dihedrals_allow) fprintf(logfile," %lu total dihedrals, %lu turned on, " "%lu turned off\n", atom->ndihedrals,dihedral_on,dihedral_off); if (atom->avec->impropers_allow) fprintf(logfile," %lu total impropers, %lu turned on, " "%lu turned off\n", atom->nimpropers,improper_on,improper_off); } } // re-compute special list if requested if (special_flag) { Special special(lmp); special.build(); } } diff --git a/src/displace_atoms.cpp b/src/displace_atoms.cpp index bd9171106..4a9be6df2 100644 --- a/src/displace_atoms.cpp +++ b/src/displace_atoms.cpp @@ -1,243 +1,243 @@ /* ---------------------------------------------------------------------- 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. ------------------------------------------------------------------------- */ #include "mpi.h" #include "stdlib.h" #include "string.h" #include "displace_atoms.h" #include "lmptype.h" #include "atom.h" #include "modify.h" #include "domain.h" #include "lattice.h" #include "comm.h" #include "irregular.h" #include "group.h" #include "random_park.h" #include "error.h" using namespace LAMMPS_NS; enum{MOVE,RAMP,RANDOM}; #define MIN(a,b) ((a) < (b) ? (a) : (b)) #define MAX(a,b) ((a) > (b) ? (a) : (b)) /* ---------------------------------------------------------------------- */ DisplaceAtoms::DisplaceAtoms(LAMMPS *lmp) : Pointers(lmp) {} /* ---------------------------------------------------------------------- */ void DisplaceAtoms::command(int narg, char **arg) { int i; if (domain->box_exist == 0) error->all("Displace_atoms command before simulation box is defined"); if (narg < 2) error->all("Illegal displace_atoms command"); if (modify->nfix_restart_peratom) error->all("Cannot displace_atoms after " "reading restart file with per-atom info"); if (comm->me == 0 && screen) fprintf(screen,"Displacing atoms ...\n"); // group and style int igroup = group->find(arg[0]); if (igroup == -1) error->all("Could not find displace_atoms group ID"); int groupbit = group->bitmask[igroup]; int style; if (strcmp(arg[1],"move") == 0) style = MOVE; else if (strcmp(arg[1],"ramp") == 0) style = RAMP; else if (strcmp(arg[1],"random") == 0) style = RANDOM; else error->all("Illegal displace_atoms command"); // set option defaults scaleflag = 1; // read options from end of input line if (style == MOVE) options(narg-5,&arg[5]); else if (style == RAMP) options(narg-8,&arg[8]); else if (style == RANDOM) options(narg-6,&arg[6]); // setup scaling if (scaleflag && domain->lattice == NULL) error->all("Use of displace_atoms with undefined lattice"); double xscale,yscale,zscale; if (scaleflag) { xscale = domain->lattice->xlattice; yscale = domain->lattice->ylattice; zscale = domain->lattice->zlattice; } else xscale = yscale = zscale = 1.0; // move atoms by 3-vector if (style == MOVE) { double delx = xscale*atof(arg[2]); double dely = yscale*atof(arg[3]); double delz = zscale*atof(arg[4]); double **x = atom->x; int *mask = atom->mask; int nlocal = atom->nlocal; for (i = 0; i < nlocal; i++) { if (mask[i] & groupbit) { x[i][0] += delx; x[i][1] += dely; x[i][2] += delz; } } } // move atoms in ramped fashion if (style == RAMP) { int d_dim; if (strcmp(arg[2],"x") == 0) d_dim = 0; else if (strcmp(arg[2],"y") == 0) d_dim = 1; else if (strcmp(arg[2],"z") == 0) d_dim = 2; else error->all("Illegal displace_atoms ramp command"); double d_lo,d_hi; if (d_dim == 0) { d_lo = xscale*atof(arg[3]); d_hi = xscale*atof(arg[4]); } else if (d_dim == 1) { d_lo = yscale*atof(arg[3]); d_hi = yscale*atof(arg[4]); } else if (d_dim == 2) { d_lo = zscale*atof(arg[3]); d_hi = zscale*atof(arg[4]); } int coord_dim; if (strcmp(arg[5],"x") == 0) coord_dim = 0; else if (strcmp(arg[5],"y") == 0) coord_dim = 1; else if (strcmp(arg[5],"z") == 0) coord_dim = 2; else error->all("Illegal displace_atoms ramp command"); double coord_lo,coord_hi; if (coord_dim == 0) { coord_lo = xscale*atof(arg[6]); coord_hi = xscale*atof(arg[7]); } else if (coord_dim == 1) { coord_lo = yscale*atof(arg[6]); coord_hi = yscale*atof(arg[7]); } else if (coord_dim == 2) { coord_lo = zscale*atof(arg[6]); coord_hi = zscale*atof(arg[7]); } double **x = atom->x; int *mask = atom->mask; int nlocal = atom->nlocal; double fraction,dramp; for (i = 0; i < nlocal; i++) { if (mask[i] & groupbit) { fraction = (x[i][coord_dim] - coord_lo) / (coord_hi - coord_lo); fraction = MAX(fraction,0.0); fraction = MIN(fraction,1.0); dramp = d_lo + fraction*(d_hi - d_lo); x[i][d_dim] += dramp; } } } // move atoms randomly // makes atom result independent of what proc owns it via random->reset() if (style == RANDOM) { RanPark *random = new RanPark(lmp,1); double dx = xscale*atof(arg[2]); double dy = yscale*atof(arg[3]); double dz = zscale*atof(arg[4]); int seed = atoi(arg[5]); if (seed <= 0) error->all("Illegal displace_atoms random command"); double **x = atom->x; int *mask = atom->mask; int nlocal = atom->nlocal; for (i = 0; i < nlocal; i++) { if (mask[i] & groupbit) { random->reset(seed,x[i]); x[i][0] += dx * 2.0*(random->uniform()-0.5); x[i][1] += dy * 2.0*(random->uniform()-0.5); x[i][2] += dz * 2.0*(random->uniform()-0.5); } } delete random; } // move atoms back inside simulation box and to new processors // use remap() instead of pbc() in case atoms moved a long distance // use irregular() in case atoms moved a long distance double **x = atom->x; int *image = atom->image; int nlocal = atom->nlocal; for (i = 0; i < nlocal; i++) domain->remap(x[i],image[i]); if (domain->triclinic) domain->x2lamda(atom->nlocal); domain->reset_box(); Irregular *irregular = new Irregular(lmp); irregular->migrate_atoms(); delete irregular; if (domain->triclinic) domain->lamda2x(atom->nlocal); // check if any atoms were lost bigint natoms; bigint nblocal = atom->nlocal; - MPI_Allreduce(&nblocal,&natoms,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&nblocal,&natoms,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); if (natoms != atom->natoms) { char str[128]; sprintf(str,"Lost atoms via displace_atoms: original %lu current %lu", atom->natoms,natoms); error->all(str); } } /* ---------------------------------------------------------------------- parse optional parameters at end of displace_atoms input line ------------------------------------------------------------------------- */ void DisplaceAtoms::options(int narg, char **arg) { if (narg < 0) error->all("Illegal displace_atoms command"); int iarg = 0; while (iarg < narg) { if (strcmp(arg[iarg],"units") == 0) { if (iarg+2 > narg) error->all("Illegal displace_atoms command"); if (strcmp(arg[iarg+1],"box") == 0) scaleflag = 0; else if (strcmp(arg[iarg+1],"lattice") == 0) scaleflag = 1; else error->all("Illegal displace_atoms command"); iarg += 2; } else error->all("Illegal displace_atoms command"); } } diff --git a/src/displace_box.cpp b/src/displace_box.cpp index a8b5b351f..33d1a3137 100644 --- a/src/displace_box.cpp +++ b/src/displace_box.cpp @@ -1,418 +1,418 @@ /* ---------------------------------------------------------------------- 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. ------------------------------------------------------------------------- */ #include "mpi.h" #include "math.h" #include "stdlib.h" #include "string.h" #include "displace_box.h" #include "lmptype.h" #include "atom.h" #include "modify.h" #include "domain.h" #include "lattice.h" #include "comm.h" #include "irregular.h" #include "group.h" #include "error.h" using namespace LAMMPS_NS; enum{NONE,FINAL,DELTA,SCALE,VOLUME}; enum{ONE_FROM_ONE,ONE_FROM_TWO,TWO_FROM_ONE}; enum{NO_REMAP,X_REMAP}; /* ---------------------------------------------------------------------- */ DisplaceBox::DisplaceBox(LAMMPS *lmp) : Pointers(lmp) {} /* ---------------------------------------------------------------------- */ void DisplaceBox::command(int narg, char **arg) { int i; if (domain->box_exist == 0) error->all("Displace_box command before simulation box is defined"); if (narg < 2) error->all("Illegal displace_box command"); if (modify->nfix_restart_peratom) error->all("Cannot displace_box after " "reading restart file with per-atom info"); if (comm->me == 0 && screen) fprintf(screen,"Displacing box ...\n"); // group int igroup = group->find(arg[0]); if (igroup == -1) error->all("Could not find displace_box group ID"); int groupbit = group->bitmask[igroup]; // set defaults set = new Set[6]; set[0].style = set[1].style = set[2].style = set[3].style = set[4].style = set[5].style = NONE; // parse arguments int triclinic = domain->triclinic; int index; int iarg = 1; while (iarg < narg) { if (strcmp(arg[iarg],"x") == 0 || strcmp(arg[iarg],"y") == 0 || strcmp(arg[iarg],"z") == 0) { if (strcmp(arg[iarg],"x") == 0) index = 0; else if (strcmp(arg[iarg],"y") == 0) index = 1; else if (strcmp(arg[iarg],"z") == 0) index = 2; if (iarg+2 > narg) error->all("Illegal displace_box command"); if (strcmp(arg[iarg+1],"final") == 0) { if (iarg+4 > narg) error->all("Illegal displace_box command"); set[index].style = FINAL; set[index].flo = atof(arg[iarg+2]); set[index].fhi = atof(arg[iarg+3]); iarg += 4; } else if (strcmp(arg[iarg+1],"delta") == 0) { if (iarg+4 > narg) error->all("Illegal displace_box command"); set[index].style = DELTA; set[index].dlo = atof(arg[iarg+2]); set[index].dhi = atof(arg[iarg+3]); iarg += 4; } else if (strcmp(arg[iarg+1],"scale") == 0) { if (iarg+3 > narg) error->all("Illegal displace_box command"); set[index].style = SCALE; set[index].scale = atof(arg[iarg+2]); iarg += 3; } else if (strcmp(arg[iarg+1],"volume") == 0) { set[index].style = VOLUME; iarg += 2; } else error->all("Illegal displace_box command"); } else if (strcmp(arg[iarg],"xy") == 0 || strcmp(arg[iarg],"xz") == 0 || strcmp(arg[iarg],"yz") == 0) { if (triclinic == 0) error->all("Displace_box tilt factors require triclinic box"); if (strcmp(arg[iarg],"xy") == 0) index = 5; else if (strcmp(arg[iarg],"xz") == 0) index = 4; else if (strcmp(arg[iarg],"yz") == 0) index = 3; if (iarg+2 > narg) error->all("Illegal displace_box command"); if (strcmp(arg[iarg+1],"final") == 0) { if (iarg+3 > narg) error->all("Illegal displace_box command"); set[index].style = FINAL; set[index].ftilt = atof(arg[iarg+2]); iarg += 3; } else if (strcmp(arg[iarg+1],"delta") == 0) { if (iarg+3 > narg) error->all("Illegal displace_box command"); set[index].style = DELTA; set[index].dtilt = atof(arg[iarg+2]); iarg += 3; } else error->all("Illegal displace_box command"); } else break; } // read options from end of input line options(narg-iarg,&arg[iarg]); // check periodicity if ((set[0].style && domain->xperiodic == 0) || (set[1].style && domain->yperiodic == 0) || (set[2].style && domain->zperiodic == 0)) error->all("Cannot displace_box on a non-periodic boundary"); if (set[3].style && (domain->yperiodic == 0 || domain->zperiodic == 0)) error->all("Cannot displace_box on a non-periodic boundary"); if (set[4].style && (domain->xperiodic == 0 || domain->zperiodic == 0)) error->all("Cannot displace_box on a non-periodic boundary"); if (set[5].style && (domain->xperiodic == 0 || domain->yperiodic == 0)) error->all("Cannot displace_box on a non-periodic boundary"); // apply scaling to FINAL,DELTA since they have distance units int flag = 0; for (int i = 0; i < 6; i++) if (set[i].style == FINAL || set[i].style == DELTA) flag = 1; if (flag && scaleflag && domain->lattice == NULL) error->all("Use of displace_box with undefined lattice"); double xscale,yscale,zscale; if (flag && scaleflag) { xscale = domain->lattice->xlattice; yscale = domain->lattice->ylattice; zscale = domain->lattice->zlattice; } else xscale = yscale = zscale = 1.0; // for 3,4,5 scaling is in 1st dimension, e.g. x for xz double map[6]; map[0] = xscale; map[1] = yscale; map[2] = zscale; map[3] = yscale; map[4] = xscale; map[5] = xscale; for (int i = 0; i < 3; i++) { if (set[i].style == FINAL) { set[i].flo *= map[i]; set[i].fhi *= map[i]; } else if (set[i].style == DELTA) { set[i].dlo *= map[i]; set[i].dhi *= map[i]; } } for (int i = 3; i < 6; i++) { if (set[i].style == FINAL) set[i].ftilt *= map[i]; else if (set[i].style == DELTA) set[i].dtilt *= map[i]; } // set initial/final values for box size and shape // final = initial if no setting for (int i = 0; i < 3; i++) { set[i].lo_stop = set[i].lo_start = domain->boxlo[i]; set[i].hi_stop = set[i].hi_start = domain->boxhi[i]; if (set[i].style == FINAL) { set[i].lo_stop = set[i].flo; set[i].hi_stop = set[i].fhi; } else if (set[i].style == DELTA) { set[i].lo_stop = set[i].lo_start + set[i].dlo; set[i].hi_stop = set[i].hi_start + set[i].dhi; } else if (set[i].style == SCALE) { set[i].lo_stop = 0.5*(set[i].lo_start+set[i].hi_start) - 0.5*set[i].scale*(set[i].hi_start-set[i].lo_start); set[i].hi_stop = 0.5*(set[i].lo_start+set[i].hi_start) + 0.5*set[i].scale*(set[i].hi_start-set[i].lo_start); } } for (int i = 3; i < 6; i++) { if (i == 5) set[i].tilt_start = domain->xy; else if (i == 4) set[i].tilt_start = domain->xz; else if (i == 3) set[i].tilt_start = domain->yz; set[i].tilt_stop = set[i].tilt_start; if (set[i].style == FINAL) { set[i].tilt_stop = set[i].ftilt; } else if (set[i].style == DELTA) { set[i].tilt_stop = set[i].tilt_start + set[i].dtilt; } } // for VOLUME, setup links to other dims // fixed, dynamic1,2, vol_start for (int i = 0; i < 3; i++) { set[i].vol_start = domain->xprd * domain->yprd * domain->zprd; if (set[i].style != VOLUME) continue; int other1 = (i+1) % 3; int other2 = (i+2) % 3; if (set[other1].style == NONE) { if (set[other2].style == NONE || set[other2].style == VOLUME) error->all("Fix deform volume setting is invalid"); set[i].substyle = ONE_FROM_ONE; set[i].fixed = other1; set[i].dynamic1 = other2; } else if (set[other2].style == NONE) { if (set[other1].style == NONE || set[other1].style == VOLUME) error->all("Fix deform volume setting is invalid"); set[i].substyle = ONE_FROM_ONE; set[i].fixed = other2; set[i].dynamic1 = other1; } else if (set[other1].style == VOLUME) { if (set[other2].style == NONE || set[other2].style == VOLUME) error->all("Fix deform volume setting is invalid"); set[i].substyle = TWO_FROM_ONE; set[i].fixed = other1; set[i].dynamic1 = other2; } else if (set[other2].style == VOLUME) { if (set[other1].style == NONE || set[other1].style == VOLUME) error->all("Fix deform volume setting is invalid"); set[i].substyle = TWO_FROM_ONE; set[i].fixed = other2; set[i].dynamic1 = other1; } else { set[i].substyle = ONE_FROM_TWO; set[i].dynamic2 = other1; set[i].dynamic2 = other2; } } // set new box size for VOLUME dims that are linked to other dims for (int i = 0; i < 3; i++) { if (set[i].style != VOLUME) continue; if (set[i].substyle == ONE_FROM_ONE) { set[i].lo_stop = 0.5*(set[i].lo_start+set[i].hi_start) - 0.5*(set[i].vol_start / (set[set[i].dynamic1].hi_stop - set[set[i].dynamic1].lo_stop) / (set[set[i].fixed].hi_start-set[set[i].fixed].lo_start)); set[i].hi_stop = 0.5*(set[i].lo_start+set[i].hi_start) + 0.5*(set[i].vol_start / (set[set[i].dynamic1].hi_stop - set[set[i].dynamic1].lo_stop) / (set[set[i].fixed].hi_start-set[set[i].fixed].lo_start)); } else if (set[i].substyle == ONE_FROM_TWO) { set[i].lo_stop = 0.5*(set[i].lo_start+set[i].hi_start) - 0.5*(set[i].vol_start / (set[set[i].dynamic1].hi_stop - set[set[i].dynamic1].lo_stop) / (set[set[i].dynamic2].hi_stop - set[set[i].dynamic2].lo_stop)); set[i].hi_stop = 0.5*(set[i].lo_start+set[i].hi_start) + 0.5*(set[i].vol_start / (set[set[i].dynamic1].hi_stop - set[set[i].dynamic1].lo_stop) / (set[set[i].dynamic2].hi_stop - set[set[i].dynamic2].lo_stop)); } else if (set[i].substyle == TWO_FROM_ONE) { set[i].lo_stop = 0.5*(set[i].lo_start+set[i].hi_start) - 0.5*sqrt(set[i].vol_start / (set[set[i].dynamic1].hi_stop - set[set[i].dynamic1].lo_stop) / (set[set[i].fixed].hi_start - set[set[i].fixed].lo_start) * (set[i].hi_start - set[i].lo_start)); set[i].hi_stop = 0.5*(set[i].lo_start+set[i].hi_start) + 0.5*sqrt(set[i].vol_start / (set[set[i].dynamic1].hi_stop - set[set[i].dynamic1].lo_stop) / (set[set[i].fixed].hi_start - set[set[i].fixed].lo_start) * (set[i].hi_start - set[i].lo_start)); } } // check that final tilt is not illegal value double xprd_stop = set[0].hi_stop - set[0].lo_stop; double yprd_stop = set[0].hi_stop - set[0].lo_stop; if (set[3].tilt_stop < -0.5*yprd_stop || set[3].tilt_stop > 0.5*yprd_stop || set[4].tilt_stop < -0.5*xprd_stop || set[4].tilt_stop > 0.5*xprd_stop || set[5].tilt_stop < -0.5*xprd_stop || set[5].tilt_stop > 0.5*xprd_stop) error->all("Induced tilt by displace_box is too large"); // convert atoms to lamda coords if (remapflag == X_REMAP) { double **x = atom->x; int *mask = atom->mask; int nlocal = atom->nlocal; for (i = 0; i < nlocal; i++) if (mask[i] & groupbit) domain->x2lamda(x[i],x[i]); } // reset global and local box to new size/shape domain->boxlo[0] = set[0].lo_stop; domain->boxlo[1] = set[1].lo_stop; domain->boxlo[2] = set[2].lo_stop; domain->boxhi[0] = set[0].hi_stop; domain->boxhi[1] = set[1].hi_stop; domain->boxhi[2] = set[2].hi_stop; if (triclinic) { domain->yz = set[3].tilt_stop; domain->xz = set[4].tilt_stop; domain->xy = set[5].tilt_stop; } domain->set_global_box(); domain->set_local_box(); // convert atoms back to box coords if (remapflag == X_REMAP) { double **x = atom->x; int *mask = atom->mask; int nlocal = atom->nlocal; for (i = 0; i < nlocal; i++) if (mask[i] & groupbit) domain->lamda2x(x[i],x[i]); } // move atoms back inside simulation box and to new processors // use remap() instead of pbc() // in case box moved a long distance relative to atoms // use irregular() in case box moved a long distance relative to atoms double **x = atom->x; int *image = atom->image; int nlocal = atom->nlocal; for (i = 0; i < nlocal; i++) domain->remap(x[i],image[i]); if (domain->triclinic) domain->x2lamda(atom->nlocal); domain->reset_box(); Irregular *irregular = new Irregular(lmp); irregular->migrate_atoms(); delete irregular; if (domain->triclinic) domain->lamda2x(atom->nlocal); // clean up delete [] set; // check if any atoms were lost bigint natoms; bigint nblocal = atom->nlocal; - MPI_Allreduce(&nblocal,&natoms,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&nblocal,&natoms,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); if (natoms != atom->natoms) { char str[128]; sprintf(str,"Lost atoms via displace_box: original %lu current %lu", atom->natoms,natoms); error->all(str); } } /* ---------------------------------------------------------------------- parse optional parameters at end of displace_box input line ------------------------------------------------------------------------- */ void DisplaceBox::options(int narg, char **arg) { if (narg < 0) error->all("Illegal displace_box command"); remapflag = X_REMAP; scaleflag = 1; int iarg = 0; while (iarg < narg) { if (strcmp(arg[iarg],"remap") == 0) { if (iarg+2 > narg) error->all("Illegal displace_box command"); if (strcmp(arg[iarg+1],"x") == 0) remapflag = X_REMAP; else if (strcmp(arg[iarg+1],"none") == 0) remapflag = NO_REMAP; else error->all("Illegal displace_box command"); iarg += 2; } else if (strcmp(arg[iarg],"units") == 0) { if (iarg+2 > narg) error->all("Illegal displace_box command"); if (strcmp(arg[iarg+1],"box") == 0) scaleflag = 0; else if (strcmp(arg[iarg+1],"lattice") == 0) scaleflag = 1; else error->all("Illegal displace_box command"); iarg += 2; } else error->all("Illegal displace_box command"); } } diff --git a/src/finish.cpp b/src/finish.cpp index 4512a3f97..1292cc7bf 100644 --- a/src/finish.cpp +++ b/src/finish.cpp @@ -1,573 +1,573 @@ /* ---------------------------------------------------------------------- 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. ------------------------------------------------------------------------- */ #include "mpi.h" #include "math.h" #include "string.h" #include "stdio.h" #include "finish.h" #include "timer.h" #include "atom.h" #include "force.h" #include "kspace.h" #include "update.h" #include "min.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "output.h" #include "memory.h" using namespace LAMMPS_NS; #define MIN(A,B) ((A) < (B)) ? (A) : (B) #define MAX(A,B) ((A) > (B)) ? (A) : (B) /* ---------------------------------------------------------------------- */ Finish::Finish(LAMMPS *lmp) : Pointers(lmp) {} /* ---------------------------------------------------------------------- */ void Finish::end(int flag) { int i,m,nneigh,nneighfull; int histo[10]; int loopflag,minflag,prdflag,timeflag,fftflag,histoflag,neighflag; double time,tmp,ave,max,min; double time_loop,time_other; bigint natoms; int me,nprocs; MPI_Comm_rank(world,&me); MPI_Comm_size(world,&nprocs); // choose flavors of statistical output // flag determines caller // flag = 0 = just loop summary // flag = 1 = dynamics or minimization // flag = 2 = PRD loopflag = 1; minflag = prdflag = timeflag = fftflag = histoflag = neighflag = 0; if (flag == 1) { if (update->whichflag == 2) minflag = 1; timeflag = histoflag = neighflag = 1; if (strstr(force->kspace_style,"pppm")) fftflag = 1; } if (flag == 2) { prdflag = histoflag = neighflag = 1; } // loop stats if (loopflag) { time_other = timer->array[TIME_LOOP] - (timer->array[TIME_PAIR] + timer->array[TIME_BOND] + timer->array[TIME_KSPACE] + timer->array[TIME_NEIGHBOR] + timer->array[TIME_COMM] + timer->array[TIME_OUTPUT]); time_loop = timer->array[TIME_LOOP]; MPI_Allreduce(&time_loop,&tmp,1,MPI_DOUBLE,MPI_SUM,world); time_loop = tmp/nprocs; // overall loop time // use actual natoms, in case atoms were lost bigint nblocal = atom->nlocal; - MPI_Allreduce(&nblocal,&natoms,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&nblocal,&natoms,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); if (me == 0) { if (screen) fprintf(screen, "Loop time of %g on %d procs for %d steps with %lu atoms\n", time_loop,nprocs,update->nsteps,natoms); if (logfile) fprintf(logfile, "Loop time of %g on %d procs for %d steps with %lu atoms\n", time_loop,nprocs,update->nsteps,natoms); } if (time_loop == 0.0) time_loop = 1.0; } // minimization stats if (minflag) { if (me == 0) { if (screen) fprintf(screen,"\n"); if (logfile) fprintf(logfile,"\n"); } if (me == 0) { if (screen) { fprintf(screen,"Minimization stats:\n"); fprintf(screen," Stopping criterion = %s\n", update->minimize->stopstr); fprintf(screen," Energy initial, next-to-last, final = \n" " %18.12g %18.12g %18.12g\n", update->minimize->einitial,update->minimize->eprevious, update->minimize->efinal); fprintf(screen," Force two-norm initial, final = %g %g\n", update->minimize->fnorm2_init,update->minimize->fnorm2_final); fprintf(screen," Force max component initial, final = %g %g\n", update->minimize->fnorminf_init, update->minimize->fnorminf_final); fprintf(screen," Final line search alpha, max atom move = %g %g\n", update->minimize->alpha_final, update->minimize->alpha_final* update->minimize->fnorminf_final); fprintf(screen," Iterations, force evaluations = %d %d\n", update->minimize->niter,update->minimize->neval); } if (logfile) { fprintf(logfile,"Minimization stats:\n"); fprintf(logfile," Stopping criterion = %s\n", update->minimize->stopstr); fprintf(logfile," Energy initial, next-to-last, final = \n" " %18.12g %18.12g %18.12g\n", update->minimize->einitial,update->minimize->eprevious, update->minimize->efinal); fprintf(logfile," Force two-norm initial, final = %g %g\n", update->minimize->fnorm2_init,update->minimize->fnorm2_final); fprintf(logfile," Force max component initial, final = %g %g\n", update->minimize->fnorminf_init, update->minimize->fnorminf_final); fprintf(logfile," Final line search alpha, max atom move = %g %g\n", update->minimize->alpha_final, update->minimize->alpha_final* update->minimize->fnorminf_final); fprintf(logfile," Iterations, force evaluations = %d %d\n", update->minimize->niter,update->minimize->neval); } } } // PRD stats using PAIR,BOND,KSPACE for dephase,dynamics,quench if (prdflag) { if (me == 0) { if (screen) fprintf(screen,"\n"); if (logfile) fprintf(logfile,"\n"); } if (screen) fprintf(screen,"PRD stats:\n"); if (logfile) fprintf(logfile,"PRD stats:\n"); time = timer->array[TIME_PAIR]; MPI_Allreduce(&time,&tmp,1,MPI_DOUBLE,MPI_SUM,world); time = tmp/nprocs; if (me == 0) { if (screen) fprintf(screen," Dephase time (%%) = %g (%g)\n", time,time/time_loop*100.0); if (logfile) fprintf(logfile," Dephase time (%%) = %g (%g)\n", time,time/time_loop*100.0); } time = timer->array[TIME_BOND]; MPI_Allreduce(&time,&tmp,1,MPI_DOUBLE,MPI_SUM,world); time = tmp/nprocs; if (me == 0) { if (screen) fprintf(screen," Dynamics time (%%) = %g (%g)\n", time,time/time_loop*100.0); if (logfile) fprintf(logfile," Dynamics time (%%) = %g (%g)\n", time,time/time_loop*100.0); } time = timer->array[TIME_KSPACE]; MPI_Allreduce(&time,&tmp,1,MPI_DOUBLE,MPI_SUM,world); time = tmp/nprocs; if (me == 0) { if (screen) fprintf(screen," Quench time (%%) = %g (%g)\n", time,time/time_loop*100.0); if (logfile) fprintf(logfile," Quench time (%%) = %g (%g)\n", time,time/time_loop*100.0); } time = time_other; MPI_Allreduce(&time,&tmp,1,MPI_DOUBLE,MPI_SUM,world); time = tmp/nprocs; if (me == 0) { if (screen) fprintf(screen," Other time (%%) = %g (%g)\n", time,time/time_loop*100.0); if (logfile) fprintf(logfile," Other time (%%) = %g (%g)\n", time,time/time_loop*100.0); } } // timing breakdowns if (timeflag) { if (me == 0) { if (screen) fprintf(screen,"\n"); if (logfile) fprintf(logfile,"\n"); } time = timer->array[TIME_PAIR]; MPI_Allreduce(&time,&tmp,1,MPI_DOUBLE,MPI_SUM,world); time = tmp/nprocs; if (me == 0) { if (screen) fprintf(screen,"Pair time (%%) = %g (%g)\n", time,time/time_loop*100.0); if (logfile) fprintf(logfile,"Pair time (%%) = %g (%g)\n", time,time/time_loop*100.0); } if (atom->molecular) { time = timer->array[TIME_BOND]; MPI_Allreduce(&time,&tmp,1,MPI_DOUBLE,MPI_SUM,world); time = tmp/nprocs; if (me == 0) { if (screen) fprintf(screen,"Bond time (%%) = %g (%g)\n", time,time/time_loop*100.0); if (logfile) fprintf(logfile,"Bond time (%%) = %g (%g)\n", time,time/time_loop*100.0); } } if (force->kspace) { time = timer->array[TIME_KSPACE]; MPI_Allreduce(&time,&tmp,1,MPI_DOUBLE,MPI_SUM,world); time = tmp/nprocs; if (me == 0) { if (screen) fprintf(screen,"Kspce time (%%) = %g (%g)\n", time,time/time_loop*100.0); if (logfile) fprintf(logfile,"Kspce time (%%) = %g (%g)\n", time,time/time_loop*100.0); } } time = timer->array[TIME_NEIGHBOR]; MPI_Allreduce(&time,&tmp,1,MPI_DOUBLE,MPI_SUM,world); time = tmp/nprocs; if (me == 0) { if (screen) fprintf(screen,"Neigh time (%%) = %g (%g)\n", time,time/time_loop*100.0); if (logfile) fprintf(logfile,"Neigh time (%%) = %g (%g)\n", time,time/time_loop*100.0); } time = timer->array[TIME_COMM]; MPI_Allreduce(&time,&tmp,1,MPI_DOUBLE,MPI_SUM,world); time = tmp/nprocs; if (me == 0) { if (screen) fprintf(screen,"Comm time (%%) = %g (%g)\n", time,time/time_loop*100.0); if (logfile) fprintf(logfile,"Comm time (%%) = %g (%g)\n", time,time/time_loop*100.0); } time = timer->array[TIME_OUTPUT]; MPI_Allreduce(&time,&tmp,1,MPI_DOUBLE,MPI_SUM,world); time = tmp/nprocs; if (me == 0) { if (screen) fprintf(screen,"Outpt time (%%) = %g (%g)\n", time,time/time_loop*100.0); if (logfile) fprintf(logfile,"Outpt time (%%) = %g (%g)\n", time,time/time_loop*100.0); } time = time_other; MPI_Allreduce(&time,&tmp,1,MPI_DOUBLE,MPI_SUM,world); time = tmp/nprocs; if (me == 0) { if (screen) fprintf(screen,"Other time (%%) = %g (%g)\n", time,time/time_loop*100.0); if (logfile) fprintf(logfile,"Other time (%%) = %g (%g)\n", time,time/time_loop*100.0); } } // FFT timing statistics // time3d,time1d = total time during run for 3d and 1d FFTs if (fftflag) { if (me == 0) { if (screen) fprintf(screen,"\n"); if (logfile) fprintf(logfile,"\n"); } int nsteps = update->nsteps; int nsample = 5; double time3d,time1d; force->kspace->timing(nsample,time3d,time1d); time3d = nsteps * time3d / nsample; MPI_Allreduce(&time3d,&tmp,1,MPI_DOUBLE,MPI_SUM,world); time3d = tmp/nprocs; time1d = nsteps * time1d / nsample; MPI_Allreduce(&time1d,&tmp,1,MPI_DOUBLE,MPI_SUM,world); time1d = tmp/nprocs; double time_kspace = timer->array[TIME_KSPACE]; MPI_Allreduce(&time_kspace,&tmp,1,MPI_DOUBLE,MPI_SUM,world); time_kspace = tmp/nprocs; double ntotal = 1.0 * force->kspace->nx_pppm * force->kspace->ny_pppm * force->kspace->nz_pppm; double nflops = 5.0 * ntotal * log(ntotal); double fraction,flop3,flop1; if (nsteps) { fraction = time3d/time_kspace*100.0; flop3 = nflops/1.0e9/(time3d/4.0/nsteps); flop1 = nflops/1.0e9/(time1d/4.0/nsteps); } else fraction = flop3 = flop1 = 0.0; if (me == 0) { if (screen) { fprintf(screen,"FFT time (%% of Kspce) = %g (%g)\n",time3d,fraction); fprintf(screen,"FFT Gflps 3d (1d only) = %g %g\n",flop3,flop1); } if (logfile) { fprintf(logfile,"FFT time (%% of Kspce) = %g (%g)\n",time3d,fraction); fprintf(logfile,"FFT Gflps 3d (1d only) = %g %g\n",flop3,flop1); } } } if (histoflag) { if (me == 0) { if (screen) fprintf(screen,"\n"); if (logfile) fprintf(logfile,"\n"); } tmp = atom->nlocal; stats(1,&tmp,&ave,&max,&min,10,histo); if (me == 0) { if (screen) { fprintf(screen,"Nlocal: %g ave %g max %g min\n",ave,max,min); fprintf(screen,"Histogram:"); for (i = 0; i < 10; i++) fprintf(screen," %d",histo[i]); fprintf(screen,"\n"); } if (logfile) { fprintf(logfile,"Nlocal: %g ave %g max %g min\n",ave,max,min); fprintf(logfile,"Histogram:"); for (i = 0; i < 10; i++) fprintf(logfile," %d",histo[i]); fprintf(logfile,"\n"); } } tmp = atom->nghost; stats(1,&tmp,&ave,&max,&min,10,histo); if (me == 0) { if (screen) { fprintf(screen,"Nghost: %g ave %g max %g min\n",ave,max,min); fprintf(screen,"Histogram:"); for (i = 0; i < 10; i++) fprintf(screen," %d",histo[i]); fprintf(screen,"\n"); } if (logfile) { fprintf(logfile,"Nghost: %g ave %g max %g min\n",ave,max,min); fprintf(logfile,"Histogram:"); for (i = 0; i < 10; i++) fprintf(logfile," %d",histo[i]); fprintf(logfile,"\n"); } } // find a non-skip neighbor list containing half the pairwise interactions // count neighbors in that list for stats purposes for (m = 0; m < neighbor->old_nrequest; m++) if ((neighbor->old_requests[m]->half || neighbor->old_requests[m]->gran || neighbor->old_requests[m]->respaouter || neighbor->old_requests[m]->half_from_full) && neighbor->old_requests[m]->skip == 0 && neighbor->lists[m]->numneigh) break; nneigh = 0; if (m < neighbor->old_nrequest) { int inum = neighbor->lists[m]->inum; int *ilist = neighbor->lists[m]->ilist; int *numneigh = neighbor->lists[m]->numneigh; for (i = 0; i < inum; i++) nneigh += numneigh[ilist[i]]; } tmp = nneigh; stats(1,&tmp,&ave,&max,&min,10,histo); if (me == 0) { if (screen) { fprintf(screen,"Neighs: %g ave %g max %g min\n",ave,max,min); fprintf(screen,"Histogram:"); for (i = 0; i < 10; i++) fprintf(screen," %d",histo[i]); fprintf(screen,"\n"); } if (logfile) { fprintf(logfile,"Neighs: %g ave %g max %g min\n",ave,max,min); fprintf(logfile,"Histogram:"); for (i = 0; i < 10; i++) fprintf(logfile," %d",histo[i]); fprintf(logfile,"\n"); } } // find a non-skip neighbor list containing full pairwise interactions // count neighbors in that list for stats purposes for (m = 0; m < neighbor->old_nrequest; m++) if (neighbor->old_requests[m]->full && neighbor->old_requests[m]->skip == 0) break; nneighfull = 0; if (m < neighbor->old_nrequest) { if (neighbor->lists[m]->numneigh > 0) { int inum = neighbor->lists[m]->inum; int *ilist = neighbor->lists[m]->ilist; int *numneigh = neighbor->lists[m]->numneigh; for (i = 0; i < inum; i++) nneighfull += numneigh[ilist[i]]; } tmp = nneighfull; stats(1,&tmp,&ave,&max,&min,10,histo); if (me == 0) { if (screen) { fprintf(screen,"FullNghs: %g ave %g max %g min\n",ave,max,min); fprintf(screen,"Histogram:"); for (i = 0; i < 10; i++) fprintf(screen," %d",histo[i]); fprintf(screen,"\n"); } if (logfile) { fprintf(logfile,"FullNghs: %g ave %g max %g min\n",ave,max,min); fprintf(logfile,"Histogram:"); for (i = 0; i < 10; i++) fprintf(logfile," %d",histo[i]); fprintf(logfile,"\n"); } } } } if (neighflag) { if (me == 0) { if (screen) fprintf(screen,"\n"); if (logfile) fprintf(logfile,"\n"); } tmp = MAX(nneigh,nneighfull); double nall; MPI_Allreduce(&tmp,&nall,1,MPI_DOUBLE,MPI_SUM,world); int nspec; double nspec_all; if (atom->molecular) { nspec = 0; for (i = 0; i < atom->nlocal; i++) nspec += atom->nspecial[i][2]; tmp = nspec; MPI_Allreduce(&tmp,&nspec_all,1,MPI_DOUBLE,MPI_SUM,world); } if (me == 0) { if (screen) { if (nall < 2.0e9) fprintf(screen, "Total # of neighbors = %d\n",static_cast<int> (nall)); else fprintf(screen,"Total # of neighbors = %g\n",nall); if (natoms > 0) fprintf(screen,"Ave neighs/atom = %g\n",nall/natoms); if (atom->molecular && natoms > 0) fprintf(screen,"Ave special neighs/atom = %g\n",nspec_all/natoms); fprintf(screen,"Neighbor list builds = %d\n",neighbor->ncalls); fprintf(screen,"Dangerous builds = %d\n",neighbor->ndanger); } if (logfile) { if (nall < 2.0e9) fprintf(logfile, "Total # of neighbors = %d\n",static_cast<int> (nall)); else fprintf(logfile,"Total # of neighbors = %g\n",nall); if (natoms > 0) fprintf(logfile,"Ave neighs/atom = %g\n",nall/natoms); if (atom->molecular && natoms > 0) fprintf(logfile,"Ave special neighs/atom = %g\n",nspec_all/natoms); fprintf(logfile,"Neighbor list builds = %d\n",neighbor->ncalls); fprintf(logfile,"Dangerous builds = %d\n",neighbor->ndanger); } } } if (logfile) fflush(logfile); } /* ---------------------------------------------------------------------- */ void Finish::stats(int n, double *data, double *pave, double *pmax, double *pmin, int nhisto, int *histo) { int i,m; int *histotmp; double min = 1.0e20; double max = -1.0e20; double ave = 0.0; for (i = 0; i < n; i++) { ave += data[i]; if (data[i] < min) min = data[i]; if (data[i] > max) max = data[i]; } int ntotal; MPI_Allreduce(&n,&ntotal,1,MPI_INT,MPI_SUM,world); double tmp; MPI_Allreduce(&ave,&tmp,1,MPI_DOUBLE,MPI_SUM,world); ave = tmp/ntotal; MPI_Allreduce(&min,&tmp,1,MPI_DOUBLE,MPI_MIN,world); min = tmp; MPI_Allreduce(&max,&tmp,1,MPI_DOUBLE,MPI_MAX,world); max = tmp; for (i = 0; i < nhisto; i++) histo[i] = 0; double del = max - min; for (i = 0; i < n; i++) { if (del == 0.0) m = 0; else m = static_cast<int> ((data[i]-min)/del * nhisto); if (m > nhisto-1) m = nhisto-1; histo[m]++; } histotmp = (int *) memory->smalloc(nhisto*sizeof(int),"finish:histotmp"); MPI_Allreduce(histo,histotmp,nhisto,MPI_INT,MPI_SUM,world); for (i = 0; i < nhisto; i++) histo[i] = histotmp[i]; memory->sfree(histotmp); *pave = ave; *pmax = max; *pmin = min; } diff --git a/src/group.cpp b/src/group.cpp index bd517d79e..b2ee3c4af 100644 --- a/src/group.cpp +++ b/src/group.cpp @@ -1,1469 +1,1469 @@ /* ---------------------------------------------------------------------- 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. ------------------------------------------------------------------------- */ #include "math.h" #include "mpi.h" #include "stdio.h" #include "string.h" #include "stdlib.h" #include "group.h" #include "lmptype.h" #include "domain.h" #include "atom.h" #include "force.h" #include "region.h" #include "modify.h" #include "fix.h" #include "compute.h" #include "output.h" #include "dump.h" #include "error.h" using namespace LAMMPS_NS; #define MAX_GROUP 32 enum{TYPE,MOLECULE,ID}; enum{LT,LE,GT,GE,EQ,NEQ,BETWEEN}; #define BIG 1.0e20 #define MIN(a,b) ((a) < (b) ? (a) : (b)) #define MAX(a,b) ((a) > (b) ? (a) : (b)) /* ---------------------------------------------------------------------- initialize group memory ------------------------------------------------------------------------- */ Group::Group(LAMMPS *lmp) : Pointers(lmp) { MPI_Comm_rank(world,&me); names = new char*[MAX_GROUP]; bitmask = new int[MAX_GROUP]; inversemask = new int[MAX_GROUP]; for (int i = 0; i < MAX_GROUP; i++) names[i] = NULL; for (int i = 0; i < MAX_GROUP; i++) bitmask[i] = 1 << i; for (int i = 0; i < MAX_GROUP; i++) inversemask[i] = bitmask[i] ^ ~0; // create "all" group char *str = (char *) "all"; int n = strlen(str) + 1; names[0] = new char[n]; strcpy(names[0],str); ngroup = 1; } /* ---------------------------------------------------------------------- free all memory ------------------------------------------------------------------------- */ Group::~Group() { for (int i = 0; i < MAX_GROUP; i++) delete [] names[i]; delete [] names; delete [] bitmask; delete [] inversemask; } /* ---------------------------------------------------------------------- assign atoms to a new or existing group ------------------------------------------------------------------------- */ void Group::assign(int narg, char **arg) { int i; if (domain->box_exist == 0) error->all("Group command before simulation box is defined"); if (narg < 2) error->all("Illegal group command"); // delete the group if not being used elsewhere // clear mask of each atom assigned to this group if (strcmp(arg[1],"delete") == 0) { int igroup = find(arg[0]); if (igroup == -1) error->all("Could not find group delete group ID"); if (igroup == 0) error->all("Cannot delete group all"); for (i = 0; i < modify->nfix; i++) if (modify->fix[i]->igroup == igroup) error->all("Cannot delete group currently used by a fix"); for (i = 0; i < modify->ncompute; i++) if (modify->compute[i]->igroup == igroup) error->all("Cannot delete group currently used by a compute"); for (i = 0; i < output->ndump; i++) if (output->dump[i]->igroup == igroup) error->all("Cannot delete group currently used by a dump"); if (atom->firstgroupname && strcmp(arg[0],atom->firstgroupname) == 0) error->all("Cannot delete group currently used by atom_modify first"); int *mask = atom->mask; int nlocal = atom->nlocal; int bits = inversemask[igroup]; for (i = 0; i < nlocal; i++) mask[i] &= bits; delete [] names[igroup]; names[igroup] = NULL; ngroup--; return; } // find group in existing list // add a new group if igroup = -1 int igroup = find(arg[0]); if (igroup == -1) { if (ngroup == MAX_GROUP) error->all("Too many groups"); igroup = find_unused(); int n = strlen(arg[0]) + 1; names[igroup] = new char[n]; strcpy(names[igroup],arg[0]); ngroup++; } double **x = atom->x; int *mask = atom->mask; int nlocal = atom->nlocal; int bit = bitmask[igroup]; // style = region // add to group if atom is in region if (strcmp(arg[1],"region") == 0) { if (narg != 3) error->all("Illegal group command"); int iregion = domain->find_region(arg[2]); if (iregion == -1) error->all("Group region ID does not exist"); for (i = 0; i < nlocal; i++) if (domain->regions[iregion]->match(x[i][0],x[i][1],x[i][2])) mask[i] |= bit; // style = logical condition } else if (narg >= 3 && (strcmp(arg[2],"<") == 0 || strcmp(arg[2],">") == 0 || strcmp(arg[2],"<=") == 0 || strcmp(arg[2],">=") == 0 || strcmp(arg[2],"<>") == 0)) { if (narg < 4 || narg > 5) error->all("Illegal group command"); int category,condition,bound1,bound2; if (strcmp(arg[1],"type") == 0) category = TYPE; else if (strcmp(arg[1],"molecule") == 0) category = MOLECULE; else if (strcmp(arg[1],"id") == 0) category = ID; else error->all("Illegal group command"); if (strcmp(arg[2],"<") == 0) condition = LT; else if (strcmp(arg[2],"<=") == 0) condition = LE; else if (strcmp(arg[2],">") == 0) condition = GT; else if (strcmp(arg[2],">=") == 0) condition = GE; else if (strcmp(arg[2],"==") == 0) condition = EQ; else if (strcmp(arg[2],"!=") == 0) condition = NEQ; else if (strcmp(arg[2],"<>") == 0) condition = BETWEEN; else error->all("Illegal group command"); bound1 = atoi(arg[3]); bound2 = -1; if (condition == BETWEEN) { if (narg != 5) error->all("Illegal group command"); bound2 = atoi(arg[4]); } int *attribute; if (category == TYPE) attribute = atom->type; else if (category == MOLECULE) attribute = atom->molecule; else if (category == ID) attribute = atom->tag; // add to group if meets condition if (condition == LT) { for (i = 0; i < nlocal; i++) if (attribute[i] < bound1) mask[i] |= bit; } else if (condition == LE) { for (i = 0; i < nlocal; i++) if (attribute[i] <= bound1) mask[i] |= bit; } else if (condition == GT) { for (i = 0; i < nlocal; i++) if (attribute[i] > bound1) mask[i] |= bit; } else if (condition == GE) { for (i = 0; i < nlocal; i++) if (attribute[i] >= bound1) mask[i] |= bit; } else if (condition == EQ) { for (i = 0; i < nlocal; i++) if (attribute[i] == bound1) mask[i] |= bit; } else if (condition == NEQ) { for (i = 0; i < nlocal; i++) if (attribute[i] != bound1) mask[i] |= bit; } else if (condition == BETWEEN) { for (i = 0; i < nlocal; i++) if (attribute[i] >= bound1 && attribute[i] <= bound2) mask[i] |= bit; } // style = list of values } else if (strcmp(arg[1],"type") == 0 || strcmp(arg[1],"molecule") == 0 || strcmp(arg[1],"id") == 0) { if (narg < 3) error->all("Illegal group command"); int length = narg-2; int *list = new int[length]; int category; if (strcmp(arg[1],"type") == 0) category = TYPE; else if (strcmp(arg[1],"molecule") == 0) category = MOLECULE; else if (strcmp(arg[1],"id") == 0) category = ID; else error->all("Illegal group command"); length = narg - 2; for (int iarg = 2; iarg < narg; iarg++) list[iarg-2] = atoi(arg[iarg]); int *attribute; if (category == TYPE) attribute = atom->type; else if (category == MOLECULE) attribute = atom->molecule; else if (category == ID) attribute = atom->tag; // add to group if attribute is any in list for (int ilist = 0; ilist < length; ilist++) for (i = 0; i < nlocal; i++) if (attribute[i] == list[ilist]) mask[i] |= bit; delete [] list; // style = subtract } else if (strcmp(arg[1],"subtract") == 0) { if (narg < 4) error->all("Illegal group command"); int length = narg-2; int *list = new int[length]; int jgroup; for (int iarg = 2; iarg < narg; iarg++) { jgroup = find(arg[iarg]); if (jgroup == -1) error->all("Group ID does not exist"); list[iarg-2] = jgroup; } // add to group if in 1st group in list int otherbit = bitmask[list[0]]; for (i = 0; i < nlocal; i++) if (mask[i] & otherbit) mask[i] |= bit; // remove atoms if they are in any of the other groups // AND with inverse mask removes the atom from group int inverse = inversemask[igroup]; for (int ilist = 1; ilist < length; ilist++) { otherbit = bitmask[list[ilist]]; for (i = 0; i < nlocal; i++) if (mask[i] & otherbit) mask[i] &= inverse; } delete [] list; // style = union } else if (strcmp(arg[1],"union") == 0) { if (narg < 3) error->all("Illegal group command"); int length = narg-2; int *list = new int[length]; int jgroup; for (int iarg = 2; iarg < narg; iarg++) { jgroup = find(arg[iarg]); if (jgroup == -1) error->all("Group ID does not exist"); list[iarg-2] = jgroup; } // add to group if in any other group in list int otherbit; for (int ilist = 0; ilist < length; ilist++) { otherbit = bitmask[list[ilist]]; for (i = 0; i < nlocal; i++) if (mask[i] & otherbit) mask[i] |= bit; } delete [] list; // style = intersect } else if (strcmp(arg[1],"intersect") == 0) { if (narg < 4) error->all("Illegal group command"); int length = narg-2; int *list = new int[length]; int jgroup; for (int iarg = 2; iarg < narg; iarg++) { jgroup = find(arg[iarg]); if (jgroup == -1) error->all("Group ID does not exist"); list[iarg-2] = jgroup; } // add to group if in all groups in list int otherbit,ok,ilist; for (i = 0; i < nlocal; i++) { ok = 1; for (ilist = 0; ilist < length; ilist++) { otherbit = bitmask[list[ilist]]; if ((mask[i] & otherbit) == 0) ok = 0; } if (ok) mask[i] |= bit; } delete [] list; // not a valid group style } else error->all("Illegal group command"); // print stats for changed group int n; n = 0; for (i = 0; i < nlocal; i++) if (mask[i] & bit) n++; double rlocal = n; double all; MPI_Allreduce(&rlocal,&all,1,MPI_DOUBLE,MPI_SUM,world); if (me == 0) { if (screen) fprintf(screen,"%.15g atoms in group %s\n",all,names[igroup]); if (logfile) fprintf(logfile,"%.15g atoms in group %s\n",all,names[igroup]); } } /* ---------------------------------------------------------------------- add flagged atoms to a new or existing group ------------------------------------------------------------------------- */ void Group::create(char *name, int *flag) { int i; // find group in existing list // add a new group if igroup = -1 int igroup = find(name); if (igroup == -1) { if (ngroup == MAX_GROUP) error->all("Too many groups"); igroup = find_unused(); int n = strlen(name) + 1; names[igroup] = new char[n]; strcpy(names[igroup],name); ngroup++; } // add atoms to group whose flags are set int *mask = atom->mask; int nlocal = atom->nlocal; int bit = bitmask[igroup]; for (i = 0; i < nlocal; i++) if (flag[i]) mask[i] |= bit; } /* ---------------------------------------------------------------------- return group index if name matches existing group, -1 if no such group ------------------------------------------------------------------------- */ int Group::find(const char *name) { for (int igroup = 0; igroup < MAX_GROUP; igroup++) if (names[igroup] && strcmp(name,names[igroup]) == 0) return igroup; return -1; } /* ---------------------------------------------------------------------- return index of first available group should never be called when group limit has been reached ------------------------------------------------------------------------- */ int Group::find_unused() { for (int igroup = 0; igroup < MAX_GROUP; igroup++) if (names[igroup] == NULL) return igroup; return -1; } /* ---------------------------------------------------------------------- write group info to a restart file only called by proc 0 ------------------------------------------------------------------------- */ void Group::write_restart(FILE *fp) { fwrite(&ngroup,sizeof(int),1,fp); // use count to not change restart format with deleted groups // remove this on next major release int n; int count = 0; for (int i = 0; i < MAX_GROUP; i++) { if (names[i]) n = strlen(names[i]) + 1; else n = 0; fwrite(&n,sizeof(int),1,fp); if (n) { fwrite(names[i],sizeof(char),n,fp); count++; } if (count == ngroup) break; } } /* ---------------------------------------------------------------------- read group info from a restart file proc 0 reads, bcast to all procs ------------------------------------------------------------------------- */ void Group::read_restart(FILE *fp) { int i,n; // delete existing group names // atom masks will be overwritten by reading of restart file for (i = 0; i < MAX_GROUP; i++) delete [] names[i]; if (me == 0) fread(&ngroup,sizeof(int),1,fp); MPI_Bcast(&ngroup,1,MPI_INT,0,world); // use count to not change restart format with deleted groups // remove this on next major release int count = 0; for (i = 0; i < MAX_GROUP; i++) { if (count == ngroup) { names[i] = NULL; continue; } if (me == 0) fread(&n,sizeof(int),1,fp); MPI_Bcast(&n,1,MPI_INT,0,world); if (n) { names[i] = new char[n]; if (me == 0) fread(names[i],sizeof(char),n,fp); MPI_Bcast(names[i],n,MPI_CHAR,0,world); count++; } else names[i] = NULL; } } // ---------------------------------------------------------------------- // computations on a group of atoms // ---------------------------------------------------------------------- /* ---------------------------------------------------------------------- count atoms in group ------------------------------------------------------------------------- */ bigint Group::count(int igroup) { int groupbit = bitmask[igroup]; int *mask = atom->mask; int nlocal = atom->nlocal; int n = 0; for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) n++; bigint nsingle = n; bigint nall; - MPI_Allreduce(&nsingle,&nall,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&nsingle,&nall,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); return nall; } /* ---------------------------------------------------------------------- count atoms in group and region ------------------------------------------------------------------------- */ bigint Group::count(int igroup, int iregion) { int groupbit = bitmask[igroup]; Region *region = domain->regions[iregion]; double **x = atom->x; int *mask = atom->mask; int nlocal = atom->nlocal; int n = 0; for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit && region->match(x[i][0],x[i][1],x[i][2])) n++; bigint nsingle = n; bigint nall; - MPI_Allreduce(&nsingle,&nall,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&nsingle,&nall,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); return nall; } /* ---------------------------------------------------------------------- compute the total mass of group of atoms use either per-type mass or per-atom rmass ------------------------------------------------------------------------- */ double Group::mass(int igroup) { int groupbit = bitmask[igroup]; double *mass = atom->mass; double *rmass = atom->rmass; int *mask = atom->mask; int *type = atom->type; int nlocal = atom->nlocal; double one = 0.0; if (rmass) { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) one += rmass[i]; } else { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) one += mass[type[i]]; } double all; MPI_Allreduce(&one,&all,1,MPI_DOUBLE,MPI_SUM,world); return all; } /* ---------------------------------------------------------------------- compute the total mass of group of atoms in region use either per-type mass or per-atom rmass ------------------------------------------------------------------------- */ double Group::mass(int igroup, int iregion) { int groupbit = bitmask[igroup]; Region *region = domain->regions[iregion]; double **x = atom->x; double *mass = atom->mass; double *rmass = atom->rmass; int *mask = atom->mask; int *type = atom->type; int nlocal = atom->nlocal; double one = 0.0; if (rmass) { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit && region->match(x[i][0],x[i][1],x[i][2])) one += rmass[i]; } else { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit && region->match(x[i][0],x[i][1],x[i][2])) one += mass[type[i]]; } double all; MPI_Allreduce(&one,&all,1,MPI_DOUBLE,MPI_SUM,world); return all; } /* ---------------------------------------------------------------------- compute the total charge of group of atoms ------------------------------------------------------------------------- */ double Group::charge(int igroup) { int groupbit = bitmask[igroup]; double *q = atom->q; int *mask = atom->mask; int nlocal = atom->nlocal; double qone = 0.0; for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) qone += q[i]; double qall; MPI_Allreduce(&qone,&qall,1,MPI_DOUBLE,MPI_SUM,world); return qall; } /* ---------------------------------------------------------------------- compute the total charge of group of atoms in region ------------------------------------------------------------------------- */ double Group::charge(int igroup, int iregion) { int groupbit = bitmask[igroup]; Region *region = domain->regions[iregion]; double **x = atom->x; double *q = atom->q; int *mask = atom->mask; int nlocal = atom->nlocal; double qone = 0.0; for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit && region->match(x[i][0],x[i][1],x[i][2])) qone += q[i]; double qall; MPI_Allreduce(&qone,&qall,1,MPI_DOUBLE,MPI_SUM,world); return qall; } /* ---------------------------------------------------------------------- compute the coordinate bounds of the group of atoms periodic images are not considered, so atoms are NOT unwrapped ------------------------------------------------------------------------- */ void Group::bounds(int igroup, double *minmax) { int groupbit = bitmask[igroup]; double extent[6]; extent[0] = extent[2] = extent[4] = BIG; extent[1] = extent[3] = extent[5] = -BIG; double **x = atom->x; int *mask = atom->mask; int nlocal = atom->nlocal; for (int i = 0; i < nlocal; i++) { if (mask[i] & groupbit) { extent[0] = MIN(extent[0],x[i][0]); extent[1] = MAX(extent[1],x[i][0]); extent[2] = MIN(extent[2],x[i][1]); extent[3] = MAX(extent[3],x[i][1]); extent[4] = MIN(extent[4],x[i][2]); extent[5] = MAX(extent[5],x[i][2]); } } // compute extent across all procs // flip sign of MIN to do it in one Allreduce MAX // set box by extent in shrink-wrapped dims extent[0] = -extent[0]; extent[2] = -extent[2]; extent[4] = -extent[4]; MPI_Allreduce(extent,minmax,6,MPI_DOUBLE,MPI_MAX,world); minmax[0] = -minmax[0]; minmax[2] = -minmax[2]; minmax[4] = -minmax[4]; } /* ---------------------------------------------------------------------- compute the coordinate bounds of the group of atoms in region periodic images are not considered, so atoms are NOT unwrapped ------------------------------------------------------------------------- */ void Group::bounds(int igroup, double *minmax, int iregion) { int groupbit = bitmask[igroup]; Region *region = domain->regions[iregion]; double extent[6]; extent[0] = extent[2] = extent[4] = BIG; extent[1] = extent[3] = extent[5] = -BIG; double **x = atom->x; int *mask = atom->mask; int nlocal = atom->nlocal; for (int i = 0; i < nlocal; i++) { if (mask[i] & groupbit && region->match(x[i][0],x[i][1],x[i][2])) { extent[0] = MIN(extent[0],x[i][0]); extent[1] = MAX(extent[1],x[i][0]); extent[2] = MIN(extent[2],x[i][1]); extent[3] = MAX(extent[3],x[i][1]); extent[4] = MIN(extent[4],x[i][2]); extent[5] = MAX(extent[5],x[i][2]); } } // compute extent across all procs // flip sign of MIN to do it in one Allreduce MAX // set box by extent in shrink-wrapped dims extent[0] = -extent[0]; extent[2] = -extent[2]; extent[4] = -extent[4]; MPI_Allreduce(extent,minmax,6,MPI_DOUBLE,MPI_MAX,world); minmax[0] = -minmax[0]; minmax[2] = -minmax[2]; minmax[4] = -minmax[4]; } /* ---------------------------------------------------------------------- compute the center-of-mass coords of group of atoms masstotal = total mass return center-of-mass coords in cm[] must unwrap atoms to compute center-of-mass correctly ------------------------------------------------------------------------- */ void Group::xcm(int igroup, double masstotal, double *cm) { int groupbit = bitmask[igroup]; double **x = atom->x; int *mask = atom->mask; int *type = atom->type; int *image = atom->image; double *mass = atom->mass; double *rmass = atom->rmass; int nlocal = atom->nlocal; double cmone[3]; cmone[0] = cmone[1] = cmone[2] = 0.0; double xprd = domain->xprd; double yprd = domain->yprd; double zprd = domain->zprd; int xbox,ybox,zbox; double massone; if (rmass) { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) { xbox = (image[i] & 1023) - 512; ybox = (image[i] >> 10 & 1023) - 512; zbox = (image[i] >> 20) - 512; massone = rmass[i]; cmone[0] += (x[i][0] + xbox*xprd) * massone; cmone[1] += (x[i][1] + ybox*yprd) * massone; cmone[2] += (x[i][2] + zbox*zprd) * massone; } } else { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) { xbox = (image[i] & 1023) - 512; ybox = (image[i] >> 10 & 1023) - 512; zbox = (image[i] >> 20) - 512; massone = mass[type[i]]; cmone[0] += (x[i][0] + xbox*xprd) * massone; cmone[1] += (x[i][1] + ybox*yprd) * massone; cmone[2] += (x[i][2] + zbox*zprd) * massone; } } MPI_Allreduce(cmone,cm,3,MPI_DOUBLE,MPI_SUM,world); if (masstotal > 0.0) { cm[0] /= masstotal; cm[1] /= masstotal; cm[2] /= masstotal; } } /* ---------------------------------------------------------------------- compute the center-of-mass coords of group of atoms in region mastotal = total mass return center-of-mass coords in cm[] must unwrap atoms to compute center-of-mass correctly ------------------------------------------------------------------------- */ void Group::xcm(int igroup, double masstotal, double *cm, int iregion) { int groupbit = bitmask[igroup]; Region *region = domain->regions[iregion]; double **x = atom->x; int *mask = atom->mask; int *type = atom->type; int *image = atom->image; double *mass = atom->mass; double *rmass = atom->rmass; int nlocal = atom->nlocal; double cmone[3]; cmone[0] = cmone[1] = cmone[2] = 0.0; double xprd = domain->xprd; double yprd = domain->yprd; double zprd = domain->zprd; int xbox,ybox,zbox; double massone; if (rmass) { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit && region->match(x[i][0],x[i][1],x[i][2])) { xbox = (image[i] & 1023) - 512; ybox = (image[i] >> 10 & 1023) - 512; zbox = (image[i] >> 20) - 512; massone = rmass[i]; cmone[0] += (x[i][0] + xbox*xprd) * massone; cmone[1] += (x[i][1] + ybox*yprd) * massone; cmone[2] += (x[i][2] + zbox*zprd) * massone; } } else { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit && region->match(x[i][0],x[i][1],x[i][2])) { xbox = (image[i] & 1023) - 512; ybox = (image[i] >> 10 & 1023) - 512; zbox = (image[i] >> 20) - 512; massone = mass[type[i]]; cmone[0] += (x[i][0] + xbox*xprd) * massone; cmone[1] += (x[i][1] + ybox*yprd) * massone; cmone[2] += (x[i][2] + zbox*zprd) * massone; } } MPI_Allreduce(cmone,cm,3,MPI_DOUBLE,MPI_SUM,world); if (masstotal > 0.0) { cm[0] /= masstotal; cm[1] /= masstotal; cm[2] /= masstotal; } } /* ---------------------------------------------------------------------- compute the center-of-mass velocity of group of atoms masstotal = total mass return center-of-mass velocity in cm[] ------------------------------------------------------------------------- */ void Group::vcm(int igroup, double masstotal, double *cm) { int groupbit = bitmask[igroup]; double **v = atom->v; int *mask = atom->mask; int *type = atom->type; double *mass = atom->mass; double *rmass = atom->rmass; int nlocal = atom->nlocal; double p[3],massone; p[0] = p[1] = p[2] = 0.0; if (rmass) { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) { massone = rmass[i]; p[0] += v[i][0]*massone; p[1] += v[i][1]*massone; p[2] += v[i][2]*massone; } } else { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) { massone = mass[type[i]]; p[0] += v[i][0]*massone; p[1] += v[i][1]*massone; p[2] += v[i][2]*massone; } } MPI_Allreduce(p,cm,3,MPI_DOUBLE,MPI_SUM,world); if (masstotal > 0.0) { cm[0] /= masstotal; cm[1] /= masstotal; cm[2] /= masstotal; } } /* ---------------------------------------------------------------------- compute the center-of-mass velocity of group of atoms in region masstotal = total mass return center-of-mass velocity in cm[] ------------------------------------------------------------------------- */ void Group::vcm(int igroup, double masstotal, double *cm, int iregion) { int groupbit = bitmask[igroup]; Region *region = domain->regions[iregion]; double **x = atom->x; double **v = atom->v; int *mask = atom->mask; int *type = atom->type; double *mass = atom->mass; double *rmass = atom->rmass; int nlocal = atom->nlocal; double p[3],massone; p[0] = p[1] = p[2] = 0.0; if (rmass) { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit && region->match(x[i][0],x[i][1],x[i][2])) { massone = rmass[i]; p[0] += v[i][0]*massone; p[1] += v[i][1]*massone; p[2] += v[i][2]*massone; } } else { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit && region->match(x[i][0],x[i][1],x[i][2])) { massone = mass[type[i]]; p[0] += v[i][0]*massone; p[1] += v[i][1]*massone; p[2] += v[i][2]*massone; } } MPI_Allreduce(p,cm,3,MPI_DOUBLE,MPI_SUM,world); if (masstotal > 0.0) { cm[0] /= masstotal; cm[1] /= masstotal; cm[2] /= masstotal; } } /* ---------------------------------------------------------------------- compute the total force on group of atoms ------------------------------------------------------------------------- */ void Group::fcm(int igroup, double *cm) { int groupbit = bitmask[igroup]; double **f = atom->f; int *mask = atom->mask; int nlocal = atom->nlocal; double flocal[3]; flocal[0] = flocal[1] = flocal[2] = 0.0; for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) { flocal[0] += f[i][0]; flocal[1] += f[i][1]; flocal[2] += f[i][2]; } MPI_Allreduce(flocal,cm,3,MPI_DOUBLE,MPI_SUM,world); } /* ---------------------------------------------------------------------- compute the total force on group of atoms in region ------------------------------------------------------------------------- */ void Group::fcm(int igroup, double *cm, int iregion) { int groupbit = bitmask[igroup]; Region *region = domain->regions[iregion]; double **x = atom->x; double **f = atom->f; int *mask = atom->mask; int nlocal = atom->nlocal; double flocal[3]; flocal[0] = flocal[1] = flocal[2] = 0.0; for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit && region->match(x[i][0],x[i][1],x[i][2])) { flocal[0] += f[i][0]; flocal[1] += f[i][1]; flocal[2] += f[i][2]; } MPI_Allreduce(flocal,cm,3,MPI_DOUBLE,MPI_SUM,world); } /* ---------------------------------------------------------------------- compute the total kinetic energy of group of atoms and return it ------------------------------------------------------------------------- */ double Group::ke(int igroup) { int groupbit = bitmask[igroup]; double **v = atom->v; int *mask = atom->mask; int *type = atom->type; double *mass = atom->mass; double *rmass = atom->rmass; int nlocal = atom->nlocal; double one = 0.0; if (rmass) { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) one += (v[i][0]*v[i][0] + v[i][1]*v[i][1] + v[i][2]*v[i][2]) * rmass[i]; } else { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) one += (v[i][0]*v[i][0] + v[i][1]*v[i][1] + v[i][2]*v[i][2]) * mass[type[i]]; } double all; MPI_Allreduce(&one,&all,1,MPI_DOUBLE,MPI_SUM,world); all *= 0.5 * force->mvv2e; return all; } /* ---------------------------------------------------------------------- compute the total kinetic energy of group of atoms in region and return it ------------------------------------------------------------------------- */ double Group::ke(int igroup, int iregion) { int groupbit = bitmask[igroup]; Region *region = domain->regions[iregion]; double **x = atom->x; double **v = atom->v; int *mask = atom->mask; int *type = atom->type; double *mass = atom->mass; double *rmass = atom->rmass; int nlocal = atom->nlocal; double one = 0.0; if (rmass) { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit && region->match(x[i][0],x[i][1],x[i][2])) one += (v[i][0]*v[i][0] + v[i][1]*v[i][1] + v[i][2]*v[i][2]) * rmass[i]; } else { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit && region->match(x[i][0],x[i][1],x[i][2])) one += (v[i][0]*v[i][0] + v[i][1]*v[i][1] + v[i][2]*v[i][2]) * mass[type[i]]; } double all; MPI_Allreduce(&one,&all,1,MPI_DOUBLE,MPI_SUM,world); all *= 0.5 * force->mvv2e; return all; } /* ---------------------------------------------------------------------- compute the radius-of-gyration of group of atoms around center-of-mass cm must unwrap atoms to compute Rg correctly ------------------------------------------------------------------------- */ double Group::gyration(int igroup, double masstotal, double *cm) { int groupbit = bitmask[igroup]; double **x = atom->x; int *mask = atom->mask; int *type = atom->type; int *image = atom->image; double *mass = atom->mass; double *rmass = atom->rmass; int nlocal = atom->nlocal; int xbox,ybox,zbox; double dx,dy,dz,massone; double xprd = domain->xprd; double yprd = domain->yprd; double zprd = domain->zprd; double rg = 0.0; for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) { xbox = (image[i] & 1023) - 512; ybox = (image[i] >> 10 & 1023) - 512; zbox = (image[i] >> 20) - 512; dx = (x[i][0] + xbox*xprd) - cm[0]; dy = (x[i][1] + ybox*yprd) - cm[1]; dz = (x[i][2] + zbox*zprd) - cm[2]; if (rmass) massone = rmass[i]; else massone = mass[type[i]]; rg += (dx*dx + dy*dy + dz*dz) * massone; } double rg_all; MPI_Allreduce(&rg,&rg_all,1,MPI_DOUBLE,MPI_SUM,world); if (masstotal > 0.0) return sqrt(rg_all/masstotal); return 0.0; } /* ---------------------------------------------------------------------- compute the radius-of-gyration of group of atoms in region around center-of-mass cm must unwrap atoms to compute Rg correctly ------------------------------------------------------------------------- */ double Group::gyration(int igroup, double masstotal, double *cm, int iregion) { int groupbit = bitmask[igroup]; Region *region = domain->regions[iregion]; double **x = atom->x; int *mask = atom->mask; int *type = atom->type; int *image = atom->image; double *mass = atom->mass; double *rmass = atom->rmass; int nlocal = atom->nlocal; int xbox,ybox,zbox; double dx,dy,dz,massone; double xprd = domain->xprd; double yprd = domain->yprd; double zprd = domain->zprd; double rg = 0.0; for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit && region->match(x[i][0],x[i][1],x[i][2])) { xbox = (image[i] & 1023) - 512; ybox = (image[i] >> 10 & 1023) - 512; zbox = (image[i] >> 20) - 512; dx = (x[i][0] + xbox*xprd) - cm[0]; dy = (x[i][1] + ybox*yprd) - cm[1]; dz = (x[i][2] + zbox*zprd) - cm[2]; if (rmass) massone = rmass[i]; else massone = mass[type[i]]; rg += (dx*dx + dy*dy + dz*dz) * massone; } double rg_all; MPI_Allreduce(&rg,&rg_all,1,MPI_DOUBLE,MPI_SUM,world); if (masstotal > 0.0) return sqrt(rg_all/masstotal); return 0.0; } /* ---------------------------------------------------------------------- compute the angular momentum L (lmom) of group around center-of-mass cm must unwrap atoms to compute L correctly ------------------------------------------------------------------------- */ void Group::angmom(int igroup, double *cm, double *lmom) { int groupbit = bitmask[igroup]; double **x = atom->x; double **v = atom->v; int *mask = atom->mask; int *type = atom->type; int *image = atom->image; double *mass = atom->mass; double *rmass = atom->rmass; int nlocal = atom->nlocal; int xbox,ybox,zbox; double dx,dy,dz,massone; double xprd = domain->xprd; double yprd = domain->yprd; double zprd = domain->zprd; double p[3]; p[0] = p[1] = p[2] = 0.0; for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) { xbox = (image[i] & 1023) - 512; ybox = (image[i] >> 10 & 1023) - 512; zbox = (image[i] >> 20) - 512; dx = (x[i][0] + xbox*xprd) - cm[0]; dy = (x[i][1] + ybox*yprd) - cm[1]; dz = (x[i][2] + zbox*zprd) - cm[2]; if (rmass) massone = rmass[i]; else massone = mass[type[i]]; p[0] += massone * (dy*v[i][2] - dz*v[i][1]); p[1] += massone * (dz*v[i][0] - dx*v[i][2]); p[2] += massone * (dx*v[i][1] - dy*v[i][0]); } MPI_Allreduce(p,lmom,3,MPI_DOUBLE,MPI_SUM,world); } /* ---------------------------------------------------------------------- compute the angular momentum L (lmom) of group of atoms in region around center-of-mass cm must unwrap atoms to compute L correctly ------------------------------------------------------------------------- */ void Group::angmom(int igroup, double *cm, double *lmom, int iregion) { int groupbit = bitmask[igroup]; Region *region = domain->regions[iregion]; double **x = atom->x; double **v = atom->v; int *mask = atom->mask; int *type = atom->type; int *image = atom->image; double *mass = atom->mass; double *rmass = atom->rmass; int nlocal = atom->nlocal; int xbox,ybox,zbox; double dx,dy,dz,massone; double xprd = domain->xprd; double yprd = domain->yprd; double zprd = domain->zprd; double p[3]; p[0] = p[1] = p[2] = 0.0; for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit && region->match(x[i][0],x[i][1],x[i][2])) { xbox = (image[i] & 1023) - 512; ybox = (image[i] >> 10 & 1023) - 512; zbox = (image[i] >> 20) - 512; dx = (x[i][0] + xbox*xprd) - cm[0]; dy = (x[i][1] + ybox*yprd) - cm[1]; dz = (x[i][2] + zbox*zprd) - cm[2]; if (rmass) massone = rmass[i]; else massone = mass[type[i]]; p[0] += massone * (dy*v[i][2] - dz*v[i][1]); p[1] += massone * (dz*v[i][0] - dx*v[i][2]); p[2] += massone * (dx*v[i][1] - dy*v[i][0]); } MPI_Allreduce(p,lmom,3,MPI_DOUBLE,MPI_SUM,world); } /* ---------------------------------------------------------------------- compute the torque T (tq) on group around center-of-mass cm must unwrap atoms to compute T correctly ------------------------------------------------------------------------- */ void Group::torque(int igroup, double *cm, double *tq) { int groupbit = bitmask[igroup]; double **x = atom->x; double **f = atom->f; int *mask = atom->mask; int *image = atom->image; int nlocal = atom->nlocal; int xbox,ybox,zbox; double dx,dy,dz; double xprd = domain->xprd; double yprd = domain->yprd; double zprd = domain->zprd; double tlocal[3]; tlocal[0] = tlocal[1] = tlocal[2] = 0.0; for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) { xbox = (image[i] & 1023) - 512; ybox = (image[i] >> 10 & 1023) - 512; zbox = (image[i] >> 20) - 512; dx = (x[i][0] + xbox*xprd) - cm[0]; dy = (x[i][1] + ybox*yprd) - cm[1]; dz = (x[i][2] + zbox*zprd) - cm[2]; tlocal[0] += dy*f[i][2] - dz*f[i][1]; tlocal[1] += dz*f[i][0] - dx*f[i][2]; tlocal[2] += dx*f[i][1] - dy*f[i][0]; } MPI_Allreduce(tlocal,tq,3,MPI_DOUBLE,MPI_SUM,world); } /* ---------------------------------------------------------------------- compute the torque T (tq) on group of atoms in region around center-of-mass cm must unwrap atoms to compute T correctly ------------------------------------------------------------------------- */ void Group::torque(int igroup, double *cm, double *tq, int iregion) { int groupbit = bitmask[igroup]; Region *region = domain->regions[iregion]; double **x = atom->x; double **f = atom->f; int *mask = atom->mask; int *image = atom->image; int nlocal = atom->nlocal; int xbox,ybox,zbox; double dx,dy,dz; double xprd = domain->xprd; double yprd = domain->yprd; double zprd = domain->zprd; double tlocal[3]; tlocal[0] = tlocal[1] = tlocal[2] = 0.0; for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit && region->match(x[i][0],x[i][1],x[i][2])) { xbox = (image[i] & 1023) - 512; ybox = (image[i] >> 10 & 1023) - 512; zbox = (image[i] >> 20) - 512; dx = (x[i][0] + xbox*xprd) - cm[0]; dy = (x[i][1] + ybox*yprd) - cm[1]; dz = (x[i][2] + zbox*zprd) - cm[2]; tlocal[0] += dy*f[i][2] - dz*f[i][1]; tlocal[1] += dz*f[i][0] - dx*f[i][2]; tlocal[2] += dx*f[i][1] - dy*f[i][0]; } MPI_Allreduce(tlocal,tq,3,MPI_DOUBLE,MPI_SUM,world); } /* ---------------------------------------------------------------------- compute moment of inertia tensor around center-of-mass cm of group must unwrap atoms to compute itensor correctly ------------------------------------------------------------------------- */ void Group::inertia(int igroup, double *cm, double itensor[3][3]) { int i,j; int groupbit = bitmask[igroup]; double **x = atom->x; int *mask = atom->mask; int *type = atom->type; int *image = atom->image; double *mass = atom->mass; double *rmass = atom->rmass; int nlocal = atom->nlocal; int xbox,ybox,zbox; double dx,dy,dz,massone; double xprd = domain->xprd; double yprd = domain->yprd; double zprd = domain->zprd; double ione[3][3]; for (i = 0; i < 3; i++) for (j = 0; j < 3; j++) ione[i][j] = 0.0; for (i = 0; i < nlocal; i++) if (mask[i] & groupbit) { xbox = (image[i] & 1023) - 512; ybox = (image[i] >> 10 & 1023) - 512; zbox = (image[i] >> 20) - 512; dx = (x[i][0] + xbox*xprd) - cm[0]; dy = (x[i][1] + ybox*yprd) - cm[1]; dz = (x[i][2] + zbox*zprd) - cm[2]; if (rmass) massone = rmass[i]; else massone = mass[type[i]]; ione[0][0] += massone * (dy*dy + dz*dz); ione[1][1] += massone * (dx*dx + dz*dz); ione[2][2] += massone * (dx*dx + dy*dy); ione[0][1] -= massone * dx*dy; ione[1][2] -= massone * dy*dz; ione[0][2] -= massone * dx*dz; } ione[1][0] = ione[0][1]; ione[2][1] = ione[1][2]; ione[2][0] = ione[0][2]; MPI_Allreduce(&ione[0][0],&itensor[0][0],9,MPI_DOUBLE,MPI_SUM,world); } /* ---------------------------------------------------------------------- compute moment of inertia tensor around cm of group of atoms in region must unwrap atoms to compute itensor correctly ------------------------------------------------------------------------- */ void Group::inertia(int igroup, double *cm, double itensor[3][3], int iregion) { int i,j; int groupbit = bitmask[igroup]; Region *region = domain->regions[iregion]; double **x = atom->x; int *mask = atom->mask; int *type = atom->type; int *image = atom->image; double *mass = atom->mass; double *rmass = atom->rmass; int nlocal = atom->nlocal; int xbox,ybox,zbox; double dx,dy,dz,massone; double xprd = domain->xprd; double yprd = domain->yprd; double zprd = domain->zprd; double ione[3][3]; for (i = 0; i < 3; i++) for (j = 0; j < 3; j++) ione[i][j] = 0.0; for (i = 0; i < nlocal; i++) if (mask[i] & groupbit && region->match(x[i][0],x[i][1],x[i][2])) { xbox = (image[i] & 1023) - 512; ybox = (image[i] >> 10 & 1023) - 512; zbox = (image[i] >> 20) - 512; dx = (x[i][0] + xbox*xprd) - cm[0]; dy = (x[i][1] + ybox*yprd) - cm[1]; dz = (x[i][2] + zbox*zprd) - cm[2]; if (rmass) massone = rmass[i]; else massone = mass[type[i]]; ione[0][0] += massone * (dy*dy + dz*dz); ione[1][1] += massone * (dx*dx + dz*dz); ione[2][2] += massone * (dx*dx + dy*dy); ione[0][1] -= massone * dx*dy; ione[1][2] -= massone * dy*dz; ione[0][2] -= massone * dx*dz; } ione[1][0] = ione[0][1]; ione[2][1] = ione[1][2]; ione[2][0] = ione[0][2]; MPI_Allreduce(&ione[0][0],&itensor[0][0],9,MPI_DOUBLE,MPI_SUM,world); } /* ---------------------------------------------------------------------- compute angular velocity omega from L = Iw, inverting I to solve for w really not a group operation, but L and I were computed for a group ------------------------------------------------------------------------- */ void Group::omega(double *angmom, double inertia[3][3], double *w) { double inverse[3][3]; inverse[0][0] = inertia[1][1]*inertia[2][2] - inertia[1][2]*inertia[2][1]; inverse[0][1] = -(inertia[0][1]*inertia[2][2] - inertia[0][2]*inertia[2][1]); inverse[0][2] = inertia[0][1]*inertia[1][2] - inertia[0][2]*inertia[1][1]; inverse[1][0] = -(inertia[1][0]*inertia[2][2] - inertia[1][2]*inertia[2][0]); inverse[1][1] = inertia[0][0]*inertia[2][2] - inertia[0][2]*inertia[2][0]; inverse[1][2] = -(inertia[0][0]*inertia[1][2] - inertia[0][2]*inertia[1][0]); inverse[2][0] = inertia[1][0]*inertia[2][1] - inertia[1][1]*inertia[2][0]; inverse[2][1] = -(inertia[0][0]*inertia[2][1] - inertia[0][1]*inertia[2][0]); inverse[2][2] = inertia[0][0]*inertia[1][1] - inertia[0][1]*inertia[1][0]; double determinant = inertia[0][0]*inertia[1][1]*inertia[2][2] + inertia[0][1]*inertia[1][2]*inertia[2][0] + inertia[0][2]*inertia[1][0]*inertia[2][1] - inertia[0][0]*inertia[1][2]*inertia[2][1] - inertia[0][1]*inertia[1][0]*inertia[2][2] - inertia[2][0]*inertia[1][1]*inertia[0][2]; if (determinant > 0.0) for (int i = 0; i < 3; i++) for (int j = 0; j < 3; j++) inverse[i][j] /= determinant; w[0] = inverse[0][0]*angmom[0] + inverse[0][1]*angmom[1] + inverse[0][2]*angmom[2]; w[1] = inverse[1][0]*angmom[0] + inverse[1][1]*angmom[1] + inverse[1][2]*angmom[2]; w[2] = inverse[2][0]*angmom[0] + inverse[2][1]*angmom[1] + inverse[2][2]*angmom[2]; } diff --git a/src/lammps.cpp b/src/lammps.cpp index 11c4a6b3c..6b87c0a33 100644 --- a/src/lammps.cpp +++ b/src/lammps.cpp @@ -1,341 +1,351 @@ /* ---------------------------------------------------------------------- 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. ------------------------------------------------------------------------- */ #include "mpi.h" #include "string.h" #include "lammps.h" #include "memory.h" #include "error.h" #include "universe.h" #include "input.h" #include "atom.h" #include "update.h" #include "neighbor.h" #include "comm.h" #include "domain.h" #include "force.h" #include "modify.h" #include "group.h" #include "output.h" #include "timer.h" using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- start up LAMMPS allocate fundamental classes (memory, error, universe, input) parse input switches initialize communicators, screen & logfile output input is allocated at end after MPI info is setup ------------------------------------------------------------------------- */ LAMMPS::LAMMPS(int narg, char **arg, MPI_Comm communicator) { memory = new Memory(this); error = new Error(this); universe = new Universe(this,communicator); output = NULL; screen = NULL; logfile = NULL; // parse input switches int inflag = 0; int screenflag = 0; int logflag = 0; int iarg = 1; while (iarg < narg) { if (strcmp(arg[iarg],"-partition") == 0) { universe->existflag = 1; if (iarg+2 > narg) error->universe_all("Invalid command-line argument"); iarg++; while (iarg < narg && arg[iarg][0] != '-') { universe->add_world(arg[iarg]); iarg++; } } else if (strcmp(arg[iarg],"-in") == 0) { if (iarg+2 > narg) error->universe_all("Invalid command-line argument"); inflag = iarg + 1; iarg += 2; } else if (strcmp(arg[iarg],"-screen") == 0) { if (iarg+2 > narg) error->universe_all("Invalid command-line argument"); screenflag = iarg + 1; iarg += 2; } else if (strcmp(arg[iarg],"-log") == 0) { if (iarg+2 > narg) error->universe_all("Invalid command-line argument"); logflag = iarg + 1; iarg += 2; } else if (strcmp(arg[iarg],"-var") == 0) { if (iarg+3 > narg) error->universe_all("Invalid command-line argument"); iarg += 3; } else if (strcmp(arg[iarg],"-echo") == 0) { if (iarg+2 > narg) error->universe_all("Invalid command-line argument"); iarg += 2; } else error->universe_all("Invalid command-line argument"); } // if no partition command-line switch, universe is one world w/ all procs if (universe->existflag == 0) universe->add_world(NULL); // sum of procs in all worlds must equal total # of procs if (!universe->consistent()) error->universe_all("Processor partitions are inconsistent"); // universe cannot use stdin for input file if (universe->existflag && inflag == 0) error->universe_all("Must use -in switch with multiple partitions"); // set universe screen and logfile if (universe->me == 0) { if (screenflag == 0) universe->uscreen = stdout; else if (strcmp(arg[screenflag],"none") == 0) universe->uscreen = NULL; else { universe->uscreen = fopen(arg[screenflag],"w"); if (universe->uscreen == NULL) error->universe_one("Cannot open universe screen file"); } if (logflag == 0) { universe->ulogfile = fopen("log.lammps","w"); if (universe->ulogfile == NULL) error->universe_one("Cannot open log.lammps"); } else if (strcmp(arg[logflag],"none") == 0) universe->ulogfile = NULL; else { universe->ulogfile = fopen(arg[logflag],"w"); if (universe->ulogfile == NULL) error->universe_one("Cannot open universe log file"); } } if (universe->me > 0) { if (screenflag == 0) universe->uscreen = stdout; else universe->uscreen = NULL; universe->ulogfile = NULL; } // universe does not exist on its own, only a single world // inherit settings from universe // set world screen, logfile, communicator, infile // open input script if from file if (universe->existflag == 0) { screen = universe->uscreen; logfile = universe->ulogfile; world = universe->uworld; infile = NULL; if (universe->me == 0) { if (inflag == 0) infile = stdin; else infile = fopen(arg[inflag],"r"); if (infile == NULL) { char str[128]; sprintf(str,"Cannot open input script %s",arg[inflag]); error->one(str); } } if (universe->me == 0) { if (screen) fprintf(screen,"LAMMPS (%s)\n",universe->version); if (logfile) fprintf(logfile,"LAMMPS (%s)\n",universe->version); } // universe is one or more worlds // split into separate communicators // set world screen, logfile, communicator, infile // open input script } else { int me; MPI_Comm_split(universe->uworld,universe->iworld,0,&world); MPI_Comm_rank(world,&me); if (me == 0) { if (screenflag == 0) { char str[32]; sprintf(str,"screen.%d",universe->iworld); screen = fopen(str,"w"); if (screen == NULL) error->one("Cannot open screen file"); } else if (strcmp(arg[screenflag],"none") == 0) screen = NULL; else { char str[128]; sprintf(str,"%s.%d",arg[screenflag],universe->iworld); screen = fopen(str,"w"); if (screen == NULL) error->one("Cannot open screen file"); } } else screen = NULL; if (me == 0) { if (logflag == 0) { char str[32]; sprintf(str,"log.lammps.%d",universe->iworld); logfile = fopen(str,"w"); if (logfile == NULL) error->one("Cannot open logfile"); } else if (strcmp(arg[logflag],"none") == 0) logfile = NULL; else { char str[128]; sprintf(str,"%s.%d",arg[logflag],universe->iworld); logfile = fopen(str,"w"); if (logfile == NULL) error->one("Cannot open logfile"); } } else logfile = NULL; if (me == 0) { infile = fopen(arg[inflag],"r"); if (infile == NULL) { char str[128]; sprintf(str,"Cannot open input script %s",arg[inflag]); error->one(str); } } else infile = NULL; // screen and logfile messages for universe and world if (universe->me == 0) { if (universe->uscreen) { fprintf(universe->uscreen,"LAMMPS (%s)\n",universe->version); fprintf(universe->uscreen,"Running on %d partitions of processors\n", universe->nworlds); } if (universe->ulogfile) { fprintf(universe->ulogfile,"LAMMPS (%s)\n",universe->version); fprintf(universe->ulogfile,"Running on %d partitions of processors\n", universe->nworlds); } } if (me == 0) { if (screen) { fprintf(screen,"LAMMPS (%s)\n",universe->version); fprintf(screen,"Processor partition = %d\n",universe->iworld); } if (logfile) { fprintf(logfile,"LAMMPS (%s)\n",universe->version); fprintf(logfile,"Processor partition = %d\n",universe->iworld); } } } + // check datatype sizes + + if (sizeof(bigint) != 8) + error->all("No support for 8-byte unsigned integers"); + + int mpisize; + MPI_Type_size(MPI_UNSIGNED_LONG_LONG,&mpisize); + if (mpisize != 8) + error->all("MPI_UNSIGNED_LONG_LONG is not 8-byte data type"); + // allocate input class now that MPI is fully setup input = new Input(this,narg,arg); // allocate top-level classes create(); } /* ---------------------------------------------------------------------- shutdown LAMMPS delete top-level classes close screen and log files in world and universe output files were already closed in destroy() delete fundamental classes ------------------------------------------------------------------------- */ LAMMPS::~LAMMPS() { destroy(); if (universe->nworlds == 1) { if (logfile) fclose(logfile); } else { if (screen && screen != stdout) fclose(screen); if (logfile) fclose(logfile); if (universe->ulogfile) fclose(universe->ulogfile); } if (world != universe->uworld) MPI_Comm_free(&world); delete input; delete universe; delete error; delete memory; } /* ---------------------------------------------------------------------- allocate single instance of top-level classes fundamental classes are allocated in constructor ------------------------------------------------------------------------- */ void LAMMPS::create() { atom = new Atom(this); neighbor = new Neighbor(this); comm = new Comm(this); domain = new Domain(this); group = new Group(this); force = new Force(this); // must be after group, to create temperature modify = new Modify(this); output = new Output(this); // must be after group, so "all" exists // must be after modify so can create Computes update = new Update(this); // must be after output, force, neighbor timer = new Timer(this); } /* ---------------------------------------------------------------------- initialize top-level classes ------------------------------------------------------------------------- */ void LAMMPS::init() { update->init(); force->init(); // pair must come after update due to minimizer domain->init(); atom->init(); // atom must come after force: // atom deletes extra array // used by fix shear_history::unpack_restart() // when force->pair->gran_history creates fix ?? modify->init(); // modify must come after update, force, atom, domain neighbor->init(); // neighbor must come after force, modify comm->init(); // comm must come after force, modify, neighbor output->init(); // output must come after domain, force, modify timer->init(); } /* ---------------------------------------------------------------------- delete single instance of top-level classes fundamental classes are deleted in destructor ------------------------------------------------------------------------- */ void LAMMPS::destroy() { delete update; delete neighbor; delete comm; delete force; delete group; delete output; delete modify; // modify must come after output, force, update // since they delete fixes delete domain; // domain must come after modify // since fix destructors access domain delete atom; // atom must come after modify, neighbor // since fixes delete callbacks in atom delete timer; } diff --git a/src/memory.cpp b/src/memory.cpp index c4eb9eba2..df8cff685 100644 --- a/src/memory.cpp +++ b/src/memory.cpp @@ -1,452 +1,441 @@ /* ---------------------------------------------------------------------- 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. ------------------------------------------------------------------------- */ #include "mpi.h" #include "stdio.h" #include "stdlib.h" #include "string.h" #include "memory.h" #include "lmptype.h" #include "error.h" using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ -Memory::Memory(LAMMPS *lmp) : Pointers(lmp) -{ - // check datatype sizes - - if (sizeof(bigint) != 8) - error->all("No support for 8-byte unsigned integers"); - - int mpisize; - MPI_Type_size(MPI_UNSIGNED_LONG,&mpisize); - if (mpisize != 8) - error->all("MPI_UNSIGNED_LONG is not 8-byte data type"); -} +Memory::Memory(LAMMPS *lmp) : Pointers(lmp) {} /* ---------------------------------------------------------------------- safe malloc ------------------------------------------------------------------------- */ void *Memory::smalloc(int n, const char *name) { if (n == 0) return NULL; void *ptr = malloc(n); if (ptr == NULL) { char str[128]; sprintf(str,"Failed to allocate %d bytes for array %s",n,name); error->one(str); } return ptr; } /* ---------------------------------------------------------------------- safe free ------------------------------------------------------------------------- */ void Memory::sfree(void *ptr) { if (ptr == NULL) return; free(ptr); } /* ---------------------------------------------------------------------- safe realloc ------------------------------------------------------------------------- */ void *Memory::srealloc(void *ptr, int n, const char *name) { if (n == 0) { sfree(ptr); return NULL; } ptr = realloc(ptr,n); if (ptr == NULL) { char str[128]; sprintf(str,"Failed to reallocate %d bytes for array %s",n,name); error->one(str); } return ptr; } /* ---------------------------------------------------------------------- create a 1d double array with index from nlo to nhi inclusive ------------------------------------------------------------------------- */ double *Memory::create_1d_double_array(int nlo, int nhi, const char *name) { int n = nhi - nlo + 1; double *array = (double *) smalloc(n*sizeof(double),name); return array-nlo; } /* ---------------------------------------------------------------------- free a 1d double array with index offset ------------------------------------------------------------------------- */ void Memory::destroy_1d_double_array(double *array, int offset) { if (array == NULL) return; sfree(array + offset); } /* ---------------------------------------------------------------------- create a 2d double array ------------------------------------------------------------------------- */ double **Memory::create_2d_double_array(int n1, int n2, const char *name) { double *data = (double *) smalloc(n1*n2*sizeof(double),name); double **array = (double **) smalloc(n1*sizeof(double *),name); int n = 0; for (int i = 0; i < n1; i++) { array[i] = &data[n]; n += n2; } return array; } /* ---------------------------------------------------------------------- free a 2d double array ------------------------------------------------------------------------- */ void Memory::destroy_2d_double_array(double **array) { if (array == NULL) return; sfree(array[0]); sfree(array); } /* ---------------------------------------------------------------------- grow or shrink 1st dim of a 2d double array last dim must stay the same if either dim is 0, return NULL ------------------------------------------------------------------------- */ double **Memory::grow_2d_double_array(double **array, int n1, int n2, const char *name) { if (array == NULL) return create_2d_double_array(n1,n2,name); double *data = (double *) srealloc(array[0],n1*n2*sizeof(double),name); array = (double **) srealloc(array,n1*sizeof(double *),name); int n = 0; for (int i = 0; i < n1; i++) { array[i] = &data[n]; n += n2; } return array; } /* ---------------------------------------------------------------------- create a 2d int array if either dim is 0, return NULL ------------------------------------------------------------------------- */ int **Memory::create_2d_int_array(int n1, int n2, const char *name) { if (n1 == 0 || n2 == 0) return NULL; int *data = (int *) smalloc(n1*n2*sizeof(int),name); int **array = (int **) smalloc(n1*sizeof(int *),name); int n = 0; for (int i = 0; i < n1; i++) { array[i] = &data[n]; n += n2; } return array; } /* ---------------------------------------------------------------------- free a 2d int array ------------------------------------------------------------------------- */ void Memory::destroy_2d_int_array(int **array) { if (array == NULL) return; sfree(array[0]); sfree(array); } /* ---------------------------------------------------------------------- grow or shrink 1st dim of a 2d int array last dim must stay the same if either dim is 0, return NULL ------------------------------------------------------------------------- */ int **Memory::grow_2d_int_array(int **array, int n1, int n2, const char *name) { if (n1 == 0 || n2 == 0) { destroy_2d_int_array(array); return NULL; } if (array == NULL) return create_2d_int_array(n1,n2,name); int *data = (int *) srealloc(array[0],n1*n2*sizeof(int),name); array = (int **) srealloc(array,n1*sizeof(int *),name); int n = 0; for (int i = 0; i < n1; i++) { array[i] = &data[n]; n += n2; } return array; } /* ---------------------------------------------------------------------- create a 2d double array with 2nd index from n2lo to n2hi inclusive ------------------------------------------------------------------------- */ double **Memory::create_2d_double_array(int n1, int n2lo, int n2hi, const char *name) { int n2 = n2hi - n2lo + 1; double **array = create_2d_double_array(n1,n2,name); for (int i = 0; i < n1; i++) array[i] -= n2lo; return array; } /* ---------------------------------------------------------------------- free a 2d double array with 2nd index offset ------------------------------------------------------------------------- */ void Memory::destroy_2d_double_array(double **array, int offset) { if (array == NULL) return; sfree(&array[0][offset]); sfree(array); } /* ---------------------------------------------------------------------- create a 3d double array ------------------------------------------------------------------------- */ double ***Memory::create_3d_double_array(int n1, int n2, int n3, const char *name) { int i,j; double *data = (double *) smalloc(n1*n2*n3*sizeof(double),name); double **plane = (double **) smalloc(n1*n2*sizeof(double *),name); double ***array = (double ***) smalloc(n1*sizeof(double **),name); int n = 0; for (i = 0; i < n1; i++) { array[i] = &plane[i*n2]; for (j = 0; j < n2; j++) { plane[i*n2+j] = &data[n]; n += n3; } } return array; } /* ---------------------------------------------------------------------- free a 3d double array ------------------------------------------------------------------------- */ void Memory::destroy_3d_double_array(double ***array) { if (array == NULL) return; sfree(array[0][0]); sfree(array[0]); sfree(array); } /* ---------------------------------------------------------------------- grow or shrink 1st dim of a 3d double array last 2 dims must stay the same if any dim is 0, return NULL ------------------------------------------------------------------------- */ double ***Memory::grow_3d_double_array(double ***array, int n1, int n2, int n3, const char *name) { int i,j; if (n1 == 0 || n2 == 0 || n3 == 0) { destroy_3d_double_array(array); return NULL; } if (array == NULL) return create_3d_double_array(n1,n2,n3,name); double *data = (double *) srealloc(array[0][0],n1*n2*n3*sizeof(double),name); double **plane = (double **) srealloc(array[0],n1*n2*sizeof(double *),name); array = (double ***) srealloc(array,n1*sizeof(double **),name); int n = 0; for (i = 0; i < n1; i++) { array[i] = &plane[i*n2]; for (j = 0; j < n2; j++) { plane[i*n2+j] = &data[n]; n += n3; } } return array; } /* ---------------------------------------------------------------------- create a 3d double array with 1st index from n1lo to n1hi inclusive ------------------------------------------------------------------------- */ double ***Memory::create_3d_double_array(int n1lo, int n1hi, int n2, int n3, const char *name) { int n1 = n1hi - n1lo + 1; double ***array = create_3d_double_array(n1,n2,n3,name); return array-n1lo; } /* ---------------------------------------------------------------------- free a 3d double array with 1st index offset ------------------------------------------------------------------------- */ void Memory::destroy_3d_double_array(double ***array, int offset) { if (array) destroy_3d_double_array(array + offset); } /* ---------------------------------------------------------------------- create a 3d double array with 1st index from n1lo to n1hi inclusive, 2nd index from n2lo to n2hi inclusive, 3rd index from n3lo to n3hi inclusive ------------------------------------------------------------------------- */ double ***Memory::create_3d_double_array(int n1lo, int n1hi, int n2lo, int n2hi, int n3lo, int n3hi, const char *name) { int n1 = n1hi - n1lo + 1; int n2 = n2hi - n2lo + 1; int n3 = n3hi - n3lo + 1; double ***array = create_3d_double_array(n1,n2,n3,name); for (int i = 0; i < n1*n2; i++) array[0][i] -= n3lo; for (int i = 0; i < n1; i++) array[i] -= n2lo; return array-n1lo; } /* ---------------------------------------------------------------------- free a 3d double array with all 3 indices offset ------------------------------------------------------------------------- */ void Memory::destroy_3d_double_array(double ***array, int n1_offset, int n2_offset, int n3_offset) { if (array == NULL) return; sfree(&array[n1_offset][n2_offset][n3_offset]); sfree(&array[n1_offset][n2_offset]); sfree(array + n1_offset); } /* ---------------------------------------------------------------------- create a 3d int array ------------------------------------------------------------------------- */ int ***Memory::create_3d_int_array(int n1, int n2, int n3, const char *name) { int i,j; int *data = (int *) smalloc(n1*n2*n3*sizeof(int),name); int **plane = (int **) smalloc(n1*n2*sizeof(int *),name); int ***array = (int ***) smalloc(n1*sizeof(int **),name); int n = 0; for (i = 0; i < n1; i++) { array[i] = &plane[i*n2]; for (j = 0; j < n2; j++) { plane[i*n2+j] = &data[n]; n += n3; } } return array; } /* ---------------------------------------------------------------------- free a 3d int array ------------------------------------------------------------------------- */ void Memory::destroy_3d_int_array(int ***array) { if (array == NULL) return; sfree(array[0][0]); sfree(array[0]); sfree(array); } /* ---------------------------------------------------------------------- create a 4d double array ------------------------------------------------------------------------- */ double ****Memory::create_4d_double_array(int n1, int n2, int n3, int n4, const char *name) { int i,j,k; double *data = (double *) smalloc(n1*n2*n3*n4*sizeof(double),name); double **cube = (double **) smalloc(n1*n2*n3*sizeof(double *),name); double ***plane = (double ***) smalloc(n1*n2*sizeof(double **),name); double ****array = (double ****) smalloc(n1*sizeof(double ***),name); int n = 0; for (i = 0; i < n1; i++) { array[i] = &plane[i*n2]; for (j = 0; j < n2; j++) { plane[i*n2+j] = &cube[i*n2*n3+j*n3]; for (k = 0; k < n3; k++) { cube[i*n2*n3+j*n3+k] = &data[n]; n += n4; } } } return array; } /* ---------------------------------------------------------------------- free a 4d double array ------------------------------------------------------------------------- */ void Memory::destroy_4d_double_array(double ****array) { if (array == NULL) return; sfree(array[0][0][0]); sfree(array[0][0]); sfree(array[0]); sfree(array); } diff --git a/src/min.cpp b/src/min.cpp index bbac6428e..8f58ceae5 100644 --- a/src/min.cpp +++ b/src/min.cpp @@ -1,764 +1,764 @@ /* ---------------------------------------------------------------------- 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: Aidan Thompson (SNL) improved CG and backtrack ls, added quadratic ls Sources: Numerical Recipes frprmn routine "Conjugate Gradient Method Without the Agonizing Pain" by JR Shewchuk, http://www-2.cs.cmu.edu/~jrs/jrspapers.html#cg ------------------------------------------------------------------------- */ #include "math.h" #include "stdlib.h" #include "string.h" #include "min.h" #include "atom.h" #include "domain.h" #include "comm.h" #include "update.h" #include "modify.h" #include "fix_minimize.h" #include "compute.h" #include "neighbor.h" #include "force.h" #include "pair.h" #include "bond.h" #include "angle.h" #include "dihedral.h" #include "improper.h" #include "kspace.h" #include "output.h" #include "thermo.h" #include "timer.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; #define MIN(A,B) ((A) < (B)) ? (A) : (B) #define MAX(A,B) ((A) > (B)) ? (A) : (B) /* ---------------------------------------------------------------------- */ Min::Min(LAMMPS *lmp) : Pointers(lmp) { dmax = 0.1; searchflag = 0; linestyle = 0; elist_global = elist_atom = NULL; vlist_global = vlist_atom = NULL; nextra_global = 0; fextra = NULL; nextra_atom = 0; xextra_atom = fextra_atom = NULL; extra_peratom = extra_nlen = NULL; extra_max = NULL; requestor = NULL; } /* ---------------------------------------------------------------------- */ Min::~Min() { delete [] elist_global; delete [] elist_atom; delete [] vlist_global; delete [] vlist_atom; delete [] fextra; memory->sfree(xextra_atom); memory->sfree(fextra_atom); memory->sfree(extra_peratom); memory->sfree(extra_nlen); memory->sfree(extra_max); memory->sfree(requestor); } /* ---------------------------------------------------------------------- */ void Min::init() { // create fix needed for storing atom-based quantities // will delete it at end of run char **fixarg = new char*[3]; fixarg[0] = (char *) "MINIMIZE"; fixarg[1] = (char *) "all"; fixarg[2] = (char *) "MINIMIZE"; modify->add_fix(3,fixarg); delete [] fixarg; fix_minimize = (FixMinimize *) modify->fix[modify->nfix-1]; // clear out extra global and per-atom dof // will receive requests for new per-atom dof during pair init() // can then add vectors to fix_minimize in setup() nextra_global = 0; delete [] fextra; fextra = NULL; nextra_atom = 0; memory->sfree(xextra_atom); memory->sfree(fextra_atom); memory->sfree(extra_peratom); memory->sfree(extra_nlen); memory->sfree(extra_max); memory->sfree(requestor); xextra_atom = fextra_atom = NULL; extra_peratom = extra_nlen = NULL; extra_max = NULL; requestor = NULL; // virial_style: // 1 if computed explicitly by pair->compute via sum over pair interactions // 2 if computed implicitly by pair->virial_compute via sum over ghost atoms if (force->newton_pair) virial_style = 2; else virial_style = 1; // setup lists of computes for global and per-atom PE and pressure ev_setup(); // set flags for what arrays to clear in force_clear() // need to clear torques,erforce if arrays exists torqueflag = 0; if (atom->torque_flag) torqueflag = 1; erforceflag = 0; if (atom->erforce_flag) erforceflag = 1; // orthogonal vs triclinic simulation box triclinic = domain->triclinic; // reset reneighboring criteria if necessary neigh_every = neighbor->every; neigh_delay = neighbor->delay; neigh_dist_check = neighbor->dist_check; if (neigh_every != 1 || neigh_delay != 0 || neigh_dist_check != 1) { if (comm->me == 0) error->warning("Resetting reneighboring criteria during minimization"); } neighbor->every = 1; neighbor->delay = 0; neighbor->dist_check = 1; niter = neval = 0; // style-specific initialization init_style(); } /* ---------------------------------------------------------------------- setup before run ------------------------------------------------------------------------- */ void Min::setup() { if (comm->me == 0 && screen) fprintf(screen,"Setting up minimization ...\n"); // setup extra global dof due to fixes // cannot be done in init() b/c update init() is before modify init() nextra_global = modify->min_dof(); if (nextra_global) fextra = new double[nextra_global]; // compute for potential energy int id = modify->find_compute("thermo_pe"); if (id < 0) error->all("Minimization could not find thermo_pe compute"); pe_compute = modify->compute[id]; // style-specific setup does two tasks // setup extra global dof vectors // setup extra per-atom dof vectors due to requests from Pair classes // cannot be done in init() b/c update init() is before modify/pair init() setup_style(); // ndoftotal = total dof for entire minimization problem // dof for atoms, extra per-atom, extra global bigint ndofme = 3*atom->nlocal; for (int m = 0; m < nextra_atom; m++) ndofme += extra_peratom[m]*atom->nlocal; - MPI_Allreduce(&ndofme,&ndoftotal,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&ndofme,&ndoftotal,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); ndoftotal += nextra_global; // setup domain, communication and neighboring // acquire ghosts // build neighbor lists atom->setup(); if (triclinic) domain->x2lamda(atom->nlocal); domain->pbc(); domain->reset_box(); comm->setup(); if (neighbor->style) neighbor->setup_bins(); comm->exchange(); if (atom->sortfreq > 0) atom->sort(); comm->borders(); if (triclinic) domain->lamda2x(atom->nlocal+atom->nghost); neighbor->build(); neighbor->ncalls = 0; // remove these restriction eventually if (nextra_global && searchflag == 0) error->all("Cannot use a damped dynamics min style with fix box/relax"); if (nextra_atom && searchflag == 0) error->all("Cannot use a damped dynamics min style with per-atom DOF"); // atoms may have migrated in comm->exchange() reset_vectors(); // compute all forces ev_set(update->ntimestep); force_clear(); modify->setup_pre_force(vflag); if (force->pair) force->pair->compute(eflag,vflag); if (atom->molecular) { if (force->bond) force->bond->compute(eflag,vflag); if (force->angle) force->angle->compute(eflag,vflag); if (force->dihedral) force->dihedral->compute(eflag,vflag); if (force->improper) force->improper->compute(eflag,vflag); } if (force->kspace) { force->kspace->setup(); force->kspace->compute(eflag,vflag); } if (force->newton) comm->reverse_comm(); // update per-atom minimization variables stored by pair styles if (nextra_atom) for (int m = 0; m < nextra_atom; m++) requestor[m]->min_xf_get(m); modify->setup(vflag); output->setup(1); // stats for Finish to print ecurrent = pe_compute->compute_scalar(); if (nextra_global) ecurrent += modify->min_energy(fextra); if (output->thermo->normflag) ecurrent /= atom->natoms; einitial = ecurrent; fnorm2_init = sqrt(fnorm_sqr()); fnorminf_init = fnorm_inf(); } /* ---------------------------------------------------------------------- setup without output or one-time post-init setup flag = 0 = just force calculation flag = 1 = reneighbor and force calculation ------------------------------------------------------------------------- */ void Min::setup_minimal(int flag) { // setup domain, communication and neighboring // acquire ghosts // build neighbor lists if (flag) { if (triclinic) domain->x2lamda(atom->nlocal); domain->pbc(); domain->reset_box(); comm->setup(); if (neighbor->style) neighbor->setup_bins(); comm->exchange(); comm->borders(); if (triclinic) domain->lamda2x(atom->nlocal+atom->nghost); neighbor->build(); neighbor->ncalls = 0; } // atoms may have migrated in comm->exchange() reset_vectors(); // compute all forces ev_set(update->ntimestep); force_clear(); modify->setup_pre_force(vflag); if (force->pair) force->pair->compute(eflag,vflag); if (atom->molecular) { if (force->bond) force->bond->compute(eflag,vflag); if (force->angle) force->angle->compute(eflag,vflag); if (force->dihedral) force->dihedral->compute(eflag,vflag); if (force->improper) force->improper->compute(eflag,vflag); } if (force->kspace) { force->kspace->setup(); force->kspace->compute(eflag,vflag); } if (force->newton) comm->reverse_comm(); // update per-atom minimization variables stored by pair styles if (nextra_atom) for (int m = 0; m < nextra_atom; m++) requestor[m]->min_xf_get(m); modify->setup(vflag); // stats for Finish to print ecurrent = pe_compute->compute_scalar(); if (nextra_global) ecurrent += modify->min_energy(fextra); if (output->thermo->normflag) ecurrent /= atom->natoms; einitial = ecurrent; fnorm2_init = sqrt(fnorm_sqr()); fnorminf_init = fnorm_inf(); } /* ---------------------------------------------------------------------- perform minimization, calling iterate() for N steps ------------------------------------------------------------------------- */ void Min::run(int n) { // minimizer iterations int iter_start = niter; stop_condition = iterate(n); stopstr = stopstrings(stop_condition); // if early exit from iterate loop: // set update->nsteps to niter for Finish stats to print // set output->next values to this timestep // call energy_force() to insure vflag is set when forces computed // output->write does final output for thermo, dump, restart files // add ntimestep to all computes that store invocation times // since are hardwiring call to thermo/dumps and computes may not be ready if (stop_condition) { update->nsteps = niter; if (update->restrict_output == 0) { for (int idump = 0; idump < output->ndump; idump++) output->next_dump[idump] = update->ntimestep; output->next_dump_any = update->ntimestep; if (output->restart_every) output->next_restart = update->ntimestep; } output->next_thermo = update->ntimestep; modify->addstep_compute_all(update->ntimestep); ecurrent = energy_force(0); output->write(update->ntimestep); } } /* ---------------------------------------------------------------------- */ void Min::cleanup() { // stats for Finish to print efinal = ecurrent; fnorm2_final = sqrt(fnorm_sqr()); fnorminf_final = fnorm_inf(); // reset reneighboring criteria neighbor->every = neigh_every; neighbor->delay = neigh_delay; neighbor->dist_check = neigh_dist_check; // delete fix at end of run, so its atom arrays won't persist modify->delete_fix("MINIMIZE"); } /* ---------------------------------------------------------------------- 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 ------------------------------------------------------------------------- */ double Min::energy_force(int resetflag) { // check for reneighboring // always communicate since minimizer moved atoms int nflag = neighbor->decide(); if (nflag == 0) { timer->stamp(); comm->forward_comm(); timer->stamp(TIME_COMM); } else { if (modify->n_min_pre_exchange) modify->min_pre_exchange(); if (triclinic) domain->x2lamda(atom->nlocal); domain->pbc(); if (domain->box_change) { domain->reset_box(); comm->setup(); if (neighbor->style) neighbor->setup_bins(); } timer->stamp(); comm->exchange(); if (atom->sortfreq > 0 && update->ntimestep >= atom->nextsort) atom->sort(); comm->borders(); if (triclinic) domain->lamda2x(atom->nlocal+atom->nghost); timer->stamp(TIME_COMM); neighbor->build(); timer->stamp(TIME_NEIGHBOR); } ev_set(update->ntimestep); force_clear(); if (modify->n_min_pre_force) modify->min_pre_force(vflag); timer->stamp(); if (force->pair) { force->pair->compute(eflag,vflag); timer->stamp(TIME_PAIR); } if (atom->molecular) { if (force->bond) force->bond->compute(eflag,vflag); if (force->angle) force->angle->compute(eflag,vflag); if (force->dihedral) force->dihedral->compute(eflag,vflag); if (force->improper) force->improper->compute(eflag,vflag); timer->stamp(TIME_BOND); } if (force->kspace) { force->kspace->compute(eflag,vflag); timer->stamp(TIME_KSPACE); } if (force->newton) { comm->reverse_comm(); timer->stamp(TIME_COMM); } // update per-atom minimization variables stored by pair styles if (nextra_atom) for (int m = 0; m < nextra_atom; m++) requestor[m]->min_xf_get(m); // fixes that affect minimization if (modify->n_min_post_force) modify->min_post_force(vflag); // compute potential energy of system // normalize if thermo PE does double energy = pe_compute->compute_scalar(); if (nextra_global) energy += modify->min_energy(fextra); if (output->thermo->normflag) energy /= atom->natoms; // if reneighbored, atoms migrated // if resetflag = 1, update x0 of atoms crossing PBC // reset vectors used by lo-level minimizer if (nflag) { if (resetflag) fix_minimize->reset_coords(); reset_vectors(); } return energy; } /* ---------------------------------------------------------------------- clear force on own & ghost atoms setup and clear other arrays as needed ------------------------------------------------------------------------- */ void Min::force_clear() { int i; // clear global force array // nall includes ghosts only if either newton flag is set int nall; if (force->newton) nall = atom->nlocal + atom->nghost; else nall = atom->nlocal; double **f = atom->f; for (i = 0; i < nall; i++) { f[i][0] = 0.0; f[i][1] = 0.0; f[i][2] = 0.0; } if (torqueflag) { double **torque = atom->torque; for (i = 0; i < nall; i++) { torque[i][0] = 0.0; torque[i][1] = 0.0; torque[i][2] = 0.0; } } if (erforceflag) { double *erforce = atom->erforce; for (i = 0; i < nall; i++) erforce[i] = 0.0; } } /* ---------------------------------------------------------------------- pair style makes request to add a per-atom variables to minimization requestor stores callback to pair class to invoke during min to get current variable and forces on it and to update the variable return flag that pair can use if it registers multiple variables ------------------------------------------------------------------------- */ int Min::request(Pair *pair, int peratom, double maxvalue) { int n = nextra_atom + 1; xextra_atom = (double **) memory->srealloc(xextra_atom,n*sizeof(double *), "min:xextra_atom"); fextra_atom = (double **) memory->srealloc(fextra_atom,n*sizeof(double *), "min:fextra_atom"); extra_peratom = (int *) memory->srealloc(extra_peratom,n*sizeof(int), "min:extra_peratom"); extra_nlen = (int *) memory->srealloc(extra_nlen,n*sizeof(int), "min:extra_nlen"); extra_max = (double *) memory->srealloc(extra_max,n*sizeof(double), "min:extra_max"); requestor = (Pair **) memory->srealloc(requestor,n*sizeof(Pair *), "min:requestor"); requestor[nextra_atom] = pair; extra_peratom[nextra_atom] = peratom; extra_max[nextra_atom] = maxvalue; nextra_atom++; return nextra_atom-1; } /* ---------------------------------------------------------------------- */ void Min::modify_params(int narg, char **arg) { if (narg == 0) error->all("Illegal min_modify command"); int iarg = 0; while (iarg < narg) { if (strcmp(arg[iarg],"dmax") == 0) { if (iarg+2 > narg) error->all("Illegal min_modify command"); dmax = atof(arg[iarg+1]); iarg += 2; } else if (strcmp(arg[iarg],"line") == 0) { if (iarg+2 > narg) error->all("Illegal min_modify command"); if (strcmp(arg[iarg+1],"backtrack") == 0) linestyle = 0; else if (strcmp(arg[iarg+1],"quadratic") == 0) linestyle = 1; else error->all("Illegal min_modify command"); iarg += 2; } else error->all("Illegal min_modify command"); } } /* ---------------------------------------------------------------------- setup lists of computes for global and per-atom PE and pressure ------------------------------------------------------------------------- */ void Min::ev_setup() { delete [] elist_global; delete [] elist_atom; delete [] vlist_global; delete [] vlist_atom; elist_global = elist_atom = NULL; vlist_global = vlist_atom = NULL; nelist_global = nelist_atom = 0; nvlist_global = nvlist_atom = 0; for (int i = 0; i < modify->ncompute; i++) { if (modify->compute[i]->peflag) nelist_global++; if (modify->compute[i]->peatomflag) nelist_atom++; if (modify->compute[i]->pressflag) nvlist_global++; if (modify->compute[i]->pressatomflag) nvlist_atom++; } if (nelist_global) elist_global = new Compute*[nelist_global]; if (nelist_atom) elist_atom = new Compute*[nelist_atom]; if (nvlist_global) vlist_global = new Compute*[nvlist_global]; if (nvlist_atom) vlist_atom = new Compute*[nvlist_atom]; nelist_global = nelist_atom = 0; nvlist_global = nvlist_atom = 0; for (int i = 0; i < modify->ncompute; i++) { if (modify->compute[i]->peflag) elist_global[nelist_global++] = modify->compute[i]; if (modify->compute[i]->peatomflag) elist_atom[nelist_atom++] = modify->compute[i]; if (modify->compute[i]->pressflag) vlist_global[nvlist_global++] = modify->compute[i]; if (modify->compute[i]->pressatomflag) vlist_atom[nvlist_atom++] = modify->compute[i]; } } /* ---------------------------------------------------------------------- set eflag,vflag for current iteration invoke matchstep() on all timestep-dependent computes to clear their arrays eflag/vflag based on computes that need info on this ntimestep always set eflag_global = 1, since need energy every iteration eflag = 0 = no energy computation eflag = 1 = global energy only eflag = 2 = per-atom energy only eflag = 3 = both global and per-atom energy vflag = 0 = no virial computation (pressure) vflag = 1 = global virial with pair portion via sum of pairwise interactions vflag = 2 = global virial with pair portion via F dot r including ghosts vflag = 4 = per-atom virial only vflag = 5 or 6 = both global and per-atom virial ------------------------------------------------------------------------- */ void Min::ev_set(int ntimestep) { int i,flag; int eflag_global = 1; for (i = 0; i < nelist_global; i++) elist_global[i]->matchstep(ntimestep); flag = 0; int eflag_atom = 0; for (i = 0; i < nelist_atom; i++) if (elist_atom[i]->matchstep(ntimestep)) flag = 1; if (flag) eflag_atom = 2; if (eflag_global) update->eflag_global = update->ntimestep; if (eflag_atom) update->eflag_atom = update->ntimestep; eflag = eflag_global + eflag_atom; flag = 0; int vflag_global = 0; for (i = 0; i < nvlist_global; i++) if (vlist_global[i]->matchstep(ntimestep)) flag = 1; if (flag) vflag_global = virial_style; flag = 0; int vflag_atom = 0; for (i = 0; i < nvlist_atom; i++) if (vlist_atom[i]->matchstep(ntimestep)) flag = 1; if (flag) vflag_atom = 4; if (vflag_global) update->vflag_global = update->ntimestep; if (vflag_atom) update->vflag_atom = update->ntimestep; vflag = vflag_global + vflag_atom; } /* ---------------------------------------------------------------------- compute and return ||force||_2^2 ------------------------------------------------------------------------- */ double Min::fnorm_sqr() { int i,n; double *fatom; double local_norm2_sqr = 0.0; for (i = 0; i < nvec; i++) local_norm2_sqr += fvec[i]*fvec[i]; if (nextra_atom) { for (int m = 0; m < nextra_atom; m++) { fatom = fextra_atom[m]; n = extra_nlen[m]; for (i = 0; i < n; i++) local_norm2_sqr += fatom[i]*fatom[i]; } } double norm2_sqr = 0.0; MPI_Allreduce(&local_norm2_sqr,&norm2_sqr,1,MPI_DOUBLE,MPI_SUM,world); if (nextra_global) for (i = 0; i < nextra_global; i++) norm2_sqr += fextra[i]*fextra[i]; return norm2_sqr; } /* ---------------------------------------------------------------------- compute and return ||force||_inf ------------------------------------------------------------------------- */ double Min::fnorm_inf() { int i,n; double *fatom; double local_norm_inf = 0.0; for (i = 0; i < nvec; i++) local_norm_inf = MAX(fabs(fvec[i]),local_norm_inf); if (nextra_atom) { for (int m = 0; m < nextra_atom; m++) { fatom = fextra_atom[m]; n = extra_nlen[m]; for (i = 0; i < n; i++) local_norm_inf = MAX(fabs(fatom[i]),local_norm_inf); } } double norm_inf = 0.0; MPI_Allreduce(&local_norm_inf,&norm_inf,1,MPI_DOUBLE,MPI_MAX,world); if (nextra_global) for (i = 0; i < nextra_global; i++) norm_inf = MAX(fabs(fextra[i]),norm_inf); return norm_inf; } /* ---------------------------------------------------------------------- possible stop conditions ------------------------------------------------------------------------- */ char *Min::stopstrings(int n) { char *strings[] = {"max iterations", "max force evaluations", "energy tolerance", "force tolerance", "search direction is not downhill", "linesearch alpha is zero", "forces are zero", "quadratic factors are zero", "trust region too small", "HFTN minimizer error"}; return strings[n]; } diff --git a/src/read_data.cpp b/src/read_data.cpp index 7ed1e5849..f8229bdfd 100644 --- a/src/read_data.cpp +++ b/src/read_data.cpp @@ -1,1364 +1,1364 @@ /* ---------------------------------------------------------------------- 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. ------------------------------------------------------------------------- */ #include "math.h" #include "mpi.h" #include "string.h" #include "stdlib.h" #include "read_data.h" #include "lmptype.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" #include "update.h" #include "force.h" #include "pair.h" #include "domain.h" #include "bond.h" #include "angle.h" #include "dihedral.h" #include "improper.h" #include "error.h" #include "memory.h" #include "special.h" using namespace LAMMPS_NS; #define MAXLINE 256 #define LB_FACTOR 1.1 #define CHUNK 1024 #define DELTA 4 // must be 2 or larger #define NSECTIONS 22 // change when add to header::section_keywords #define MIN(a,b) ((a) < (b) ? (a) : (b)) #define MAX(a,b) ((a) > (b) ? (a) : (b)) /* ---------------------------------------------------------------------- */ ReadData::ReadData(LAMMPS *lmp) : Pointers(lmp) { MPI_Comm_rank(world,&me); line = new char[MAXLINE]; keyword = new char[MAXLINE]; buffer = new char[CHUNK*MAXLINE]; narg = maxarg = 0; arg = NULL; } /* ---------------------------------------------------------------------- */ ReadData::~ReadData() { delete [] line; delete [] keyword; delete [] buffer; memory->sfree(arg); } /* ---------------------------------------------------------------------- */ void ReadData::command(int narg, char **arg) { if (narg != 1) error->all("Illegal read_data command"); if (domain->box_exist) error->all("Cannot read_data after simulation box is defined"); if (domain->dimension == 2 && domain->zperiodic == 0) error->all("Cannot run 2d simulation with nonperiodic Z dimension"); // scan data file to determine max topology needed per atom // allocate initial topology arrays if (atom->molecular) { if (me == 0) { if (screen) fprintf(screen,"Scanning data file ...\n"); open(arg[0]); header(0); scan(atom->bond_per_atom,atom->angle_per_atom, atom->dihedral_per_atom,atom->improper_per_atom); if (compressed) pclose(fp); else fclose(fp); atom->bond_per_atom += atom->extra_bond_per_atom; } MPI_Bcast(&atom->bond_per_atom,1,MPI_INT,0,world); MPI_Bcast(&atom->angle_per_atom,1,MPI_INT,0,world); MPI_Bcast(&atom->dihedral_per_atom,1,MPI_INT,0,world); MPI_Bcast(&atom->improper_per_atom,1,MPI_INT,0,world); } else atom->bond_per_atom = atom->angle_per_atom = atom->dihedral_per_atom = atom->improper_per_atom = 0; // read header info if (me == 0) { if (screen) fprintf(screen,"Reading data file ...\n"); open(arg[0]); } header(1); domain->box_exist = 1; // problem setup using info from header update->ntimestep = 0; int n; if (comm->nprocs == 1) n = static_cast<int> (atom->natoms); else n = static_cast<int> (LB_FACTOR * atom->natoms / comm->nprocs); atom->allocate_type_arrays(); atom->avec->grow(n); n = atom->nmax; domain->print_box(" "); domain->set_initial_box(); domain->set_global_box(); comm->set_procs(); domain->set_local_box(); // read rest of file in free format // if add a section keyword, add to header::section_keywords and NSECTIONS int atomflag = 0; while (strlen(keyword)) { if (strcmp(keyword,"Atoms") == 0) { atoms(); atomflag = 1; } else if (strcmp(keyword,"Velocities") == 0) { if (atomflag == 0) error->all("Must read Atoms before Velocities"); velocities(); } else if (strcmp(keyword,"Bonds") == 0) { if (atom->avec->bonds_allow == 0) error->all("Invalid data file section: Bonds"); if (atomflag == 0) error->all("Must read Atoms before Bonds"); bonds(); } else if (strcmp(keyword,"Angles") == 0) { if (atom->avec->angles_allow == 0) error->all("Invalid data file section: Angles"); if (atomflag == 0) error->all("Must read Atoms before Angles"); angles(); } else if (strcmp(keyword,"Dihedrals") == 0) { if (atom->avec->dihedrals_allow == 0) error->all("Invalid data file section: Dihedrals"); if (atomflag == 0) error->all("Must read Atoms before Dihedrals"); dihedrals(); } else if (strcmp(keyword,"Impropers") == 0) { if (atom->avec->impropers_allow == 0) error->all("Invalid data file section: Impropers"); if (atomflag == 0) error->all("Must read Atoms before Impropers"); impropers(); } else if (strcmp(keyword,"Masses") == 0) { mass(); } else if (strcmp(keyword,"Shapes") == 0) { shape(); } else if (strcmp(keyword,"Dipoles") == 0) { dipole(); } else if (strcmp(keyword,"Pair Coeffs") == 0) { if (force->pair == NULL) error->all("Must define pair_style before Pair Coeffs"); paircoeffs(); } else if (strcmp(keyword,"Bond Coeffs") == 0) { if (atom->avec->bonds_allow == 0) error->all("Invalid data file section: Bond Coeffs"); if (force->bond == NULL) error->all("Must define bond_style before Bond Coeffs"); bondcoeffs(); } else if (strcmp(keyword,"Angle Coeffs") == 0) { if (atom->avec->angles_allow == 0) error->all("Invalid data file section: Angle Coeffs"); if (force->angle == NULL) error->all("Must define angle_style before Angle Coeffs"); anglecoeffs(0); } else if (strcmp(keyword,"Dihedral Coeffs") == 0) { if (atom->avec->dihedrals_allow == 0) error->all("Invalid data file section: Dihedral Coeffs"); if (force->dihedral == NULL) error->all("Must define dihedral_style before Dihedral Coeffs"); dihedralcoeffs(0); } else if (strcmp(keyword,"Improper Coeffs") == 0) { if (atom->avec->impropers_allow == 0) error->all("Invalid data file section: Improper Coeffs"); if (force->improper == NULL) error->all("Must define improper_style before Improper Coeffs"); impropercoeffs(0); } else if (strcmp(keyword,"BondBond Coeffs") == 0) { if (atom->avec->angles_allow == 0) error->all("Invalid data file section: BondBond Coeffs"); if (force->angle == NULL) error->all("Must define angle_style before BondBond Coeffs"); anglecoeffs(1); } else if (strcmp(keyword,"BondAngle Coeffs") == 0) { if (atom->avec->angles_allow == 0) error->all("Invalid data file section: BondAngle Coeffs"); if (force->angle == NULL) error->all("Must define angle_style before BondAngle Coeffs"); anglecoeffs(2); } else if (strcmp(keyword,"MiddleBondTorsion Coeffs") == 0) { if (atom->avec->dihedrals_allow == 0) error->all("Invalid data file section: MiddleBondTorsion Coeffs"); if (force->dihedral == NULL) error->all("Must define dihedral_style before MiddleBondTorsion Coeffs"); dihedralcoeffs(1); } else if (strcmp(keyword,"EndBondTorsion Coeffs") == 0) { if (atom->avec->dihedrals_allow == 0) error->all("Invalid data file section: EndBondTorsion Coeffs"); if (force->dihedral == NULL) error->all("Must define dihedral_style before EndBondTorsion Coeffs"); dihedralcoeffs(2); } else if (strcmp(keyword,"AngleTorsion Coeffs") == 0) { if (atom->avec->dihedrals_allow == 0) error->all("Invalid data file section: AngleTorsion Coeffs"); if (force->dihedral == NULL) error->all("Must define dihedral_style before AngleTorsion Coeffs"); dihedralcoeffs(3); } else if (strcmp(keyword,"AngleAngleTorsion Coeffs") == 0) { if (atom->avec->dihedrals_allow == 0) error->all("Invalid data file section: AngleAngleTorsion Coeffs"); if (force->dihedral == NULL) error->all("Must define dihedral_style before AngleAngleTorsion Coeffs"); dihedralcoeffs(4); } else if (strcmp(keyword,"BondBond13 Coeffs") == 0) { if (atom->avec->dihedrals_allow == 0) error->all("Invalid data file section: BondBond13 Coeffs"); if (force->dihedral == NULL) error->all("Must define dihedral_style before BondBond13 Coeffs"); dihedralcoeffs(5); } else if (strcmp(keyword,"AngleAngle Coeffs") == 0) { if (atom->avec->impropers_allow == 0) error->all("Invalid data file section: AngleAngle Coeffs"); if (force->improper == NULL) error->all("Must define improper_style before AngleAngle Coeffs"); impropercoeffs(1); } else { char str[128]; sprintf(str,"Unknown identifier in data file: %s",keyword); error->all(str); } parse_keyword(0,1); } // close file if (me == 0) { if (compressed) pclose(fp); else fclose(fp); } // error if natoms > 0 yet no atoms were read if (atom->natoms > 0 && atomflag == 0) error->all("No atoms in data file"); // create bond topology now that system is defined if (atom->molecular) { Special special(lmp); special.build(); } } /* ---------------------------------------------------------------------- read free-format header of data file if flag = 0, only called by proc 0 if flag = 1, called by all procs so bcast lines as read them 1st line and blank lines are skipped non-blank lines are checked for header keywords and leading value is read header ends with EOF or non-blank line containing no header keyword if EOF, line is set to blank line else line has first keyword line for rest of file ------------------------------------------------------------------------- */ void ReadData::header(int flag) { int n; char *ptr; char *section_keywords[NSECTIONS] = {"Atoms","Velocities","Bonds","Angles","Dihedrals","Impropers", "Masses","Shapes","Dipoles", "Pair Coeffs","Bond Coeffs","Angle Coeffs", "Dihedral Coeffs","Improper Coeffs", "BondBond Coeffs","BondAngle Coeffs","MiddleBondTorsion Coeffs", "EndBondTorsion Coeffs","AngleTorsion Coeffs", "AngleAngleTorsion Coeffs","BondBond13 Coeffs","AngleAngle Coeffs"}; // skip 1st line of file if (me == 0) { char *eof = fgets(line,MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); } while (1) { // read a line and bcast length if flag is set if (me == 0) { if (fgets(line,MAXLINE,fp) == NULL) n = 0; else n = strlen(line) + 1; } if (flag) MPI_Bcast(&n,1,MPI_INT,0,world); // if n = 0 then end-of-file so return with blank line if (n == 0) { line[0] = '\0'; return; } // bcast line if flag is set if (flag) MPI_Bcast(line,n,MPI_CHAR,0,world); // trim anything from '#' onward // if line is blank, continue if (ptr = strchr(line,'#')) *ptr = '\0'; if (strspn(line," \t\n\r") == strlen(line)) continue; // search line for header keyword and set corresponding variable if (strstr(line,"atoms")) sscanf(line,"%lu",&atom->natoms); else if (strstr(line,"bonds")) sscanf(line,"%lu",&atom->nbonds); else if (strstr(line,"angles")) sscanf(line,"%lu",&atom->nangles); else if (strstr(line,"dihedrals")) sscanf(line,"%lu",&atom->ndihedrals); else if (strstr(line,"impropers")) sscanf(line,"%lu",&atom->nimpropers); else if (strstr(line,"atom types")) sscanf(line,"%d",&atom->ntypes); else if (strstr(line,"bond types")) sscanf(line,"%d",&atom->nbondtypes); else if (strstr(line,"angle types")) sscanf(line,"%d",&atom->nangletypes); else if (strstr(line,"dihedral types")) sscanf(line,"%d",&atom->ndihedraltypes); else if (strstr(line,"improper types")) sscanf(line,"%d",&atom->nimpropertypes); else if (strstr(line,"extra bond per atom")) sscanf(line,"%d",&atom->extra_bond_per_atom); else if (strstr(line,"xlo xhi")) sscanf(line,"%lg %lg",&domain->boxlo[0],&domain->boxhi[0]); else if (strstr(line,"ylo yhi")) sscanf(line,"%lg %lg",&domain->boxlo[1],&domain->boxhi[1]); else if (strstr(line,"zlo zhi")) sscanf(line,"%lg %lg",&domain->boxlo[2],&domain->boxhi[2]); else if (strstr(line,"xy xz yz")) { domain->triclinic = 1; sscanf(line,"%lg %lg %lg",&domain->xy,&domain->xz,&domain->yz); } else break; } // check that exiting string is a valid section keyword parse_keyword(1,flag); for (n = 0; n < NSECTIONS; n++) if (strcmp(keyword,section_keywords[n]) == 0) break; if (n == NSECTIONS) { char str[128]; sprintf(str,"Unknown identifier in data file: %s",keyword); error->all(str); } // error check on consistency of header values if ((atom->nbonds || atom->nbondtypes) && atom->avec->bonds_allow == 0) error->one("No bonds allowed with this atom style"); if ((atom->nangles || atom->nangletypes) && atom->avec->angles_allow == 0) error->one("No angles allowed with this atom style"); if ((atom->ndihedrals || atom->ndihedraltypes) && atom->avec->dihedrals_allow == 0) error->one("No dihedrals allowed with this atom style"); if ((atom->nimpropers || atom->nimpropertypes) && atom->avec->impropers_allow == 0) error->one("No impropers allowed with this atom style"); if (atom->nbonds > 0 && atom->nbondtypes <= 0) error->one("Bonds defined but no bond types"); if (atom->nangles > 0 && atom->nangletypes <= 0) error->one("Angles defined but no angle types"); if (atom->ndihedrals > 0 && atom->ndihedraltypes <= 0) error->one("Dihedrals defined but no dihedral types"); if (atom->nimpropers > 0 && atom->nimpropertypes <= 0) error->one("Impropers defined but no improper types"); } /* ---------------------------------------------------------------------- read all atoms ------------------------------------------------------------------------- */ void ReadData::atoms() { int i,m,nchunk; bigint nread = 0; bigint natoms = atom->natoms; while (nread < natoms) { if (natoms-nread > CHUNK) nchunk = CHUNK; else nchunk = natoms-nread; if (me == 0) { char *eof; m = 0; for (i = 0; i < nchunk; i++) { eof = fgets(&buffer[m],MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); m += strlen(&buffer[m]); } buffer[m++] = '\n'; } MPI_Bcast(&m,1,MPI_INT,0,world); MPI_Bcast(buffer,m,MPI_CHAR,0,world); atom->data_atoms(nchunk,buffer); nread += nchunk; } // check that all atoms were assigned correctly bigint tmp = atom->nlocal; - MPI_Allreduce(&tmp,&natoms,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&tmp,&natoms,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); if (me == 0) { if (screen) fprintf(screen," %lu atoms\n",natoms); if (logfile) fprintf(logfile," %lu atoms\n",natoms); } if (natoms != atom->natoms) error->all("Did not assign all atoms correctly"); // if any atom ID < 0, error // if all atom IDs = 0, tag_enable = 0 // if any atom ID > 0, error if any atom ID == 0 // not checking if atom IDs > natoms or are unique int nlocal = atom->nlocal; int *tag = atom->tag; int flag = 0; for (int i = 0; i < nlocal; i++) if (tag[i] < 0) flag = 1; int flag_all; MPI_Allreduce(&flag,&flag_all,1,MPI_INT,MPI_SUM,world); if (flag_all) error->all("Invalid atom ID in Atoms section of data file"); flag = 0; for (int i = 0; i < nlocal; i++) if (tag[i] > 0) flag = 1; MPI_Allreduce(&flag,&flag_all,1,MPI_INT,MPI_MAX,world); if (flag_all == 0) atom->tag_enable = 0; if (atom->tag_enable) { flag = 0; for (int i = 0; i < nlocal; i++) if (tag[i] == 0) flag = 1; MPI_Allreduce(&flag,&flag_all,1,MPI_INT,MPI_SUM,world); if (flag_all) error->all("Invalid atom ID in Atoms section of data file"); } // create global mapping if (atom->map_style) { atom->map_init(); atom->map_set(); } } /* ---------------------------------------------------------------------- read all velocities to find atoms, must build atom map if not a molecular system ------------------------------------------------------------------------- */ void ReadData::velocities() { int i,m,nchunk; int mapflag = 0; if (atom->map_style == 0) { mapflag = 1; atom->map_style = 1; atom->map_init(); atom->map_set(); } bigint nread = 0; bigint natoms = atom->natoms; while (nread < natoms) { if (natoms-nread > CHUNK) nchunk = CHUNK; else nchunk = natoms-nread; if (me == 0) { char *eof; m = 0; for (i = 0; i < nchunk; i++) { eof = fgets(&buffer[m],MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); m += strlen(&buffer[m]); } buffer[m++] = '\n'; } MPI_Bcast(&m,1,MPI_INT,0,world); MPI_Bcast(buffer,m,MPI_CHAR,0,world); atom->data_vels(nchunk,buffer); nread += nchunk; } if (mapflag) { atom->map_delete(); atom->map_style = 0; } if (me == 0) { if (screen) fprintf(screen," %lu velocities\n",natoms); if (logfile) fprintf(logfile," %lu velocities\n",natoms); } } /* ---------------------------------------------------------------------- */ void ReadData::bonds() { int i,m,nchunk; bigint nread = 0; bigint nbonds = atom->nbonds; while (nread < nbonds) { nchunk = MIN(nbonds-nread,CHUNK); if (me == 0) { char *eof; m = 0; for (i = 0; i < nchunk; i++) { eof = fgets(&buffer[m],MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); m += strlen(&buffer[m]); } buffer[m++] = '\n'; } MPI_Bcast(&m,1,MPI_INT,0,world); MPI_Bcast(buffer,m,MPI_CHAR,0,world); atom->data_bonds(nchunk,buffer); nread += nchunk; } // check that bonds were assigned correctly int nlocal = atom->nlocal; bigint sum; bigint n = 0; for (i = 0; i < nlocal; i++) n += atom->num_bond[i]; - MPI_Allreduce(&n,&sum,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&n,&sum,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); int factor = 1; if (!force->newton_bond) factor = 2; if (me == 0) { if (screen) fprintf(screen," %lu bonds\n",sum/factor); if (logfile) fprintf(logfile," %lu bonds\n",sum/factor); } if (sum != factor*atom->nbonds) error->all("Bonds assigned incorrectly"); } /* ---------------------------------------------------------------------- */ void ReadData::angles() { int i,m,nchunk; bigint nread = 0; bigint nangles = atom->nangles; while (nread < nangles) { nchunk = MIN(nangles-nread,CHUNK); if (me == 0) { char *eof; m = 0; for (i = 0; i < nchunk; i++) { eof = fgets(&buffer[m],MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); m += strlen(&buffer[m]); } buffer[m++] = '\n'; } MPI_Bcast(&m,1,MPI_INT,0,world); MPI_Bcast(buffer,m,MPI_CHAR,0,world); atom->data_angles(nchunk,buffer); nread += nchunk; } // check that ang int nlocal = atom->nlocal; bigint sum; bigint n = 0; for (i = 0; i < nlocal; i++) n += atom->num_angle[i]; - MPI_Allreduce(&n,&sum,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&n,&sum,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); int factor = 1; if (!force->newton_bond) factor = 3; if (me == 0) { if (screen) fprintf(screen," %lu angles\n",sum/factor); if (logfile) fprintf(logfile," %lu angles\n",sum/factor); } if (sum != factor*atom->nangles) error->all("Angles assigned incorrectly"); } /* ---------------------------------------------------------------------- */ void ReadData::dihedrals() { int i,m,nchunk; bigint nread = 0; bigint ndihedrals = atom->ndihedrals; while (nread < ndihedrals) { nchunk = MIN(ndihedrals-nread,CHUNK); if (me == 0) { char *eof; m = 0; for (i = 0; i < nchunk; i++) { eof = fgets(&buffer[m],MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); m += strlen(&buffer[m]); } buffer[m++] = '\n'; } MPI_Bcast(&m,1,MPI_INT,0,world); MPI_Bcast(buffer,m,MPI_CHAR,0,world); atom->data_dihedrals(nchunk,buffer); nread += nchunk; } // check that dihedrals were assigned correctly int nlocal = atom->nlocal; bigint sum; bigint n = 0; for (i = 0; i < nlocal; i++) n += atom->num_dihedral[i]; - MPI_Allreduce(&n,&sum,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&n,&sum,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); int factor = 1; if (!force->newton_bond) factor = 4; if (me == 0) { if (screen) fprintf(screen," %lu dihedrals\n",sum/factor); if (logfile) fprintf(logfile," %lu dihedrals\n",sum/factor); } if (sum != factor*atom->ndihedrals) error->all("Dihedrals assigned incorrectly"); } /* ---------------------------------------------------------------------- */ void ReadData::impropers() { int i,m,nchunk; bigint nread = 0; bigint nimpropers = atom->nimpropers; while (nread < nimpropers) { nchunk = MIN(nimpropers-nread,CHUNK); if (me == 0) { char *eof; m = 0; for (i = 0; i < nchunk; i++) { eof = fgets(&buffer[m],MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); m += strlen(&buffer[m]); } buffer[m++] = '\n'; } MPI_Bcast(&m,1,MPI_INT,0,world); MPI_Bcast(buffer,m,MPI_CHAR,0,world); atom->data_impropers(nchunk,buffer); nread += nchunk; } // check that impropers were assigned correctly int nlocal = atom->nlocal; bigint sum; bigint n = 0; for (i = 0; i < nlocal; i++) n += atom->num_improper[i]; - MPI_Allreduce(&n,&sum,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&n,&sum,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); int factor = 1; if (!force->newton_bond) factor = 4; if (me == 0) { if (screen) fprintf(screen," %lu impropers\n",sum/factor); if (logfile) fprintf(logfile," %lu impropers\n",sum/factor); } if (sum != factor*atom->nimpropers) error->all("Impropers assigned incorrectly"); } /* ---------------------------------------------------------------------- */ void ReadData::mass() { int i,m; char *buf = new char[atom->ntypes*MAXLINE]; char *original = buf; if (me == 0) { char *eof; m = 0; for (i = 0; i < atom->ntypes; i++) { eof = fgets(&buf[m],MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); m += strlen(&buf[m]); buf[m-1] = '\0'; } } MPI_Bcast(&m,1,MPI_INT,0,world); MPI_Bcast(buf,m,MPI_CHAR,0,world); for (i = 0; i < atom->ntypes; i++) { atom->set_mass(buf); buf += strlen(buf) + 1; } delete [] original; } /* ---------------------------------------------------------------------- */ void ReadData::shape() { int i,m; char *buf = new char[atom->ntypes*MAXLINE]; char *original = buf; if (me == 0) { char *eof; m = 0; for (i = 0; i < atom->ntypes; i++) { eof = fgets(&buf[m],MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); m += strlen(&buf[m]); buf[m-1] = '\0'; } } MPI_Bcast(&m,1,MPI_INT,0,world); MPI_Bcast(buf,m,MPI_CHAR,0,world); for (i = 0; i < atom->ntypes; i++) { atom->set_shape(buf); buf += strlen(buf) + 1; } delete [] original; } /* ---------------------------------------------------------------------- */ void ReadData::dipole() { int i,m; char *buf = new char[atom->ntypes*MAXLINE]; char *original = buf; if (me == 0) { char *eof; m = 0; for (i = 0; i < atom->ntypes; i++) { eof = fgets(&buf[m],MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); m += strlen(&buf[m]); buf[m-1] = '\0'; } } MPI_Bcast(&m,1,MPI_INT,0,world); MPI_Bcast(buf,m,MPI_CHAR,0,world); for (i = 0; i < atom->ntypes; i++) { atom->set_dipole(buf); buf += strlen(buf) + 1; } delete [] original; } /* ---------------------------------------------------------------------- */ void ReadData::paircoeffs() { int i,m; char *buf = new char[atom->ntypes*MAXLINE]; char *original = buf; if (me == 0) { char *eof; m = 0; for (i = 0; i < atom->ntypes; i++) { eof = fgets(&buf[m],MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); m += strlen(&buf[m]); buf[m-1] = '\0'; } } MPI_Bcast(&m,1,MPI_INT,0,world); MPI_Bcast(buf,m,MPI_CHAR,0,world); for (i = 0; i < atom->ntypes; i++) { m = strlen(buf) + 1; parse_coeffs(buf,NULL,1); force->pair->coeff(narg,arg); buf += m; } delete [] original; } /* ---------------------------------------------------------------------- */ void ReadData::bondcoeffs() { int i,m; char *buf = new char[atom->nbondtypes*MAXLINE]; char *original = buf; if (me == 0) { char *eof; m = 0; for (i = 0; i < atom->nbondtypes; i++) { eof = fgets(&buf[m],MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); m += strlen(&buf[m]); buf[m-1] = '\0'; } } MPI_Bcast(&m,1,MPI_INT,0,world); MPI_Bcast(buf,m,MPI_CHAR,0,world); for (i = 0; i < atom->nbondtypes; i++) { m = strlen(buf) + 1; parse_coeffs(buf,NULL,0); force->bond->coeff(narg,arg); buf += m; } delete [] original; } /* ---------------------------------------------------------------------- */ void ReadData::anglecoeffs(int which) { int i,m; char *buf = new char[atom->nangletypes*MAXLINE]; char *original = buf; if (me == 0) { char *eof; m = 0; for (i = 0; i < atom->nangletypes; i++) { eof = fgets(&buf[m],MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); m += strlen(&buf[m]); buf[m-1] = '\0'; } } MPI_Bcast(&m,1,MPI_INT,0,world); MPI_Bcast(buf,m,MPI_CHAR,0,world); for (i = 0; i < atom->nangletypes; i++) { m = strlen(buf) + 1; if (which == 0) parse_coeffs(buf,NULL,0); else if (which == 1) parse_coeffs(buf,"bb",0); else if (which == 2) parse_coeffs(buf,"ba",0); force->angle->coeff(narg,arg); buf += m; } delete [] original; } /* ---------------------------------------------------------------------- */ void ReadData::dihedralcoeffs(int which) { int i,m; char *buf = new char[atom->ndihedraltypes*MAXLINE]; char *original = buf; if (me == 0) { char *eof; m = 0; for (i = 0; i < atom->ndihedraltypes; i++) { eof = fgets(&buf[m],MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); m += strlen(&buf[m]); buf[m-1] = '\0'; } } MPI_Bcast(&m,1,MPI_INT,0,world); MPI_Bcast(buf,m,MPI_CHAR,0,world); for (i = 0; i < atom->ndihedraltypes; i++) { m = strlen(buf) + 1; if (which == 0) parse_coeffs(buf,NULL,0); else if (which == 1) parse_coeffs(buf,"mbt",0); else if (which == 2) parse_coeffs(buf,"ebt",0); else if (which == 3) parse_coeffs(buf,"at",0); else if (which == 4) parse_coeffs(buf,"aat",0); else if (which == 5) parse_coeffs(buf,"bb13",0); force->dihedral->coeff(narg,arg); buf += m; } delete [] original; } /* ---------------------------------------------------------------------- */ void ReadData::impropercoeffs(int which) { int i,m; char *buf = new char[atom->nimpropertypes*MAXLINE]; char *original = buf; if (me == 0) { char *eof; m = 0; for (i = 0; i < atom->nimpropertypes; i++) { eof = fgets(&buf[m],MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); m += strlen(&buf[m]); buf[m-1] = '\0'; } } MPI_Bcast(&m,1,MPI_INT,0,world); MPI_Bcast(buf,m,MPI_CHAR,0,world); for (i = 0; i < atom->nimpropertypes; i++) { m = strlen(buf) + 1; if (which == 0) parse_coeffs(buf,NULL,0); else if (which == 1) parse_coeffs(buf,"aa",0); force->improper->coeff(narg,arg); buf += m; } delete [] original; } /* ---------------------------------------------------------------------- proc 0 scans the data file for topology maximums ------------------------------------------------------------------------- */ void ReadData::scan(int &bond_per_atom, int &angle_per_atom, int &dihedral_per_atom, int &improper_per_atom) { int i,tmp1,tmp2,atom1,atom2,atom3,atom4; char *eof; if (atom->natoms > MAXINT32) error->all("Molecular data file has too many atoms"); int natoms = static_cast<int> (atom->natoms); bond_per_atom = angle_per_atom = dihedral_per_atom = improper_per_atom = 0; // allocate topology counting vector // initially, array length = 1 to natoms // will grow via reallocate() if atom IDs > natoms int cmax = natoms + 1; int *count = (int *) memory->smalloc(cmax*sizeof(int),"read_data:count"); while (strlen(keyword)) { if (strcmp(keyword,"Masses") == 0) skip_lines(atom->ntypes); else if (strcmp(keyword,"Dipoles") == 0) skip_lines(atom->ntypes); else if (strcmp(keyword,"Atoms") == 0) skip_lines(natoms); else if (strcmp(keyword,"Velocities") == 0) skip_lines(natoms); else if (strcmp(keyword,"Pair Coeffs") == 0) { if (force->pair == NULL) error->all("Must define pair_style before Pair Coeffs"); skip_lines(atom->ntypes); } else if (strcmp(keyword,"Bond Coeffs") == 0) { if (atom->avec->bonds_allow == 0) error->all("Invalid data file section: Bond Coeffs"); if (force->bond == NULL) error->all("Must define bond_style before Bond Coeffs"); skip_lines(atom->nbondtypes); } else if (strcmp(keyword,"Angle Coeffs") == 0) { if (atom->avec->angles_allow == 0) error->all("Invalid data file section: Angle Coeffs"); if (force->angle == NULL) error->all("Must define angle_style before Angle Coeffs"); skip_lines(atom->nangletypes); } else if (strcmp(keyword,"Dihedral Coeffs") == 0) { skip_lines(atom->ndihedraltypes); if (atom->avec->dihedrals_allow == 0) error->all("Invalid data file section: Dihedral Coeffs"); if (force->dihedral == NULL) error->all("Must define dihedral_style before Dihedral Coeffs"); } else if (strcmp(keyword,"Improper Coeffs") == 0) { if (atom->avec->impropers_allow == 0) error->all("Invalid data file section: Improper Coeffs"); if (force->improper == NULL) error->all("Must define improper_style before Improper Coeffs"); skip_lines(atom->nimpropertypes); } else if (strcmp(keyword,"BondBond Coeffs") == 0) { if (atom->avec->angles_allow == 0) error->all("Invalid data file section: BondBond Coeffs"); if (force->angle == NULL) error->all("Must define angle_style before BondBond Coeffs"); skip_lines(atom->nangletypes); } else if (strcmp(keyword,"BondAngle Coeffs") == 0) { if (atom->avec->angles_allow == 0) error->all("Invalid data file section: BondAngle Coeffs"); if (force->angle == NULL) error->all("Must define angle_style before BondAngle Coeffs"); skip_lines(atom->nangletypes); } else if (strcmp(keyword,"MiddleBondTorsion Coeffs") == 0) { if (atom->avec->dihedrals_allow == 0) error->all("Invalid data file section: MiddleBondTorsion Coeffs"); if (force->dihedral == NULL) error->all("Must define dihedral_style before MiddleBondTorsion Coeffs"); skip_lines(atom->ndihedraltypes); } else if (strcmp(keyword,"EndBondTorsion Coeffs") == 0) { if (atom->avec->dihedrals_allow == 0) error->all("Invalid data file section: EndBondTorsion Coeffs"); if (force->dihedral == NULL) error->all("Must define dihedral_style before EndBondTorsion Coeffs"); skip_lines(atom->ndihedraltypes); } else if (strcmp(keyword,"AngleTorsion Coeffs") == 0) { if (atom->avec->dihedrals_allow == 0) error->all("Invalid data file section: AngleTorsion Coeffs"); if (force->dihedral == NULL) error->all("Must define dihedral_style before AngleTorsion Coeffs"); skip_lines(atom->ndihedraltypes); } else if (strcmp(keyword,"AngleAngleTorsion Coeffs") == 0) { if (atom->avec->dihedrals_allow == 0) error->all("Invalid data file section: AngleAngleTorsion Coeffs"); if (force->dihedral == NULL) error->all("Must define dihedral_style before AngleAngleTorsion Coeffs"); skip_lines(atom->ndihedraltypes); } else if (strcmp(keyword,"BondBond13 Coeffs") == 0) { if (atom->avec->dihedrals_allow == 0) error->all("Invalid data file section: BondBond13 Coeffs"); if (force->dihedral == NULL) error->all("Must define dihedral_style before BondBond13 Coeffs"); skip_lines(atom->ndihedraltypes); } else if (strcmp(keyword,"AngleAngle Coeffs") == 0) { if (atom->avec->impropers_allow == 0) error->all("Invalid data file section: AngleAngle Coeffs"); if (force->improper == NULL) error->all("Must define improper_style before AngleAngle Coeffs"); skip_lines(atom->nimpropertypes); } else if (strcmp(keyword,"Bonds") == 0) { for (i = 1; i < cmax; i++) count[i] = 0; if (force->newton_bond) for (i = 0; i < atom->nbonds; i++) { eof = fgets(line,MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); sscanf(line,"%d %d %d %d",&tmp1,&tmp2,&atom1,&atom2); if (atom1 >= cmax) cmax = reallocate(&count,cmax,atom1); count[atom1]++; } else for (i = 0; i < atom->nbonds; i++) { eof = fgets(line,MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); sscanf(line,"%d %d %d %d",&tmp1,&tmp2,&atom1,&atom2); int amax = MAX(atom1,atom2); if (amax >= cmax) cmax = reallocate(&count,cmax,amax); count[atom1]++; count[atom2]++; } for (i = 1; i < cmax; i++) bond_per_atom = MAX(bond_per_atom,count[i]); if (screen) fprintf(screen," %d = max bonds/atom\n",bond_per_atom); if (logfile) fprintf(logfile," %d = max bonds/atom\n",bond_per_atom); } else if (strcmp(keyword,"Angles") == 0) { for (i = 1; i < cmax; i++) count[i] = 0; if (force->newton_bond) for (i = 0; i < atom->nangles; i++) { eof = fgets(line,MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); sscanf(line,"%d %d %d %d %d",&tmp1,&tmp2,&atom1,&atom2,&atom3); if (atom2 >= cmax) cmax = reallocate(&count,cmax,atom2); count[atom2]++; } else for (i = 0; i < atom->nangles; i++) { eof = fgets(line,MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); sscanf(line,"%d %d %d %d %d",&tmp1,&tmp2,&atom1,&atom2,&atom3); int amax = MAX(atom1,atom2); amax = MAX(amax,atom3); if (amax >= cmax) cmax = reallocate(&count,cmax,amax); count[atom1]++; count[atom2]++; count[atom3]++; } for (i = 1; i < cmax; i++) angle_per_atom = MAX(angle_per_atom,count[i]); if (screen) fprintf(screen," %d = max angles/atom\n",angle_per_atom); if (logfile) fprintf(logfile," %d = max angles/atom\n",angle_per_atom); } else if (strcmp(keyword,"Dihedrals") == 0) { for (i = 1; i < cmax; i++) count[i] = 0; if (force->newton_bond) for (i = 0; i < atom->ndihedrals; i++) { eof = fgets(line,MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); sscanf(line,"%d %d %d %d %d %d", &tmp1,&tmp2,&atom1,&atom2,&atom3,&atom4); if (atom2 >= cmax) cmax = reallocate(&count,cmax,atom2); count[atom2]++; } else for (i = 0; i < atom->ndihedrals; i++) { eof = fgets(line,MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); sscanf(line,"%d %d %d %d %d %d", &tmp1,&tmp2,&atom1,&atom2,&atom3,&atom4); int amax = MAX(atom1,atom2); amax = MAX(amax,atom3); amax = MAX(amax,atom4); if (amax >= cmax) cmax = reallocate(&count,cmax,amax); count[atom1]++; count[atom2]++; count[atom3]++; count[atom4]++; } for (i = 1; i < cmax; i++) dihedral_per_atom = MAX(dihedral_per_atom,count[i]); if (screen) fprintf(screen," %d = max dihedrals/atom\n",dihedral_per_atom); if (logfile) fprintf(logfile," %d = max dihedrals/atom\n",dihedral_per_atom); } else if (strcmp(keyword,"Impropers") == 0) { for (i = 1; i < cmax; i++) count[i] = 0; if (force->newton_bond) for (i = 0; i < atom->nimpropers; i++) { eof = fgets(line,MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); sscanf(line,"%d %d %d %d %d %d", &tmp1,&tmp2,&atom1,&atom2,&atom3,&atom4); if (atom2 >= cmax) cmax = reallocate(&count,cmax,atom2); count[atom2]++; } else for (i = 0; i < atom->nimpropers; i++) { eof = fgets(line,MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); sscanf(line,"%d %d %d %d %d %d", &tmp1,&tmp2,&atom1,&atom2,&atom3,&atom4); int amax = MAX(atom1,atom2); amax = MAX(amax,atom3); amax = MAX(amax,atom4); if (amax >= cmax) cmax = reallocate(&count,cmax,amax); count[atom1]++; count[atom2]++; count[atom3]++; count[atom4]++; } for (i = 1; i < cmax; i++) improper_per_atom = MAX(improper_per_atom,count[i]); if (screen) fprintf(screen," %d = max impropers/atom\n",improper_per_atom); if (logfile) fprintf(logfile," %d = max impropers/atom\n",improper_per_atom); } else { char str[128]; sprintf(str,"Unknown identifier in data file: %s",keyword); error->one(str); } parse_keyword(0,0); } // free topology counting vector memory->sfree(count); // error check that topology was specified in file if ((atom->nbonds && !bond_per_atom) || (atom->nangles && !angle_per_atom) || (atom->ndihedrals && !dihedral_per_atom) || (atom->nimpropers && !improper_per_atom)) error->one("Needed topology not in data file"); } /* ---------------------------------------------------------------------- reallocate the count vector from cmax to amax+1 and return new length zero new locations ------------------------------------------------------------------------- */ int ReadData::reallocate(int **pcount, int cmax, int amax) { int *count = *pcount; count = (int *) memory->srealloc(count,(amax+1)*sizeof(int),"read_data:count"); for (int i = cmax; i <= amax; i++) count[i] = 0; *pcount = count; return amax+1; } /* ---------------------------------------------------------------------- proc 0 opens data file test if gzipped ------------------------------------------------------------------------- */ void ReadData::open(char *file) { compressed = 0; char *suffix = file + strlen(file) - 3; if (suffix > file && strcmp(suffix,".gz") == 0) compressed = 1; if (!compressed) fp = fopen(file,"r"); else { #ifdef LAMMPS_GZIP char gunzip[128]; sprintf(gunzip,"gunzip -c %s",file); fp = popen(gunzip,"r"); #else error->one("Cannot open gzipped file"); #endif } if (fp == NULL) { char str[128]; sprintf(str,"Cannot open file %s",file); error->one(str); } } /* ---------------------------------------------------------------------- grab next keyword read lines until one is non-blank keyword is all text on line w/out leading & trailing white space read one additional line (assumed blank) if any read hits EOF, set keyword to empty if first = 1, line variable holds non-blank line that ended header if flag = 0, only proc 0 is calling so no bcast else flag = 1, bcast keyword line to all procs ------------------------------------------------------------------------- */ void ReadData::parse_keyword(int first, int flag) { int eof = 0; // proc 0 reads upto non-blank line plus 1 following line // eof is set to 1 if any read hits end-of-file if (me == 0) { if (!first) { if (fgets(line,MAXLINE,fp) == NULL) eof = 1; } while (eof == 0 && strspn(line," \t\n\r") == strlen(line)) { if (fgets(line,MAXLINE,fp) == NULL) eof = 1; } if (fgets(buffer,MAXLINE,fp) == NULL) eof = 1; } // if eof, set keyword empty and return if (flag) MPI_Bcast(&eof,1,MPI_INT,0,world); if (eof) { keyword[0] = '\0'; return; } // bcast keyword line to all procs if (flag) { int n; if (me == 0) n = strlen(line) + 1; MPI_Bcast(&n,1,MPI_INT,0,world); MPI_Bcast(line,n,MPI_CHAR,0,world); } // copy non-whitespace portion of line into keyword int start = strspn(line," \t\n\r"); int stop = strlen(line) - 1; while (line[stop] == ' ' || line[stop] == '\t' || line[stop] == '\n' || line[stop] == '\r') stop--; line[stop+1] = '\0'; strcpy(keyword,&line[start]); } /* ---------------------------------------------------------------------- proc 0 reads N lines from file ------------------------------------------------------------------------- */ void ReadData::skip_lines(int n) { char *eof; for (int i = 0; i < n; i++) eof = fgets(line,MAXLINE,fp); if (eof == NULL) error->one("Unexpected end of data file"); } /* ---------------------------------------------------------------------- parse a line of coeffs into words, storing them in narg,arg trim anything from '#' onward word strings remain in line, are not copied if addstr != NULL, add addstr as 2nd arg for class2 angle/dihedral/improper if dupflag, duplicate 1st word, so pair_coeff "2" becomes "2 2" ------------------------------------------------------------------------- */ void ReadData::parse_coeffs(char *line, char *addstr, int dupflag) { char *ptr; if (ptr = strchr(line,'#')) *ptr = '\0'; narg = 0; char *word = strtok(line," \t\n\r\f"); while (word) { if (narg == maxarg) { maxarg += DELTA; arg = (char **) memory->srealloc(arg,maxarg*sizeof(char *),"read_data:arg"); } arg[narg++] = word; if (addstr && narg == 1) arg[narg++] = addstr; if (dupflag && narg == 1) arg[narg++] = word; word = strtok(NULL," \t\n\r\f"); } } diff --git a/src/read_restart.cpp b/src/read_restart.cpp index 9e0bd656b..f325bc67b 100644 --- a/src/read_restart.cpp +++ b/src/read_restart.cpp @@ -1,824 +1,824 @@ /* ---------------------------------------------------------------------- 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. ------------------------------------------------------------------------- */ #include "mpi.h" #include "string.h" #include "stdlib.h" #include "sys/types.h" #include "dirent.h" #include "read_restart.h" #include "lmptype.h" #include "atom.h" #include "atom_vec.h" #include "domain.h" #include "comm.h" #include "irregular.h" #include "update.h" #include "modify.h" #include "fix.h" #include "fix_read_restart.h" #include "group.h" #include "force.h" #include "pair.h" #include "bond.h" #include "angle.h" #include "dihedral.h" #include "improper.h" #include "special.h" #include "universe.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; // same as write_restart.cpp enum{VERSION,UNITS,NTIMESTEP,DIMENSION,NPROCS,PROCGRID_0,PROCGRID_1,PROCGRID_2, NEWTON_PAIR,NEWTON_BOND,XPERIODIC,YPERIODIC,ZPERIODIC, BOUNDARY_00,BOUNDARY_01,BOUNDARY_10,BOUNDARY_11,BOUNDARY_20,BOUNDARY_21, ATOM_STYLE,NATOMS,NTYPES, NBONDS,NBONDTYPES,BOND_PER_ATOM, NANGLES,NANGLETYPES,ANGLE_PER_ATOM, NDIHEDRALS,NDIHEDRALTYPES,DIHEDRAL_PER_ATOM, NIMPROPERS,NIMPROPERTYPES,IMPROPER_PER_ATOM, BOXLO_0,BOXHI_0,BOXLO_1,BOXHI_1,BOXLO_2,BOXHI_2, SPECIAL_LJ_1,SPECIAL_LJ_2,SPECIAL_LJ_3, SPECIAL_COUL_1,SPECIAL_COUL_2,SPECIAL_COUL_3, XY,XZ,YZ}; enum{MASS,SHAPE,DIPOLE}; enum{PAIR,BOND,ANGLE,DIHEDRAL,IMPROPER}; #define LB_FACTOR 1.1 /* ---------------------------------------------------------------------- */ ReadRestart::ReadRestart(LAMMPS *lmp) : Pointers(lmp) {} /* ---------------------------------------------------------------------- */ void ReadRestart::command(int narg, char **arg) { if (narg != 1) error->all("Illegal read_restart command"); if (domain->box_exist) error->all("Cannot read_restart after simulation box is defined"); MPI_Comm_rank(world,&me); MPI_Comm_size(world,&nprocs); // if filename contains "*", search dir for latest restart file char *file = new char[strlen(arg[0]) + 16]; if (strchr(arg[0],'*')) file_search(arg[0],file); else strcpy(file,arg[0]); // check if filename contains "%" int multiproc; if (strchr(file,'%')) multiproc = 1; else multiproc = 0; // open single restart file or base file for multiproc case if (me == 0) { if (screen) fprintf(screen,"Reading restart file ...\n"); char *hfile; if (multiproc) { hfile = new char[strlen(file) + 16]; char *ptr = strchr(file,'%'); *ptr = '\0'; sprintf(hfile,"%s%s%s",file,"base",ptr+1); *ptr = '%'; } else hfile = file; fp = fopen(hfile,"rb"); if (fp == NULL) { char str[128]; sprintf(str,"Cannot open restart file %s",hfile); error->one(str); } if (multiproc) delete [] hfile; } // read header info and create atom style and simulation box header(); domain->box_exist = 1; // problem setup using info from header int n; if (nprocs == 1) n = static_cast<int> (atom->natoms); else n = static_cast<int> (LB_FACTOR * atom->natoms / nprocs); atom->allocate_type_arrays(); atom->avec->grow(n); n = atom->nmax; domain->print_box(" "); domain->set_initial_box(); domain->set_global_box(); comm->set_procs(); domain->set_local_box(); // read groups, ntype-length arrays, force field, fix info from file // nextra = max # of extra quantities stored with each atom group->read_restart(fp); type_arrays(); force_fields(); int nextra = modify->read_restart(fp); atom->nextra_store = nextra; atom->extra = memory->create_2d_double_array(n,nextra,"atom:extra"); // single file: // nprocs_file = # of chunks in file // proc 0 reads chunks one at a time and bcasts it to other procs // each proc unpacks the atoms, saving ones in it's sub-domain // check for atom in sub-domain differs for orthogonal vs triclinic box // close restart file when done AtomVec *avec = atom->avec; int maxbuf = 0; double *buf = NULL; int m; if (multiproc == 0) { int triclinic = domain->triclinic; double *x,lamda[3]; double *coord,*sublo,*subhi; if (triclinic == 0) { sublo = domain->sublo; subhi = domain->subhi; } else { sublo = domain->sublo_lamda; subhi = domain->subhi_lamda; } for (int iproc = 0; iproc < nprocs_file; iproc++) { if (me == 0) fread(&n,sizeof(int),1,fp); MPI_Bcast(&n,1,MPI_INT,0,world); if (n > maxbuf) { maxbuf = n; memory->sfree(buf); buf = (double *) memory->smalloc(maxbuf*sizeof(double), "read_restart:buf"); } if (n > 0) { if (me == 0) fread(buf,sizeof(double),n,fp); MPI_Bcast(buf,n,MPI_DOUBLE,0,world); } m = 0; while (m < n) { x = &buf[m+1]; if (triclinic) { domain->x2lamda(x,lamda); coord = lamda; } else coord = x; if (coord[0] >= sublo[0] && coord[0] < subhi[0] && coord[1] >= sublo[1] && coord[1] < subhi[1] && coord[2] >= sublo[2] && coord[2] < subhi[2]) { m += avec->unpack_restart(&buf[m]); } else m += static_cast<int> (buf[m]); } } if (me == 0) fclose(fp); // one file per proc: // nprocs_file = # of files // each proc reads 1/P fraction of files, keeping all atoms in the files // perform irregular comm to migrate atoms to correct procs // close restart file when done } else { if (me == 0) fclose(fp); char *perproc = new char[strlen(file) + 16]; char *ptr = strchr(file,'%'); for (int iproc = me; iproc < nprocs_file; iproc += nprocs) { *ptr = '\0'; sprintf(perproc,"%s%d%s",file,iproc,ptr+1); *ptr = '%'; fp = fopen(perproc,"rb"); if (fp == NULL) { char str[128]; sprintf(str,"Cannot open restart file %s",perproc); error->one(str); } fread(&n,sizeof(int),1,fp); if (n > maxbuf) { maxbuf = n; memory->sfree(buf); buf = (double *) memory->smalloc(maxbuf*sizeof(double), "read_restart:buf"); } if (n > 0) fread(buf,sizeof(double),n,fp); m = 0; while (m < n) m += avec->unpack_restart(&buf[m]); fclose(fp); } delete [] perproc; // create a temporary fix to hold and migrate extra atom info // necessary b/c irregular will migrate atoms if (nextra) { char cextra[8],fixextra[8]; sprintf(cextra,"%d",nextra); sprintf(fixextra,"%d",modify->nfix_restart_peratom); char **newarg = new char*[5]; newarg[0] = (char *) "_read_restart"; newarg[1] = (char *) "all"; newarg[2] = (char *) "READ_RESTART"; newarg[3] = cextra; newarg[4] = fixextra; modify->add_fix(5,newarg); delete [] newarg; } // move atoms to new processors via irregular() // in case read by different proc than wrote restart file if (domain->triclinic) domain->x2lamda(atom->nlocal); Irregular *irregular = new Irregular(lmp); irregular->migrate_atoms(); delete irregular; if (domain->triclinic) domain->lamda2x(atom->nlocal); // put extra atom info held by fix back into atom->extra // destroy temporary fix if (nextra) { memory->destroy_2d_double_array(atom->extra); atom->extra = memory->create_2d_double_array(atom->nmax,nextra, "atom:extra"); int ifix = modify->find_fix("_read_restart"); FixReadRestart *fix = (FixReadRestart *) modify->fix[ifix]; int *count = fix->count; double **extra = fix->extra; double **atom_extra = atom->extra; int nlocal = atom->nlocal; for (int i = 0; i < nlocal; i++) for (int j = 0; j < count[i]; j++) atom_extra[i][j] = extra[i][j]; modify->delete_fix("_read_restart"); } } // clean-up memory delete [] file; memory->sfree(buf); // check that all atoms were assigned to procs bigint natoms; bigint nblocal = atom->nlocal; - MPI_Allreduce(&nblocal,&natoms,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&nblocal,&natoms,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); if (me == 0) { if (screen) fprintf(screen," %lu atoms\n",natoms); if (logfile) fprintf(logfile," %lu atoms\n",natoms); } if (natoms != atom->natoms) error->all("Did not assign all atoms correctly"); if (me == 0) { if (atom->nbonds) { if (screen) fprintf(screen," %lu bonds\n",atom->nbonds); if (logfile) fprintf(logfile," %lu bonds\n",atom->nbonds); } if (atom->nangles) { if (screen) fprintf(screen," %lu angles\n",atom->nangles); if (logfile) fprintf(logfile," %lu angles\n",atom->nangles); } if (atom->ndihedrals) { if (screen) fprintf(screen," %lu dihedrals\n",atom->ndihedrals); if (logfile) fprintf(logfile," %lu dihedrals\n",atom->ndihedrals); } if (atom->nimpropers) { if (screen) fprintf(screen," %lu impropers\n",atom->nimpropers); if (logfile) fprintf(logfile," %lu impropers\n",atom->nimpropers); } } // check if tags are being used // create global mapping and bond topology now that system is defined int flag = 0; for (int i = 0; i < atom->nlocal; i++) if (atom->tag[i] > 0) flag = 1; int flag_all; MPI_Allreduce(&flag,&flag_all,1,MPI_INT,MPI_MAX,world); if (flag_all == 0) atom->tag_enable = 0; if (atom->map_style) { atom->map_init(); atom->map_set(); } if (atom->molecular) { Special special(lmp); special.build(); } } /* ---------------------------------------------------------------------- search for all files matching infile which contains a "*" replace "*" with latest timestep value to create outfile name search dir referenced by initial pathname of file if infile also contains "%", need to use "base" when search directory ------------------------------------------------------------------------- */ void ReadRestart::file_search(char *infile, char *outfile) { char *ptr; // separate infile into dir + filename char *dirname = new char[strlen(infile) + 1]; char *filename = new char[strlen(infile) + 1]; if (strchr(infile,'/')) { ptr = strrchr(infile,'/'); *ptr = '\0'; strcpy(dirname,infile); strcpy(filename,ptr+1); *ptr = '/'; } else { strcpy(dirname,"./"); strcpy(filename,infile); } // if filename contains "%" replace "%" with "base" char *pattern = new char[strlen(filename) + 16]; if (ptr = strchr(filename,'%')) { *ptr = '\0'; sprintf(pattern,"%s%s%s",filename,"base",ptr+1); *ptr = '%'; } else strcpy(pattern,filename); // scan all files in directory, searching for files that match pattern // maxnum = largest int that matches "*" int n = strlen(pattern) + 16; char *begin = new char[n]; char *middle = new char[n]; char *end = new char[n]; ptr = strchr(pattern,'*'); *ptr = '\0'; strcpy(begin,pattern); strcpy(end,ptr+1); int nbegin = strlen(begin); int maxnum = -1; if (me == 0) { struct dirent *ep; DIR *dp = opendir(dirname); if (dp == NULL) error->one("Cannot open dir to search for restart file"); while (ep = readdir(dp)) { if (strstr(ep->d_name,begin) != ep->d_name) continue; if ((ptr = strstr(&ep->d_name[nbegin],end)) == NULL) continue; if (strlen(end) == 0) ptr = ep->d_name + strlen(ep->d_name); *ptr = '\0'; if (strlen(&ep->d_name[nbegin]) < n) { strcpy(middle,&ep->d_name[nbegin]); if (atoi(middle) > maxnum) maxnum = atoi(middle); } } closedir(dp); if (maxnum < 0) error->one("Found no restart file matching pattern"); } // create outfile with maxint substituted for "*" // use original infile, not pattern, since need to retain "%" in filename ptr = strchr(infile,'*'); *ptr = '\0'; sprintf(outfile,"%s%d%s",infile,maxnum,ptr+1); *ptr = '*'; // clean up delete [] dirname; delete [] filename; delete [] pattern; delete [] begin; delete [] middle; delete [] end; } /* ---------------------------------------------------------------------- read header of restart file ------------------------------------------------------------------------- */ void ReadRestart::header() { int px,py,pz; int xperiodic,yperiodic,zperiodic; int boundary[3][2]; // read flags and values until flag = -1 int flag = read_int(); while (flag >= 0) { // check restart file version, warn if different if (flag == VERSION) { char *version = read_char(); if (strcmp(version,universe->version) != 0 && me == 0) { error->warning("Restart file version does not match LAMMPS version"); if (screen) fprintf(screen," restart file = %s, LAMMPS = %s\n", version,universe->version); } delete [] version; // reset unit_style only if different // so that timestep,neighbor-skin are not changed } else if (flag == UNITS) { char *style = read_char(); if (strcmp(style,update->unit_style) != 0) update->set_units(style); delete [] style; } else if (flag == NTIMESTEP) { update->ntimestep = read_int(); // set dimension from restart file } else if (flag == DIMENSION) { int dimension = read_int(); domain->dimension = dimension; if (domain->dimension == 2 && domain->zperiodic == 0) error->all("Cannot run 2d simulation with nonperiodic Z dimension"); // read nprocs from restart file, warn if different } else if (flag == NPROCS) { nprocs_file = read_int(); if (nprocs_file != comm->nprocs && me == 0) error->warning("Restart file used different # of processors"); // don't set procgrid, warn if different } else if (flag == PROCGRID_0) { px = read_int(); } else if (flag == PROCGRID_1) { py = read_int(); } else if (flag == PROCGRID_2) { pz = read_int(); if (comm->user_procgrid[0] != 0 && (px != comm->user_procgrid[0] || py != comm->user_procgrid[1] || pz != comm->user_procgrid[2]) && me == 0) error->warning("Restart file used different 3d processor grid"); // don't set newton_pair, leave input script value unchanged // set newton_bond from restart file // warn if different and input script settings are not default } else if (flag == NEWTON_PAIR) { int newton_pair_file = read_int(); if (force->newton_pair != 1) { if (newton_pair_file != force->newton_pair && me == 0) error->warning("Restart file used different newton pair setting, " "using input script value"); } } else if (flag == NEWTON_BOND) { int newton_bond_file = read_int(); if (force->newton_bond != 1) { if (newton_bond_file != force->newton_bond && me == 0) error->warning("Restart file used different newton bond setting, " "using restart file value"); } force->newton_bond = newton_bond_file; if (force->newton_pair || force->newton_bond) force->newton = 1; else force->newton = 0; // set boundary settings from restart file // warn if different and input script settings are not default } else if (flag == XPERIODIC) { xperiodic = read_int(); } else if (flag == YPERIODIC) { yperiodic = read_int(); } else if (flag == ZPERIODIC) { zperiodic = read_int(); } else if (flag == BOUNDARY_00) { boundary[0][0] = read_int(); } else if (flag == BOUNDARY_01) { boundary[0][1] = read_int(); } else if (flag == BOUNDARY_10) { boundary[1][0] = read_int(); } else if (flag == BOUNDARY_11) { boundary[1][1] = read_int(); } else if (flag == BOUNDARY_20) { boundary[2][0] = read_int(); } else if (flag == BOUNDARY_21) { boundary[2][1] = read_int(); if (domain->boundary[0][0] || domain->boundary[0][1] || domain->boundary[1][0] || domain->boundary[1][1] || domain->boundary[2][0] || domain->boundary[2][1]) { if (boundary[0][0] != domain->boundary[0][0] || boundary[0][1] != domain->boundary[0][1] || boundary[1][0] != domain->boundary[1][0] || boundary[1][1] != domain->boundary[1][1] || boundary[2][0] != domain->boundary[2][0] || boundary[2][1] != domain->boundary[2][1]) { if (me == 0) error->warning("Restart file used different boundary settings, " "using restart file values"); } } domain->boundary[0][0] = boundary[0][0]; domain->boundary[0][1] = boundary[0][1]; domain->boundary[1][0] = boundary[1][0]; domain->boundary[1][1] = boundary[1][1]; domain->boundary[2][0] = boundary[2][0]; domain->boundary[2][1] = boundary[2][1]; domain->periodicity[0] = domain->xperiodic = xperiodic; domain->periodicity[1] = domain->yperiodic = yperiodic; domain->periodicity[2] = domain->zperiodic = zperiodic; domain->nonperiodic = 0; if (xperiodic == 0 || yperiodic == 0 || zperiodic == 0) { domain->nonperiodic = 1; if (boundary[0][0] >= 2 || boundary[0][1] >= 2 || boundary[1][0] >= 2 || boundary[1][1] >= 2 || boundary[2][0] >= 2 || boundary[2][1] >= 2) domain->nonperiodic = 2; } // create new AtomVec class // if style = hybrid, read additional sub-class arguments } else if (flag == ATOM_STYLE) { char *style = read_char(); int nwords = 0; char **words = NULL; if (strcmp(style,"hybrid") == 0) { nwords = read_int(); words = new char*[nwords]; for (int i = 0; i < nwords; i++) words[i] = read_char(); } atom->create_avec(style,nwords,words); for (int i = 0; i < nwords; i++) delete [] words[i]; delete [] words; delete [] style; } else if (flag == NATOMS) { atom->natoms = read_bigint(); } else if (flag == NTYPES) { atom->ntypes = read_int(); } else if (flag == NBONDS) { atom->nbonds = read_bigint(); } else if (flag == NBONDTYPES) { atom->nbondtypes = read_int(); } else if (flag == BOND_PER_ATOM) { atom->bond_per_atom = read_int(); } else if (flag == NANGLES) { atom->nangles = read_bigint(); } else if (flag == NANGLETYPES) { atom->nangletypes = read_int(); } else if (flag == ANGLE_PER_ATOM) { atom->angle_per_atom = read_int(); } else if (flag == NDIHEDRALS) { atom->ndihedrals = read_bigint(); } else if (flag == NDIHEDRALTYPES) { atom->ndihedraltypes = read_int(); } else if (flag == DIHEDRAL_PER_ATOM) { atom->dihedral_per_atom = read_int(); } else if (flag == NIMPROPERS) { atom->nimpropers = read_bigint(); } else if (flag == NIMPROPERTYPES) { atom->nimpropertypes = read_int(); } else if (flag == IMPROPER_PER_ATOM) { atom->improper_per_atom = read_int(); } else if (flag == BOXLO_0) { domain->boxlo[0] = read_double(); } else if (flag == BOXHI_0) { domain->boxhi[0] = read_double(); } else if (flag == BOXLO_1) { domain->boxlo[1] = read_double(); } else if (flag == BOXHI_1) { domain->boxhi[1] = read_double(); } else if (flag == BOXLO_2) { domain->boxlo[2] = read_double(); } else if (flag == BOXHI_2) { domain->boxhi[2] = read_double(); } else if (flag == SPECIAL_LJ_1) { force->special_lj[1] = read_double(); } else if (flag == SPECIAL_LJ_2) { force->special_lj[2] = read_double(); } else if (flag == SPECIAL_LJ_3) { force->special_lj[3] = read_double(); } else if (flag == SPECIAL_COUL_1) { force->special_coul[1] = read_double(); } else if (flag == SPECIAL_COUL_2) { force->special_coul[2] = read_double(); } else if (flag == SPECIAL_COUL_3) { force->special_coul[3] = read_double(); } else if (flag == XY) { domain->triclinic = 1; domain->xy = read_double(); } else if (flag == XZ) { domain->triclinic = 1; domain->xz = read_double(); } else if (flag == YZ) { domain->triclinic = 1; domain->yz = read_double(); } else error->all("Invalid flag in header section of restart file"); flag = read_int(); } } /* ---------------------------------------------------------------------- */ void ReadRestart::type_arrays() { int flag = read_int(); while (flag >= 0) { if (flag == MASS) { double *mass = new double[atom->ntypes+1]; if (me == 0) fread(&mass[1],sizeof(double),atom->ntypes,fp); MPI_Bcast(&mass[1],atom->ntypes,MPI_DOUBLE,0,world); atom->set_mass(mass); delete [] mass; } else if (flag == SHAPE) { double **shape = memory->create_2d_double_array(atom->ntypes+1,3,"restart:shape"); if (me == 0) fread(&shape[1][0],sizeof(double),atom->ntypes*3,fp); MPI_Bcast(&shape[1][0],atom->ntypes*3,MPI_DOUBLE,0,world); atom->set_shape(shape); memory->destroy_2d_double_array(shape); } else if (flag == DIPOLE) { double *dipole = new double[atom->ntypes+1]; if (me == 0) fread(&dipole[1],sizeof(double),atom->ntypes,fp); MPI_Bcast(&dipole[1],atom->ntypes,MPI_DOUBLE,0,world); atom->set_dipole(dipole); delete [] dipole; } else error->all("Invalid flag in type arrays section of restart file"); flag = read_int(); } } /* ---------------------------------------------------------------------- */ void ReadRestart::force_fields() { int n; char *style; int flag = read_int(); while (flag >= 0) { if (flag == PAIR) { if (me == 0) fread(&n,sizeof(int),1,fp); MPI_Bcast(&n,1,MPI_INT,0,world); style = new char[n]; if (me == 0) fread(style,sizeof(char),n,fp); MPI_Bcast(style,n,MPI_CHAR,0,world); force->create_pair(style); delete [] style; force->pair->read_restart(fp); } else if (flag == BOND) { if (me == 0) fread(&n,sizeof(int),1,fp); MPI_Bcast(&n,1,MPI_INT,0,world); style = new char[n]; if (me == 0) fread(style,sizeof(char),n,fp); MPI_Bcast(style,n,MPI_CHAR,0,world); force->create_bond(style); delete [] style; force->bond->read_restart(fp); } else if (flag == ANGLE) { if (me == 0) fread(&n,sizeof(int),1,fp); MPI_Bcast(&n,1,MPI_INT,0,world); style = new char[n]; if (me == 0) fread(style,sizeof(char),n,fp); MPI_Bcast(style,n,MPI_CHAR,0,world); force->create_angle(style); delete [] style; force->angle->read_restart(fp); } else if (flag == DIHEDRAL) { if (me == 0) fread(&n,sizeof(int),1,fp); MPI_Bcast(&n,1,MPI_INT,0,world); style = new char[n]; if (me == 0) fread(style,sizeof(char),n,fp); MPI_Bcast(style,n,MPI_CHAR,0,world); force->create_dihedral(style); delete [] style; force->dihedral->read_restart(fp); } else if (flag == IMPROPER) { if (me == 0) fread(&n,sizeof(int),1,fp); MPI_Bcast(&n,1,MPI_INT,0,world); style = new char[n]; if (me == 0) fread(style,sizeof(char),n,fp); MPI_Bcast(style,n,MPI_CHAR,0,world); force->create_improper(style); delete [] style; force->improper->read_restart(fp); } else error->all("Invalid flag in force field section of restart file"); flag = read_int(); } } /* ---------------------------------------------------------------------- read an int from restart file and bcast it ------------------------------------------------------------------------- */ int ReadRestart::read_int() { int value; if (me == 0) fread(&value,sizeof(int),1,fp); MPI_Bcast(&value,1,MPI_INT,0,world); return value; } /* ---------------------------------------------------------------------- read a double from restart file and bcast it ------------------------------------------------------------------------- */ double ReadRestart::read_double() { double value; if (me == 0) fread(&value,sizeof(double),1,fp); MPI_Bcast(&value,1,MPI_DOUBLE,0,world); return value; } /* ---------------------------------------------------------------------- read a char str from restart file and bcast it str is allocated here, ptr is returned, caller must deallocate ------------------------------------------------------------------------- */ char *ReadRestart::read_char() { int n; if (me == 0) fread(&n,sizeof(int),1,fp); MPI_Bcast(&n,1,MPI_INT,0,world); char *value = new char[n]; if (me == 0) fread(value,sizeof(char),n,fp); MPI_Bcast(value,n,MPI_CHAR,0,world); return value; } /* ---------------------------------------------------------------------- read a bigint from restart file and bcast it ------------------------------------------------------------------------- */ bigint ReadRestart::read_bigint() { bigint value; if (me == 0) fread(&value,sizeof(bigint),1,fp); - MPI_Bcast(&value,1,MPI_UNSIGNED_LONG,0,world); + MPI_Bcast(&value,1,MPI_UNSIGNED_LONG_LONG,0,world); return value; } diff --git a/src/replicate.cpp b/src/replicate.cpp index 9798b0a09..a4e02bd12 100644 --- a/src/replicate.cpp +++ b/src/replicate.cpp @@ -1,408 +1,408 @@ /* ---------------------------------------------------------------------- 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. ------------------------------------------------------------------------- */ #include "stdlib.h" #include "string.h" #include "replicate.h" #include "lmptype.h" #include "atom.h" #include "atom_vec.h" #include "atom_vec_hybrid.h" #include "force.h" #include "domain.h" #include "comm.h" #include "special.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; #define LB_FACTOR 1.1 #define EPSILON 1.0e-6 #define MIN(a,b) ((a) < (b) ? (a) : (b)) #define MAX(a,b) ((a) > (b) ? (a) : (b)) /* ---------------------------------------------------------------------- */ Replicate::Replicate(LAMMPS *lmp) : Pointers(lmp) {} /* ---------------------------------------------------------------------- */ void Replicate::command(int narg, char **arg) { int i,j,m,n; if (domain->box_exist == 0) error->all("Replicate command before simulation box is defined"); if (narg != 3) error->all("Illegal replicate command"); int me = comm->me; int nprocs = comm->nprocs; if (me == 0 && screen) fprintf(screen,"Replicating atoms ...\n"); // nrep = total # of replications int nx = atoi(arg[0]); int ny = atoi(arg[1]); int nz = atoi(arg[2]); int nrep = nx*ny*nz; // error and warning checks if (nx <= 0 || ny <= 0 || nz <= 0) error->all("Illegal replicate command"); if (domain->dimension == 2 && nz != 1) error->all("Cannot replicate 2d simulation in z dimension"); if ((nx > 1 && domain->xperiodic == 0) || (ny > 1 && domain->yperiodic == 0) || (nz > 1 && domain->zperiodic == 0)) error->warning("Replicating in a non-periodic dimension"); if (atom->nextra_grow || atom->nextra_restart || atom->nextra_store) error->all("Cannot replicate with fixes that store atom quantities"); // maxtag = largest atom tag across all existing atoms int maxtag = 0; for (i = 0; i < atom->nlocal; i++) maxtag = MAX(atom->tag[i],maxtag); int maxtag_all; MPI_Allreduce(&maxtag,&maxtag_all,1,MPI_INT,MPI_MAX,world); maxtag = maxtag_all; // maxmol = largest molecule tag across all existing atoms int maxmol = 0; if (atom->molecular) { for (i = 0; i < atom->nlocal; i++) maxmol = MAX(atom->molecule[i],maxmol); int maxmol_all; MPI_Allreduce(&maxmol,&maxmol_all,1,MPI_INT,MPI_MAX,world); maxmol = maxmol_all; } // unmap existing atoms via image flags for (i = 0; i < atom->nlocal; i++) domain->unmap(atom->x[i],atom->image[i]); // communication buffer for all my atom's info // max_size = largest buffer needed by any proc // must do before new Atom class created, // since size_restart() uses atom->nlocal int max_size; int send_size = atom->avec->size_restart(); MPI_Allreduce(&send_size,&max_size,1,MPI_INT,MPI_MAX,world); double *buf = (double *) memory->smalloc(max_size*sizeof(double),"replicate:buf"); // old = original atom class // atom = new replicated atom class // if old atom style was hybrid, pass sub-style names to create_avec Atom *old = atom; atom = new Atom(lmp); atom->settings(old); int nstyles = 0; char **keywords = NULL; if (strcmp(old->atom_style,"hybrid") == 0) { AtomVecHybrid *avec_hybrid = (AtomVecHybrid *) old->avec; nstyles = avec_hybrid->nstyles; keywords = avec_hybrid->keywords; } atom->create_avec(old->atom_style,nstyles,keywords); // check that new problem size will not be too large // if N > 2^31, turn off tags for existing and new atoms // if molecular, N/Nbonds/etc cannot be > 2^31 else tags/counts invalid double rep = nrep; if (rep*old->natoms > MAXINT32) atom->tag_enable = 0; if (atom->tag_enable == 0) for (int i = 0; i < atom->nlocal; i++) atom->tag[i] = 0; if (atom->molecular) { if (rep*old->natoms > MAXINT32 || rep*old->nbonds > MAXINT32 || rep*old->nangles > MAXINT32 || rep*old->ndihedrals > MAXINT32 || rep*old->nimpropers > MAXINT32) error->all("Too big a problem to replicate with molecular atom style"); } // assign atom and topology counts in new class from old one atom->natoms = old->natoms * nrep; atom->nbonds = old->nbonds * nrep; atom->nangles = old->nangles * nrep; atom->ndihedrals = old->ndihedrals * nrep; atom->nimpropers = old->nimpropers * nrep; atom->ntypes = old->ntypes; atom->nbondtypes = old->nbondtypes; atom->nangletypes = old->nangletypes; atom->ndihedraltypes = old->ndihedraltypes; atom->nimpropertypes = old->nimpropertypes; atom->bond_per_atom = old->bond_per_atom; atom->angle_per_atom = old->angle_per_atom; atom->dihedral_per_atom = old->dihedral_per_atom; atom->improper_per_atom = old->improper_per_atom; // store old simulation box int triclinic = domain->triclinic; double old_xprd = domain->xprd; double old_yprd = domain->yprd; double old_zprd = domain->zprd; double old_xy = domain->xy; double old_xz = domain->xz; double old_yz = domain->yz; // setup new simulation box domain->boxhi[0] = domain->boxlo[0] + nx*old_xprd; domain->boxhi[1] = domain->boxlo[1] + ny*old_yprd; domain->boxhi[2] = domain->boxlo[2] + nz*old_zprd; if (triclinic) { domain->xy *= ny; domain->xz *= nz; domain->yz *= nz; } // new problem setup using new box boundaries if (nprocs == 1) n = static_cast<int> (atom->natoms); else n = static_cast<int> (LB_FACTOR * atom->natoms / nprocs); atom->allocate_type_arrays(); atom->avec->grow(n); n = atom->nmax; domain->print_box(" "); domain->set_initial_box(); domain->set_global_box(); comm->set_procs(); domain->set_local_box(); // copy type arrays to new atom class if (atom->mass) { for (int itype = 1; itype <= atom->ntypes; itype++) { atom->mass_setflag[itype] = old->mass_setflag[itype]; if (atom->mass_setflag[itype]) atom->mass[itype] = old->mass[itype]; } } if (atom->shape) { for (int itype = 1; itype <= atom->ntypes; itype++) { atom->shape_setflag[itype] = old->shape_setflag[itype]; if (atom->shape_setflag[itype]) { atom->shape[itype][0] = old->shape[itype][0]; atom->shape[itype][1] = old->shape[itype][1]; atom->shape[itype][2] = old->shape[itype][2]; } } } if (atom->dipole) { for (int itype = 1; itype <= atom->ntypes; itype++) { atom->dipole_setflag[itype] = old->dipole_setflag[itype]; if (atom->dipole_setflag[itype]) atom->dipole[itype] = old->dipole[itype]; } } // set bounds for my proc // if periodic and I am lo/hi proc, adjust bounds by EPSILON // insures all replicated atoms will be owned even with round-off double sublo[3],subhi[3]; if (triclinic == 0) { sublo[0] = domain->sublo[0]; subhi[0] = domain->subhi[0]; sublo[1] = domain->sublo[1]; subhi[1] = domain->subhi[1]; sublo[2] = domain->sublo[2]; subhi[2] = domain->subhi[2]; } else { sublo[0] = domain->sublo_lamda[0]; subhi[0] = domain->subhi_lamda[0]; sublo[1] = domain->sublo_lamda[1]; subhi[1] = domain->subhi_lamda[1]; sublo[2] = domain->sublo_lamda[2]; subhi[2] = domain->subhi_lamda[2]; } if (domain->xperiodic) { if (comm->myloc[0] == 0) sublo[0] -= EPSILON; if (comm->myloc[0] == comm->procgrid[0]-1) subhi[0] += EPSILON; } if (domain->yperiodic) { if (comm->myloc[1] == 0) sublo[1] -= EPSILON; if (comm->myloc[1] == comm->procgrid[1]-1) subhi[1] += EPSILON; } if (domain->zperiodic) { if (comm->myloc[2] == 0) sublo[2] -= EPSILON; if (comm->myloc[2] == comm->procgrid[2]-1) subhi[2] += EPSILON; } // loop over all procs // if this iteration of loop is me: // pack my unmapped atom data into buf // bcast it to all other procs // performs 3d replicate loop with while loop over atoms in buf // x = new replicated position, remapped into simulation box // unpack atom into new atom class from buf if I own it // adjust tag, mol #, coord, topology info as needed AtomVec *old_avec = old->avec; AtomVec *avec = atom->avec; int ix,iy,iz,image,atom_offset,mol_offset; double x[3],lamda[3]; double *coord; int tag_enable = atom->tag_enable; for (int iproc = 0; iproc < nprocs; iproc++) { if (me == iproc) { n = 0; for (i = 0; i < old->nlocal; i++) n += old_avec->pack_restart(i,&buf[n]); } MPI_Bcast(&n,1,MPI_INT,iproc,world); MPI_Bcast(buf,n,MPI_DOUBLE,iproc,world); for (ix = 0; ix < nx; ix++) { for (iy = 0; iy < ny; iy++) { for (iz = 0; iz < nz; iz++) { // while loop over one proc's atom list m = 0; while (m < n) { image = (512 << 20) | (512 << 10) | 512; if (triclinic == 0) { x[0] = buf[m+1] + ix*old_xprd; x[1] = buf[m+2] + iy*old_yprd; x[2] = buf[m+3] + iz*old_zprd; } else { x[0] = buf[m+1] + ix*old_xprd + iy*old_xy + iz*old_xz; x[1] = buf[m+2] + iy*old_yprd + iz*old_yz; x[2] = buf[m+3] + iz*old_zprd; } domain->remap(x,image); if (triclinic) { domain->x2lamda(x,lamda); coord = lamda; } else coord = x; if (coord[0] >= sublo[0] && coord[0] < subhi[0] && coord[1] >= sublo[1] && coord[1] < subhi[1] && coord[2] >= sublo[2] && coord[2] < subhi[2]) { m += avec->unpack_restart(&buf[m]); i = atom->nlocal - 1; if (tag_enable) atom_offset = iz*ny*nx*maxtag + iy*nx*maxtag + ix*maxtag; else atom_offset = 0; mol_offset = iz*ny*nx*maxmol + iy*nx*maxmol + ix*maxmol; atom->x[i][0] = x[0]; atom->x[i][1] = x[1]; atom->x[i][2] = x[2]; atom->tag[i] += atom_offset; atom->image[i] = image; if (atom->molecular) { if (atom->molecule[i] > 0) atom->molecule[i] += mol_offset; if (atom->avec->bonds_allow) for (j = 0; j < atom->num_bond[i]; j++) atom->bond_atom[i][j] += atom_offset; if (atom->avec->angles_allow) for (j = 0; j < atom->num_angle[i]; j++) { atom->angle_atom1[i][j] += atom_offset; atom->angle_atom2[i][j] += atom_offset; atom->angle_atom3[i][j] += atom_offset; } if (atom->avec->dihedrals_allow) for (j = 0; j < atom->num_dihedral[i]; j++) { atom->dihedral_atom1[i][j] += atom_offset; atom->dihedral_atom2[i][j] += atom_offset; atom->dihedral_atom3[i][j] += atom_offset; atom->dihedral_atom4[i][j] += atom_offset; } if (atom->avec->impropers_allow) for (j = 0; j < atom->num_improper[i]; j++) { atom->improper_atom1[i][j] += atom_offset; atom->improper_atom2[i][j] += atom_offset; atom->improper_atom3[i][j] += atom_offset; atom->improper_atom4[i][j] += atom_offset; } } } else m += static_cast<int> (buf[m]); } } } } } // end of proc loop // free communication buffer and old atom class memory->sfree(buf); delete old; // check that all atoms were assigned to procs bigint natoms; bigint nblocal = atom->nlocal; - MPI_Allreduce(&nblocal,&natoms,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&nblocal,&natoms,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); if (me == 0) { if (screen) fprintf(screen," %lu atoms\n",natoms); if (logfile) fprintf(logfile," %lu atoms\n",natoms); } if (natoms != atom->natoms) error->all("Replicate did not assign all atoms correctly"); if (me == 0) { if (atom->nbonds) { if (screen) fprintf(screen," %lu bonds\n",atom->nbonds); if (logfile) fprintf(logfile," %lu bonds\n",atom->nbonds); } if (atom->nangles) { if (screen) fprintf(screen," %lu angles\n",atom->nangles); if (logfile) fprintf(logfile," %lu angles\n",atom->nangles); } if (atom->ndihedrals) { if (screen) fprintf(screen," %lu dihedrals\n",atom->ndihedrals); if (logfile) fprintf(logfile," %lu dihedrals\n",atom->ndihedrals); } if (atom->nimpropers) { if (screen) fprintf(screen," %lu impropers\n",atom->nimpropers); if (logfile) fprintf(logfile," %lu impropers\n",atom->nimpropers); } } // create global mapping and bond topology now that system is defined if (atom->map_style) { atom->nghost = 0; atom->map_init(); atom->map_set(); } if (atom->molecular) { Special special(lmp); special.build(); } } diff --git a/src/thermo.cpp b/src/thermo.cpp index 60997baf2..042a28fce 100644 --- a/src/thermo.cpp +++ b/src/thermo.cpp @@ -1,1807 +1,1807 @@ /* ---------------------------------------------------------------------- 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. ------------------------------------------------------------------------- */ #include "mpi.h" #include "math.h" #include "stdlib.h" #include "string.h" #include "thermo.h" #include "atom.h" #include "update.h" #include "comm.h" #include "domain.h" #include "lattice.h" #include "modify.h" #include "fix.h" #include "compute.h" #include "input.h" #include "variable.h" #include "force.h" #include "pair.h" #include "bond.h" #include "angle.h" #include "dihedral.h" #include "improper.h" #include "kspace.h" #include "output.h" #include "timer.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; // customize a new keyword by adding to this list: // step, elapsed, elaplong, dt, cpu, tpcpu, spcpu // atoms, temp, press, pe, ke, etotal, enthalpy // evdwl, ecoul, epair, ebond, eangle, edihed, eimp, emol, elong, etail // vol, lx, ly, lz, xlo, xhi, ylo, yhi, zlo, zhi, xy, xz, yz, xlat, ylat, zlat // pxx, pyy, pzz, pxy, pxz, pyz // fmax, fnorm // customize a new thermo style by adding a DEFINE to this list #define ONE "step temp epair emol etotal press" #define MULTI "etotal ke temp pe ebond eangle edihed eimp evdwl ecoul elong press" enum{IGNORE,WARN,ERROR}; // same as write_restart.cpp enum{ONELINE,MULTILINE}; enum{INT,FLOAT,BIGINT}; enum{SCALAR,VECTOR,ARRAY}; #define INVOKED_SCALAR 1 #define INVOKED_VECTOR 2 #define INVOKED_ARRAY 4 #define MAXLINE 8192 // make this 4x longer than Input::MAXLINE #define DELTA 8 #define MIN(A,B) ((A) < (B)) ? (A) : (B) #define MAX(A,B) ((A) > (B)) ? (A) : (B) /* ---------------------------------------------------------------------- */ Thermo::Thermo(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) { MPI_Comm_rank(world,&me); int n = strlen(arg[0]) + 1; style = new char[n]; strcpy(style,arg[0]); // set thermo_modify defaults modified = 0; normuserflag = 0; lineflag = ONELINE; lostflag = ERROR; lostbefore = 0; flushflag = 0; // set style and corresponding lineflag // custom style builds its own line of keywords // customize a new thermo style by adding to if statement line = new char[MAXLINE]; if (strcmp(style,"one") == 0) { strcpy(line,ONE); } else if (strcmp(style,"multi") == 0) { strcpy(line,MULTI); lineflag = MULTILINE; } else if (strcmp(style,"custom") == 0) { if (narg == 1) error->all("Illegal thermo style custom command"); line[0] = '\0'; for (int iarg = 1; iarg < narg; iarg++) { strcat(line,arg[iarg]); strcat(line," "); } line[strlen(line)-1] = '\0'; } else error->all("Illegal thermo style command"); // ptrs, flags, IDs for compute objects thermo may use or create temperature = NULL; pressure = NULL; pe = NULL; index_temp = index_press_scalar = index_press_vector = index_pe = -1; id_temp = (char *) "thermo_temp"; id_press = (char *) "thermo_press"; id_pe = (char *) "thermo_pe"; // count fields in line // allocate per-field memory // process line of keywords nfield_initial = atom->count_words(line); allocate(); parse_fields(line); // format strings format_multi = (char *) "---------------- Step %8d ----- " "CPU = %11.4f (sec) ----------------"; format_float_one_def = (char *) "%12.8g"; format_float_multi_def = (char *) "%14.4f"; format_int_one_def = (char *) "%8d"; format_int_multi_def = (char *) "%14d"; format_bigint_one_def = (char *) "%8lu"; format_bigint_multi_def = (char *) "%14lu"; format_float_user = NULL; format_int_user = NULL; format_bigint_user = NULL; } /* ---------------------------------------------------------------------- */ Thermo::~Thermo() { delete [] style; delete [] line; deallocate(); // format strings delete [] format_float_user; delete [] format_int_user; delete [] format_bigint_user; } /* ---------------------------------------------------------------------- */ void Thermo::init() { int i,n; // set normvalue to default setting unless user has specified it if (normuserflag) normvalue = normuser; else if (strcmp(update->unit_style,"lj") == 0) normvalue = 1; else normvalue = 0; // add Volume field if volume changes and not style = custom // this check must come after domain init, so box_change is set nfield = nfield_initial; if (domain->box_change && strcmp(style,"custom") != 0) addfield("Volume",&Thermo::compute_vol,FLOAT); // set format string for each field // include keyword if lineflag = MULTILINE // add '/n' every 3 values if lineflag = MULTILINE // add trailing '/n' to last value char *ptr; for (i = 0; i < nfield; i++) { format[i][0] = '\0'; if (lineflag == MULTILINE && i % 3 == 0) strcat(format[i],"\n"); if (format_user[i]) ptr = format_user[i]; else if (vtype[i] == FLOAT) { if (format_float_user) ptr = format_float_user; else if (lineflag == ONELINE) ptr = format_float_one_def; else if (lineflag == MULTILINE) ptr = format_float_multi_def; } else if (vtype[i] == INT) { if (format_int_user) ptr = format_int_user; else if (lineflag == ONELINE) ptr = format_int_one_def; else if (lineflag == MULTILINE) ptr = format_int_multi_def; } else if (vtype[i] == BIGINT) { if (format_bigint_user) ptr = format_bigint_user; else if (lineflag == ONELINE) ptr = format_bigint_one_def; else if (lineflag == MULTILINE) ptr = format_bigint_multi_def; } n = strlen(format[i]); if (lineflag == ONELINE) sprintf(&format[i][n],"%s ",ptr); else sprintf(&format[i][n],"%-8s = %s ",keyword[i],ptr); if (i == nfield-1) strcat(format[i],"\n"); } // find current ptr for each Compute ID int icompute; for (i = 0; i < ncompute; i++) { icompute = modify->find_compute(id_compute[i]); if (icompute < 0) error->all("Could not find thermo compute ID"); computes[i] = modify->compute[icompute]; } // find current ptr for each Fix ID // check that fix frequency is acceptable with thermo output frequency int ifix; for (i = 0; i < nfix; i++) { ifix = modify->find_fix(id_fix[i]); if (ifix < 0) error->all("Could not find thermo fix ID"); fixes[i] = modify->fix[ifix]; if (output->thermo_every % fixes[i]->global_freq) error->all("Thermo and fix not computed at compatible times"); } // find current ptr for each Variable ID int ivariable; for (i = 0; i < nvariable; i++) { ivariable = input->variable->find(id_variable[i]); if (ivariable < 0) error->all("Could not find thermo custom variable name"); variables[i] = ivariable; } // set ptrs to keyword-specific Compute objects if (index_temp >= 0) temperature = computes[index_temp]; if (index_press_scalar >= 0) pressure = computes[index_press_scalar]; if (index_press_vector >= 0) pressure = computes[index_press_vector]; if (index_pe >= 0) pe = computes[index_pe]; } /* ---------------------------------------------------------------------- */ void Thermo::header() { if (lineflag == MULTILINE) return; int loc = 0; for (int i = 0; i < nfield; i++) loc += sprintf(&line[loc],"%s ",keyword[i]); sprintf(&line[loc],"\n"); if (me == 0) { if (screen) fprintf(screen,line); if (logfile) fprintf(logfile,line); } } /* ---------------------------------------------------------------------- */ void Thermo::compute(int flag) { int i; firststep = flag; int ntimestep = update->ntimestep; // check for lost atoms // turn off normflag if natoms = 0 to avoid divide by 0 natoms = lost_check(); if (natoms == 0) normflag = 0; else normflag = normvalue; // invoke Compute methods needed for thermo keywords // which = 0 is global scalar, which = 1 is global vector for (i = 0; i < ncompute; i++) if (compute_which[i] == SCALAR) { if (!(computes[i]->invoked_flag & INVOKED_SCALAR)) { computes[i]->compute_scalar(); computes[i]->invoked_flag |= INVOKED_SCALAR; } } else if (compute_which[i] == VECTOR) { if (!(computes[i]->invoked_flag & INVOKED_VECTOR)) { computes[i]->compute_vector(); computes[i]->invoked_flag |= INVOKED_VECTOR; } } else if (compute_which[i] == ARRAY) { if (!(computes[i]->invoked_flag & INVOKED_ARRAY)) { computes[i]->compute_array(); computes[i]->invoked_flag |= INVOKED_ARRAY; } } // if lineflag = MULTILINE, prepend step/cpu header line int loc = 0; if (lineflag == MULTILINE) { double cpu; if (flag) cpu = timer->elapsed(TIME_LOOP); else cpu = 0.0; loc = sprintf(&line[loc],format_multi,ntimestep,cpu); } // add each thermo value to line with its specific format for (ifield = 0; ifield < nfield; ifield++) { (this->*vfunc[ifield])(); if (vtype[ifield] == FLOAT) loc += sprintf(&line[loc],format[ifield],dvalue); else if (vtype[ifield] == INT) loc += sprintf(&line[loc],format[ifield],ivalue); else if (vtype[ifield] == BIGINT) { loc += sprintf(&line[loc],format[ifield],bivalue); } } // kludge for RedStorm timing issue // if (ntimestep == 100) return; // print line to screen and logfile if (me == 0) { if (screen) fprintf(screen,line); if (logfile) { fprintf(logfile,line); if (flushflag) fflush(logfile); } } } /* ---------------------------------------------------------------------- check for lost atoms, return current number of atoms ------------------------------------------------------------------------- */ bigint Thermo::lost_check() { // ntotal = current # of atoms bigint ntotal; bigint nblocal = atom->nlocal; - MPI_Allreduce(&nblocal,&ntotal,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&nblocal,&ntotal,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); if (ntotal == atom->natoms) return ntotal; // if not checking or already warned, just return if (lostflag == IGNORE) return ntotal; if (lostflag == WARN && lostbefore == 1) return ntotal; // error message if (lostflag == ERROR) { char str[128]; sprintf(str,"Lost atoms: original %lu current %lu",atom->natoms,ntotal); error->all(str); } // warning message char str[128]; sprintf(str,"Lost atoms: original %lu current %lu",atom->natoms,ntotal); if (me == 0) error->warning(str,0); lostbefore = 1; return ntotal; } /* ---------------------------------------------------------------------- modify thermo parameters ------------------------------------------------------------------------- */ void Thermo::modify_params(int narg, char **arg) { if (narg == 0) error->all("Illegal thermo_modify command"); modified = 1; int iarg = 0; while (iarg < narg) { if (strcmp(arg[iarg],"every") == 0) { if (iarg+2 > narg) error->all("Illegal thermo_modify command"); if (strstr(arg[iarg+1],"v_") == arg[iarg+1]) { delete [] output->var_thermo; int n = strlen(&arg[iarg+1][2]) + 1; output->var_thermo = new char[n]; strcpy(output->var_thermo,&arg[iarg+1][2]); } else error->all("Illegal thermo_modify command"); output->thermo_every = 0; iarg += 2; } else if (strcmp(arg[iarg],"temp") == 0) { if (iarg+2 > narg) error->all("Illegal thermo_modify command"); if (index_temp < 0) error->all("Thermo style does not use temp"); delete [] id_compute[index_temp]; int n = strlen(arg[iarg+1]) + 1; id_compute[index_temp] = new char[n]; strcpy(id_compute[index_temp],arg[iarg+1]); int icompute = modify->find_compute(arg[iarg+1]); if (icompute < 0) error->all("Could not find thermo_modify temperature ID"); temperature = modify->compute[icompute]; if (temperature->tempflag == 0) error->all("Thermo_modify temperature ID does not " "compute temperature"); if (temperature->igroup != 0 && comm->me == 0) error->warning("Temperature for thermo pressure is not for group all"); // reset id_temp of pressure to new temperature ID // either pressure currently being used by thermo or "thermo_press" if (index_press_scalar >= 0) { icompute = modify->find_compute(id_compute[index_press_scalar]); if (icompute < 0) error->all("Pressure ID for thermo does not exist"); } else if (index_press_vector >= 0) { icompute = modify->find_compute(id_compute[index_press_vector]); if (icompute < 0) error->all("Pressure ID for thermo does not exist"); } else icompute = modify->find_compute((char *) "thermo_press"); modify->compute[icompute]->reset_extra_compute_fix(arg[iarg+1]); iarg += 2; } else if (strcmp(arg[iarg],"press") == 0) { if (iarg+2 > narg) error->all("Illegal thermo_modify command"); if (index_press_scalar < 0 && index_press_vector < 0) error->all("Thermo style does not use press"); if (index_press_scalar >= 0) { delete [] id_compute[index_press_scalar]; int n = strlen(arg[iarg+1]) + 1; id_compute[index_press_scalar] = new char[n]; strcpy(id_compute[index_press_scalar],arg[iarg+1]); } if (index_press_vector >= 0) { delete [] id_compute[index_press_vector]; int n = strlen(arg[iarg+1]) + 1; id_compute[index_press_vector] = new char[n]; strcpy(id_compute[index_press_vector],arg[iarg+1]); } int icompute = modify->find_compute(arg[iarg+1]); if (icompute < 0) error->all("Could not find thermo_modify pressure ID"); pressure = modify->compute[icompute]; if (pressure->pressflag == 0) error->all("Thermo_modify pressure ID does not compute pressure"); iarg += 2; } else if (strcmp(arg[iarg],"lost") == 0) { if (iarg+2 > narg) error->all("Illegal thermo_modify command"); if (strcmp(arg[iarg+1],"ignore") == 0) lostflag = IGNORE; else if (strcmp(arg[iarg+1],"warn") == 0) lostflag = WARN; else if (strcmp(arg[iarg+1],"error") == 0) lostflag = ERROR; else error->all("Illegal thermo_modify command"); iarg += 2; } else if (strcmp(arg[iarg],"norm") == 0) { if (iarg+2 > narg) error->all("Illegal thermo_modify command"); normuserflag = 1; if (strcmp(arg[iarg+1],"no") == 0) normuser = 0; else if (strcmp(arg[iarg+1],"yes") == 0) normuser = 1; else error->all("Illegal thermo_modify command"); iarg += 2; } else if (strcmp(arg[iarg],"flush") == 0) { if (iarg+2 > narg) error->all("Illegal thermo_modify command"); if (strcmp(arg[iarg+1],"no") == 0) flushflag = 0; else if (strcmp(arg[iarg+1],"yes") == 0) flushflag = 1; else error->all("Illegal thermo_modify command"); iarg += 2; } else if (strcmp(arg[iarg],"line") == 0) { if (iarg+2 > narg) error->all("Illegal thermo_modify command"); if (strcmp(arg[iarg+1],"one") == 0) lineflag = ONELINE; else if (strcmp(arg[iarg+1],"multi") == 0) lineflag = MULTILINE; else error->all("Illegal thermo_modify command"); iarg += 2; } else if (strcmp(arg[iarg],"format") == 0) { if (iarg+3 > narg) error->all("Illegal thermo_modify command"); if (strcmp(arg[iarg+1],"int") == 0) { if (format_int_user) delete [] format_int_user; int n = strlen(arg[iarg+2]) + 1; format_int_user = new char[n]; strcpy(format_int_user,arg[iarg+2]); if (format_bigint_user) delete [] format_bigint_user; n = strlen(format_int_user) + 2; format_bigint_user = new char[n]; char *ptr = strchr(format_int_user,'d'); if (ptr == NULL) error->all("Thermo_modify int format does not contain d character"); *ptr = '\0'; sprintf(format_bigint_user,"%s%s%s",format_int_user,"lu",ptr+1); *ptr = 'd'; } else if (strcmp(arg[iarg+1],"float") == 0) { if (format_float_user) delete [] format_float_user; int n = strlen(arg[iarg+2]) + 1; format_float_user = new char[n]; strcpy(format_float_user,arg[iarg+2]); } else { int i = atoi(arg[iarg+1]) - 1; if (i < 0 || i >= nfield_initial) error->all("Illegal thermo_modify command"); if (format_user[i]) delete [] format_user[i]; int n = strlen(arg[iarg+2]) + 1; format_user[i] = new char[n]; strcpy(format_user[i],arg[iarg+2]); } iarg += 3; } else error->all("Illegal thermo_modify command"); } } /* ---------------------------------------------------------------------- allocate all per-field memory ------------------------------------------------------------------------- */ void Thermo::allocate() { // n = specified fields + Volume field (added at run time) int n = nfield_initial + 1; keyword = new char*[n]; for (int i = 0; i < n; i++) keyword[i] = new char[32]; vfunc = new FnPtr[n]; vtype = new int[n]; format = new char*[n]; for (int i = 0; i < n; i++) format[i] = new char[32]; format_user = new char*[n]; for (int i = 0; i < n; i++) format_user[i] = NULL; field2index = new int[n]; argindex1 = new int[n]; argindex2 = new int[n]; // factor of 3 is max number of computes a single field can add ncompute = 0; id_compute = new char*[3*n]; compute_which = new int[3*n]; computes = new Compute*[3*n]; nfix = 0; id_fix = new char*[n]; fixes = new Fix*[n]; nvariable = 0; id_variable = new char*[n]; variables = new int[n]; } /* ---------------------------------------------------------------------- deallocate all per-field memory ------------------------------------------------------------------------- */ void Thermo::deallocate() { int n = nfield_initial + 1; for (int i = 0; i < n; i++) delete [] keyword[i]; delete [] keyword; delete [] vfunc; delete [] vtype; for (int i = 0; i < n; i++) delete [] format[i]; delete [] format; for (int i = 0; i < n; i++) delete [] format_user[i]; delete [] format_user; delete [] field2index; delete [] argindex1; delete [] argindex2; for (int i = 0; i < ncompute; i++) delete [] id_compute[i]; delete [] id_compute; delete [] compute_which; delete [] computes; for (int i = 0; i < nfix; i++) delete [] id_fix[i]; delete [] id_fix; delete [] fixes; for (int i = 0; i < nvariable; i++) delete [] id_variable[i]; delete [] id_variable; delete [] variables; } /* ---------------------------------------------------------------------- parse list of thermo keywords from str set compute flags (temp, press, pe, etc) ------------------------------------------------------------------------- */ void Thermo::parse_fields(char *str) { nfield = 0; // customize a new keyword by adding to if statement char *word = strtok(str," \0"); while (word) { if (strcmp(word,"step") == 0) { addfield("Step",&Thermo::compute_step,INT); } else if (strcmp(word,"elapsed") == 0) { addfield("Elapsed",&Thermo::compute_elapsed,INT); } else if (strcmp(word,"elaplong") == 0) { addfield("Elaplong",&Thermo::compute_elapsed_long,INT); } else if (strcmp(word,"dt") == 0) { addfield("Dt",&Thermo::compute_dt,FLOAT); } else if (strcmp(word,"cpu") == 0) { addfield("CPU",&Thermo::compute_cpu,FLOAT); } else if (strcmp(word,"tpcpu") == 0) { addfield("T/CPU",&Thermo::compute_tpcpu,FLOAT); } else if (strcmp(word,"spcpu") == 0) { addfield("S/CPU",&Thermo::compute_spcpu,FLOAT); } else if (strcmp(word,"atoms") == 0) { addfield("Atoms",&Thermo::compute_atoms,BIGINT); } else if (strcmp(word,"temp") == 0) { addfield("Temp",&Thermo::compute_temp,FLOAT); index_temp = add_compute(id_temp,SCALAR); } else if (strcmp(word,"press") == 0) { addfield("Press",&Thermo::compute_press,FLOAT); index_press_scalar = add_compute(id_press,SCALAR); } else if (strcmp(word,"pe") == 0) { addfield("PotEng",&Thermo::compute_pe,FLOAT); index_pe = add_compute(id_pe,SCALAR); } else if (strcmp(word,"ke") == 0) { addfield("KinEng",&Thermo::compute_ke,FLOAT); index_temp = add_compute(id_temp,SCALAR); } else if (strcmp(word,"etotal") == 0) { addfield("TotEng",&Thermo::compute_etotal,FLOAT); index_temp = add_compute(id_temp,SCALAR); index_pe = add_compute(id_pe,SCALAR); } else if (strcmp(word,"enthalpy") == 0) { addfield("Enthalpy",&Thermo::compute_enthalpy,FLOAT); index_temp = add_compute(id_temp,SCALAR); index_press_scalar = add_compute(id_press,SCALAR); index_pe = add_compute(id_pe,SCALAR); } else if (strcmp(word,"evdwl") == 0) { addfield("E_vdwl",&Thermo::compute_evdwl,FLOAT); index_pe = add_compute(id_pe,SCALAR); } else if (strcmp(word,"ecoul") == 0) { addfield("E_coul",&Thermo::compute_ecoul,FLOAT); index_pe = add_compute(id_pe,SCALAR); } else if (strcmp(word,"epair") == 0) { addfield("E_pair",&Thermo::compute_epair,FLOAT); index_pe = add_compute(id_pe,SCALAR); } else if (strcmp(word,"ebond") == 0) { addfield("E_bond",&Thermo::compute_ebond,FLOAT); index_pe = add_compute(id_pe,SCALAR); } else if (strcmp(word,"eangle") == 0) { addfield("E_angle",&Thermo::compute_eangle,FLOAT); index_pe = add_compute(id_pe,SCALAR); } else if (strcmp(word,"edihed") == 0) { addfield("E_dihed",&Thermo::compute_edihed,FLOAT); index_pe = add_compute(id_pe,SCALAR); } else if (strcmp(word,"eimp") == 0) { addfield("E_impro",&Thermo::compute_eimp,FLOAT); index_pe = add_compute(id_pe,SCALAR); } else if (strcmp(word,"emol") == 0) { addfield("E_mol",&Thermo::compute_emol,FLOAT); index_pe = add_compute(id_pe,SCALAR); } else if (strcmp(word,"elong") == 0) { addfield("E_long",&Thermo::compute_elong,FLOAT); index_pe = add_compute(id_pe,SCALAR); } else if (strcmp(word,"etail") == 0) { addfield("E_tail",&Thermo::compute_etail,FLOAT); index_pe = add_compute(id_pe,SCALAR); } else if (strcmp(word,"vol") == 0) { addfield("Volume",&Thermo::compute_vol,FLOAT); } else if (strcmp(word,"lx") == 0) { addfield("Lx",&Thermo::compute_lx,FLOAT); } else if (strcmp(word,"ly") == 0) { addfield("Ly",&Thermo::compute_ly,FLOAT); } else if (strcmp(word,"lz") == 0) { addfield("Lz",&Thermo::compute_lz,FLOAT); } else if (strcmp(word,"xlo") == 0) { addfield("Xlo",&Thermo::compute_xlo,FLOAT); } else if (strcmp(word,"xhi") == 0) { addfield("Xhi",&Thermo::compute_xhi,FLOAT); } else if (strcmp(word,"ylo") == 0) { addfield("Ylo",&Thermo::compute_ylo,FLOAT); } else if (strcmp(word,"yhi") == 0) { addfield("Yhi",&Thermo::compute_yhi,FLOAT); } else if (strcmp(word,"zlo") == 0) { addfield("Zlo",&Thermo::compute_zlo,FLOAT); } else if (strcmp(word,"zhi") == 0) { addfield("Zhi",&Thermo::compute_zhi,FLOAT); } else if (strcmp(word,"xy") == 0) { addfield("Xy",&Thermo::compute_xy,FLOAT); } else if (strcmp(word,"xz") == 0) { addfield("Xz",&Thermo::compute_xz,FLOAT); } else if (strcmp(word,"yz") == 0) { addfield("Yz",&Thermo::compute_yz,FLOAT); } else if (strcmp(word,"xlat") == 0) { if (domain->lattice == NULL) error->all("Thermo keyword requires lattice be defined"); addfield("Xlat",&Thermo::compute_xlat,FLOAT); } else if (strcmp(word,"ylat") == 0) { if (domain->lattice == NULL) error->all("Thermo keyword requires lattice be defined"); addfield("Ylat",&Thermo::compute_ylat,FLOAT); } else if (strcmp(word,"zlat") == 0) { if (domain->lattice == NULL) error->all("Thermo keyword requires lattice be defined"); addfield("Zlat",&Thermo::compute_zlat,FLOAT); } else if (strcmp(word,"pxx") == 0) { addfield("Pxx",&Thermo::compute_pxx,FLOAT); index_press_vector = add_compute(id_press,VECTOR); } else if (strcmp(word,"pyy") == 0) { addfield("Pyy",&Thermo::compute_pyy,FLOAT); index_press_vector = add_compute(id_press,VECTOR); } else if (strcmp(word,"pzz") == 0) { addfield("Pzz",&Thermo::compute_pzz,FLOAT); index_press_vector = add_compute(id_press,VECTOR); } else if (strcmp(word,"pxy") == 0) { addfield("Pxy",&Thermo::compute_pxy,FLOAT); index_press_vector = add_compute(id_press,VECTOR); } else if (strcmp(word,"pxz") == 0) { addfield("Pxz",&Thermo::compute_pxz,FLOAT); index_press_vector = add_compute(id_press,VECTOR); } else if (strcmp(word,"pyz") == 0) { addfield("Pyz",&Thermo::compute_pyz,FLOAT); index_press_vector = add_compute(id_press,VECTOR); } else if (strcmp(word,"fmax") == 0) { addfield("Fmax",&Thermo::compute_fmax,FLOAT); } else if (strcmp(word,"fnorm") == 0) { addfield("Fnorm",&Thermo::compute_fnorm,FLOAT); // compute value = c_ID, fix value = f_ID, variable value = v_ID // count trailing [] and store int arguments // copy = at most 8 chars of ID to pass to addfield } else if ((strncmp(word,"c_",2) == 0) || (strncmp(word,"f_",2) == 0) || (strncmp(word,"v_",2) == 0)) { int n = strlen(word); char *id = new char[n]; strcpy(id,&word[2]); char copy[9]; strncpy(copy,id,8); copy[8] = '\0'; // parse zero or one or two trailing brackets from ID // argindex1,argindex2 = int inside each bracket pair, 0 if no bracket char *ptr = strchr(id,'['); if (ptr == NULL) argindex1[nfield] = 0; else { *ptr = '\0'; argindex1[nfield] = input->variable->int_between_brackets(ptr); ptr++; if (*ptr == '[') { argindex2[nfield] = input->variable->int_between_brackets(ptr); ptr++; } else argindex2[nfield] = 0; } if (word[0] == 'c') { n = modify->find_compute(id); if (n < 0) error->all("Could not find thermo custom compute ID"); if (argindex1[nfield] == 0 && modify->compute[n]->scalar_flag == 0) error->all("Thermo compute does not compute scalar"); if (argindex1[nfield] > 0 && argindex2[nfield] == 0) { if (modify->compute[n]->vector_flag == 0) error->all("Thermo compute does not compute vector"); if (argindex1[nfield] > modify->compute[n]->size_vector) error->all("Thermo compute vector is accessed out-of-range"); } if (argindex1[nfield] > 0 && argindex2[nfield] > 0) { if (modify->compute[n]->array_flag == 0) error->all("Thermo compute does not compute array"); if (argindex1[nfield] > modify->compute[n]->size_array_rows || argindex2[nfield] > modify->compute[n]->size_array_cols) error->all("Thermo compute array is accessed out-of-range"); } if (argindex1[nfield] == 0) field2index[nfield] = add_compute(id,SCALAR); else if (argindex2[nfield] == 0) field2index[nfield] = add_compute(id,VECTOR); else field2index[nfield] = add_compute(id,ARRAY); addfield(copy,&Thermo::compute_compute,FLOAT); } else if (word[0] == 'f') { n = modify->find_fix(id); if (n < 0) error->all("Could not find thermo custom fix ID"); if (argindex1[nfield] == 0 && modify->fix[n]->scalar_flag == 0) error->all("Thermo fix does not compute scalar"); if (argindex1[nfield] > 0 && argindex2[nfield] == 0) { if (modify->fix[n]->vector_flag == 0) error->all("Thermo fix does not compute vector"); if (argindex1[nfield] > modify->fix[n]->size_vector) error->all("Thermo fix vector is accessed out-of-range"); } if (argindex1[nfield] > 0 && argindex2[nfield] > 0) { if (modify->fix[n]->array_flag == 0) error->all("Thermo fix does not compute array"); if (argindex1[nfield] > modify->fix[n]->size_array_rows || argindex2[nfield] > modify->fix[n]->size_array_cols) error->all("Thermo fix array is accessed out-of-range"); } field2index[nfield] = add_fix(id); addfield(copy,&Thermo::compute_fix,FLOAT); } else if (word[0] == 'v') { n = input->variable->find(id); if (n < 0) error->all("Could not find thermo custom variable name"); if (input->variable->equalstyle(n) == 0) error->all("Thermo custom variable is not equal-style variable"); if (argindex1[nfield]) error->all("Thermo custom variable cannot be indexed"); field2index[nfield] = add_variable(id); addfield(copy,&Thermo::compute_variable,FLOAT); } delete [] id; } else error->all("Invalid keyword in thermo_style custom command"); word = strtok(NULL," \0"); } } /* ---------------------------------------------------------------------- add field to list of quantities to print ------------------------------------------------------------------------- */ void Thermo::addfield(const char *key, FnPtr func, int typeflag) { strcpy(keyword[nfield],key); vfunc[nfield] = func; vtype[nfield] = typeflag; nfield++; } /* ---------------------------------------------------------------------- add compute ID to list of Compute objects to call return location of where this Compute is in list if already in list with same which, do not add, just return index ------------------------------------------------------------------------- */ int Thermo::add_compute(const char *id, int which) { int icompute; for (icompute = 0; icompute < ncompute; icompute++) if ((strcmp(id,id_compute[icompute]) == 0) && which == compute_which[icompute]) break; if (icompute < ncompute) return icompute; int n = strlen(id) + 1; id_compute[ncompute] = new char[n]; strcpy(id_compute[ncompute],id); compute_which[ncompute] = which; ncompute++; return ncompute-1; } /* ---------------------------------------------------------------------- add fix ID to list of Fix objects to call ------------------------------------------------------------------------- */ int Thermo::add_fix(const char *id) { int n = strlen(id) + 1; id_fix[nfix] = new char[n]; strcpy(id_fix[nfix],id); nfix++; return nfix-1; } /* ---------------------------------------------------------------------- add variable ID to list of Variables to evaluate ------------------------------------------------------------------------- */ int Thermo::add_variable(const char *id) { int n = strlen(id) + 1; id_variable[nvariable] = new char[n]; strcpy(id_variable[nvariable],id); nvariable++; return nvariable-1; } /* ---------------------------------------------------------------------- compute a single thermodyanmic value, word is any keyword in custom list called when a variable is evaluated by Variable class return value as double in answer return 0 if str is recoginzed keyword, 1 if unrecognized customize a new keyword by adding to if statement ------------------------------------------------------------------------- */ int Thermo::evaluate_keyword(char *word, double *answer) { // invoke a lo-level thermo routine to compute the variable value // if keyword requires a compute, error if thermo doesn't use the compute // if inbetween runs and needed compute is not current, error // if in middle of run and needed compute is not current, invoke it // for keywords that use pe indirectly (evdwl, ebond, etc): // check if energy was tallied on this timestep and set pe->invoked_flag // this will trigger next timestep for energy tallying via addstep() if (strcmp(word,"step") == 0) { compute_step(); dvalue = ivalue; } else if (strcmp(word,"elapsed") == 0) { if (update->whichflag == 0) error->all("This variable thermo keyword cannot be used between runs"); compute_elapsed(); dvalue = ivalue; } else if (strcmp(word,"elaplong") == 0) { if (update->whichflag == 0) error->all("This variable thermo keyword cannot be used between runs"); compute_elapsed_long(); dvalue = ivalue; } else if (strcmp(word,"dt") == 0) { compute_dt(); } else if (strcmp(word,"cpu") == 0) { if (update->whichflag == 0) error->all("This variable thermo keyword cannot be used between runs"); compute_cpu(); } else if (strcmp(word,"tpcpu") == 0) { if (update->whichflag == 0) error->all("This variable thermo keyword cannot be used between runs"); compute_tpcpu(); } else if (strcmp(word,"spcpu") == 0) { if (update->whichflag == 0) error->all("This variable thermo keyword cannot be used between runs"); compute_spcpu(); } else if (strcmp(word,"atoms") == 0) { compute_atoms(); } else if (strcmp(word,"temp") == 0) { if (!temperature) error->all("Thermo keyword in variable requires " "thermo to use/init temp"); if (update->whichflag == 0) { if (temperature->invoked_scalar != update->ntimestep) error->all("Compute used in variable thermo keyword between runs " "is not current"); } else if (!(temperature->invoked_flag & INVOKED_SCALAR)) { temperature->compute_scalar(); temperature->invoked_flag |= INVOKED_SCALAR; } compute_temp(); } else if (strcmp(word,"press") == 0) { if (!pressure) error->all("Thermo keyword in variable requires " "thermo to use/init press"); if (update->whichflag == 0) { if (pressure->invoked_scalar != update->ntimestep) error->all("Compute used in variable thermo keyword between runs " "is not current"); } else if (!(pressure->invoked_flag & INVOKED_SCALAR)) { pressure->compute_scalar(); pressure->invoked_flag |= INVOKED_SCALAR; } compute_press(); } else if (strcmp(word,"pe") == 0) { if (!pe) error->all("Thermo keyword in variable requires thermo to use/init pe"); if (update->whichflag == 0) { if (pe->invoked_scalar != update->ntimestep) error->all("Compute used in variable thermo keyword between runs " "is not current"); } else if (!(pe->invoked_flag & INVOKED_SCALAR)) { pe->compute_scalar(); pe->invoked_flag |= INVOKED_SCALAR; } compute_pe(); } else if (strcmp(word,"ke") == 0) { if (!temperature) error->all("Thermo keyword in variable requires " "thermo to use/init temp"); if (update->whichflag == 0) { if (temperature->invoked_scalar != update->ntimestep) error->all("Compute used in variable thermo keyword between runs " "is not current"); } else if (!(temperature->invoked_flag & INVOKED_SCALAR)) { temperature->compute_scalar(); temperature->invoked_flag |= INVOKED_SCALAR; } compute_ke(); } else if (strcmp(word,"etotal") == 0) { if (!pe) error->all("Thermo keyword in variable requires thermo to use/init pe"); if (update->whichflag == 0) { if (pe->invoked_scalar != update->ntimestep) error->all("Compute used in variable thermo keyword between runs " "is not current"); } else if (!(pe->invoked_flag & INVOKED_SCALAR)) { pe->compute_scalar(); pe->invoked_flag |= INVOKED_SCALAR; } if (!temperature) error->all("Thermo keyword in variable requires " "thermo to use/init temp"); if (update->whichflag == 0) { if (temperature->invoked_scalar != update->ntimestep) error->all("Compute used in variable thermo keyword between runs " "is not current"); } else if (!(temperature->invoked_flag & INVOKED_SCALAR)) { temperature->compute_scalar(); temperature->invoked_flag |= INVOKED_SCALAR; } compute_etotal(); } else if (strcmp(word,"enthalpy") == 0) { if (!pe) error->all("Thermo keyword in variable requires thermo to use/init pe"); if (update->whichflag == 0) { if (pe->invoked_scalar != update->ntimestep) error->all("Compute used in variable thermo keyword between runs " "is not current"); } else if (!(pe->invoked_flag & INVOKED_SCALAR)) { pe->compute_scalar(); pe->invoked_flag |= INVOKED_SCALAR; } if (!temperature) error->all("Thermo keyword in variable requires " "thermo to use/init temp"); if (update->whichflag == 0) { if (temperature->invoked_scalar != update->ntimestep) error->all("Compute used in variable thermo keyword between runs " "is not current"); } else if (!(temperature->invoked_flag & INVOKED_SCALAR)) { temperature->compute_scalar(); temperature->invoked_flag |= INVOKED_SCALAR; } if (!pressure) error->all("Thermo keyword in variable requires " "thermo to use/init press"); if (update->whichflag == 0) { if (pressure->invoked_scalar != update->ntimestep) error->all("Compute used in variable thermo keyword between runs " "is not current"); } else if (!(pressure->invoked_flag & INVOKED_SCALAR)) { pressure->compute_scalar(); pressure->invoked_flag |= INVOKED_SCALAR; } compute_enthalpy(); } else if (strcmp(word,"evdwl") == 0) { if (update->eflag_global != update->ntimestep) error->all("Energy was not tallied on needed timestep"); if (!pe) error->all("Thermo keyword in variable requires thermo to use/init pe"); pe->invoked_flag |= INVOKED_SCALAR; compute_evdwl(); } else if (strcmp(word,"ecoul") == 0) { if (update->eflag_global != update->ntimestep) error->all("Energy was not tallied on needed timestep"); if (!pe) error->all("Thermo keyword in variable requires thermo to use/init pe"); pe->invoked_flag |= INVOKED_SCALAR; compute_ecoul(); } else if (strcmp(word,"epair") == 0) { if (update->eflag_global != update->ntimestep) error->all("Energy was not tallied on needed timestep"); if (!pe) error->all("Thermo keyword in variable requires thermo to use/init pe"); pe->invoked_flag |= INVOKED_SCALAR; compute_epair(); } else if (strcmp(word,"ebond") == 0) { if (update->eflag_global != update->ntimestep) error->all("Energy was not tallied on needed timestep"); if (!pe) error->all("Thermo keyword in variable requires thermo to use/init pe"); pe->invoked_flag |= INVOKED_SCALAR; compute_ebond(); } else if (strcmp(word,"eangle") == 0) { if (update->eflag_global != update->ntimestep) error->all("Energy was not tallied on needed timestep"); if (!pe) error->all("Thermo keyword in variable requires thermo to use/init pe"); pe->invoked_flag |= INVOKED_SCALAR; compute_eangle(); } else if (strcmp(word,"edihed") == 0) { if (update->eflag_global != update->ntimestep) error->all("Energy was not tallied on needed timestep"); if (!pe) error->all("Thermo keyword in variable requires thermo to use/init pe"); pe->invoked_flag |= INVOKED_SCALAR; compute_edihed(); } else if (strcmp(word,"eimp") == 0) { if (update->eflag_global != update->ntimestep) error->all("Energy was not tallied on needed timestep"); if (!pe) error->all("Thermo keyword in variable requires thermo to use/init pe"); pe->invoked_flag |= INVOKED_SCALAR; compute_eimp(); } else if (strcmp(word,"emol") == 0) { if (update->eflag_global != update->ntimestep) error->all("Energy was not tallied on needed timestep"); if (!pe) error->all("Thermo keyword in variable requires thermo to use/init pe"); pe->invoked_flag |= INVOKED_SCALAR; compute_emol(); } else if (strcmp(word,"elong") == 0) { if (update->eflag_global != update->ntimestep) error->all("Energy was not tallied on needed timestep"); if (!pe) error->all("Thermo keyword in variable requires thermo to use/init pe"); pe->invoked_flag |= INVOKED_SCALAR; compute_elong(); } else if (strcmp(word,"etail") == 0) { if (update->eflag_global != update->ntimestep) error->all("Energy was not tallied on needed timestep"); if (!pe) error->all("Thermo keyword in variable requires thermo to use/init pe"); pe->invoked_flag |= INVOKED_SCALAR; compute_etail(); } else if (strcmp(word,"vol") == 0) compute_vol(); else if (strcmp(word,"lx") == 0) compute_lx(); else if (strcmp(word,"ly") == 0) compute_ly(); else if (strcmp(word,"lz") == 0) compute_lz(); else if (strcmp(word,"xlo") == 0) compute_xlo(); else if (strcmp(word,"xhi") == 0) compute_xhi(); else if (strcmp(word,"ylo") == 0) compute_ylo(); else if (strcmp(word,"yhi") == 0) compute_yhi(); else if (strcmp(word,"zlo") == 0) compute_zlo(); else if (strcmp(word,"zhi") == 0) compute_zhi(); else if (strcmp(word,"xy") == 0) compute_xy(); else if (strcmp(word,"xz") == 0) compute_xz(); else if (strcmp(word,"yz") == 0) compute_yz(); else if (strcmp(word,"xlat") == 0) { if (domain->lattice == NULL) error->all("Thermo keyword in variable requires lattice be defined"); compute_xlat(); } else if (strcmp(word,"ylat") == 0) { if (domain->lattice == NULL) error->all("Thermo keyword in variable requires lattice be defined"); compute_ylat(); } else if (strcmp(word,"zlat") == 0) { if (domain->lattice == NULL) error->all("Thermo keyword in variable requires lattice be defined"); compute_zlat(); } else if (strcmp(word,"pxx") == 0) { if (!pressure) error->all("Thermo keyword in variable requires " "thermo to use/init press"); if (update->whichflag == 0) { if (pressure->invoked_vector != update->ntimestep) error->all("Compute used in variable thermo keyword between runs " "is not current"); } else if (!(pressure->invoked_flag & INVOKED_VECTOR)) { pressure->compute_vector(); pressure->invoked_flag |= INVOKED_VECTOR; } compute_pxx(); } else if (strcmp(word,"pyy") == 0) { if (!pressure) error->all("Thermo keyword in variable requires " "thermo to use/init press"); if (update->whichflag == 0) { if (pressure->invoked_vector != update->ntimestep) error->all("Compute used in variable thermo keyword between runs " "is not current"); } else if (!(pressure->invoked_flag & INVOKED_VECTOR)) { pressure->compute_vector(); pressure->invoked_flag |= INVOKED_VECTOR; } compute_pyy(); } else if (strcmp(word,"pzz") == 0) { if (!pressure) error->all("Thermo keyword in variable requires " "thermo to use/init press"); if (update->whichflag == 0) { if (pressure->invoked_vector != update->ntimestep) error->all("Compute used in variable thermo keyword between runs " "is not current"); } else if (!(pressure->invoked_flag & INVOKED_VECTOR)) { pressure->compute_vector(); pressure->invoked_flag |= INVOKED_VECTOR; } compute_pzz(); } else if (strcmp(word,"pxy") == 0) { if (!pressure) error->all("Thermo keyword in variable requires " "thermo to use/init press"); if (update->whichflag == 0) { if (pressure->invoked_vector != update->ntimestep) error->all("Compute used in variable thermo keyword between runs " "is not current"); } else if (!(pressure->invoked_flag & INVOKED_VECTOR)) { pressure->compute_vector(); pressure->invoked_flag |= INVOKED_VECTOR; } compute_pxy(); } else if (strcmp(word,"pxz") == 0) { if (!pressure) error->all("Thermo keyword in variable requires " "thermo to use/init press"); if (update->whichflag == 0) { if (pressure->invoked_vector != update->ntimestep) error->all("Compute used in variable thermo keyword between runs " "is not current"); } else if (!(pressure->invoked_flag & INVOKED_VECTOR)) { pressure->compute_vector(); pressure->invoked_flag |= INVOKED_VECTOR; } compute_pxz(); } else if (strcmp(word,"pyz") == 0) { if (!pressure) error->all("Thermo keyword in variable requires " "thermo to use/init press"); if (update->whichflag == 0) { if (pressure->invoked_vector != update->ntimestep) error->all("Compute used in variable thermo keyword between runs " "is not current"); } else if (!(pressure->invoked_flag & INVOKED_VECTOR)) { pressure->compute_vector(); pressure->invoked_flag |= INVOKED_VECTOR; } compute_pyz(); } else if (strcmp(word,"fmax") == 0) compute_fmax(); else if (strcmp(word,"fnorm") == 0) compute_fnorm(); else return 1; *answer = dvalue; return 0; } /* ---------------------------------------------------------------------- extraction of Compute, Fix, Variable results compute/fix are normalized by atoms if returning extensive value variable value is not normalized (formula should normalize if desired) ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- */ void Thermo::compute_compute() { int m = field2index[ifield]; Compute *compute = computes[m]; if (compute_which[m] == SCALAR) { dvalue = compute->scalar; if (normflag && compute->extscalar) dvalue /= natoms; } else if (compute_which[m] == VECTOR) { dvalue = compute->vector[argindex1[ifield]-1]; if (normflag) { if (compute->extvector == 0) return; else if (compute->extvector == 1) dvalue /= natoms; else if (compute->extlist[argindex1[ifield]-1]) dvalue /= natoms; } } else { dvalue = compute->array[argindex1[ifield]-1][argindex2[ifield]-1]; if (normflag && compute->extarray) dvalue /= natoms; } } /* ---------------------------------------------------------------------- */ void Thermo::compute_fix() { int m = field2index[ifield]; Fix *fix = fixes[m]; if (argindex1[ifield] == 0) { dvalue = fix->compute_scalar(); if (normflag && fix->extscalar) dvalue /= natoms; } else if (argindex2[ifield] == 0) { dvalue = fix->compute_vector(argindex1[ifield]-1); if (normflag) { if (fix->extvector == 0) return; else if (fix->extvector == 1) dvalue /= natoms; else if (fix->extlist[argindex1[ifield]-1]) dvalue /= natoms; } } else { dvalue = fix->compute_array(argindex1[ifield]-1,argindex2[ifield]-1); if (normflag && fix->extarray) dvalue /= natoms; } } /* ---------------------------------------------------------------------- */ void Thermo::compute_variable() { dvalue = input->variable->compute_equal(variables[field2index[ifield]]); } /* ---------------------------------------------------------------------- one method for every keyword thermo can output called by compute() or evaluate_keyword() compute will have already been called set ivalue/dvalue if value is integer/double customize a new keyword by adding a method ------------------------------------------------------------------------- */ void Thermo::compute_step() { ivalue = update->ntimestep; } /* ---------------------------------------------------------------------- */ void Thermo::compute_elapsed() { ivalue = update->ntimestep - update->firststep; } /* ---------------------------------------------------------------------- */ void Thermo::compute_elapsed_long() { ivalue = update->ntimestep - update->beginstep; } /* ---------------------------------------------------------------------- */ void Thermo::compute_dt() { dvalue = update->dt; } /* ---------------------------------------------------------------------- */ void Thermo::compute_cpu() { if (firststep == 0) dvalue = 0.0; else dvalue = timer->elapsed(TIME_LOOP); } /* ---------------------------------------------------------------------- */ void Thermo::compute_tpcpu() { double new_cpu; double new_time = update->ntimestep * update->dt; if (firststep == 0) { new_cpu = 0.0; dvalue = 0.0; } else { new_cpu = timer->elapsed(TIME_LOOP); double cpu_diff = new_cpu - last_tpcpu; double time_diff = new_time - last_time; if (time_diff > 0.0 && cpu_diff > 0.0) dvalue = time_diff/cpu_diff; else dvalue = 0.0; } last_time = new_time; last_tpcpu = new_cpu; } /* ---------------------------------------------------------------------- */ void Thermo::compute_spcpu() { double new_cpu; int new_step = update->ntimestep; if (firststep == 0) { new_cpu = 0.0; dvalue = 0.0; } else { new_cpu = timer->elapsed(TIME_LOOP); double cpu_diff = new_cpu - last_spcpu; int step_diff = new_step - last_step; if (cpu_diff > 0.0) dvalue = step_diff/cpu_diff; else dvalue = 0.0; } last_step = new_step; last_spcpu = new_cpu; } /* ---------------------------------------------------------------------- */ void Thermo::compute_atoms() { bivalue = natoms; } /* ---------------------------------------------------------------------- */ void Thermo::compute_temp() { dvalue = temperature->scalar; } /* ---------------------------------------------------------------------- */ void Thermo::compute_press() { dvalue = pressure->scalar; } /* ---------------------------------------------------------------------- */ void Thermo::compute_pe() { dvalue = pe->scalar; if (normflag) dvalue /= natoms; } /* ---------------------------------------------------------------------- */ void Thermo::compute_ke() { dvalue = temperature->scalar; dvalue *= 0.5 * temperature->dof * force->boltz; if (normflag) dvalue /= natoms; } /* ---------------------------------------------------------------------- */ void Thermo::compute_etotal() { compute_pe(); double ke = temperature->scalar; ke *= 0.5 * temperature->dof * force->boltz; if (normflag) ke /= natoms; dvalue += ke; } /* ---------------------------------------------------------------------- */ void Thermo::compute_enthalpy() { compute_etotal(); double etmp = dvalue; compute_vol(); double vtmp = dvalue; if (normflag) vtmp /= natoms; compute_press(); double ptmp = dvalue; dvalue = etmp + ptmp*vtmp/(force->nktv2p); } /* ---------------------------------------------------------------------- */ void Thermo::compute_evdwl() { double tmp = 0.0; if (force->pair) tmp += force->pair->eng_vdwl; MPI_Allreduce(&tmp,&dvalue,1,MPI_DOUBLE,MPI_SUM,world); if (force->pair && force->pair->tail_flag) { double volume = domain->xprd * domain->yprd * domain->zprd; dvalue += force->pair->etail / volume; } if (normflag) dvalue /= natoms; } /* ---------------------------------------------------------------------- */ void Thermo::compute_ecoul() { double tmp = 0.0; if (force->pair) tmp += force->pair->eng_coul; MPI_Allreduce(&tmp,&dvalue,1,MPI_DOUBLE,MPI_SUM,world); if (normflag) dvalue /= natoms; } /* ---------------------------------------------------------------------- */ void Thermo::compute_epair() { double tmp = 0.0; if (force->pair) tmp += force->pair->eng_vdwl + force->pair->eng_coul; MPI_Allreduce(&tmp,&dvalue,1,MPI_DOUBLE,MPI_SUM,world); if (force->kspace) dvalue += force->kspace->energy; if (force->pair && force->pair->tail_flag) { double volume = domain->xprd * domain->yprd * domain->zprd; dvalue += force->pair->etail / volume; } if (normflag) dvalue /= natoms; } /* ---------------------------------------------------------------------- */ void Thermo::compute_ebond() { if (force->bond) { double tmp = force->bond->energy; MPI_Allreduce(&tmp,&dvalue,1,MPI_DOUBLE,MPI_SUM,world); if (normflag) dvalue /= natoms; } else dvalue = 0.0; } /* ---------------------------------------------------------------------- */ void Thermo::compute_eangle() { if (force->angle) { double tmp = force->angle->energy; MPI_Allreduce(&tmp,&dvalue,1,MPI_DOUBLE,MPI_SUM,world); if (normflag) dvalue /= natoms; } else dvalue = 0.0; } /* ---------------------------------------------------------------------- */ void Thermo::compute_edihed() { if (force->dihedral) { double tmp = force->dihedral->energy; MPI_Allreduce(&tmp,&dvalue,1,MPI_DOUBLE,MPI_SUM,world); if (normflag) dvalue /= natoms; } else dvalue = 0.0; } /* ---------------------------------------------------------------------- */ void Thermo::compute_eimp() { if (force->improper) { double tmp = force->improper->energy; MPI_Allreduce(&tmp,&dvalue,1,MPI_DOUBLE,MPI_SUM,world); if (normflag) dvalue /= natoms; } else dvalue = 0.0; } /* ---------------------------------------------------------------------- */ void Thermo::compute_emol() { double tmp = 0.0; if (atom->molecular) { if (force->bond) tmp += force->bond->energy; if (force->angle) tmp += force->angle->energy; if (force->dihedral) tmp += force->dihedral->energy; if (force->improper) tmp += force->improper->energy; MPI_Allreduce(&tmp,&dvalue,1,MPI_DOUBLE,MPI_SUM,world); if (normflag) dvalue /= natoms; } else dvalue = 0.0; } /* ---------------------------------------------------------------------- */ void Thermo::compute_elong() { if (force->kspace) { dvalue = force->kspace->energy; if (normflag) dvalue /= natoms; } else dvalue = 0.0; } /* ---------------------------------------------------------------------- */ void Thermo::compute_etail() { if (force->pair && force->pair->tail_flag) { double volume = domain->xprd * domain->yprd * domain->zprd; dvalue = force->pair->etail / volume; if (normflag) dvalue /= natoms; } else dvalue = 0.0; } /* ---------------------------------------------------------------------- */ void Thermo::compute_vol() { if (domain->dimension == 3) dvalue = domain->xprd * domain->yprd * domain->zprd; else dvalue = domain->xprd * domain->yprd; } /* ---------------------------------------------------------------------- */ void Thermo::compute_lx() { dvalue = domain->xprd; } /* ---------------------------------------------------------------------- */ void Thermo::compute_ly() { dvalue = domain->yprd; } /* ---------------------------------------------------------------------- */ void Thermo::compute_lz() { dvalue = domain->zprd; } /* ---------------------------------------------------------------------- */ void Thermo::compute_xlo() { dvalue = domain->boxlo[0]; } /* ---------------------------------------------------------------------- */ void Thermo::compute_xhi() { dvalue = domain->boxhi[0]; } /* ---------------------------------------------------------------------- */ void Thermo::compute_ylo() { dvalue = domain->boxlo[1]; } /* ---------------------------------------------------------------------- */ void Thermo::compute_yhi() { dvalue = domain->boxhi[1]; } /* ---------------------------------------------------------------------- */ void Thermo::compute_zlo() { dvalue = domain->boxlo[2]; } /* ---------------------------------------------------------------------- */ void Thermo::compute_zhi() { dvalue = domain->boxhi[2]; } /* ---------------------------------------------------------------------- */ void Thermo::compute_xy() { dvalue = domain->xy; } /* ---------------------------------------------------------------------- */ void Thermo::compute_xz() { dvalue = domain->xz; } /* ---------------------------------------------------------------------- */ void Thermo::compute_yz() { dvalue = domain->yz; } /* ---------------------------------------------------------------------- */ void Thermo::compute_xlat() { dvalue = domain->lattice->xlattice; } /* ---------------------------------------------------------------------- */ void Thermo::compute_ylat() { dvalue = domain->lattice->ylattice; } /* ---------------------------------------------------------------------- */ void Thermo::compute_zlat() { dvalue = domain->lattice->zlattice; } /* ---------------------------------------------------------------------- */ void Thermo::compute_pxx() { dvalue = pressure->vector[0]; } /* ---------------------------------------------------------------------- */ void Thermo::compute_pyy() { dvalue = pressure->vector[1]; } /* ---------------------------------------------------------------------- */ void Thermo::compute_pzz() { dvalue = pressure->vector[2]; } /* ---------------------------------------------------------------------- */ void Thermo::compute_pxy() { dvalue = pressure->vector[3]; } /* ---------------------------------------------------------------------- */ void Thermo::compute_pxz() { dvalue = pressure->vector[4]; } /* ---------------------------------------------------------------------- */ void Thermo::compute_pyz() { dvalue = pressure->vector[5]; } /* ---------------------------------------------------------------------- */ void Thermo::compute_fmax() { double **f = atom->f; int nlocal = atom->nlocal; double max = 0.0; for (int i = 0; i < nlocal; i++) { max = MAX(max,fabs(f[i][0])); max = MAX(max,fabs(f[i][1])); max = MAX(max,fabs(f[i][2])); } double maxall; MPI_Allreduce(&max,&maxall,1,MPI_DOUBLE,MPI_MAX,world); dvalue = maxall; } /* ---------------------------------------------------------------------- */ void Thermo::compute_fnorm() { double **f = atom->f; int nlocal = atom->nlocal; double dot = 0.0; for (int i = 0; i < nlocal; i++) dot += f[i][0]*f[i][0] + f[i][1]*f[i][1] + f[i][2]*f[i][2]; double dotall; MPI_Allreduce(&dot,&dotall,1,MPI_DOUBLE,MPI_SUM,world); dvalue = sqrt(dotall); } diff --git a/src/write_restart.cpp b/src/write_restart.cpp index 44e3de263..25cba1c04 100644 --- a/src/write_restart.cpp +++ b/src/write_restart.cpp @@ -1,498 +1,498 @@ /* ---------------------------------------------------------------------- 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. ------------------------------------------------------------------------- */ #include "mpi.h" #include "string.h" #include "write_restart.h" #include "lmptype.h" #include "atom.h" #include "atom_vec.h" #include "atom_vec_hybrid.h" #include "group.h" #include "force.h" #include "pair.h" #include "bond.h" #include "angle.h" #include "dihedral.h" #include "improper.h" #include "update.h" #include "domain.h" #include "modify.h" #include "universe.h" #include "comm.h" #include "output.h" #include "thermo.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; #define MIN(A,B) ((A) < (B)) ? (A) : (B) #define MAX(A,B) ((A) > (B)) ? (A) : (B) // same as read_restart.cpp and tools/restart2data.cpp enum{VERSION,UNITS,NTIMESTEP,DIMENSION,NPROCS,PROCGRID_0,PROCGRID_1,PROCGRID_2, NEWTON_PAIR,NEWTON_BOND,XPERIODIC,YPERIODIC,ZPERIODIC, BOUNDARY_00,BOUNDARY_01,BOUNDARY_10,BOUNDARY_11,BOUNDARY_20,BOUNDARY_21, ATOM_STYLE,NATOMS,NTYPES, NBONDS,NBONDTYPES,BOND_PER_ATOM, NANGLES,NANGLETYPES,ANGLE_PER_ATOM, NDIHEDRALS,NDIHEDRALTYPES,DIHEDRAL_PER_ATOM, NIMPROPERS,NIMPROPERTYPES,IMPROPER_PER_ATOM, BOXLO_0,BOXHI_0,BOXLO_1,BOXHI_1,BOXLO_2,BOXHI_2, SPECIAL_LJ_1,SPECIAL_LJ_2,SPECIAL_LJ_3, SPECIAL_COUL_1,SPECIAL_COUL_2,SPECIAL_COUL_3, XY,XZ,YZ}; enum{MASS,SHAPE,DIPOLE}; enum{PAIR,BOND,ANGLE,DIHEDRAL,IMPROPER}; enum{IGNORE,WARN,ERROR}; // same as thermo.cpp /* ---------------------------------------------------------------------- */ WriteRestart::WriteRestart(LAMMPS *lmp) : Pointers(lmp) { MPI_Comm_rank(world,&me); MPI_Comm_size(world,&nprocs); } /* ---------------------------------------------------------------------- called as write_restart command in input script ------------------------------------------------------------------------- */ void WriteRestart::command(int narg, char **arg) { if (domain->box_exist == 0) error->all("Write_restart command before simulation box is defined"); if (narg != 1) error->all("Illegal write_restart command"); // if filename contains a "*", replace with current timestep char *ptr; int n = strlen(arg[0]) + 16; char *file = new char[n]; if (ptr = strchr(arg[0],'*')) { *ptr = '\0'; sprintf(file,"%s%d%s",arg[0],update->ntimestep,ptr+1); } else strcpy(file,arg[0]); // init entire system since comm->exchange is done // comm::init needs neighbor::init needs pair::init needs kspace::init, etc if (comm->me == 0 && screen) fprintf(screen,"System init for write_restart ...\n"); lmp->init(); // move atoms to new processors before writing file // enforce PBC before in case atoms are outside box // call borders() to rebuild atom map since exchange() destroys map if (domain->triclinic) domain->x2lamda(atom->nlocal); domain->pbc(); domain->reset_box(); comm->setup(); comm->exchange(); comm->borders(); if (domain->triclinic) domain->lamda2x(atom->nlocal+atom->nghost); write(file); delete [] file; } /* ---------------------------------------------------------------------- called from command() and directly from output within run/minimize loop file = final file name to write, except may contain a "%" ------------------------------------------------------------------------- */ void WriteRestart::write(char *file) { // natoms = sum of nlocal = value to write into restart file // if unequal and thermo lostflag is "error", don't write restart file bigint nblocal = atom->nlocal; - MPI_Allreduce(&nblocal,&natoms,1,MPI_UNSIGNED_LONG,MPI_SUM,world); + MPI_Allreduce(&nblocal,&natoms,1,MPI_UNSIGNED_LONG_LONG,MPI_SUM,world); if (natoms != atom->natoms && output->thermo->lostflag == ERROR) error->all("Atom count is inconsistent, cannot write restart file"); // check if filename contains "%" int multiproc; if (strchr(file,'%')) multiproc = 1; else multiproc = 0; // open single restart file or base file for multiproc case if (me == 0) { char *hfile; if (multiproc) { hfile = new char[strlen(file) + 16]; char *ptr = strchr(file,'%'); *ptr = '\0'; sprintf(hfile,"%s%s%s",file,"base",ptr+1); *ptr = '%'; } else hfile = file; fp = fopen(hfile,"wb"); if (fp == NULL) { char str[128]; sprintf(str,"Cannot open restart file %s",hfile); error->one(str); } if (multiproc) delete [] hfile; } // proc 0 writes header, groups, ntype-length arrays, force field // all procs write fix info if (me == 0) { header(); group->write_restart(fp); type_arrays(); force_fields(); } modify->write_restart(fp); // communication buffer for all my atom's info // max_size = largest buffer needed by any proc int max_size; int send_size = atom->avec->size_restart(); MPI_Allreduce(&send_size,&max_size,1,MPI_INT,MPI_MAX,world); double *buf; if (me == 0) buf = (double *) memory->smalloc(max_size*sizeof(double),"write_restart:buf"); else buf = (double *) memory->smalloc(send_size*sizeof(double),"write_restart:buf"); // pack my atom data into buf AtomVec *avec = atom->avec; int n = 0; for (int i = 0; i < atom->nlocal; i++) n += avec->pack_restart(i,&buf[n]); // if any fix requires it, remap each atom's coords via PBC // is because fix changes atom coords (excepting an integrate fix) // just remap in buffer, not actual atoms if (modify->restart_pbc_any) { int triclinic = domain->triclinic; double *lo,*hi,*period; if (triclinic == 0) { lo = domain->boxlo; hi = domain->boxhi; period = domain->prd; } else { lo = domain->boxlo_lamda; hi = domain->boxhi_lamda; period = domain->prd_lamda; } int xperiodic = domain->xperiodic; int yperiodic = domain->yperiodic; int zperiodic = domain->zperiodic; double *x; int m = 0; for (int i = 0; i < atom->nlocal; i++) { x = &buf[m+1]; if (triclinic) domain->x2lamda(x,x); if (xperiodic) { if (x[0] < lo[0]) x[0] += period[0]; if (x[0] >= hi[0]) x[0] -= period[0]; x[0] = MAX(x[0],lo[0]); } if (yperiodic) { if (x[1] < lo[1]) x[1] += period[1]; if (x[1] >= hi[1]) x[1] -= period[1]; x[1] = MAX(x[1],lo[1]); } if (zperiodic) { if (x[2] < lo[2]) x[2] += period[2]; if (x[2] >= hi[2]) x[2] -= period[2]; x[2] = MAX(x[2],lo[2]); } if (triclinic) domain->lamda2x(x,x); m += static_cast<int> (buf[m]); } } // if single file: // write one chunk of atoms per proc to file // proc 0 pings each proc, receives its chunk, writes to file // all other procs wait for ping, send their chunk to proc 0 // else if one file per proc: // each proc opens its own file and writes its chunk directly if (multiproc == 0) { int tmp,recv_size; MPI_Status status; MPI_Request request; if (me == 0) { for (int iproc = 0; iproc < nprocs; iproc++) { if (iproc) { MPI_Irecv(buf,max_size,MPI_DOUBLE,iproc,0,world,&request); MPI_Send(&tmp,0,MPI_INT,iproc,0,world); MPI_Wait(&request,&status); MPI_Get_count(&status,MPI_DOUBLE,&recv_size); } else recv_size = send_size; fwrite(&recv_size,sizeof(int),1,fp); fwrite(buf,sizeof(double),recv_size,fp); } fclose(fp); } else { MPI_Recv(&tmp,0,MPI_INT,0,0,world,&status); MPI_Rsend(buf,send_size,MPI_DOUBLE,0,0,world); } } else { if (me == 0) fclose(fp); char *perproc = new char[strlen(file) + 16]; char *ptr = strchr(file,'%'); *ptr = '\0'; sprintf(perproc,"%s%d%s",file,me,ptr+1); *ptr = '%'; fp = fopen(perproc,"wb"); if (fp == NULL) { char str[128]; sprintf(str,"Cannot open restart file %s",perproc); error->one(str); } delete [] perproc; fwrite(&send_size,sizeof(int),1,fp); fwrite(buf,sizeof(double),send_size,fp); fclose(fp); } memory->sfree(buf); } /* ---------------------------------------------------------------------- proc 0 writes out problem description ------------------------------------------------------------------------- */ void WriteRestart::header() { write_char(VERSION,universe->version); write_char(UNITS,update->unit_style); write_int(NTIMESTEP,update->ntimestep); write_int(DIMENSION,domain->dimension); write_int(NPROCS,nprocs); write_int(PROCGRID_0,comm->procgrid[0]); write_int(PROCGRID_1,comm->procgrid[1]); write_int(PROCGRID_2,comm->procgrid[2]); write_int(NEWTON_PAIR,force->newton_pair); write_int(NEWTON_BOND,force->newton_bond); write_int(XPERIODIC,domain->xperiodic); write_int(YPERIODIC,domain->yperiodic); write_int(ZPERIODIC,domain->zperiodic); write_int(BOUNDARY_00,domain->boundary[0][0]); write_int(BOUNDARY_01,domain->boundary[0][1]); write_int(BOUNDARY_10,domain->boundary[1][0]); write_int(BOUNDARY_11,domain->boundary[1][1]); write_int(BOUNDARY_20,domain->boundary[2][0]); write_int(BOUNDARY_21,domain->boundary[2][1]); // atom_style must be written before atom class values // so read_restart can create class before reading class values // if style = hybrid, also write sub-class styles write_char(ATOM_STYLE,atom->atom_style); if (strcmp(atom->atom_style,"hybrid") == 0) { AtomVecHybrid *avec_hybrid = (AtomVecHybrid *) atom->avec; int nstyles = avec_hybrid->nstyles; char **keywords = avec_hybrid->keywords; fwrite(&nstyles,sizeof(int),1,fp); for (int i = 0; i < nstyles; i++) { int n = strlen(keywords[i]) + 1; fwrite(&n,sizeof(int),1,fp); fwrite(keywords[i],sizeof(char),n,fp); } } write_bigint(NATOMS,natoms); write_int(NTYPES,atom->ntypes); write_bigint(NBONDS,atom->nbonds); write_int(NBONDTYPES,atom->nbondtypes); write_int(BOND_PER_ATOM,atom->bond_per_atom); write_bigint(NANGLES,atom->nangles); write_int(NANGLETYPES,atom->nangletypes); write_int(ANGLE_PER_ATOM,atom->angle_per_atom); write_bigint(NDIHEDRALS,atom->ndihedrals); write_int(NDIHEDRALTYPES,atom->ndihedraltypes); write_int(DIHEDRAL_PER_ATOM,atom->dihedral_per_atom); write_bigint(NIMPROPERS,atom->nimpropers); write_int(NIMPROPERTYPES,atom->nimpropertypes); write_int(IMPROPER_PER_ATOM,atom->improper_per_atom); write_double(BOXLO_0,domain->boxlo[0]); write_double(BOXHI_0,domain->boxhi[0]); write_double(BOXLO_1,domain->boxlo[1]); write_double(BOXHI_1,domain->boxhi[1]); write_double(BOXLO_2,domain->boxlo[2]); write_double(BOXHI_2,domain->boxhi[2]); write_double(SPECIAL_LJ_1,force->special_lj[1]); write_double(SPECIAL_LJ_2,force->special_lj[2]); write_double(SPECIAL_LJ_3,force->special_lj[3]); write_double(SPECIAL_COUL_1,force->special_coul[1]); write_double(SPECIAL_COUL_2,force->special_coul[2]); write_double(SPECIAL_COUL_3,force->special_coul[3]); if (domain->triclinic) { write_double(XY,domain->xy); write_double(XZ,domain->xz); write_double(YZ,domain->yz); } // -1 flag signals end of header int flag = -1; fwrite(&flag,sizeof(int),1,fp); } /* ---------------------------------------------------------------------- proc 0 writes out any type-based arrays that are defined ------------------------------------------------------------------------- */ void WriteRestart::type_arrays() { if (atom->mass) { int flag = MASS; fwrite(&flag,sizeof(int),1,fp); fwrite(&atom->mass[1],sizeof(double),atom->ntypes,fp); } if (atom->shape) { int flag = SHAPE; fwrite(&flag,sizeof(int),1,fp); fwrite(&atom->shape[1][0],sizeof(double),atom->ntypes*3,fp); } if (atom->dipole) { int flag = DIPOLE; fwrite(&flag,sizeof(int),1,fp); fwrite(&atom->dipole[1],sizeof(double),atom->ntypes,fp); } // -1 flag signals end of type arrays int flag = -1; fwrite(&flag,sizeof(int),1,fp); } /* ---------------------------------------------------------------------- proc 0 writes out and force field styles and data that are defined ------------------------------------------------------------------------- */ void WriteRestart::force_fields() { if (force->pair) { int flag = PAIR; fwrite(&flag,sizeof(int),1,fp); int n = strlen(force->pair_style) + 1; fwrite(&n,sizeof(int),1,fp); fwrite(force->pair_style,sizeof(char),n,fp); force->pair->write_restart(fp); } if (atom->avec->bonds_allow && force->bond) { int flag = BOND; fwrite(&flag,sizeof(int),1,fp); int n = strlen(force->bond_style) + 1; fwrite(&n,sizeof(int),1,fp); fwrite(force->bond_style,sizeof(char),n,fp); force->bond->write_restart(fp); } if (atom->avec->angles_allow && force->angle) { int flag = ANGLE; fwrite(&flag,sizeof(int),1,fp); int n = strlen(force->angle_style) + 1; fwrite(&n,sizeof(int),1,fp); fwrite(force->angle_style,sizeof(char),n,fp); force->angle->write_restart(fp); } if (atom->avec->dihedrals_allow && force->dihedral) { int flag = DIHEDRAL; fwrite(&flag,sizeof(int),1,fp); int n = strlen(force->dihedral_style) + 1; fwrite(&n,sizeof(int),1,fp); fwrite(force->dihedral_style,sizeof(char),n,fp); force->dihedral->write_restart(fp); } if (atom->avec->impropers_allow && force->improper) { int flag = IMPROPER; fwrite(&flag,sizeof(int),1,fp); int n = strlen(force->improper_style) + 1; fwrite(&n,sizeof(int),1,fp); fwrite(force->improper_style,sizeof(char),n,fp); force->improper->write_restart(fp); } // -1 flag signals end of force field info int flag = -1; fwrite(&flag,sizeof(int),1,fp); } /* ---------------------------------------------------------------------- write a flag and an int into restart file ------------------------------------------------------------------------- */ void WriteRestart::write_int(int flag, int value) { fwrite(&flag,sizeof(int),1,fp); fwrite(&value,sizeof(int),1,fp); } /* ---------------------------------------------------------------------- write a flag and a double into restart file ------------------------------------------------------------------------- */ void WriteRestart::write_double(int flag, double value) { fwrite(&flag,sizeof(int),1,fp); fwrite(&value,sizeof(double),1,fp); } /* ---------------------------------------------------------------------- write a flag and a char str into restart file ------------------------------------------------------------------------- */ void WriteRestart::write_char(int flag, char *value) { fwrite(&flag,sizeof(int),1,fp); int n = strlen(value) + 1; fwrite(&n,sizeof(int),1,fp); fwrite(value,sizeof(char),n,fp); } /* ---------------------------------------------------------------------- write a flag and a bigint into restart file ------------------------------------------------------------------------- */ void WriteRestart::write_bigint(int flag, bigint value) { fwrite(&flag,sizeof(int),1,fp); fwrite(&value,sizeof(bigint),1,fp); }