My Project
Loading...
Searching...
No Matches
mc_widom.h
1#include <algorithm>
2#include <omp.h>
3#include <cuda_fp16.h>
4#include <thrust/device_ptr.h>
5#include <thrust/reduce.h>
6static inline size_t SelectTrialPosition(std::vector <double> LogBoltzmannFactors) //In Zhao's code, LogBoltzmannFactors = Rosen
7{
8 std::vector<double> ShiftedBoltzmannFactors(LogBoltzmannFactors.size());
9
10 // Energies are always bounded from below [-U_max, infinity>
11 // Find the lowest energy value, i.e. the largest value of (-Beta U)
12 double largest_value = *std::max_element(LogBoltzmannFactors.begin(), LogBoltzmannFactors.end());
13
14 // Standard trick: shift the Boltzmann factors down to avoid numerical problems
15 // The largest value of 'ShiftedBoltzmannFactors' will be 1 (which corresponds to the lowest energy).
16 double SumShiftedBoltzmannFactors = 0.0;
17 for (size_t i = 0; i < LogBoltzmannFactors.size(); ++i)
18 {
19 ShiftedBoltzmannFactors[i] = exp(LogBoltzmannFactors[i] - largest_value);
20 SumShiftedBoltzmannFactors += ShiftedBoltzmannFactors[i];
21 }
22
23 // select the Boltzmann factor
24 size_t selected = 0;
25 double cumw = ShiftedBoltzmannFactors[0];
26 double ws = Get_Uniform_Random() * SumShiftedBoltzmannFactors;
27 while (cumw < ws)
28 cumw += ShiftedBoltzmannFactors[++selected];
29
30 return selected;
31}
32
33template<typename T>
34inline void Host_sum_Widom_HGGG_SEPARATE(size_t NumberWidomTrials, double Beta, T* energy_array, bool* flag, size_t HG_Nblock, size_t HGGG_Nblock, std::vector<MoveEnergy>& energies, std::vector<size_t>& Trialindex, std::vector<double>& Rosen, size_t Cycle)
35{
36 std::vector<size_t>reasonable_trials;
37 for(size_t i = 0; i < NumberWidomTrials; i++){
38 if(!flag[i]){
39 reasonable_trials.push_back(i);}}
40 T host_array[HGGG_Nblock * 2];
41 for(size_t i = 0; i < reasonable_trials.size(); i++)
42 {
43 size_t trial = reasonable_trials[i];
44 cudaMemcpy(host_array, &energy_array[trial*HGGG_Nblock * 2], 2 * HGGG_Nblock*sizeof(T), cudaMemcpyDeviceToHost);
45 T HG_vdw = 0.0; T HG_real = 0.0;
46 T GG_vdw = 0.0; T GG_real = 0.0;
47 //Zhao's note: If during the pairwise interaction, there is no overlap, then don't check overlap in the summation//
48 //Otherwise, it will cause issues when using the fractional molecule (energy drift in retrace)//
49 //So translation/rotation summation of energy are not checking the overlaps, so this is the reason for the discrepancy//
50 for(size_t ijk=0; ijk < HG_Nblock; ijk++) HG_vdw+=host_array[ijk];
51 for(size_t ijk=HG_Nblock; ijk < HGGG_Nblock; ijk++) GG_vdw+=host_array[ijk];
52
53 for(size_t ijk=HGGG_Nblock; ijk < HG_Nblock + HGGG_Nblock; ijk++) HG_real+=host_array[ijk];
54 for(size_t ijk=HG_Nblock + HGGG_Nblock; ijk < HGGG_Nblock + HGGG_Nblock; ijk++) GG_real+=host_array[ijk];
55
56 double tot = static_cast<double>(HG_vdw + GG_vdw + HG_real + GG_real);
57
58 MoveEnergy E;
59 E.HGVDW = static_cast<double>(HG_vdw);
60 E.HGReal= static_cast<double>(HG_real);
61 E.GGVDW = static_cast<double>(GG_vdw);
62 E.GGReal= static_cast<double>(GG_real);
63 //if(Cycle == 687347) printf("trial: %zu, HG: %.5f, GG: %.5f, tot: %.5f\n", i, HG_tot, GG_tot, tot);
64 energies.push_back(E);
65 Trialindex.push_back(trial);
66 Rosen.push_back(-Beta*tot);
67 //printf("Trial %zu ", trial); E.print();
68 }
69}
70
71__global__ void get_random_trial_position(Boxsize Box, Atoms* d_a, Atoms NewMol, bool* device_flag, RandomNumber Random, size_t start_position, size_t SelectedComponent, size_t MolID, int MoveType, double2 proposed_scale)
72{
73 double3* random = Random.device_random;
74 size_t offset = Random.offset;
75
76 const size_t i = blockIdx.x * blockDim.x + threadIdx.x;
77 const size_t random_index = i + offset;
78 const Atoms AllData = d_a[SelectedComponent];
79 double scale=0.0; double scaleCoul = 0.0;
80
81 switch(MoveType)
82 {
83 case CBMC_INSERTION: //Insertion (whole and fractional molecule)//
84 {
85 scale = proposed_scale.x; scaleCoul = proposed_scale.y;
86 double3 BoxLength = {Box.Cell[0], Box.Cell[4], Box.Cell[8]};
87 NewMol.pos[i] = BoxLength * random[random_index];
88 break;
89 }
90 case CBMC_DELETION: //Deletion (whole and fractional molecule)//
91 {
92 scale = AllData.scale[start_position]; scaleCoul = AllData.scaleCoul[start_position];
93 if(i==0) //if deletion, the first trial position is the old position of the selected molecule//
94 {
95 NewMol.pos[i] = AllData.pos[start_position];
96 }
97 else
98 {
99 double3 BoxLength = {Box.Cell[0], Box.Cell[4], Box.Cell[8]};
100 NewMol.pos[i] = BoxLength * random[random_index];
101 }
102 //printf("FIRSTBEAD: trial: %lu, xyz: %.5f %.5f %.5f\n", i, NewMol.pos[i].x, NewMol.pos[i].y, NewMol.pos[i].z);
103 //if(i == 0) printf("i=0, start_position: %lu\n", start_position);
104 break;
105 }
106 case REINSERTION_INSERTION: //Reinsertion-Insertion//
107 {
108 scale = AllData.scale[start_position];
109 scaleCoul = AllData.scaleCoul[start_position];
110 double3 BoxLength = {Box.Cell[0], Box.Cell[4], Box.Cell[8]};
111 NewMol.pos[i] = BoxLength * random[random_index];
112 break;
113 }
114 case REINSERTION_RETRACE: //Reinsertion-Retrace//
115 {
116 scale = AllData.scale[start_position]; scaleCoul = AllData.scaleCoul[start_position];
117 if(i==0) //if deletion, the first trial position is the old position of the selected molecule//
118 {
119 NewMol.pos[i] = AllData.pos[start_position];
120 }
121 else //Zhao's note: not necessarily correct, retrace only needs 1 trial, no else statement needed//
122 {
123 double3 BoxLength = {Box.Cell[0], Box.Cell[4], Box.Cell[8]};
124 NewMol.pos[i] = BoxLength * random[random_index];
125 }
126 break;
127 }
128 case IDENTITY_SWAP_NEW: //IDENTITY-SWAP, NEW CONFIGURATION//
129 {
130 //xyz = the first bead of the molecule being identity swapped, already taken care of outside of the function//
131 scale = proposed_scale.x; scaleCoul = proposed_scale.y;
132 break;
133 }
134 case IDENTITY_SWAP_OLD:
135 {
136 scale = AllData.scale[start_position]; scaleCoul = AllData.scaleCoul[start_position];
137 if(i==0) //if deletion, the first trial position is the old position of the selected molecule//
138 {
139 NewMol.pos[i] = AllData.pos[start_position];
140 }
141 }
142 }
143 NewMol.scale[i] = scale;
144 NewMol.charge[i] = AllData.charge[start_position];
145 NewMol.scaleCoul[i] = scaleCoul;
146 NewMol.Type[i] = AllData.Type[start_position];
147 NewMol.MolID[i] = MolID;
148 /*
149 if(MoveType == IDENTITY_SWAP_NEW)
150 {
151 printf("scale: %.5f charge: %.5f scaleCoul: %.5f, Type: %lu, MolID: %lu\n", NewMol.scale[i], NewMol.charge[i], NewMol.scaleCoul[i] , NewMol.Type[i], NewMol.MolID[i] );
152 }
153 */
154 device_flag[i] = false;
155}
156
157__global__ void get_random_trial_orientation(Boxsize Box, Atoms* d_a, Atoms Mol, Atoms NewMol, bool* device_flag, double3* random, size_t offset, size_t FirstBeadTrial, size_t start_position, size_t SelectedComponent, size_t MolID, size_t chainsize, int MoveType, double2 proposed_scale, size_t Cycle)
158{
159 //Zhao's note: for trial orientations, each orientation may have more than 1 atom, do a for loop. So the threads are for different trial orientations, rather than different atoms in different orientations//
160 //Zhao's note: chainsize is the size of the molecule excluding the first bead(-1).
161 //Zhao's note: caveat: I am assuming the first bead of insertion is the first bead defined in def file. Need to relax this assumption in the future//
162 //Zhao's note: First bead position stored in Mol, at position zero
163 //Insertion/Widom: MolID = NewValue (Component.NumberOfMolecule_for_Component[SelectedComponent])
164 //Deletion: MolID = selected ID
165 const size_t i = blockIdx.x * blockDim.x + threadIdx.x;
166
167 //Record First Bead Information//
168 if(i == 0)
169 {
170 Mol.pos[0] = NewMol.pos[FirstBeadTrial];
171 Mol.scale[0] = NewMol.scale[FirstBeadTrial];
172 Mol.charge[0] = NewMol.charge[FirstBeadTrial];
173 Mol.scaleCoul[0] = NewMol.scaleCoul[FirstBeadTrial];
174 Mol.Type[0] = NewMol.Type[FirstBeadTrial];
175 Mol.MolID[0] = NewMol.MolID[FirstBeadTrial];
176 }
177 //Quaternions uses 3 random seeds//
178 size_t random_index = i + offset;
179 const Atoms AllData = d_a[SelectedComponent];
180 //different from translation (where we copy a whole molecule), here we duplicate the properties of the first bead of a molecule
181 // so use start_position, not real_pos
182 //Zhao's note: when there are zero molecule for the species, we need to use some preset values
183 //the first values always have some numbers. The xyz are not correct, but type and charge are correct. Use those.
184 double scale = 0.0; double scaleCoul = 0.0;
185 for(size_t a = 0; a < chainsize; a++)
186 {
187 double3 Vec;
188 Vec = AllData.pos[1+a] - AllData.pos[0];
189 switch(MoveType)
190 {
192 //Zhao's note: It depends on whether Identity_swap needs to be operated on fractional molecules//
193 //FOR NOW, JUST PUT IT ALONGSIDE WITH CBMC_INSERTION //
195 case CBMC_INSERTION: case IDENTITY_SWAP_NEW: //Insertion (whole/fractional Molecule)//
196 {
197 scale = proposed_scale.x; scaleCoul = proposed_scale.y;
198 Rotate_Quaternions(Vec, random[random_index]);
199 NewMol.pos[i*chainsize+a] = Mol.pos[0] + Vec;
200 break;
201 }
202 case CBMC_DELETION: //Deletion (whole/fractional molecule)//
203 {
204 scale = AllData.scale[start_position+a]; scaleCoul = AllData.scaleCoul[start_position+a];
205 if(i==0) //if deletion, the first trial position is the old position of the selected molecule//
206 {
207 NewMol.pos[i*chainsize+a] = AllData.pos[start_position+a];
208 }
209 else
210 {
211 Rotate_Quaternions(Vec, random[random_index]);
212 NewMol.pos[i*chainsize+a] = Mol.pos[0] + Vec;
213 }
214 //printf("CHAIN: trial: %lu, xyz: %.5f %.5f %.5f\n", i, NewMol.pos[i*chainsize+a].x, NewMol.pos[i*chainsize+a].y, NewMol.pos[i*chainsize+a].z);
215 //if(i == 0) printf("i=0, start_position: %lu\n", start_position);
216 break;
217 }
218 case REINSERTION_INSERTION: //Reinsertion-Insertion//
219 {
220 scale = AllData.scale[start_position+a]; scaleCoul = AllData.scaleCoul[start_position+a];
221 Rotate_Quaternions(Vec, random[random_index]);
222 NewMol.pos[i*chainsize+a] = Mol.pos[0] + Vec;
223 break;
224 }
225 case REINSERTION_RETRACE: case IDENTITY_SWAP_OLD: //Reinsertion-Retrace, but also works for Identity swap (old molecule) for multiple orientations (not first bead) //
226 {
227 scale = AllData.scale[start_position+a]; scaleCoul = AllData.scaleCoul[start_position+a];
228 if(i==0) //if deletion, the first trial position is the old position of the selected molecule//
229 {
230 NewMol.pos[i*chainsize+a] = AllData.pos[start_position+a];
231 }
232 else
233 {
234 Rotate_Quaternions(Vec, random[random_index]);
235 NewMol.pos[i*chainsize+a] = Mol.pos[0] + Vec;
236 }
237 break;
238 }
239 }
240 NewMol.scale[i*chainsize+a] = scale; NewMol.charge[i*chainsize+a] = AllData.charge[start_position+a];
241 NewMol.scaleCoul[i*chainsize+a] = scaleCoul;
242 NewMol.Type[i*chainsize+a] = AllData.Type[start_position+a]; NewMol.MolID[i*chainsize+a] = MolID;
243 }
244 device_flag[i] = false;
245}
246
247
248static inline double Widom_Move_FirstBead_PARTIAL(Components& SystemComponents, Simulations& Sims, ForceField& FF, RandomNumber& Random, WidomStruct& Widom, size_t SelectedMolInComponent, size_t SelectedComponent, int MoveType, double &StoredR, size_t *REAL_Selected_Trial, bool *SuccessConstruction, MoveEnergy *energy, double2 proposed_scale)
249{
250
251 bool Goodconstruction = false; size_t SelectedTrial = 0; double Rosenbluth = 0.0;
252 size_t Atomsize = 0;
253 for(size_t ijk = 0; ijk < SystemComponents.NComponents.x; ijk++)
254 {
255 Atomsize += SystemComponents.Moleculesize[ijk] * SystemComponents.NumberOfMolecule_for_Component[ijk];
256 }
257 std::vector<double>Rosen; std::vector<MoveEnergy>energies; std::vector<size_t>Trialindex;
258
259 //Three variables to settle: NumberOfTrials, start_position, SelectedMolID
260 //start_position: where to copy data from
261 //SelectedMolID : MolID to assign to the new molecule
262 size_t NumberOfTrials = Widom.NumberWidomTrials;
263 size_t start_position = SelectedMolInComponent*SystemComponents.Moleculesize[SelectedComponent];
264 size_t SelectedMolID = SelectedMolInComponent;
265 switch(MoveType)
266 {
267 case CBMC_INSERTION:
268 {
269 start_position = 0;
270 SelectedMolID = SystemComponents.NumberOfMolecule_for_Component[SelectedComponent];
271 break;
272 }
273 case CBMC_DELETION: case REINSERTION_INSERTION:
274 {
275 break; //Go With Default//
276 }
277 case REINSERTION_RETRACE: case IDENTITY_SWAP_OLD:
278 {
279 NumberOfTrials = 1;
280
281 break;
282 }
283 case IDENTITY_SWAP_NEW:
284 {
285 NumberOfTrials = 1;
286 start_position = 0;
287 SelectedMolID = SystemComponents.NumberOfMolecule_for_Component[SelectedComponent];
288 break;
289 }
290 }
291 size_t threadsNeeded = Atomsize * NumberOfTrials;
292
293 Random.Check(NumberOfTrials);
294
295 //printf("MoveType: %d, Ntrial: %zu, SelectedMolID: %zu, start_position: %zu, selectedComponent: %zu\n", MoveType, NumberOfTrials, SelectedMolID, start_position, SelectedComponent);
296
297 get_random_trial_position<<<1,NumberOfTrials>>>(Sims.Box, Sims.d_a, Sims.New, Sims.device_flag, Random, start_position, SelectedComponent, SelectedMolID, MoveType, proposed_scale); checkCUDAError("error getting random trials");
298 Random.Update(NumberOfTrials);
299
300 //printf("Selected Component: %zu, Selected Molecule: %zu (%zu), Total in Component: %zu\n", SelectedComponent, SelectedMolID, SelectedMolInComponent, SystemComponents.NumberOfMolecule_for_Component[SelectedComponent]);
301
302 // Setup the pairwise calculation //
303 // Setup Number of Blocks and threads for separated HG + GG calculations //
304 size_t NHostAtom = 0; size_t NGuestAtom = 0;
305 for(size_t i = 0; i < SystemComponents.NComponents.y; i++)
306 NHostAtom += SystemComponents.Moleculesize[i] * SystemComponents.NumberOfMolecule_for_Component[i];
307 for(size_t i = SystemComponents.NComponents.y; i < SystemComponents.NComponents.x; i++)
308 NGuestAtom+= SystemComponents.Moleculesize[i] * SystemComponents.NumberOfMolecule_for_Component[i];
309
310 size_t HG_Nthread=0; size_t HG_Nblock=0; Setup_threadblock(NHostAtom * 1, &HG_Nblock, &HG_Nthread);
311 size_t GG_Nthread=0; size_t GG_Nblock=0; Setup_threadblock(NGuestAtom * 1, &GG_Nblock, &GG_Nthread);
312 size_t HGGG_Nthread = std::max(HG_Nthread, GG_Nthread);
313 size_t HGGG_Nblock = HG_Nblock + GG_Nblock;
314 if(Atomsize != 0)
315 {
316 Calculate_Multiple_Trial_Energy_SEPARATE_HostGuest_VDWReal<<<HGGG_Nblock * NumberOfTrials, HGGG_Nthread, 2 * HGGG_Nthread * sizeof(double)>>>(Sims.Box, Sims.d_a, Sims.New, FF, Sims.Blocksum, SelectedComponent, Atomsize, Sims.device_flag, threadsNeeded,1, HGGG_Nblock, HG_Nblock, SystemComponents.NComponents, Sims.ExcludeList); checkCUDAError("Error calculating energies (PARTIAL SUM HGGG)");
317 cudaMemcpy(SystemComponents.flag, Sims.device_flag, NumberOfTrials*sizeof(bool), cudaMemcpyDeviceToHost);
318 }
319 //printf("OldNBlock: %zu, HG_Nblock: %zu, GG_Nblock: %zu, HGGG_Nblock: %zu\n", Nblock, HG_Nblock, GG_Nblock, HGGG_Nblock);
320
321 //printf("FIRST BEAD ENERGIES\n");
322 Host_sum_Widom_HGGG_SEPARATE(NumberOfTrials, SystemComponents.Beta, Sims.Blocksum, SystemComponents.flag, HG_Nblock, HGGG_Nblock, energies, Trialindex, Rosen, SystemComponents.CURRENTCYCLE);
323
324 double averagedRosen = 0.0;
325 size_t REALselected = 0;
326 //Zhao's note: The final part of the CBMC seems complicated, using a switch may help understand how each case is processed//
327 switch(MoveType)
328 {
329 case CBMC_INSERTION: case REINSERTION_INSERTION:
330 {
331 if(Rosen.size() == 0) break;
332 SelectedTrial = SelectTrialPosition(Rosen);
333 for(size_t a = 0; a < Rosen.size(); a++) Rosen[a] = std::exp(Rosen[a]);
334 Rosenbluth =std::accumulate(Rosen.begin(), Rosen.end(), decltype(Rosen)::value_type(0));
335 if(Rosenbluth < 1e-150) break;
336 Goodconstruction = true;
337 break;
338 }
339 case IDENTITY_SWAP_NEW:
340 {
341 if(Rosen.size() == 0) break;
342 SelectedTrial = 0;
343 for(size_t a = 0; a < Rosen.size(); a++) Rosen[a] = std::exp(Rosen[a]);
344 Rosenbluth =std::accumulate(Rosen.begin(), Rosen.end(), decltype(Rosen)::value_type(0));
345 if(Rosenbluth < 1e-150) break;
346 Goodconstruction = true;
347 break;
348 }
349 case CBMC_DELETION: case REINSERTION_RETRACE: case IDENTITY_SWAP_OLD:
350 {
351 SelectedTrial = 0;
352 for(size_t a = 0; a < Rosen.size(); a++) Rosen[a] = std::exp(Rosen[a]);
353 Rosenbluth =std::accumulate(Rosen.begin(), Rosen.end(), decltype(Rosen)::value_type(0));
354 Goodconstruction = true;
355 break;
356 }
357 }
358
359 if(!Goodconstruction) return 0.0;
360 REALselected = Trialindex[SelectedTrial];
361
362 if(MoveType == REINSERTION_INSERTION) StoredR = Rosenbluth - Rosen[SelectedTrial];
363 if(MoveType == REINSERTION_RETRACE) Rosenbluth += StoredR;
364 //For 1st bead for identity swap, there is only 1 bead used for insertion/retrace, don't divide.//
365 averagedRosen = Rosenbluth;
366 if(MoveType != IDENTITY_SWAP_OLD && MoveType != IDENTITY_SWAP_NEW)
367 averagedRosen /= double(Widom.NumberWidomTrials);
368
369 *REAL_Selected_Trial = REALselected;
370 *SuccessConstruction = Goodconstruction;
371 *energy = energies[SelectedTrial];
372 return averagedRosen;
373}
374
375static inline double Widom_Move_Chain_PARTIAL(Components& SystemComponents, Simulations& Sims, ForceField& FF, RandomNumber& Random, WidomStruct& Widom, size_t SelectedMolInComponent, size_t SelectedComponent, int MoveType, size_t *REAL_Selected_Trial, bool *SuccessConstruction, MoveEnergy *energy, size_t FirstBeadTrial, double2 proposed_scale)
376{
377 MoveEnergy TEMP;
378 *energy = TEMP;
379 //printf("DOING RANDOM ORIENTAITONS\n");
380 size_t Atomsize = 0;
381 size_t chainsize = SystemComponents.Moleculesize[SelectedComponent]-1; //size for the data of trial orientations are the number of trial orientations times the size of molecule excluding the first bead//
382 bool Goodconstruction = false; size_t SelectedTrial = 0; double Rosenbluth = 0.0;
383
384 // here, the Atomsize is the total number of atoms in the system
385 for(size_t ijk = 0; ijk < SystemComponents.NComponents.x; ijk++)
386 {
387 Atomsize += SystemComponents.Moleculesize[ijk] * SystemComponents.NumberOfMolecule_for_Component[ijk];
388 }
389
390 std::vector<double>Rosen; std::vector<MoveEnergy>energies; std::vector<size_t>Trialindex;
391
392 //Two variables to settle: start_position, SelectedMolID
393 //start_position: where to copy data from
394 //SelectedMolID : MolID to assign to the new molecule
395 size_t start_position = SelectedMolInComponent*SystemComponents.Moleculesize[SelectedComponent] + 1;
396 size_t SelectedMolID = SelectedMolInComponent;
397 switch(MoveType)
398 {
399 case CBMC_INSERTION:
400 {
401 start_position = 1;
402 SelectedMolID = SystemComponents.NumberOfMolecule_for_Component[SelectedComponent];
403 break;
404 }
405 case CBMC_DELETION: case REINSERTION_INSERTION: case REINSERTION_RETRACE: case IDENTITY_SWAP_OLD:
406 {
407 break; //Go With Default//
408 }
409 case IDENTITY_SWAP_NEW:
410 {
411 start_position = 1;
412 SelectedMolID = SystemComponents.NumberOfMolecule_for_Component[SelectedComponent];
413 break;
414 }
415 }
416 // number of threads needed = Atomsize*Widom.NumberWidomTrialsOrientations;
417 size_t threadsNeeded = Atomsize*Widom.NumberWidomTrialsOrientations*chainsize;
418
419 Random.Check(Widom.NumberWidomTrialsOrientations);
420 //Get the first bead positions, and setup trial orientations//
421 get_random_trial_orientation<<<1,Widom.NumberWidomTrialsOrientations>>>(Sims.Box, Sims.d_a, Sims.Old, Sims.New, Sims.device_flag, Random.device_random, Random.offset, FirstBeadTrial, start_position, SelectedComponent, SelectedMolID, chainsize, MoveType, proposed_scale, SystemComponents.CURRENTCYCLE); checkCUDAError("error getting random trials orientations");
422
423 Random.Update(Widom.NumberWidomTrialsOrientations);
424
425 // Setup the pairwise calculation //
426 // Setup Number of Blocks and threads for separated HG + GG calculations //
427 size_t NHostAtom = 0; size_t NGuestAtom = 0;
428 for(size_t i = 0; i < SystemComponents.NComponents.y; i++)
429 NHostAtom += SystemComponents.Moleculesize[i] * SystemComponents.NumberOfMolecule_for_Component[i];
430 for(size_t i = SystemComponents.NComponents.y; i < SystemComponents.NComponents.x; i++)
431 NGuestAtom+= SystemComponents.Moleculesize[i] * SystemComponents.NumberOfMolecule_for_Component[i];
432
433 size_t HG_Nthread=0; size_t HG_Nblock=0; Setup_threadblock(NHostAtom * chainsize, &HG_Nblock, &HG_Nthread);
434 size_t GG_Nthread=0; size_t GG_Nblock=0; Setup_threadblock(NGuestAtom * chainsize, &GG_Nblock, &GG_Nthread);
435 size_t HGGG_Nthread = std::max(HG_Nthread, GG_Nthread);
436 size_t HGGG_Nblock = HG_Nblock + GG_Nblock;
437
438 //Setup calculation for separated HG + GG interactions//
439 if(Atomsize != 0)
440 {
441 Calculate_Multiple_Trial_Energy_SEPARATE_HostGuest_VDWReal<<<HGGG_Nblock * Widom.NumberWidomTrialsOrientations, HGGG_Nthread, 2 * HGGG_Nthread * sizeof(double)>>>(Sims.Box, Sims.d_a, Sims.New, FF, Sims.Blocksum, SelectedComponent, Atomsize, Sims.device_flag, threadsNeeded, chainsize, HGGG_Nblock, HG_Nblock, SystemComponents.NComponents, Sims.ExcludeList); checkCUDAError("Error calculating energies (PARTIAL SUM HGGG Orientation)");
442
443 cudaMemcpy(SystemComponents.flag, Sims.device_flag, Widom.NumberWidomTrialsOrientations*sizeof(bool), cudaMemcpyDeviceToHost);
444 }
445 //printf("CHAIN ENERGIES\n");
446
447 Host_sum_Widom_HGGG_SEPARATE(Widom.NumberWidomTrialsOrientations, SystemComponents.Beta, Sims.Blocksum, SystemComponents.flag, HG_Nblock, HGGG_Nblock, energies, Trialindex, Rosen, SystemComponents.CURRENTCYCLE);
448
449 double averagedRosen= 0.0;
450 size_t REALselected = 0;
451
452 //Zhao's note: The final part of the CBMC seems complicated, using a switch may help understand how each case is processed//
453 switch(MoveType)
454 {
455 case CBMC_INSERTION: case REINSERTION_INSERTION: case IDENTITY_SWAP_NEW:
456 {
457 if(Rosen.size() == 0) break;
458 SelectedTrial = SelectTrialPosition(Rosen);
459
460 for(size_t a = 0; a < Rosen.size(); a++) Rosen[a] = std::exp(Rosen[a]);
461 Rosenbluth =std::accumulate(Rosen.begin(), Rosen.end(), decltype(Rosen)::value_type(0));
462 if(Rosenbluth < 1e-150) break;
463 Goodconstruction = true;
464 break;
465 }
466 case CBMC_DELETION: case REINSERTION_RETRACE: case IDENTITY_SWAP_OLD:
467 {
468 SelectedTrial = 0;
469 for(size_t a = 0; a < Rosen.size(); a++) Rosen[a] = std::exp(Rosen[a]);
470 Rosenbluth =std::accumulate(Rosen.begin(), Rosen.end(), decltype(Rosen)::value_type(0));
471 Goodconstruction = true;
472 break;
473 }
474 }
475 if(!Goodconstruction) return 0.0;
476 REALselected = Trialindex[SelectedTrial];
477
478
479 averagedRosen = Rosenbluth/double(Widom.NumberWidomTrialsOrientations);
480 *REAL_Selected_Trial = REALselected;
481 *SuccessConstruction = Goodconstruction;
482 *energy = energies[SelectedTrial];
483 //if(SystemComponents.CURRENTCYCLE == 687347) energies[SelectedTrial].print();
484 return averagedRosen;
485}
Definition data_struct.h:746
Definition data_struct.h:819
Definition data_struct.h:843
Definition data_struct.h:794
Definition data_struct.h:615
Definition data_struct.h:1053
Definition data_struct.h:1027
Definition data_struct.h:1044