n2p2 - A neural network potential package
Loading...
Searching...
No Matches
kspace_hdnnp.h
Go to the documentation of this file.
1/* -*- c++ -*- ----------------------------------------------------------
2 LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator
3 http://lammps.sandia.gov, Sandia National Laboratories
4 Steve Plimpton, sjplimp@sandia.gov
5
6 Copyright (2003) Sandia Corporation. Under the terms of Contract
7 DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains
8 certain rights in this software. This software is distributed under
9 the GNU General Public License.
10
11 See the README file in the top-level LAMMPS directory.
12------------------------------------------------------------------------- */
13
14#ifdef KSPACE_CLASS
15
16KSpaceStyle(hdnnp,KSpaceHDNNP)
17
18#else
19
20#ifndef LMP_KSPACE_HDNNP_H
21#define LMP_KSPACE_HDNNP_H
22
23#include <gsl/gsl_multimin.h>
24#include "kspace.h"
25#include "grid3d.h"
26
27#if defined(FFT_FFTW3)
28#define LMP_FFT_LIB "FFTW3"
29#elif defined(FFT_MKL)
30#define LMP_FFT_LIB "MKL FFT"
31#elif defined(FFT_CUFFT)
32#define LMP_FFT_LIB "cuFFT"
33#else
34#define LMP_FFT_LIB "KISS FFT"
35#endif
36
37#ifdef FFT_SINGLE
38typedef float FFT_SCALAR;
39#define LMP_FFT_PREC "single"
40#define MPI_FFT_SCALAR MPI_FLOAT
41#else
42
43typedef double FFT_SCALAR;
44#define LMP_FFT_PREC "double"
45#define MPI_FFT_SCALAR MPI_DOUBLE
46#endif
47
48#include "InterfaceLammps.h"
49
50
51namespace LAMMPS_NS {
52
53 class KSpaceHDNNP : public KSpace {
54 friend class PairHDNNP4G;
55 friend class FixHDNNP;
56 public:
57 KSpaceHDNNP(class LAMMPS *);
59
60 virtual void settings(int, char **);
61 virtual void init();
62 virtual void setup();
63 //virtual void setup_grid();
64 virtual void compute(int, int);
65 //virtual int timing_1d(int, double &);
66 //virtual int timing_3d(int, double &);
67 //virtual double memory_usage();
68
69 protected:
70
71 class PairHDNNP4G *hdnnp; // interface to HDNNP pair_style
72
74
75 int triclinic; // domain settings, orthog or triclinic
76
77 double cutoff;
78 double gsqmx;
79
81 int kewaldflag; // O if no kspace_modify
82
83 double unitk[3];
87 int kcount;
88
89 int ewald_truncation_method; // truncation method (RuNNer)
90
91 double ewald_eta;
92 double s_ewald;
95
98
99 double *ug;
100 double **eg,**vg;
101 double **ek;
102
103 double *kcoeff;
104 double **sfexp_rl,**sfexp_im;
105 double *sf_real, *sf_im;
106 double *sfexp_rl_all,*sfexp_im_all; // structure factors after communications ?
107 double ***cs,***sn; // cosine and sine grid
108
109 void calculate_ewald_eta(int);
111
112 void ewald_coeffs();
113 void ewald_sfexp();
114
115 void ewald_pbc(double); // TODO: this is from RuNNer
116
117 double rms(int, double, bigint, double);
118
119 double compute_ewald_eqeq(const gsl_vector*);
120
122
126
127 double volume;
129 double h_x,h_y,h_z;
138
145 double *greensfn;
146 double *fkx,*fky,*fkz;
149
150 double *gf_b;
154 double sf_coeff[6]; // coefficients for calculating ad self-forces
155 double **acons;
156
157 // FFTs and grid communication
158
159 class FFT3d *fft1,*fft2;
160 class Remap *remap;
161 class Grid3d *gc;
162
165
166 int **part2grid; // storage for particle -> grid mapping
167 int nmax;
168
169 double *boxlo;
170
171 virtual void set_grid_global();
172 void set_grid_local();
173 void adjust_gewald();
174 virtual double newton_raphson_f();
175 double derivf();
176 double final_accuracy();
177
178 virtual void allocate();
179 //virtual void allocate_peratom();
180 virtual void deallocate();
181 //virtual void deallocate_peratom();
182
183
184 int factorable(int);
185 double compute_df_kspace();
186 double estimate_ik_error(double, double, bigint);
187 //virtual double compute_qopt();
188 virtual void compute_gf_denom();
189 virtual void compute_gf_ik();
190
191
192 void make_rho_qeq(const gsl_vector*); // charge density (rho) / charge
193 virtual void particle_map();
194 double compute_pppm_eqeq();
195 double compute_pppm_dEdQ(int);
196
197 //virtual void make_rho();
198
199 virtual void brick2fft();
200
201 virtual void poisson(); // Poisson solver for P3M (differentiation_flag == 0)
202
203 /*void compute_sf_precoeff();
204
205 virtual void fieldforce();
206 virtual void fieldforce_ik();
207 virtual void fieldforce_ad();
208
209 virtual void poisson_peratom();
210 virtual void fieldforce_peratom();*/
211 void procs2grid2d(int,int,int,int *, int*);
212 void compute_rho1d(const FFT_SCALAR &, const FFT_SCALAR &, const FFT_SCALAR &);
213 //void compute_drho1d(const FFT_SCALAR &, const FFT_SCALAR &,const FFT_SCALAR &);
214 void compute_rho_coeff();
215
216
217 // grid communication
218 /*
219 virtual void pack_forward_grid(int, void *, int, int *);
220 virtual void unpack_forward_grid(int, void *, int, int *);
221 virtual void pack_reverse_grid(int, void *, int, int *);
222 virtual void unpack_reverse_grid(int, void *, int, int *);
223
224 // triclinic
225
226 void setup_triclinic();
227 void compute_gf_ik_triclinic();
228 void poisson_ik_triclinic();
229 void poisson_groups_triclinic();
230
231 // group-group interactions
232
233 virtual void allocate_groups();
234 virtual void deallocate_groups();
235 virtual void make_rho_groups(int, int, int);
236 virtual void poisson_groups(int);
237 virtual void slabcorr_groups(int,int,int);*/
238
239/* ----------------------------------------------------------------------
240 denominator for Hockney-Eastwood Green's function
241 of x,y,z = sin(kx*deltax/2), etc
242
243 inf n-1
244 S(n,k) = Sum W(k+pi*j)**2 = Sum b(l)*(z*z)**l
245 j=-inf l=0
246
247 = -(z*z)**n /(2n-1)! * (d/dx)**(2n-1) cot(x) at z = sin(x)
248 gf_b = denominator expansion coeffs
249------------------------------------------------------------------------- */
250
251 inline double gf_denom(const double &x, const double &y,
252 const double &z) const {
253 double sx,sy,sz;
254 sz = sy = sx = 0.0;
255 for (int l = order-1; l >= 0; l--) {
256 sx = gf_b[l] + sx*x;
257 sy = gf_b[l] + sy*y;
258 sz = gf_b[l] + sz*z;
259 }
260 double s = sx*sy*sz;
261 return s*s;
262 };
263
264
265 };
266
267}
268
269#endif
270#endif
FFT_SCALAR *** vx_brick
KSpaceHDNNP(class LAMMPS *)
FFT_SCALAR ** rho_coeff
FFT_SCALAR *** vdy_brick
class PairHDNNP4G * hdnnp
virtual void compute_gf_ik()
FFT_SCALAR *** vz_brick
virtual void set_grid_global()
FFT_SCALAR *** v5_brick
virtual void compute_gf_denom()
FFT_SCALAR *** v1_brick
friend class PairHDNNP4G
void compute_rho1d(const FFT_SCALAR &, const FFT_SCALAR &, const FFT_SCALAR &)
FFT_SCALAR *** v4_brick
virtual void settings(int, char **)
double estimate_ik_error(double, double, bigint)
FFT_SCALAR *** vdz_brick
FFT_SCALAR *** v0_brick
void procs2grid2d(int, int, int, int *, int *)
double gf_denom(const double &x, const double &y, const double &z) const
FFT_SCALAR *** density_brick
FFT_SCALAR *** vy_brick
virtual void particle_map()
FFT_SCALAR *** vdx_brick
virtual void compute(int, int)
FFT_SCALAR *** v2_brick
double rms(int, double, bigint, double)
FFT_SCALAR ** drho_coeff
double compute_ewald_eqeq(const gsl_vector *)
FFT_SCALAR *** v3_brick
FFT_SCALAR *** u_brick
virtual double newton_raphson_f()
void make_rho_qeq(const gsl_vector *)
double FFT_SCALAR