My Project
Loading...
Searching...
No Matches
torch_allegro.h
1struct Allegro
2{
3 std::string ModelName;
4 torch::jit::script::Module Model;
5 Boxsize UCBox;
6 Boxsize ReplicaBox;
7 std::vector<Atoms> UCAtoms;
8 std::vector<Atoms> ReplicaAtoms;
9 double Cutoff = 6.0;
10 double Cutoffsq = 0.0;
11 NeighList NL;
12 int3 NReplicacell = {1,1,1};
13
14 size_t DNN_Molsize = 0; //Atom size to be considered for DNN, since there might be fictional atom sites for a classical sim molecule
15
16 size_t nstep = 0;
17
18 void GetSQ_From_Cutoff()
19 {
20 Cutoffsq = Cutoff * Cutoff;
21 }
22
23 double dot(double3 a, double3 b)
24 {
25 return a.x * b.x + a.y * b.y + a.z * b.z;
26 }
27 double matrix_determinant(double* x) //9*1 array
28 {
29 double m11 = x[0*3+0]; double m21 = x[1*3+0]; double m31 = x[2*3+0];
30 double m12 = x[0*3+1]; double m22 = x[1*3+1]; double m32 = x[2*3+1];
31 double m13 = x[0*3+2]; double m23 = x[1*3+2]; double m33 = x[2*3+2];
32 double determinant = +m11 * (m22 * m33 - m23 * m32) - m12 * (m21 * m33 - m23 * m31) + m13 * (m21 * m32 - m22 * m31);
33 return determinant;
34 }
35
36 void inverse_matrix(double* x, double **inverse_x)
37 {
38 double m11 = x[0*3+0]; double m21 = x[1*3+0]; double m31 = x[2*3+0];
39 double m12 = x[0*3+1]; double m22 = x[1*3+1]; double m32 = x[2*3+1];
40 double m13 = x[0*3+2]; double m23 = x[1*3+2]; double m33 = x[2*3+2];
41 double determinant = +m11 * (m22 * m33 - m23 * m32) - m12 * (m21 * m33 - m23 * m31) + m13 * (m21 * m32 - m22 * m31);
42 double* result = (double*) malloc(9 * sizeof(double));
43 result[0] = +(m22 * m33 - m32 * m23) / determinant;
44 result[3] = -(m21 * m33 - m31 * m23) / determinant;
45 result[6] = +(m21 * m32 - m31 * m22) / determinant;
46 result[1] = -(m12 * m33 - m32 * m13) / determinant;
47 result[4] = +(m11 * m33 - m31 * m13) / determinant;
48 result[7] = -(m11 * m32 - m31 * m12) / determinant;
49 result[2] = +(m12 * m23 - m22 * m13) / determinant;
50 result[5] = -(m11 * m23 - m21 * m13) / determinant;
51 result[8] = +(m11 * m22 - m21 * m12) / determinant;
52 *inverse_x = result;
53 }
54
55 __host__ double3 GetFractionalCoord(double* InverseCell, bool Cubic, double3 posvec)
56 {
57 double3 s = {0.0, 0.0, 0.0};
58 s.x=InverseCell[0*3+0]*posvec.x + InverseCell[1*3+0]*posvec.y + InverseCell[2*3+0]*posvec.z;
59 s.y=InverseCell[0*3+1]*posvec.x + InverseCell[1*3+1]*posvec.y + InverseCell[2*3+1]*posvec.z;
60 s.z=InverseCell[0*3+2]*posvec.x + InverseCell[1*3+2]*posvec.y + InverseCell[2*3+2]*posvec.z;
61 return s;
62 }
63
64 __host__ double3 GetRealCoordFromFractional(double* Cell, bool Cubic, double3 s)
65 {
66 double3 posvec = {0.0, 0.0, 0.0};
67 posvec.x=Cell[0*3+0]*s.x+Cell[1*3+0]*s.y+Cell[2*3+0]*s.z;
68 posvec.y=Cell[0*3+1]*s.x+Cell[1*3+1]*s.y+Cell[2*3+1]*s.z;
69 posvec.z=Cell[0*3+2]*s.x+Cell[1*3+2]*s.y+Cell[2*3+2]*s.z;
70 return posvec;
71 }
72
73 std::vector<std::string> split(const std::string txt, char ch)
74 {
75 size_t pos = txt.find(ch);
76 size_t initialPos = 0;
77 std::vector<std::string> strs{};
78
79 // Decompose statement
80 while (pos != std::string::npos) {
81
82 std::string s = txt.substr(initialPos, pos - initialPos);
83 if (!s.empty())
84 {
85 strs.push_back(s);
86 }
87 initialPos = pos + 1;
88
89 pos = txt.find(ch, initialPos);
90 }
91
92 // Add the last one
93 std::string s = txt.substr(initialPos, std::min(pos, txt.size()) - initialPos + 1);
94 if (!s.empty())
95 {
96 strs.push_back(s);
97 }
98
99 return strs;
100 }
101
102 bool caseInSensStringCompare(const std::string& str1, const std::string& str2)
103 {
104 return str1.size() == str2.size() && std::equal(str1.begin(), str1.end(), str2.begin(), [](auto a, auto b) {return std::tolower(a) == std::tolower(b); });
105 }
106
107 void Split_Tab_Space(std::vector<std::string>& termsScannedLined, std::string& str)
108 {
109 if (str.find("\t", 0) != std::string::npos) //if the delimiter is tab
110 {
111 termsScannedLined = split(str, '\t');
112 }
113 else
114 {
115 termsScannedLined = split(str, ' ');
116 }
117 }
118 /*
119 void write_ReplicaPos(auto& pos, auto& ij2type, size_t ntotal, size_t nstep)
120 {
121 std::ofstream textrestartFile{};
122 std::string fname = "Pos_Replica_" + std::to_string(nstep) + ".txt";
123 std::filesystem::path cwd = std::filesystem::current_path();
124 std::filesystem::path fileName = cwd /fname;
125 textrestartFile = std::ofstream(fileName, std::ios::out);
126
127 textrestartFile << "i x y z type\n";
128 for(size_t i = 0; i < ntotal; i++)
129 textrestartFile << i << " " << pos[i][0] << " " << pos[i][1] << " " << pos[i][2] << " " << ij2type[i] << "\n";
130 textrestartFile.close();
131 }
132 void write_edges(auto& edges, auto& ij2type, size_t nedges, size_t nstep)
133 {
134 std::ofstream textrestartFile{};
135 std::string fname = "Neighbor_List_" + std::to_string(nstep) + ".txt";
136 std::filesystem::path cwd = std::filesystem::current_path();
137 std::filesystem::path fileName = cwd /fname;
138 textrestartFile = std::ofstream(fileName, std::ios::out);
139
140 printf("There are %zu edges\n", nedges);
141
142 textrestartFile << "i j ij2type edge_counter\n";
143 for(size_t i = 0; i < nedges; i++)
144 textrestartFile << edges[0][i] << " " << edges[1][i] << " " << ij2type[edges[0][i]] << " " << i << "\n";
145 textrestartFile.close();
146 }
147 */
148 void AllocateUCSpace(size_t comp)
149 {
150 UCAtoms[comp].pos = (double3*) malloc(UCAtoms[comp].size * sizeof(double3));
151 UCAtoms[comp].Type = (size_t*) malloc(UCAtoms[comp].size * sizeof(size_t));
152 }
153
154 void GenerateUCBox(double* SuperCell, int3 Ncell)
155 {
156 UCBox.Cell = (double*) malloc(9 * sizeof(double));
157 UCBox.InverseCell = (double*) malloc(9 * sizeof(double));
158 for(size_t i = 0; i < 9; i++) UCBox.Cell[i] = SuperCell[i];
159 UCBox.Cell[0] /= Ncell.x; UCBox.Cell[1] = 0.0; UCBox.Cell[2] = 0.0;
160 UCBox.Cell[3] /= Ncell.y; UCBox.Cell[4] /= Ncell.y; UCBox.Cell[5] = 0.0;
161 UCBox.Cell[6] /= Ncell.z; UCBox.Cell[7] /= Ncell.z; UCBox.Cell[8] /= Ncell.z;
162 inverse_matrix(UCBox.Cell, &UCBox.InverseCell);
163 }
164
165 //Assuming the framework atoms are reproduced, and the order of atoms in a unit cell matches the order in the cif//
166 //This assumes rigid framework//
167 //Since it is framework (assuming all the atoms are DNN-used, consider them all)
168 //This will gaurentee that UCAtoms.size = DNN_consider_size, not NAtoms or HostAtoms.Molsize;
169 //Consider a TIP4P molecule, there is a fictional charge site that needs to be excluded//
170 //So the DNN will consider 2*hydrogen + 1*oxygen, but not the fictional charge site//
171 //TIP4P HostAtoms.Molsize = 4, here we want UCAtoms.size = 3//
172 void CopyAtomsFromFirstUnitcell(Atoms& HostAtoms, size_t comp, int3 NSupercell, PseudoAtomDefinitions& PseudoAtoms, bool* ConsiderThisAdsorbateAtom)
173 {
174 size_t NAtoms = HostAtoms.Molsize / (NSupercell.x * NSupercell.y * NSupercell.z);
175 if(HostAtoms.size % NAtoms != 0) throw std::runtime_error("SuperCell size cannot be divided by number of supercell atoms!!!!");
176 UCAtoms[comp].size = NAtoms;
177 //During the initialization phase, for adsorbate atoms, exclude those that are NOT considered in DNN.
178 //Still assuming one adsorbate species, do it only for adsorbate
179 if(comp != 0)
180 for(size_t i = 0; i < NAtoms; i++)
181 if(ConsiderThisAdsorbateAtom[i])
182 DNN_Molsize += 1;
183
184 if(comp != 0) UCAtoms[comp].size = DNN_Molsize;
185 AllocateUCSpace(comp);
186
187 size_t update_i = 0;
188 for(size_t i = 0; i < NAtoms; i++)
189 {
190 if(comp != 0)
191 if(!ConsiderThisAdsorbateAtom[i]) continue;
192 UCAtoms[comp].pos[update_i] = HostAtoms.pos[i];
193 size_t SymbolIdx = PseudoAtoms.GetSymbolIdxFromPseudoAtomTypeIdx(HostAtoms.Type[i]);
194 UCAtoms[comp].Type[update_i] = SymbolIdx;
195 //printf("Component %zu, Atom %zu, xyz %f %f %f, Type %zu, SymbolIndex %zu\n", comp, i, UCAtoms[comp].pos[i].x, UCAtoms[comp].pos[i].y, UCAtoms[comp].pos[i].z, HostAtoms.Type[i], UCAtoms[comp].Type[i]);
196 update_i ++;
197 }
198 }
199 /*
200 void ReadCutOffFromModel(std::string Name)
201 {
202 std::vector<std::string> termsScannedLined{};
203 std::ifstream simfile(Name);
204 std::filesystem::path pathfile = std::filesystem::path(Name);
205 std::string str;
206 size_t skip = 1;
207 size_t count= 0;
208 while (std::getline(simfile, str))
209 {
210 //if(count <= skip) continue;
211 if(str.find("r_max", 0) != std::string::npos)
212 {
213 Split_Tab_Space(termsScannedLined, str);
214 Cutoff = std::stod(termsScannedLined[1]);
215 return;
216 }
217 }
218 }
219 */
220 void ReadModel(std::string Name)
221 {
222 ModelName = Name;
223 //https://stackoverflow.com/questions/18199728/is-it-possible-to-have-an-auto-member-variable
224 //auto device = torch::kCPU;
225 auto device = torch::kCUDA;//c10::Device(torch::kCUDA,1);
226 //Added new lines from pair_allegro.cpp to see if it fixes the issue//
227 std::unordered_map<std::string, std::string> metadata =
228 {
229 {"config", ""},
230 {"nequip_version", ""},
231 {"r_max", ""},
232 {"n_species", ""},
233 {"type_names", ""},
234 {"_jit_bailout_depth", ""},
235 {"_jit_fusion_strategy", ""},
236 {"allow_tf32", ""}
237 };
238 Model = torch::jit::load(ModelName, device, metadata);
239 Model.eval();
240 //Freeze the model
241 Model = torch::jit::freeze(Model);
242 //ReadCutOffFromModel(ModelName);
243 }
244
245 double Predict()
246 {
247 size_t nAtoms = 0; for(size_t i = 0; i < UCAtoms.size(); i++) nAtoms += UCAtoms[i].size;
248 size_t ntotal = 0; for(size_t i = 0; i < ReplicaAtoms.size(); i++) ntotal += ReplicaAtoms[i].size;
249
250 torch::Tensor edges_tensor = torch::zeros({2,NL.nedges}, torch::TensorOptions().dtype(torch::kInt64));
251 auto edges = edges_tensor.accessor<long, 2>();
252
253 torch::Tensor pos_tensor = torch::zeros({ntotal, 3});
254 auto pos = pos_tensor.accessor<float, 2>();
255
256 torch::Tensor ij2type_tensor = torch::zeros({ntotal}, torch::TensorOptions().dtype(torch::kInt64));
257 auto ij2type = ij2type_tensor.accessor<long, 1>();
258
259 size_t counter = 0;
260 for(size_t comp = 0; comp < ReplicaAtoms.size(); comp++)
261 for(size_t i = 0; i < ReplicaAtoms[comp].size; i++)
262 {
263 pos[counter][0] = ReplicaAtoms[comp].pos[i].x;
264 pos[counter][1] = ReplicaAtoms[comp].pos[i].y;
265 pos[counter][2] = ReplicaAtoms[comp].pos[i].z;
266 ij2type[counter]= ReplicaAtoms[comp].Type[i];
267 //if(comp != 0)
268 // printf("comp %zu, counter %zu, ij2type %zu\n", comp, counter, ij2type[counter]);
269 counter ++;
270 }
271 size_t N_Replica_FrameworkAtoms = 0; size_t NFrameworkAtoms = 0;
272 N_Replica_FrameworkAtoms = ReplicaAtoms[0].size;
273 NFrameworkAtoms = UCAtoms[0].size;
274 for(size_t i = 0; i < nAtoms; i++)
275 {
276 for(size_t j = 0; j < NL.List[i].size(); j++)
277 {
278 size_t edge_counter = NL.List[i][j].z;
279 edges[0][edge_counter] = NL.List[i][j].x; //i
280 //Try to map the adsorbate i index to the replica-cell index
281 //So the replicacell-adsorbate for cell 0 (center box) is located after the framework atoms//
282 if(NL.List[i][j].x >= NFrameworkAtoms) //adsorbate molecule, shift i by number of framework replica atoms//
283 {
284 edges[0][edge_counter] -= NFrameworkAtoms;
285 edges[0][edge_counter] += (N_Replica_FrameworkAtoms);
286 }
287 edges[1][edge_counter] = NL.List[i][j].y; //j
288 //printf("i %d, j %d, edge_counter %d\n", NL.List[i][j].x, NL.List[i][j].y, NL.List[i][j].z);
289 }
290 }
291 //write_ReplicaPos(pos, ij2type, ntotal, nstep);
292 //write_edges(edges, ij2type, NL.nedges, nstep);
293
294 //auto device = torch::kCPU;
295 auto device = torch::kCUDA;//c10::Device(torch::kCUDA,1);
296 c10::Dict<std::string, torch::Tensor> input;
297 input.insert("pos", pos_tensor.to(device));
298 input.insert("edge_index", edges_tensor.to(device));
299 input.insert("atom_types", ij2type_tensor.to(device));
300 std::vector<torch::IValue> input_vector(1, input);
301
302 auto output = Model.forward(input_vector).toGenericDict();
303
304 torch::Tensor atomic_energy_tensor = output.at("atomic_energy").toTensor().cpu();
305 auto atomic_energies = atomic_energy_tensor.accessor<float, 2>();
306
307 float atomic_energy_sum = atomic_energy_tensor.sum().data_ptr<float>()[0];
308
309 float nAtomSum = 0.0;
310 for(size_t i = 0; i < nAtoms; i++)
311 {
312 size_t AtomIndex = i;
313 if(i >= NFrameworkAtoms) //adsorbate molecule, shift i by number of framework replica atoms//
314 {
315 AtomIndex -= NFrameworkAtoms;
316 AtomIndex += N_Replica_FrameworkAtoms;
317 }
318 nAtomSum += atomic_energies[AtomIndex][0];
319 //printf("atom %zu, AtomIndex %zu, energy: %.5f\n", i, AtomIndex, atomic_energies[AtomIndex][0]);
320 }
321 nstep ++;
322 return static_cast<double>(nAtomSum);
323 }
324
325 void ReplicateAtomsPerComponent(size_t comp, bool Allocate)
326 {
327 //Get Fractional positions//
328 std::vector<double3>fpos;
329 for(size_t i = 0; i < UCAtoms[comp].size; i++)
330 {
331 fpos.push_back(GetFractionalCoord(UCBox.InverseCell, UCBox.Cubic, UCAtoms[comp].pos[i]));
332 }
333
334 size_t NTotalCell = static_cast<size_t>(NReplicacell.x * NReplicacell.y * NReplicacell.z);
335 double3 Shift = {(double)1/NReplicacell.x, (double)1/NReplicacell.y, (double)1/NReplicacell.z};
336 if(NReplicacell.x % 2 == 0) throw std::runtime_error("Ncell in x needs to be an odd number (so that original unit cell sits in the center\n");
337 if(NReplicacell.y % 2 == 0) throw std::runtime_error("Ncell in y needs to be an odd number (so that original unit cell sits in the center\n");
338 if(NReplicacell.z % 2 == 0) throw std::runtime_error("Ncell in z needs to be an odd number (so that original unit cell sits in the center\n");
339 int Minx = (NReplicacell.x - 1)/2 * -1; int Maxx = (NReplicacell.x - 1)/2;
340 int Miny = (NReplicacell.y - 1)/2 * -1; int Maxy = (NReplicacell.y - 1)/2;
341 int Minz = (NReplicacell.z - 1)/2 * -1; int Maxz = (NReplicacell.z - 1)/2;
342 std::vector<int>xs; std::vector<int>ys; std::vector<int>zs;
343 xs.push_back(0);
344 ys.push_back(0);
345 zs.push_back(0);
346 for(int i = Minx; i <= Maxx; i++)
347 if(i != 0)
348 xs.push_back(i);
349 for(int i = Miny; i <= Maxy; i++)
350 if(i != 0)
351 ys.push_back(i);
352 for(int i = Minz; i <= Maxz; i++)
353 if(i != 0)
354 zs.push_back(i);
355
356 if(Allocate)
357 {
358 ReplicaAtoms[comp].pos = (double3*) malloc(NTotalCell * UCAtoms[comp].size * sizeof(double3));
359 ReplicaAtoms[comp].Type = (size_t*) malloc(NTotalCell * UCAtoms[comp].size * sizeof(size_t));
360 }
361 size_t counter = 0;
362 for(size_t a = 0; a < static_cast<size_t>(NReplicacell.x); a++)
363 for(size_t b = 0; b < static_cast<size_t>(NReplicacell.y); b++)
364 for(size_t c = 0; c < static_cast<size_t>(NReplicacell.z); c++)
365 {
366 int ix = xs[a];
367 int jy = ys[b];
368 int kz = zs[c];
369 //printf("a: %zu, ix: %d, b: %zu, jy: %d, c: %zu, kz: %d\n", a, ix, b, jy, c, kz);
370 double3 NCellID = {(double) ix, (double) jy, (double) kz};
371 for(size_t i = 0; i < UCAtoms[comp].size; i++)
372 {
373 double3 temp = {fpos[i].x + NCellID.x,
374 fpos[i].y + NCellID.y,
375 fpos[i].z + NCellID.z};
376 double3 super_fpos = {temp.x * Shift.x,
377 temp.y * Shift.y,
378 temp.z * Shift.z};
379 // Get real xyz from fractional xyz //
380 double3 Replica_pos;
381 Replica_pos.x = super_fpos.x*ReplicaBox.Cell[0]+super_fpos.y*ReplicaBox.Cell[3]+super_fpos.z*ReplicaBox.Cell[6];
382 Replica_pos.y = super_fpos.x*ReplicaBox.Cell[1]+super_fpos.y*ReplicaBox.Cell[4]+super_fpos.z*ReplicaBox.Cell[7];
383 Replica_pos.z = super_fpos.x*ReplicaBox.Cell[2]+super_fpos.y*ReplicaBox.Cell[5]+super_fpos.z*ReplicaBox.Cell[8];
384 ReplicaAtoms[comp].pos[counter] = Replica_pos;
385 ReplicaAtoms[comp].Type[counter] = UCAtoms[comp].Type[i];
386 counter ++;
387 }
388 }
389 ReplicaAtoms[comp].size = NTotalCell * UCAtoms[comp].size;
390 }
391
392 //For Single Unit cell atoms, we separate them into different components//
393 //For replica, we also do that//
394 void GenerateReplicaCells(bool Allocate)
395 {
396 size_t NComp = UCAtoms.size();
397 size_t N_UCAtom = 0; for(size_t comp = 0; comp < NComp; comp++) N_UCAtom += UCAtoms[comp].size;
398 if(Allocate)
399 {
400 ReplicaBox.Cell = (double*) malloc(9 * sizeof(double));
401 ReplicaBox.InverseCell = (double*) malloc(9 * sizeof(double));
402 for(size_t i = 0; i < 9; i++) ReplicaBox.Cell[i] = UCBox.Cell[i];
403
404 ReplicaBox.Cell[0] *= NReplicacell.x; ReplicaBox.Cell[1] *= 0.0; ReplicaBox.Cell[2] *= 0.0;
405 ReplicaBox.Cell[3] *= NReplicacell.y; ReplicaBox.Cell[4] *= NReplicacell.y; ReplicaBox.Cell[5] *= 0.0;
406 ReplicaBox.Cell[6] *= NReplicacell.z; ReplicaBox.Cell[7] *= NReplicacell.z; ReplicaBox.Cell[8] *= NReplicacell.z;
407
408 printf("a: %f, b: %f, c: %f\n", ReplicaBox.Cell[0], ReplicaBox.Cell[4], ReplicaBox.Cell[8]);
409 inverse_matrix(ReplicaBox.Cell, &ReplicaBox.InverseCell);
410 }
411 //Assuming Framework fixed//
412 for(size_t comp = 0; comp < UCAtoms.size(); comp++)
413 if(Allocate || comp != 0)
414 ReplicateAtomsPerComponent(comp, Allocate);
415 }
416 void Get_Neighbor_List_Replica(bool Initialize)
417 {
418 if(Initialize) GetSQ_From_Cutoff();
419 size_t AtomCount = 0;
420 for(size_t comp = 0; comp < UCAtoms.size(); comp++)
421 {
422 for(size_t j = 0; j < UCAtoms[comp].size; j++)
423 {
424 std::vector<int3>Neigh_per_atom;
425 if(Initialize)
426 {
427 NL.List.push_back(Neigh_per_atom);
428 NL.cumsum_neigh_per_atom.push_back(0);
429 }
430 else
431 {
432 NL.List[AtomCount] = Neigh_per_atom;
433 NL.cumsum_neigh_per_atom[AtomCount] = 0;
434 }
435 AtomCount ++; //printf("AtomCount: %zu\n", AtomCount);
436 }
437 }
438 NL.nedges = 0; //rezero
439 if(!Initialize) Copy_From_Rigid_Framework_Edges(UCAtoms[0].size); //When compi = 0 and compj = 0//
440
441 size_t i_start = 0;
442 for(size_t compi = 0; compi < UCAtoms.size(); compi++)
443 {
444 size_t j_start = 0;
445 for(size_t compj = 0; compj < ReplicaAtoms.size(); compj++)
446 {
447 if(Initialize || (compi != 0 || compj != 0))
448 {
449 //printf("compi %zu, compj %zu, nedges %zu\n", compi, compj, NL.nedges);
450 bool SameComponent = false; if(compi == compj) SameComponent = true;
451 Count_Edges_Replica(compi, compj, i_start, j_start, SameComponent);
452 if(Initialize && compi == 0 && compj == 0) Copy_To_Rigid_Framework_Edges(UCAtoms[0].size);
453 }
454 j_start += ReplicaAtoms[compj].size;
455 }
456 i_start += UCAtoms[compi].size;
457 }
458 int prev = 0;
459 for(size_t i = 0; i < NL.List.size(); i++)
460 {
461 size_t nedge_perAtom = NL.List[i].size();
462 if(i != 0) prev = NL.cumsum_neigh_per_atom[i-1];
463 NL.cumsum_neigh_per_atom[i] = prev + nedge_perAtom;
464 //printf("Atom %zu, cumsum: %zu\n", i, NL.cumsum_neigh_per_atom[i]);
465 }
466 }
467
468 void Count_Edges_Replica(size_t compi, size_t compj, size_t i_start, size_t j_start, bool SameComponent)
469 {
470 //printf("Atom size %zu, ReplicaAtom size %zu, i_start %zu, j_start %zu\n", UCAtoms[compi].size, ReplicaAtoms[compj].size, i_start, j_start);
471 for(size_t i = 0; i < UCAtoms[compi].size; i++)
472 {
473 size_t i_idx = i_start + i;
474 for(size_t j = 0; j < ReplicaAtoms[compj].size; j++)
475 {
476 size_t j_idx = j_start + j;
477 if(i == j && SameComponent) continue; //Becareful with this line, we are separating the atoms into different components, CO2 atom for replica-cell and for unitcell should have the same i/j, so we just compare i/j (relative index), not i_idx/j_idx (absolute index).
478 //Also need to make sure that they are the same component when comparing//
479 double3 dist = {UCAtoms[compi].pos[i].x - ReplicaAtoms[compj].pos[j].x,
480 UCAtoms[compi].pos[i].y - ReplicaAtoms[compj].pos[j].y,
481 UCAtoms[compi].pos[i].z - ReplicaAtoms[compj].pos[j].z};
482
483 double dsq = dot(dist, dist);
484 if(dsq <= Cutoffsq)
485 {
486 NL.List[i_idx].push_back({(int)i_idx, (int)j_idx, (int) NL.nedges}); //nedge here = edge_counter//
487 NL.nedges ++;
488 }
489 }
490 }
491 //printf("i_start %zu, j_start %zu, nedges %zu\n", i_start, j_start, NL.nedges);
492 }
493
494 //Record framework-framework neighbor list//
495 void Copy_To_Rigid_Framework_Edges(size_t NFrameworkAtom)
496 {
497 for(size_t i = 0; i < NFrameworkAtom; i++)
498 {
499 NL.FrameworkList.push_back(NL.List[i]);
500 }
501 }
502 void Copy_From_Rigid_Framework_Edges(size_t NFrameworkAtom)
503 {
504 for(size_t i = 0; i < NFrameworkAtom; i++)
505 {
506 NL.List[i] = NL.FrameworkList[i];
507 NL.nedges += NL.FrameworkList[i].size();
508 }
509 }
510 void WrapSuperCellAtomIntoUCBox(size_t comp)
511 {
512 std::vector<double>Bonds; //For checking bond distances if the molecule is wrapped onto different sides of the box//
513 std::vector<double3>newpos;
514 for(size_t i = 0; i < UCAtoms[comp].size; i++)
515 {
516 double3 FPOS = GetFractionalCoord(UCBox.InverseCell, UCBox.Cubic, UCAtoms[comp].pos[i]);
517 //printf("New Atom %zu, fxyz: %f %f %f\n", i, FPOS.x, FPOS.y, FPOS.z);
518 double3 FLOOR = {(double)floor(FPOS.x), (double)floor(FPOS.y), (double)floor(FPOS.z)};
519 double3 New_fpos = {FPOS.x - FLOOR.x,
520 FPOS.y - FLOOR.y,
521 FPOS.z - FLOOR.z};
522
523 newpos.push_back(New_fpos);
524
525 if(i == 0) continue;
526 double3 dist = {UCAtoms[comp].pos[i].x - UCAtoms[comp].pos[i - 1].x,
527 UCAtoms[comp].pos[i].y - UCAtoms[comp].pos[i - 1].y,
528 UCAtoms[comp].pos[i].z - UCAtoms[comp].pos[i - 1].z};
529 double dsq = dot(dist, dist);
530 Bonds.push_back(dsq);
531 }
532 for(size_t i = 0; i < UCAtoms[comp].size; i++)
533 {
534 double3 Real_Pos = GetRealCoordFromFractional(UCBox.Cell, UCBox.Cubic, newpos[i]);
535 UCAtoms[comp].pos[i] = Real_Pos;
536 /*
537 //printf("NEW POS %zu, xyz: %f %f %f\n", Real_Pos.x, Real_Pos.y, Real_Pos.z);
538 if(i == 0) continue;
539 double3 dist = {UCAtoms[comp].pos[i].x - UCAtoms[comp].pos[i - 1].x,
540 UCAtoms[comp].pos[i].y - UCAtoms[comp].pos[i - 1].y,
541 UCAtoms[comp].pos[i].z - UCAtoms[comp].pos[i - 1].z};
542 double dsq = dot(dist, dist);
543 if(abs(dsq - Bonds[i]) > 1e-10)
544 printf("THERE IS ERROR IN BOND LENGTH AFTER WRAPPING for ATOM %zu\n", i);
545 */
546 }
547 }
548 //This function is called after the position of the trial adsorbate molecule is prepared in UCAtoms//
549 double MCEnergyWrapper(size_t comp, bool Initialize, double DNNEnergyConversion)
550 {
551 WrapSuperCellAtomIntoUCBox(comp);
552 GenerateReplicaCells(Initialize);
553 Get_Neighbor_List_Replica(Initialize);
554 double DNN_E = Predict();
555 //This generates the unit of eV, convert to 10J/mol.
556 //https://www.weizmann.ac.il/oc/martin/tools/hartree.html
557 return DNN_E * DNNEnergyConversion;
558 }
559 /*
560 void CopyHostToUCAtoms(double3* pos, size_t comp, size_t Molsize)
561 {
562 for(size_t i = 0; i < Molsize; i++)
563 UCAtoms[comp].pos[i] = pos[i];
564 }
565 */
566};
Definition torch_allegro.h:2
Definition data_struct.h:746
Definition data_struct.h:819
Definition data_struct.h:811
Definition data_struct.h:767