OPAL (Object Oriented Parallel Accelerator Library)  2021.1.99
OPAL
ParallelCyclotronTracker.cpp
Go to the documentation of this file.
1 //
2 // Class ParallelCyclotronTracker
3 // Tracker for OPAL-Cycl
4 //
5 // Copyright (c) 2007 - 2014, Jianjun Yang, Andreas Adelmann and Matthias Toggweiler,
6 // Paul Scherrer Institut, Villigen PSI, Switzerland
7 // Copyright (c) 2014, Daniel Winklehner, MIT, Cambridge, MA, USA
8 // Copyright (c) 2012 - 2020, Paul Scherrer Institut, Villigen PSI, Switzerland
9 // All rights reserved
10 //
11 // Implemented as part of the PhD thesis
12 // "Beam dynamics in high intensity cyclotrons including neighboring bunch effects"
13 // and the paper
14 // "Beam dynamics in high intensity cyclotrons including neighboring bunch effects:
15 // Model, implementation, and application"
16 // (https://journals.aps.org/prab/pdf/10.1103/PhysRevSTAB.13.064201)
17 //
18 // This file is part of OPAL.
19 //
20 // OPAL is free software: you can redistribute it and/or modify
21 // it under the terms of the GNU General Public License as published by
22 // the Free Software Foundation, either version 3 of the License, or
23 // (at your option) any later version.
24 //
25 // You should have received a copy of the GNU General Public License
26 // along with OPAL. If not, see <https://www.gnu.org/licenses/>.
27 //
29 
30 #include <fstream>
31 #include <iostream>
32 #include <limits>
33 #include <vector>
34 #include <numeric>
35 #include <cmath>
36 
38 #include "AbsBeamline/Corrector.h"
39 #include "AbsBeamline/Cyclotron.h"
40 #include "AbsBeamline/Degrader.h"
41 #include "AbsBeamline/Drift.h"
42 #include "AbsBeamline/Marker.h"
43 #include "AbsBeamline/Monitor.h"
44 #include "AbsBeamline/Multipole.h"
45 #include "AbsBeamline/MultipoleT.h"
50 #include "AbsBeamline/Offset.h"
52 #include "AbsBeamline/Probe.h"
53 #include "AbsBeamline/RBend.h"
54 #include "AbsBeamline/RFCavity.h"
55 #include "AbsBeamline/Ring.h"
56 #include "AbsBeamline/SBend.h"
57 #include "AbsBeamline/SBend3D.h"
59 #include "AbsBeamline/Septum.h"
60 #include "AbsBeamline/Solenoid.h"
61 #include "AbsBeamline/Stripper.h"
62 #include "AbsBeamline/Vacuum.h"
66 
69 
70 #include "Algorithms/Ctunes.h"
72 
75 
76 #include "Beamlines/Beamline.h"
78 
79 #include "Elements/OpalBeamline.h"
80 
81 #include "Physics/Physics.h"
82 
84 #include "Structure/DataSink.h"
85 #include "Structure/LossDataSink.h"
86 
88 #include "Utilities/Options.h"
89 
90 constexpr double c_mmtns = Physics::c * 1.0e-6; // m/s --> mm/ns
91 
95 
96 extern Inform *gmsg;
97 
112  DataSink &ds,
113  const PartData &reference,
114  bool revBeam, bool revTrack,
115  int maxSTEPS, int timeIntegrator,
116  const int& numBunch,
117  const double& mbEta,
118  const double& mbPara,
119  const std::string& mbMode,
120  const std::string& mbBinning)
121  : Tracker(beamline, bunch, reference, revBeam, revTrack)
122  , bgf_m(nullptr)
123  , maxSteps_m(maxSTEPS)
124  , lastDumpedStep_m(0)
125  , myNode_m(Ippl::myNode())
126  , initialLocalNum_m(bunch->getLocalNum())
127  , initialTotalNum_m(bunch->getTotalNum())
128  , opalRing_m(nullptr)
129  , itsStepper_mp(nullptr)
130 {
131  itsBeamline = dynamic_cast<Beamline *>(beamline.clone());
132  itsDataSink = &ds;
133 
134  if ( numBunch > 1 ) {
135  mbHandler_m = std::unique_ptr<MultiBunchHandler>(
136  new MultiBunchHandler(bunch, numBunch, mbEta,
137  mbPara, mbMode, mbBinning)
138  );
139  }
140 
141  IntegrationTimer_m = IpplTimings::getTimer("Integration");
142  TransformTimer_m = IpplTimings::getTimer("Frametransform");
144  BinRepartTimer_m = IpplTimings::getTimer("Binaryrepart");
145  PluginElemTimer_m = IpplTimings::getTimer("PluginElements");
146  DelParticleTimer_m = IpplTimings::getTimer("DeleteParticles");
147 
148  // FIXME Change track command
149  if ( initialTotalNum_m == 1 ) {
151  } else if ( initialTotalNum_m == 2 ) {
152  mode_m = MODE::SEO;
153  } else if ( initialTotalNum_m > 2 ) {
155  } else
157 
158  if ( timeIntegrator == 0 ) {
160  } else if ( timeIntegrator == 1) {
162  } else if ( timeIntegrator == 2) {
164  }
165 }
166 
172  if(bgf_m)
173  lossDs_m->save();
174  for(Component* component : myElements) {
175  delete(component);
176  }
177  for(auto fd : FieldDimensions) {
178  delete(fd);
179  }
180  delete itsBeamline;
181  // delete opalRing_m;
182 }
183 
184 
186  if(!bgf_m) return;
187 
188  Inform msg("bgf_main_collision_test ");
189 
194  Vector_t intecoords = 0.0;
195 
196  // This has to match the dT in the rk4 pusher
197  double dtime = itsBunch_m->getdT() * getHarmonicNumber();
198 
199  int triId = 0;
200  for(size_t i = 0; i < itsBunch_m->getLocalNum(); i++) {
201  int res = bgf_m->partInside(itsBunch_m->R[i], itsBunch_m->P[i],
202  dtime, intecoords, triId);
203  if(res >= 0) {
204  lossDs_m->addParticle(OpalParticle(itsBunch_m->ID[i],
205  itsBunch_m->R[i], itsBunch_m->P[i],
206  itsBunch_m->getT(),
207  itsBunch_m->Q[i], itsBunch_m->M[i]),
208  std::make_pair(turnnumber_m, itsBunch_m->bunchNum[i]));
209  itsBunch_m->Bin[i] = -1;
210  Inform gmsgALL("OPAL", INFORM_ALL_NODES);
211  gmsgALL << level4 << "* Particle " << itsBunch_m->ID[i]
212  << " lost on boundary geometry" << endl;
213  }
214  }
215 }
216 
217 // only used for dumping into stat file
218 void ParallelCyclotronTracker::dumpAngle(const double& theta,
219  double& prevAzimuth,
220  double& azimuth,
221  const short& bunchNr)
222 {
223  if ( prevAzimuth < 0.0 ) { // only at first occurrence
224  double plus = 0.0;
225  if ( OpalData::getInstance()->inRestartRun() ) {
226  plus = 360.0 * (turnnumber_m - bunchNr);
227  }
228  azimuth = theta + plus;
229  } else {
230  double dtheta = theta - prevAzimuth;
231  if ( dtheta < 0 ) {
232  dtheta += 360.0;
233  }
234  if ( dtheta > 180 ) { // rotating clockwise, reduce angle
235  dtheta -= 360;
236  }
237  azimuth += dtheta;
238  }
239  prevAzimuth = theta;
240 }
241 
242 
244  // New OPAL 2.0: m --> mm
245  return 1000.0 * std::sqrt(meanR(0) * meanR(0) + meanR(1) * meanR(1));
246 }
247 
248 
250  const double& dt)
251 {
252  // the last element in dotP is the dot-product over all particles
253  std::vector<double> dotP(dl.size());
255 
256  for(unsigned int i = 0; i < itsBunch_m->getLocalNum(); ++i) {
257  dotP[itsBunch_m->bunchNum[i]] += dot(itsBunch_m->P[i], itsBunch_m->P[i]);
258  }
259 
260  allreduce(dotP.data(), dotP.size(), std::plus<double>());
261 
262  // dot-product over all particles
263  double sum = std::accumulate(dotP.begin(), dotP.end() - 1, 0);
264  dotP.back() = sum / double(itsBunch_m->getTotalNum());
265 
266  // bunch specific --> multi-bunches only
267  for (short b = 0; b < (short)dotP.size() - 1; ++b) {
268  dotP[b] /= double(itsBunch_m->getTotalNumPerBunch(b));
269  }
270 
271  } else if ( itsBunch_m->getLocalNum() == 0 ) {
272  // here we are in Options::GLOBAL mode
273  dotP[0] = 0.0;
274  } else {
275  // here we are in Options::GLOBAL mode
276  dotP[0] = dot(itsBunch_m->P[0], itsBunch_m->P[0]);
277  }
278 
279  for (size_t i = 0; i < dotP.size(); ++i) {
280  double const gamma = std::sqrt(1.0 + dotP[i]);
281  double const beta = std::sqrt(dotP[i]) / gamma;
282  dl[i] = c_mmtns * dt * 1.0e-3 * beta; // unit: m
283  }
284 }
285 
286 
287 
293 void ParallelCyclotronTracker::openFiles(size_t numFiles, std::string SfileName) {
294 
295  for (unsigned int i=0; i<numFiles; i++) {
296  std::string SfileName2 = SfileName;
297  if (i<=2) {
298  SfileName2 += std::string("-Angle" + std::to_string(int(i)) + ".dat");
299  }
300  else {
301  // for single Particle Mode, output after each turn, to define matched initial phase ellipse.
302  SfileName2 += std::string("-afterEachTurn.dat");
303  }
304 
305  outfTheta_m.emplace_back(new std::ofstream(SfileName2.c_str()));
306  outfTheta_m.back()->precision(8);
307  outfTheta_m.back()->setf(std::ios::scientific, std::ios::floatfield);
308  *outfTheta_m.back() << "# r [mm] beta_r*gamma "
309  << "theta [deg] beta_theta*gamma "
310  << "z [mm] beta_z*gamma" << std::endl;
311  }
312 }
313 
320  for (auto & file : outfTheta_m) {
321  file->close();
322  }
323 }
324 
325 
332  *gmsg << "* ----------------------------- Cyclotron -------------------------------- *" << endl;
333 
334  cycl_m = dynamic_cast<Cyclotron *>(cycl.clone());
335  myElements.push_back(cycl_m);
336 
337  // Is this a Spiral Inflector Simulation? If yes, we'll give the user some
338  // useful information
340  if (spiral_flag) {
341  *gmsg << endl << "* This is a Spiral Inflector Simulation! This means the following:" << endl;
342  *gmsg << "* 1.) It is up to the user to provide appropriate geometry, electric and magnetic fields!" << endl;
343  *gmsg << "* (Use BANDRF type cyclotron and use RFMAPFN to load both magnetic" << endl;
344  *gmsg << "* and electric fields, setting SUPERPOSE to an array of TRUE values.)" << endl;
345  *gmsg << "* 2.) For high currents it is strongly recommended to use the SAAMG fieldsolver," << endl;
346  *gmsg << "* FFT does not give the correct results (boundary conditions are missing)." << endl;
347  *gmsg << "* 3.) The whole geometry will be meshed and used for the fieldsolver." << endl;
348  *gmsg << "* There will be no transformations of the bunch into a local frame und consequently," << endl;
349  *gmsg << "* the problem will be treated non-relativistically!" << endl;
350  *gmsg << "* (This is not an issue for spiral inflectors as they are typically < 100 keV/amu.)" << endl;
351  *gmsg << endl << "* Note: For now, multi-bunch mode (MBM) needs to be de-activated for spiral inflector" << endl;
352  *gmsg << "* and space charge needs to be solved every time-step. numBunch_m and scSolveFreq are reset." << endl;
353  if (isMultiBunch()) {
354  mbHandler_m = nullptr;
355  }
356  }
357 
358  // Fresh run (no restart):
360 
361  // Get reference values from cyclotron element
362  // For now, these are still stored in mm. should be the only ones. -DW
368 
369  if (referenceTheta <= -180.0 || referenceTheta > 180.0) {
370  throw OpalException("Error in ParallelCyclotronTracker::visitCyclotron",
371  "PHIINIT is out of [-180, 180)!");
372  }
373 
375 
376  // Calculate reference azimuthal (tangential) momentum from total-, z- and radial momentum:
377  float insqrt = referencePtot * referencePtot - \
378  referencePr * referencePr - referencePz * referencePz;
379 
380  if (insqrt < 0) {
381 
382  if (insqrt > -1.0e-10) {
383  referencePt = 0.0;
384  } else {
385  throw OpalException("Error in ParallelCyclotronTracker::visitCyclotron",
386  "Pt imaginary!");
387  }
388 
389  } else {
390  referencePt = std::sqrt(insqrt);
391  }
392 
393  if (referencePtot < 0.0) {
394  referencePt *= -1.0;
395  }
396  // End calculate referencePt
397 
398  // Restart a run:
399  } else {
400 
401  // If the user wants to save the restarted run in local frame,
402  // make sure the previous h5 file was local too
404  if (!previousH5Local) {
405  throw OpalException("Error in ParallelCyclotronTracker::visitCyclotron",
406  "You are trying a local restart from a global h5 file!");
407  }
408  // Else, if the user wants to save the restarted run in global frame,
409  // make sure the previous h5 file was global too
410  } else {
411  if (previousH5Local) {
412  throw OpalException("Error in ParallelCyclotronTracker::visitCyclotron",
413  "You are trying a global restart from a local h5 file!");
414  }
415  }
416 
417  // Adjust some of the reference variables from the h5 file
421  if (referenceTheta <= -180.0 || referenceTheta > 180.0) {
422  throw OpalException("Error in ParallelCyclotronTracker::visitCyclotron",
423  "PHIINIT is out of [-180, 180)!");
424  }
425  }
426 
429 
430  *gmsg << endl;
431  *gmsg << "* Bunch global starting position:" << endl;
432  *gmsg << "* RINIT = " << referenceR << " [mm]" << endl;
433  *gmsg << "* PHIINIT = " << referenceTheta << " [deg]" << endl;
434  *gmsg << "* ZINIT = " << referenceZ << " [mm]" << endl;
435  *gmsg << endl;
436  *gmsg << "* Bunch global starting momenta:" << endl;
437  *gmsg << "* Initial gamma = " << itsReference.getGamma() << endl;
438  *gmsg << "* Initial beta = " << itsReference.getBeta() << endl;
439  *gmsg << "* Reference total momentum (beta * gamma) = " << referencePtot * 1000.0 << " [MCU]" << endl;
440  *gmsg << "* Reference azimuthal momentum (Pt) = " << referencePt * 1000.0 << " [MCU]" << endl;
441  *gmsg << "* Reference radial momentum (Pr) = " << referencePr * 1000.0 << " [MCU]" << endl;
442  *gmsg << "* Reference axial momentum (Pz) = " << referencePz * 1000.0 << " [MCU]" << endl;
443  *gmsg << endl;
444 
445  double sym = cycl_m->getSymmetry();
446  *gmsg << "* " << sym << "-fold field symmetry " << endl;
447 
448  // ckr: this just returned the default value as defined in Component.h
449  // double rff = cycl_m->getRfFrequ(0);
450  // *gmsg << "* Rf frequency= " << rff << " [MHz]" << endl;
451 
452  std::string fmfn = cycl_m->getFieldMapFN();
453  *gmsg << "* Field map file = " << fmfn << " " << endl;
454 
455  std::string type = cycl_m->getCyclotronType();
456  *gmsg << "* Type of cyclotron = " << type << " " << endl;
457 
458  double rmin = cycl_m->getMinR();
459  double rmax = cycl_m->getMaxR();
460  *gmsg << "* Radial aperture = " << rmin << " ... " << rmax<<" [m] "<< endl;
461 
462  double zmin = cycl_m->getMinZ();
463  double zmax = cycl_m->getMaxZ();
464  *gmsg << "* Vertical aperture = " << zmin << " ... " << zmax<<" [m]"<< endl;
465 
466  double h = cycl_m->getCyclHarm();
467  *gmsg << "* Number of trimcoils = " << cycl_m->getNumberOfTrimcoils() << endl;
468  *gmsg << "* Harmonic number h = " << h << " " << endl;
469 
470  if (type == std::string("BANDRF")) {
471  double escale = cycl_m->getEScale(0);
472  *gmsg << "* RF field scale factor = " << escale << endl;
473  double rfphi= cycl_m->getRfPhi(0);
474  *gmsg << "* RF inital phase = " << rfphi * Physics::rad2deg << " [deg]" << endl;
475  bool superpose = cycl_m->getSuperpose(0);
476  *gmsg << std::boolalpha << "* Superpose electric field maps -> " << superpose << endl;
477  }
478 
479  // Read in cyclotron field maps
481 
482  double BcParameter[8] = {};
483 
484  BcParameter[0] = 0.001 * cycl_m->getRmin();
485  BcParameter[1] = 0.001 * cycl_m->getRmax();
486 
487  // Store inner radius and outer radius of cyclotron field map in the list
489 }
490 
497  *gmsg << "* ----------------------------- Collimator ------------------------------- *" << endl;
498 
499  CCollimator* elptr = dynamic_cast<CCollimator *>(coll.clone());
500  myElements.push_back(elptr);
501 
502  *gmsg << "* Name = " << elptr->getName() << endl;
503 
504  double xstart = elptr->getXStart();
505  *gmsg << "* XStart = " << xstart << " [m]" << endl;
506 
507  double xend = elptr->getXEnd();
508  *gmsg << "* XEnd = " << xend << " [m]" << endl;
509 
510  double ystart = elptr->getYStart();
511  *gmsg << "* YStart = " << ystart << " [m]" << endl;
512 
513  double yend = elptr->getYEnd();
514  *gmsg << "* YEnd = " << yend << " [m]" << endl;
515 
516  double zstart = elptr->getZStart();
517  *gmsg << "* ZStart = " << zstart << " [m]" << endl;
518 
519  double zend = elptr->getZEnd();
520  *gmsg << "* ZEnd = " << zend << " [m]" << endl;
521 
522  double width = elptr->getWidth();
523  *gmsg << "* Width = " << width << " [m]" << endl;
524 
525  elptr->initialise(itsBunch_m);
526 
527  double BcParameter[8] = {};
528 
529  BcParameter[0] = xstart;
530  BcParameter[1] = xend;
531  BcParameter[2] = ystart;
532  BcParameter[3] = yend;
533  BcParameter[4] = width;
534 
535  buildupFieldList(BcParameter, ElementBase::CCOLLIMATOR, elptr);
536 }
537 
544  *gmsg << "In Corrector; L= " << corr.getElementLength() << endl;
545  myElements.push_back(dynamic_cast<Corrector *>(corr.clone()));
546 }
547 
554  *gmsg << "In Degrader; L= " << deg.getElementLength() << endl;
555  myElements.push_back(dynamic_cast<Degrader *>(deg.clone()));
556 
557 }
558 
565  *gmsg << "In drift L= " << drift.getElementLength() << endl;
566  myElements.push_back(dynamic_cast<Drift *>(drift.clone()));
567 }
568 
575 
576 }
577 
584  if (opalRing_m == NULL)
585  throw OpalException(
586  "ParallelCylcotronTracker::visitOffset",
587  "Attempt to place an offset when Ring not defined");
588  Offset* offNonConst = const_cast<Offset*>(&off);
589  offNonConst->updateGeometry(opalRing_m->getNextPosition(),
592 }
593 
600  // *gmsg << "In Marker; L= " << marker.getElementLength() << endl;
601  myElements.push_back(dynamic_cast<Marker *>(marker.clone()));
602  // Do nothing.
603 }
604 
611  // *gmsg << "In Monitor; L= " << corr.getElementLength() << endl;
612  myElements.push_back(dynamic_cast<Monitor *>(corr.clone()));
613  // applyDrift(flip_s * corr.getElementLength());
614 }
615 
622  *gmsg << "In Multipole; L= " << mult.getElementLength() << " however the element is missing " << endl;
623  myElements.push_back(dynamic_cast<Multipole *>(mult.clone()));
624 }
625 
632  *gmsg << "Adding MultipoleT" << endl;
633  if (opalRing_m != NULL) {
634  opalRing_m->appendElement(multT);
635  } else {
636  throw OpalException("ParallelCyclotronTracker::visitMultipoleT",
637  "Need to define a RINGDEFINITION to use MultipoleT element");
638  }
639  myElements.push_back(dynamic_cast<MultipoleT *>(multT.clone()));
640 }
641 
648  *gmsg << "Adding MultipoleTStraight" << endl;
649  if (opalRing_m != NULL) {
650  opalRing_m->appendElement(multTstraight);
651  } else {
652  throw OpalException("ParallelCyclotronTracker::visitMultipoleTStraight",
653  "Need to define a RINGDEFINITION to use MultipoleTStraight element");
654  }
655  myElements.push_back(dynamic_cast<MultipoleTStraight *>(multTstraight.clone()));
656 }
657 
664  *gmsg << "Adding MultipoleTCurvedConstRadius" << endl;
665  if (opalRing_m != NULL) {
666  opalRing_m->appendElement(multTccurv);
667  } else {
668  throw OpalException("ParallelCyclotronTracker::visitMultipoleTCurvedConstRadius",
669  "Need to define a RINGDEFINITION to use MultipoleTCurvedConstRadius element");
670  }
671  myElements.push_back(dynamic_cast<MultipoleTCurvedConstRadius *>(multTccurv.clone()));
672 }
673 
680  *gmsg << "Adding MultipoleTCurvedVarRadius" << endl;
681  if (opalRing_m != NULL) {
682  opalRing_m->appendElement(multTvcurv);
683  } else {
684  throw OpalException("ParallelCyclotronTracker::visitMultipoleTCurvedVarRadius",
685  "Need to define a RINGDEFINITION to use MultipoleTCurvedVarRadius element");
686  }
687  myElements.push_back(dynamic_cast<MultipoleTCurvedVarRadius *>(multTvcurv.clone()));
688 }
689 
696  *gmsg << "* ----------------------------- Probe ------------------------------------ *" << endl;
697 
698  Probe *elptr = dynamic_cast<Probe *>(prob.clone());
699  myElements.push_back(elptr);
700 
701  *gmsg << "* Name = " << elptr->getName() << endl;
702 
703  double xstart = elptr->getXStart();
704  *gmsg << "* XStart = " << xstart << " [m]" << endl;
705 
706  double xend = elptr->getXEnd();
707  *gmsg << "* XEnd = " << xend << " [m]" << endl;
708 
709  double ystart = elptr->getYStart();
710  *gmsg << "* YStart = " << ystart << " [m]" << endl;
711 
712  double yend = elptr->getYEnd();
713  *gmsg << "* YEnd = " << yend << " [m]" << endl;
714 
715  // initialise, do nothing
716  elptr->initialise(itsBunch_m);
717 
718  double BcParameter[8] = {};
719 
720  BcParameter[0] = xstart;
721  BcParameter[1] = xend;
722  BcParameter[2] = ystart;
723  BcParameter[3] = yend;
724  BcParameter[4] = 1 ; // width
725 
726  buildupFieldList(BcParameter, ElementBase::PROBE, elptr);
727 }
728 
735  *gmsg << "In RBend; L= " << bend.getElementLength() << " however the element is missing " << endl;
736  myElements.push_back(dynamic_cast<RBend *>(bend.clone()));
737 }
738 
745  *gmsg << "* ----------------------------- RFCavity --------------------------------- * " << endl;
746 
747  RFCavity *elptr = dynamic_cast<RFCavity *>(as.clone());
748  myElements.push_back(elptr);
749 
750  if ( elptr->getComponentType() != "SINGLEGAP" ) {
751  *gmsg << (elptr->getComponentType()) << endl;
752  throw OpalException("ParallelCyclotronTracker::visitRFCavity",
753  "The ParallelCyclotronTracker can only play with cyclotron type RF system currently ...");
754  }
755 
756  *gmsg << "* Name = " << elptr->getName() << endl;
757 
758  double rmin = elptr->getRmin();
759  *gmsg << "* Minimal radius of cavity= " << rmin << " [mm]" << endl;
760 
761  double rmax = elptr->getRmax();
762  *gmsg << "* Maximal radius of cavity= " << rmax << " [mm]" << endl;
763 
764  double rff = elptr->getCycFrequency();
765  *gmsg << "* RF frequency (2*pi*f)= " << rff << " [rad/s]" << endl;
766 
767  std::string fmfn = elptr->getFieldMapFN();
768  *gmsg << "* RF Field map file = " << fmfn << endl;
769 
770  double angle = elptr->getAzimuth();
771  *gmsg << "* Cavity azimuth position= " << angle << " [deg] " << endl;
772 
773  double gap = elptr->getGapWidth();
774  *gmsg << "* Cavity gap width= " << gap << " [mm] " << endl;
775 
776  double pdis = elptr->getPerpenDistance();
777  *gmsg << "* Cavity Shift distance= " << pdis << " [mm] " << endl;
778 
779  double phi0 = elptr->getPhi0();
780  *gmsg << "* Initial RF phase (t=0)= " << phi0 << " [deg] " << endl;
781 
782  /*
783  Setup time dependence and in case of no
784  timedependence use a polynom with a_0 = 1 and a_k = 0, k = 1,2,3.
785  */
786 
787  std::shared_ptr<AbstractTimeDependence> freq_atd = nullptr;
788  std::shared_ptr<AbstractTimeDependence> ampl_atd = nullptr;
789  std::shared_ptr<AbstractTimeDependence> phase_atd = nullptr;
790 
791  dvector_t unityVec;
792  unityVec.push_back(1.);
793  unityVec.push_back(0.);
794  unityVec.push_back(0.);
795  unityVec.push_back(0.);
796 
797  if (elptr->getFrequencyModelName() != "") {
799  *gmsg << "* Variable frequency RF Model name " << elptr->getFrequencyModelName() << endl;
800  } else {
801  freq_atd = std::shared_ptr<AbstractTimeDependence>(new PolynomialTimeDependence(unityVec));
802  }
803 
804  if (elptr->getAmplitudeModelName() != "") {
806  *gmsg << "* Variable amplitude RF Model name " << elptr->getAmplitudeModelName() << endl;
807  } else {
808  ampl_atd = std::shared_ptr<AbstractTimeDependence>(new PolynomialTimeDependence(unityVec));
809  }
810 
811  if (elptr->getPhaseModelName() != "") {
813  *gmsg << "* Variable phase RF Model name " << elptr->getPhaseModelName() << endl;
814  } else {
815  phase_atd = std::shared_ptr<AbstractTimeDependence>(new PolynomialTimeDependence(unityVec));
816  }
817  // read cavity voltage profile data from file.
818  elptr->initialise(itsBunch_m, freq_atd, ampl_atd, phase_atd);
819 
820  double BcParameter[8] = {};
821 
822  BcParameter[0] = 0.001 * rmin;
823  BcParameter[1] = 0.001 * rmax;
824  BcParameter[2] = 0.001 * pdis;
825  BcParameter[3] = angle;
826 
827  buildupFieldList(BcParameter, ElementBase::RFCAVITY, elptr);
828 }
829 
835  *gmsg << "* ----------------------------- Ring ------------------------------------- *" << endl;
836 
837  delete opalRing_m;
838 
839  opalRing_m = dynamic_cast<Ring*>(ring.clone());
840 
841  myElements.push_back(opalRing_m);
842 
844 
848 
849  if(referenceTheta <= -180.0 || referenceTheta > 180.0) {
850  throw OpalException("Error in ParallelCyclotronTracker::visitRing",
851  "PHIINIT is out of [-180, 180)!");
852  }
853 
854  referenceZ = 0.0;
855  referencePz = 0.0;
856 
859 
860  if(referencePtot < 0.0)
861  referencePt *= -1.0;
862 
865 
866  double BcParameter[8] = {}; // zero initialise array
867 
869 
870  // Finally print some diagnostic
871  *gmsg << "* Initial beam radius = " << referenceR << " [mm] " << endl;
872  *gmsg << "* Initial gamma = " << itsReference.getGamma() << endl;
873  *gmsg << "* Initial beta = " << itsReference.getBeta() << endl;
874  *gmsg << "* Total reference momentum = " << referencePtot * 1000.0
875  << " [MCU]" << endl;
876  *gmsg << "* Reference azimuthal momentum = " << referencePt * 1000.0
877  << " [MCU]" << endl;
878  *gmsg << "* Reference radial momentum = " << referencePr * 1000.0
879  << " [MCU]" << endl;
880  *gmsg << "* " << opalRing_m->getSymmetry() << " fold field symmetry "
881  << endl;
882  *gmsg << "* Harmonic number h= " << opalRing_m->getHarmonicNumber() << " "
883  << endl;
884 }
885 
892  *gmsg << "In SBend; L = " << bend.getElementLength() << " however the element is missing " << endl;
893  myElements.push_back(dynamic_cast<SBend *>(bend.clone()));
894 }
895 
897  *gmsg << "Adding SBend3D" << endl;
898  if (opalRing_m != NULL)
899  opalRing_m->appendElement(bend);
900  else
901  throw OpalException("ParallelCyclotronTracker::visitSBend3D",
902  "Need to define a RINGDEFINITION to use SBend3D element");
903 }
904 
906  *gmsg << "Adding ScalingFFAMagnet" << endl;
907  if (opalRing_m != NULL) {
908  opalRing_m->appendElement(bend);
909  } else {
910  throw OpalException("ParallelCyclotronTracker::visitScalingFFAMagnet",
911  "Need to define a RINGDEFINITION to use ScalingFFAMagnet element");
912  }
913 }
914 
921  *gmsg << "* ----------------------------- Septum ----------------------------------- *" << endl;
922 
923  Septum *elptr = dynamic_cast<Septum *>(sept.clone());
924  myElements.push_back(elptr);
925 
926  *gmsg << "* Name = " << elptr->getName() << endl;
927 
928  double xstart = elptr->getXStart();
929  *gmsg << "* XStart = " << xstart << " [m]" << endl;
930 
931  double xend = elptr->getXEnd();
932  *gmsg << "* XEnd = " << xend << " [m]" << endl;
933 
934  double ystart = elptr->getYStart();
935  *gmsg << "* YStart = " << ystart << " [m]" << endl;
936 
937  double yend = elptr->getYEnd();
938  *gmsg << "* YEnd = " << yend << " [m]" << endl;
939 
940  double width = elptr->getWidth();
941  *gmsg << "* Width = " << width << " [m]" << endl;
942 
943  // initialise, do nothing
944  elptr->initialise(itsBunch_m);
945 
946  double BcParameter[8] = {};
947 
948  BcParameter[0] = xstart;
949  BcParameter[1] = xend;
950  BcParameter[2] = ystart;
951  BcParameter[3] = yend;
952  BcParameter[4] = width;
953 
954  buildupFieldList(BcParameter, ElementBase::SEPTUM, elptr);
955 }
956 
963  myElements.push_back(dynamic_cast<Solenoid *>(solenoid.clone()));
964  Component *elptr = *(--myElements.end());
965  if(!elptr->hasAttribute("ELEMEDGE")) {
966  *gmsg << "Solenoid: no position of the element given!" << endl;
967  return;
968  }
969 }
970 
977  *gmsg << "* ----------------------------- Stripper --------------------------------- *" << endl;
978 
979  Stripper *elptr = dynamic_cast<Stripper *>(stripper.clone());
980  myElements.push_back(elptr);
981 
982  *gmsg << "* Name = " << elptr->getName() << endl;
983 
984  double xstart = elptr->getXStart();
985  *gmsg << "* XStart = " << xstart << " [m]" << endl;
986 
987  double xend = elptr->getXEnd();
988  *gmsg << "* XEnd = " << xend << " [m]" << endl;
989 
990  double ystart = elptr->getYStart();
991  *gmsg << "* YStart = " << ystart << " [m]" << endl;
992 
993  double yend = elptr->getYEnd();
994  *gmsg << "* YEnd = " << yend << " [m]" << endl;
995 
996  double opcharge = elptr->getOPCharge();
997  *gmsg << "* Charge of outcoming particle = +e * " << opcharge << endl;
998 
999  double opmass = elptr->getOPMass();
1000  *gmsg << "* Mass of the outcoming particle = " << opmass << " [GeV/c^2]" << endl;
1001 
1002  bool stop = elptr->getStop();
1003  *gmsg << std::boolalpha
1004  << "* Particles stripped will be deleted after interaction -> "
1005  << stop << endl;
1006 
1007  elptr->initialise(itsBunch_m);
1008 
1009  double BcParameter[8] = {};
1010 
1011  BcParameter[0] = xstart;
1012  BcParameter[1] = xend;
1013  BcParameter[2] = ystart;
1014  BcParameter[3] = yend;
1015  BcParameter[4] = 1; // width
1016  BcParameter[5] = opcharge;
1017  BcParameter[6] = opmass;
1018 
1019  buildupFieldList(BcParameter, ElementBase::STRIPPER, elptr);
1020 }
1021 
1028  *gmsg << "* ----------------------------- Vacuum ----------------------------------- *" << endl;
1029 
1030  Vacuum* elptr = dynamic_cast<Vacuum*>(vac.clone());
1031  myElements.push_back(elptr);
1032 
1033  double BcParameter[8] = {};
1034 
1035  double pressure = elptr->getPressure();
1036 
1037  if (elptr->getPressureMapFN() != "") {
1038  std::string pmfn = elptr->getPressureMapFN();
1039  *gmsg << "* Pressure field map file = " << pmfn << " " << endl;
1040  *gmsg << "* Default pressure = " << pressure << " [mbar]" << endl;
1041  } else {
1042  *gmsg << "* Pressure = " << pressure << " [mbar]" << endl;
1043  }
1044 
1045  double temperature = elptr->getTemperature();
1046  *gmsg << "* Temperature = " << temperature << " [K]" << endl;
1047 
1048  std::string gas = elptr->getResidualGasName();
1049  *gmsg << "* Residual gas = " << gas << endl;
1050 
1051  bool stop = elptr->getStop();
1052  *gmsg << std::boolalpha
1053  << "* Particles stripped will be deleted after interaction -> "
1054  << stop << endl;
1055 
1056  elptr->initialise(itsBunch_m, elptr->getPScale());
1057 
1058  BcParameter[0] = pressure;
1059  BcParameter[1] = temperature;
1060 
1061  buildupFieldList(BcParameter, ElementBase::VACUUM, elptr);
1062 }
1063 
1070  *gmsg << "Adding Variable RF Cavity" << endl;
1071  if (opalRing_m != NULL)
1072  opalRing_m->appendElement(cav);
1073  else
1074  throw OpalException("ParallelCyclotronTracker::visitVariableRFCavity",
1075  "Need to define a RINGDEFINITION to use VariableRFCavity element");
1076 }
1077 
1084  (const VariableRFCavityFringeField &cav) {
1085  *gmsg << "Adding Variable RF Cavity with Fringe Field" << endl;
1086  if (opalRing_m != NULL)
1087  opalRing_m->appendElement(cav);
1088  else
1089  throw OpalException("ParallelCyclotronTracker::visitVariableRFCavityFringeField",
1090  "Need to define a RINGDEFINITION to use VariableRFCavity element");
1091 }
1092 
1099  *gmsg << "Adding Vertical FFA Magnet" << endl;
1100  if (opalRing_m != NULL)
1101  opalRing_m->appendElement(mag);
1102  else
1103  throw OpalException("ParallelCyclotronTracker::visitVerticalFFAMagnet",
1104  "Need to define a RINGDEFINITION to use VerticalFFAMagnet element");
1105 }
1106 
1107 
1115 void ParallelCyclotronTracker::buildupFieldList(double BcParameter[], ElementBase::ElementType elementType, Component *elptr) {
1116  beamline_list::iterator sindex;
1117 
1118  type_pair *localpair = new type_pair();
1119  localpair->first = elementType;
1120 
1121  for(int i = 0; i < 8; i++)
1122  *(((localpair->second).first) + i) = *(BcParameter + i);
1123 
1124  (localpair->second).second = elptr;
1125 
1126  // always put cyclotron as the first element in the list.
1127  if (elementType == ElementBase::RING || elementType == ElementBase::CYCLOTRON) {
1128  sindex = FieldDimensions.begin();
1129  } else {
1130  sindex = FieldDimensions.end();
1131  }
1132  FieldDimensions.insert(sindex, localpair);
1133 }
1134 
1141  const FlaggedBeamline* fbl = static_cast<const FlaggedBeamline*>(&bl);
1142  fbl->iterate(*this, false);//*dynamic_cast<BeamlineVisitor *>(this), false);
1143 }
1144 
1146  int nlp = itsBunch_m->getLocalNum();
1147  int minnlp = 0;
1148  int maxnlp = 111111;
1149  reduce(nlp, minnlp, OpMinAssign());
1150  reduce(nlp, maxnlp, OpMaxAssign());
1151  *gmsg << s << "min local particle number: "<< minnlp << endl;
1152  *gmsg << "* max local particle number: " << maxnlp << endl;
1153 }
1154 
1155 
1157  /*
1158  Initialize common variables and structures
1159  for the integrators
1160  */
1161  if (OpalData::getInstance()->inRestartRun()) {
1163  }
1164 
1165  step_m = 0;
1166  restartStep0_m = 0;
1167  turnnumber_m = 1;
1168  azimuth_m = -1.0;
1169  prevAzimuth_m = -1.0;
1170 
1171  // Record how many bunches have already been injected. ONLY FOR MPM
1172  if (isMultiBunch())
1173  mbHandler_m->setNumBunch(itsBunch_m->getNumBunch());
1174 
1175  itsBeamline->accept(*this);
1176  if (opalRing_m != NULL)
1177  opalRing_m->lockRing();
1178 
1179  // Display the selected elements
1180  *gmsg << "* ------------------------------------------------------------------------ *" << endl;
1181  *gmsg << "* The selected Beam line elements are :" << endl;
1182  for (auto fd : FieldDimensions) {
1183  ElementBase::ElementType type = fd->first;
1184  *gmsg << "* -> " << ElementBase::getTypeString(type) << endl;
1185  if (type == ElementBase::RFCAVITY) {
1186  RFCavity* cav = static_cast<RFCavity*>((fd->second).second);
1187  CavityCrossData ccd = {cav, cav->getSinAzimuth(), cav->getCosAzimuth(), cav->getPerpenDistance() * 0.001};
1188  cavCrossDatas_m.push_back(ccd);
1189  } else if ( type == ElementBase::CCOLLIMATOR ||
1190  type == ElementBase::PROBE ||
1193  PluginElement* element = static_cast<PluginElement*>((fd->second).second);
1194  pluginElements_m.push_back(element);
1195  }
1196  }
1197  *gmsg << "* ------------------------------------------------------------------------ *" << endl << endl;
1198 
1199  // Get BoundaryGeometry that is already initialized
1201  if (bgf_m)
1202  lossDs_m = std::unique_ptr<LossDataSink>(new LossDataSink(bgf_m->getOpalName(),!Options::asciidump));
1203 
1204  // External field arrays for dumping
1205  for (int k = 0; k < 2; k++)
1206  FDext_m[k] = Vector_t(0.0, 0.0, 0.0);
1207 
1208  extE_m = Vector_t(0.0, 0.0, 0.0);
1209  extB_m = Vector_t(0.0, 0.0, 0.0);
1210  DumpFields::writeFields((((*FieldDimensions.begin())->second).second));
1211  DumpEMFields::writeFields((((*FieldDimensions.begin())->second).second));
1212 
1214  this,
1215  std::placeholders::_1,
1216  std::placeholders::_2,
1217  std::placeholders::_3,
1218  std::placeholders::_4);
1219 
1220  switch ( stepper_m ) {
1221  case stepper::INTEGRATOR::LF2: {
1222  *gmsg << "* 2nd order Leap-Frog integrator" << endl;
1223  itsStepper_mp.reset(new LF2<function_t>(func));
1224  break;
1225  }
1226  case stepper::INTEGRATOR::MTS: {
1227  *gmsg << "* Multiple time stepping (MTS) integrator" << endl;
1228  break;
1229  }
1231  default: {
1232  *gmsg << "* 4th order Runge-Kutta integrator" << endl;
1233  itsStepper_mp.reset(new RK4<function_t>(func));
1234  break;
1235  }
1236  }
1237 
1239  MtsTracker();
1240  } else {
1241  GenericTracker();
1242  }
1243 
1244  *gmsg << "* ------------------------------------------------------------------------ *" << endl;
1245  *gmsg << "* Finalizing i.e. write data and close files :" << endl;
1246  for (auto fd : FieldDimensions) {
1247  ((fd->second).second)->finalise();
1248  }
1249  *gmsg << "* ------------------------------------------------------------------------ *" << endl;
1250 }
1251 
1252 
1254  /*
1255  * variable unit meaning
1256  * ------------------------------------------------
1257  * t [ns] time
1258  * dt [ns] time step
1259  * oldReferenceTheta [rad] azimuth angle
1260  * itsBunch_m->R [m] particle position
1261  *
1262  */
1263 
1264  double t = 0, dt = 0, oldReferenceTheta = 0;
1265  std::tie(t, dt, oldReferenceTheta) = initializeTracking_m();
1266 
1267  int const numSubsteps = std::max(Options::mtsSubsteps, 1);
1268  *gmsg << "* MTS: Number of substeps per step is " << numSubsteps << endl;
1269 
1270  double const dt_inner = dt / double(numSubsteps);
1271  *gmsg << "* MTS: The inner time step is therefore " << dt_inner << " [ns]" << endl;
1272 
1273 // int SteptoLastInj = itsBunch_m->getSteptoLastInj();
1274 
1275  bool flagTransition = false; // flag to determine when to transit from single-bunch to multi-bunches mode
1276 
1277  *gmsg << "* ---------------------- Start tracking ---------------------------------- *" << endl;
1278 
1279  if ( itsBunch_m->hasFieldSolver() )
1281 
1282  for (; (step_m < maxSteps_m) && (itsBunch_m->getTotalNum()>0); step_m++) {
1283 
1284  bool finishedTurn = false;
1285 
1286  if (step_m % Options::sptDumpFreq == 0) {
1288  }
1289 
1290  Ippl::Comm->barrier();
1291 
1292  // First half kick from space charge force
1293  if (itsBunch_m->hasFieldSolver()) {
1294  kick(0.5 * dt);
1295  }
1296 
1297  // Substeps for external field integration
1298  for (int n = 0; n < numSubsteps; ++n)
1299  borisExternalFields(dt_inner);
1300 
1301  // bunch injection
1302  // TODO: Where is correct location for this piece of code? Beginning/end of step? Before field solve?
1303  injectBunch(flagTransition);
1304 
1305  if ( itsBunch_m->hasFieldSolver() ) {
1307  } else {
1308  // if field solver is not available , only update bunch, to transfer particles between nodes if needed,
1309  // reset parameters such as LocalNum, initialTotalNum_m.
1310  // INFOMSG("No space charge Effects are included!"<<endl;);
1311  if ((step_m % Options::repartFreq * 100) == 0) { //TODO: why * 100?
1312  Vector_t const meanP = calcMeanP();
1313  double const phi = calculateAngle(meanP(0), meanP(1)) - 0.5 * Physics::pi;
1314  Vector_t const meanR = calcMeanR();
1315  globalToLocal(itsBunch_m->R, phi, meanR);
1317  repartition();
1318  localToGlobal(itsBunch_m->R, phi, meanR);
1319  }
1320  }
1321 
1322  // Second half kick from space charge force
1323  if (itsBunch_m->hasFieldSolver())
1324  kick(0.5 * dt);
1325 
1326  // recalculate bingamma and reset the BinID for each particles according to its current gamma
1327  if (isMultiBunch() && (step_m % Options::rebinFreq == 0)) {
1328  mbHandler_m->updateParticleBins(itsBunch_m);
1329  }
1330 
1331  // dump some data after one push in single particle tracking
1332  if ( mode_m == MODE::SINGLE ) {
1333 
1334  unsigned int i = 0;
1335 
1336  double temp_meanTheta = calculateAngle2(itsBunch_m->R[i](0),
1337  itsBunch_m->R[i](1)); // [-pi, pi]
1338 
1340  temp_meanTheta, finishedTurn);
1341 
1343  oldReferenceTheta, temp_meanTheta);
1344 
1345  oldReferenceTheta = temp_meanTheta;
1346  } else if ( mode_m == MODE::BUNCH ) {
1347  // both for single bunch and multi-bunch
1348  // avoid dump at the first step
1349  // finishedTurn has not been changed in first push
1350  if ( isTurnDone() ) {
1351  ++turnnumber_m;
1352  finishedTurn = true;
1353 
1354  *gmsg << endl;
1355  *gmsg << "*** Finished turn " << turnnumber_m - 1
1356  << ", Total number of live particles: "
1357  << itsBunch_m->getTotalNum() << endl;
1358  }
1359 
1360  // Recalculate bingamma and reset the BinID for each particles according to its current gamma
1361  if (isMultiBunch() && (step_m % Options::rebinFreq == 0)) {
1362  mbHandler_m->updateParticleBins(itsBunch_m);
1363  }
1364  }
1365 
1366  // printing + updating bunch parameters + updating t
1367  update_m(t, dt, finishedTurn);
1368 
1369  }
1370 
1371  // Some post-integration stuff
1372  *gmsg << endl;
1373  *gmsg << "* ---------------------- DONE TRACKING PARTICLES ------------------------- *" << endl;
1374 
1375 
1376  //FIXME
1377  dvector_t Ttime = dvector_t();
1378  dvector_t Tdeltr = dvector_t();
1379  dvector_t Tdeltz = dvector_t();
1380  ivector_t TturnNumber = ivector_t();
1381 
1382  finalizeTracking_m(Ttime, Tdeltr, Tdeltz, TturnNumber);
1383 }
1384 
1385 
1387  /*
1388  * variable unit meaning
1389  * ------------------------------------------------
1390  * t [ns] time
1391  * dt [ns] time step
1392  * oldReferenceTheta [rad] azimuth angle
1393  * itsBunch_m->R [m] particle position
1394  *
1395  */
1396  // Generic Tracker that has three modes defined by timeIntegrator_m:
1397  // 0 --- RK-4 (default)
1398  // 1 --- LF-2
1399  // (2 --- MTS ... not yet implemented in generic tracker)
1400  // mbHandler_m->getNumBunch() determines the number of bunches in multibunch mode (MBM, 1 for OFF)
1401  // Total number of particles determines single particle mode (SPM, 1 particle) or
1402  // Static Equilibrium Orbit Mode (SEO, 2 particles)
1403 
1404  double t = 0, dt = 0, oldReferenceTheta = 0;
1405  std::tie(t, dt, oldReferenceTheta) = initializeTracking_m();
1406 
1407  // If initialTotalNum_m = 2, trigger SEO mode and prepare for transverse tuning calculation
1408  // Where is the IF here? -DW
1409  dvector_t Ttime, Tdeltr, Tdeltz;
1410  ivector_t TturnNumber;
1411 
1412  // Apply the plugin elements: probe, collimator, stripper, septum once before first step
1413  bool flagNeedUpdate = applyPluginElements(dt);
1414 
1415  // Destroy particles if they are marked as Bin = -1 in the plugin elements
1416  // or out of global aperture
1417  deleteParticle(flagNeedUpdate);
1418 
1419  /********************************
1420  * Main integration loop *
1421  ********************************/
1422  *gmsg << endl;
1423  *gmsg << "* ---------------------- Start tracking ---------------------------------- *" << endl;
1424 
1425  for (; (step_m < maxSteps_m) && (itsBunch_m->getTotalNum()>0); step_m++) {
1426 
1427  bool finishedTurn = false;
1428 
1429  switch (mode_m) {
1430  case MODE::SEO: {
1431  // initialTotalNum_m == 2
1432  seoMode_m(t, dt, finishedTurn, Ttime, Tdeltr, Tdeltz, TturnNumber);
1433  break;
1434  }
1435  case MODE::SINGLE: {
1436  // initialTotalNum_m == 1
1437  singleMode_m(t, dt, finishedTurn, oldReferenceTheta);
1438  break;
1439  }
1440  case MODE::BUNCH: {
1441  // initialTotalNum_m > 2
1442  // Start Tracking for number of particles > 2 (i.e. not single and not SEO mode)
1443  bunchMode_m(t, dt, finishedTurn);
1444  break;
1445  }
1446  case MODE::UNDEFINED: {
1447  default:
1448  throw OpalException("ParallelCyclotronTracker::GenericTracker()",
1449  "No such tracking mode.");
1450  }
1451  }
1452  // Update bunch and some parameters and output some info
1453  update_m(t, dt, finishedTurn);
1454 
1455  } // end for: the integration is DONE after maxSteps_m steps or if all particles are lost!
1456 
1457  // Some post-integration stuff
1458  *gmsg << endl;
1459  *gmsg << "* ---------------------- DONE TRACKING PARTICLES ------------------------- *" << endl;
1460 
1461  finalizeTracking_m(Ttime, Tdeltr, Tdeltz, TturnNumber);
1462 }
1463 
1464 bool ParallelCyclotronTracker::getFieldsAtPoint(const double &t, const size_t &Pindex, Vector_t &Efield, Vector_t &Bfield) {
1465 
1466  bool outOfBound = this->computeExternalFields_m(Pindex, t, Efield, Bfield);
1467 
1468  // For runs without space charge effects, override this step to save time
1469  if(itsBunch_m->hasFieldSolver()) {
1470 
1471  // Don't do for reference particle
1472  if(itsBunch_m->ID[Pindex] != 0) {
1473 
1474  // add external Field and self space charge field
1475  Efield += itsBunch_m->Ef[Pindex];
1476  Bfield += itsBunch_m->Bf[Pindex];
1477  }
1478  }
1479 
1480  return outOfBound;
1481 }
1482 
1483 
1496  RFCavity * rfcavity, double &Dold)
1497 {
1498  bool flag = false;
1499  double sinx = rfcavity->getSinAzimuth();
1500  double cosx = rfcavity->getCosAzimuth();
1501  // TODO: Presumably this is still in mm, so for now, change to m -DW
1502  double PerpenDistance = 0.001 * rfcavity->getPerpenDistance();
1503  double distNew = (Rnew[0] * sinx - Rnew[1] * cosx) - PerpenDistance;
1504  double distOld = (Rold[0] * sinx - Rold[1] * cosx) - PerpenDistance;
1505  if(distOld > 0.0 && distNew <= 0.0) flag = true;
1506  // This parameter is used correct cavity phase
1507  Dold = 1.0e3 * distOld; // m --> mm
1508  return flag;
1509 }
1510 
1511 bool ParallelCyclotronTracker::RFkick(RFCavity * rfcavity, const double t, const double dt, const int Pindex){
1512  // For OPAL 2.0: As long as the RFCavity is in mm, we have to change R to mm here -DW
1513  double radius = std::sqrt(std::pow(1000.0 * itsBunch_m->R[Pindex](0), 2.0) + std::pow(1000.0 * itsBunch_m->R[Pindex](1), 2.0)
1514  - std::pow(rfcavity->getPerpenDistance() , 2.0));
1515  double rmin = rfcavity->getRmin();
1516  double rmax = rfcavity->getRmax();
1517  double nomalRadius = (radius - rmin) / (rmax - rmin);
1518  double tempP[3];
1519  if(nomalRadius <= 1.0 && nomalRadius >= 0.0) {
1520 
1521  for(int j = 0; j < 3; j++)
1522  tempP[j] = itsBunch_m->P[Pindex](j); //[px,py,pz] units: dimensionless
1523 
1524  // here evaluate voltage and conduct momenta kicking;
1525  rfcavity->getMomentaKick(nomalRadius, tempP, t, dt, itsBunch_m->ID[Pindex], itsBunch_m->getM(), itsBunch_m->getQ()); // t : ns
1526 
1527  for(int j = 0; j < 3; j++)
1528  itsBunch_m->P[Pindex](j) = tempP[j];
1529  return true;
1530  }
1531  return false;
1532 }
1533 
1534 
1535 struct adder {
1536  adder() : sum(0) {}
1537  double sum;
1538  void operator()(double x) { sum += x; }
1539 };
1540 
1554  int lastTurn, double &/*nur*/, double &/*nuz*/) {
1555  TUNE_class *tune;
1556 
1557  int Ndat = t.size();
1558 
1559  /*
1560  remove mean
1561  */
1562  double rsum = for_each(r.begin(), r.end(), adder()).sum;
1563 
1564  for(int i = 0; i < Ndat; i++)
1565  r[i] -= rsum;
1566 
1567  double zsum = for_each(z.begin(), z.end(), adder()).sum;
1568 
1569  for(int i = 0; i < Ndat; i++)
1570  z[i] -= zsum;
1571  double ti = *(t.begin());
1572  double tf = t[t.size()-1];
1573  double T = (tf - ti);
1574 
1575  t.clear();
1576  for(int i = 0; i < Ndat; i++) {
1577  t.push_back(i);
1578  }
1579 
1580  T = t[Ndat-1];
1581 
1582  *gmsg << endl;
1583  *gmsg << "* ************************************* nuR ******************************************* *" << endl;
1584  *gmsg << endl << "* ===> " << Ndat << " data points Ti=" << ti << " Tf= " << tf << " -> T= " << T << endl;
1585 
1586  int nhis_lomb = 10;
1587  int stat = 0;
1588  // book tune class
1589  tune = new TUNE_class();
1590  stat = tune->lombAnalysis(t, r, nhis_lomb, T / lastTurn);
1591  if(stat != 0)
1592  *gmsg << "* TUNE: Lomb analysis failed" << endl;
1593  *gmsg << "* ************************************************************************************* *" << endl;
1594 
1595  delete tune;
1596  tune = NULL;
1597  // FIXME: FixMe: need to come from the inputfile
1598  nhis_lomb = 100;
1599 
1600  if(zsum != 0.0) {
1601 
1602  *gmsg << endl;
1603  *gmsg << "* ************************************* nuZ ******************************************* *" << endl;
1604  *gmsg << endl << "* ===> " << Ndat << " data points Ti=" << ti << " Tf= " << tf << " -> T= " << T << endl;
1605 
1606  // book tune class
1607  tune = new TUNE_class();
1608  stat = tune->lombAnalysis(t, z, nhis_lomb, T / lastTurn);
1609  if(stat != 0)
1610  *gmsg << "* TUNE: Lomb analysis failed" << endl;
1611  *gmsg << "* ************************************************************************************* *" << endl;
1612 
1613  delete tune;
1614  tune = NULL;
1615  }
1616  return true;
1617 }
1618 
1619 
1621  if (opalRing_m != NULL)
1622  return opalRing_m->getHarmonicNumber();
1623  Cyclotron* elcycl = dynamic_cast<Cyclotron*>(((*FieldDimensions.begin())->second).second);
1624  if (elcycl != NULL)
1625  return elcycl->getCyclHarm();
1626  throw OpalException("ParallelCyclotronTracker::getHarmonicNumber()",
1627  std::string("The first item in the FieldDimensions list does not ")
1628  +std::string("seem to be a Ring or a Cyclotron element"));
1629 }
1630 
1631 
1633  Vector_t meanR(0.0, 0.0, 0.0);
1634 
1635  for(unsigned int i = 0; i < itsBunch_m->getLocalNum(); ++i) {
1636  // take all particles if bunchNr <= -1
1637  if ( bunchNr > -1 && itsBunch_m->bunchNum[i] != bunchNr)
1638  continue;
1639 
1640  for(int d = 0; d < 3; ++d) {
1641  meanR(d) += itsBunch_m->R[i](d);
1642  }
1643  }
1644 
1645  reduce(meanR, meanR, OpAddAssign());
1646 
1647  size_t n = itsBunch_m->getTotalNum();
1648 
1649  if ( bunchNr > -1 )
1650  n = itsBunch_m->getTotalNumPerBunch(bunchNr);
1651 
1652  return meanR / Vector_t(n);
1653 }
1654 
1656  Vector_t meanP(0.0, 0.0, 0.0);
1657 
1658  for(unsigned int i = 0; i < itsBunch_m->getLocalNum(); ++i) {
1659  for(int d = 0; d < 3; ++d) {
1660  meanP(d) += itsBunch_m->P[i](d);
1661  }
1662  }
1663 
1664  reduce(meanP, meanP, OpAddAssign());
1665  return meanP / Vector_t(itsBunch_m->getTotalNum());
1666 }
1667 
1669  if((step_m % Options::repartFreq) == 0) {
1672  Ippl::Comm->barrier();
1674  }
1675 }
1676 
1678  double phi, Vector_t const translationToGlobal) {
1680  particleVectors -= translationToGlobal;
1681 
1682  Tenzor<double, 3> const rotation( std::cos(phi), std::sin(phi), 0,
1683  -std::sin(phi), std::cos(phi), 0,
1684  0, 0, 1); // clockwise rotation
1685 
1686  for(unsigned int i = 0; i < itsBunch_m->getLocalNum(); ++i) {
1687 
1688  particleVectors[i] = dot(rotation, particleVectors[i]);
1689  }
1691 }
1692 
1694  double phi, Vector_t const translationToGlobal) {
1696  Tenzor<double, 3> const rotation(std::cos(phi), -std::sin(phi), 0,
1697  std::sin(phi), std::cos(phi), 0,
1698  0, 0, 1); // counter-clockwise rotation
1699 
1700  for(unsigned int i = 0; i < itsBunch_m->getLocalNum(); ++i) {
1701 
1702  particleVectors[i] = dot(rotation, particleVectors[i]);
1703  }
1704 
1705  particleVectors += translationToGlobal;
1707 }
1708 
1709 
1711  Quaternion_t const quaternion,
1712  Vector_t const meanR) {
1714 
1715  // Translation from global to local
1716  particleVectors -= meanR;
1717 
1718  // Rotation to align P_mean with x-axis
1719  rotateWithQuaternion(particleVectors, quaternion);
1721 }
1722 
1724  Quaternion_t const quaternion,
1725  Vector_t const meanR) {
1727  // Reverse the quaternion by multiplying the axis components (x,y,z) with -1
1728  Quaternion_t reverseQuaternion = quaternion * -1.0;
1729  reverseQuaternion(0) *= -1.0;
1730 
1731  // Rotation back to original P_mean direction
1732  rotateWithQuaternion(particleVectors, reverseQuaternion);
1733 
1734  // Translation from local to global
1735  particleVectors += meanR;
1737 }
1738 
1740  double const phi,
1741  double const psi,
1742  Vector_t const meanR) {
1743 
1745  //double const tolerance = 1.0e-4; // TODO What is a good angle threshold? -DW
1746 
1747  // Translation from global to local
1748  particleVectors -= meanR;
1749 
1750  // Rotation to align P_mean with x-axis
1751  rotateAroundZ(particleVectors, phi);
1752 
1753  // If theta is large enough (i.e. there is significant momentum in z direction)
1754  // rotate around x-axis next
1755  //if (fabs(psi) > tolerance)
1756  rotateAroundX(particleVectors, psi);
1758 }
1759 
1761  double const phi,
1762  double const psi,
1763  Vector_t const meanR) {
1764 
1766  //double const tolerance = 1.0e-4; // TODO What is a good angle threshold? -DW
1767 
1768  // Translation from global to local
1769  myVector -= meanR;
1770 
1771  // Rotation to align P_mean with x-axis
1772  rotateAroundZ(myVector, phi);
1773 
1774  // If theta is large enough (i.e. there is significant momentum in z direction)
1775  // rotate around x-axis next
1776  //if (fabs(psi) > tolerance)
1777  rotateAroundX(myVector, psi);
1779 }
1780 
1782  double const phi,
1783  double const psi,
1784  Vector_t const meanR) {
1785 
1787  //double const tolerance = 1.0e-4; // TODO What is a good angle threshold? -DW
1788 
1789  // If theta is large enough (i.e. there is significant momentum in z direction)
1790  // rotate back around x-axis next
1791  //if (fabs(psi) > tolerance)
1792  rotateAroundX(particleVectors, -psi);
1793 
1794  // Rotation to align P_mean with x-axis
1795  rotateAroundZ(particleVectors, -phi);
1796 
1797  // Translation from local to global
1798  particleVectors += meanR;
1800 }
1801 
1803  double const phi,
1804  double const psi,
1805  Vector_t const meanR) {
1806 
1808  //double const tolerance = 1.0e-4; // TODO What is a good angle threshold? -DW
1809 
1810  // If theta is large enough (i.e. there is significant momentum in z direction)
1811  // rotate back around x-axis next
1812  //if (fabs(psi) > tolerance)
1813  rotateAroundX(myVector, -psi);
1814 
1815  // Rotation to align P_mean with x-axis
1816  rotateAroundZ(myVector, -phi);
1817 
1818  // Translation from local to global
1819  myVector += meanR;
1821 }
1822 
1824 
1825  Vector_t const quaternionVectorComponent = Vector_t(quaternion(1), quaternion(2), quaternion(3));
1826  double const quaternionScalarComponent = quaternion(0);
1827 
1828  for(unsigned int i = 0; i < itsBunch_m->getLocalNum(); ++i) {
1829 
1830  particleVectors[i] = 2.0f * dot(quaternionVectorComponent, particleVectors[i]) * quaternionVectorComponent +
1831  (quaternionScalarComponent * quaternionScalarComponent -
1832  dot(quaternionVectorComponent, quaternionVectorComponent)) * particleVectors[i] + 2.0f *
1833  quaternionScalarComponent * cross(quaternionVectorComponent, particleVectors[i]);
1834  }
1835 }
1836 
1838 
1839  double tolerance = 1.0e-10;
1840  double length2 = dot(quaternion, quaternion);
1841 
1842  if (std::abs(length2) > tolerance && std::abs(length2 - 1.0f) > tolerance) {
1843 
1844  double length = std::sqrt(length2);
1845  quaternion /= length;
1846  }
1847 }
1848 
1850 
1851  double tolerance = 1.0e-10;
1852  double length2 = dot(vector, vector);
1853 
1854  if (std::abs(length2) > tolerance && std::abs(length2 - 1.0f) > tolerance) {
1855 
1856  double length = std::sqrt(length2);
1857  vector /= length;
1858  }
1859 }
1860 
1861 inline void ParallelCyclotronTracker::rotateAroundZ(ParticleAttrib<Vector_t> & particleVectors, double const phi) {
1862  // Clockwise rotation of particles 'particleVectors' by 'phi' around Z axis
1863 
1864  Tenzor<double, 3> const rotation( std::cos(phi), std::sin(phi), 0,
1865  -std::sin(phi), std::cos(phi), 0,
1866  0, 0, 1);
1867 
1868  for(unsigned int i = 0; i < itsBunch_m->getLocalNum(); ++i) {
1869 
1870  particleVectors[i] = dot(rotation, particleVectors[i]);
1871  }
1872 }
1873 
1874 inline void ParallelCyclotronTracker::rotateAroundZ(Vector_t & myVector, double const phi) {
1875  // Clockwise rotation of single vector 'myVector' by 'phi' around Z axis
1876 
1877  Tenzor<double, 3> const rotation( std::cos(phi), std::sin(phi), 0,
1878  -std::sin(phi), std::cos(phi), 0,
1879  0, 0, 1);
1880 
1881  myVector = dot(rotation, myVector);
1882 }
1883 
1884 inline void ParallelCyclotronTracker::rotateAroundX(ParticleAttrib<Vector_t> & particleVectors, double const psi) {
1885  // Clockwise rotation of particles 'particleVectors' by 'psi' around X axis
1886 
1887  Tenzor<double, 3> const rotation(1, 0, 0,
1888  0, std::cos(psi), std::sin(psi),
1889  0, -std::sin(psi), std::cos(psi));
1890 
1891  for(unsigned int i = 0; i < itsBunch_m->getLocalNum(); ++i) {
1892 
1893  particleVectors[i] = dot(rotation, particleVectors[i]);
1894  }
1895 }
1896 
1897 inline void ParallelCyclotronTracker::rotateAroundX(Vector_t & myVector, double const psi) {
1898  // Clockwise rotation of single vector 'myVector' by 'psi' around X axis
1899 
1900  Tenzor<double, 3> const rotation(1, 0, 0,
1901  0, std::cos(psi), std::sin(psi),
1902  0, -std::sin(psi), std::cos(psi));
1903 
1904  myVector = dot(rotation, myVector);
1905 }
1906 
1908  // four vector (w,x,y,z) of the quaternion of P_mean with the positive x-axis
1909 
1910  normalizeVector(u);
1911  normalizeVector(v);
1912 
1913  double k_cos_theta = dot(u, v);
1914  double k = std::sqrt(dot(u, u) * dot(v, v));
1915  double tolerance1 = 1.0e-5;
1916  double tolerance2 = 1.0e-8;
1917  Vector_t resultVectorComponent;
1918 
1919  if (std::abs(k_cos_theta / k + 1.0) < tolerance1) {
1920  // u and v are almost exactly antiparallel so we need to do
1921  // 180 degree rotation around any vector orthogonal to u
1922 
1923  resultVectorComponent = cross(u, xaxis);
1924 
1925  // If by chance u is parallel to xaxis, use zaxis instead
1926  if (dot(resultVectorComponent, resultVectorComponent) < tolerance2) {
1927 
1928  resultVectorComponent = cross(u, zaxis);
1929  }
1930 
1931  double halfAngle = 0.5 * Physics::pi;
1932  double sinHalfAngle = std::sin(halfAngle);
1933 
1934  resultVectorComponent *= sinHalfAngle;
1935 
1936  k = 0.0;
1937  k_cos_theta = std::cos(halfAngle);
1938 
1939  } else {
1940 
1941  resultVectorComponent = cross(u, v);
1942 
1943  }
1944 
1945  quaternion(0) = k_cos_theta + k;
1946  quaternion(1) = resultVectorComponent(0);
1947  quaternion(2) = resultVectorComponent(1);
1948  quaternion(3) = resultVectorComponent(2);
1949 
1950  normalizeQuaternion(quaternion);
1951 }
1952 
1953 
1955  /* h [ns]
1956  * dt1 [ns]
1957  * dt2 [ns]
1958  */
1960 
1961  // h [ns] --> h [s]
1962  h *= 1.0e-9;
1963 
1964  bool flagNeedUpdate = false;
1965  for(unsigned int i = 0; i < itsBunch_m->getLocalNum(); ++i) {
1966  Vector_t const oldR = itsBunch_m->R[i];
1967  double const gamma = std::sqrt(1.0 + dot(itsBunch_m->P[i], itsBunch_m->P[i]));
1968  double const c_gamma = Physics::c / gamma;
1969  Vector_t const v = itsBunch_m->P[i] * c_gamma;
1970  itsBunch_m->R[i] += h * v;
1971  for(const auto & ccd : cavCrossDatas_m) {
1972  double const distNew = (itsBunch_m->R[i][0] * ccd.sinAzimuth - itsBunch_m->R[i][1] * ccd.cosAzimuth) - ccd.perpenDistance;
1973  bool tagCrossing = false;
1974  double distOld;
1975  if(distNew <= 0.0) {
1976  distOld = (oldR[0] * ccd.sinAzimuth - oldR[1] * ccd.cosAzimuth) - ccd.perpenDistance;
1977  if(distOld > 0.0) tagCrossing = true;
1978  }
1979  if(tagCrossing) {
1980  double const dt1 = distOld / std::sqrt(dot(v, v));
1981  double const dt2 = h - dt1;
1982 
1983  // Retrack particle from the old postion to cavity gap point
1984  itsBunch_m->R[i] = oldR + dt1 * v;
1985 
1986  // Momentum kick
1987  //itsBunch_m->R[i] *= 1000.0; // RFkick uses [itsBunch_m->R] == mm
1988  RFkick(ccd.cavity, itsBunch_m->getT() * 1.0e9, dt1, i);
1989  //itsBunch_m->R[i] *= 0.001;
1990 
1991  itsBunch_m->R[i] += dt2 * itsBunch_m->P[i] * c_gamma;
1992  }
1993  }
1994  flagNeedUpdate |= (itsBunch_m->Bin[i] < 0);
1995  }
1996 
1998  return flagNeedUpdate;
1999 }
2000 
2001 
2004 
2005  bool flagNeedUpdate = false;
2006  BorisPusher pusher;
2007  double const q = itsBunch_m->Q[0] / Physics::q_e; // For now all particles have the same charge
2008  double const M = itsBunch_m->M[0] * 1.0e9; // For now all particles have the same rest energy
2009 
2010  for(unsigned int i = 0; i < itsBunch_m->getLocalNum(); ++i) {
2011 
2012  pusher.kick(itsBunch_m->R[i], itsBunch_m->P[i],
2013  itsBunch_m->Ef[i], itsBunch_m->Bf[i],
2014  h * 1.0e-9, M, q);
2015  flagNeedUpdate |= (itsBunch_m->Bin[i] < 0);
2016  }
2018  return flagNeedUpdate;
2019 }
2020 
2021 
2023  // h in [ns]
2024 
2025  // push particles for first half step
2026  bool flagNeedUpdate = push(0.5 * h);
2027 
2028  // Evaluate external fields
2030  for(unsigned int i = 0; i < itsBunch_m->getLocalNum(); ++i) {
2031 
2032  itsBunch_m->Ef[i] = Vector_t(0.0, 0.0, 0.0);
2033  itsBunch_m->Bf[i] = Vector_t(0.0, 0.0, 0.0);
2034 
2035  computeExternalFields_m(i, itsBunch_m->getT() * 1e9 /*ns*/,
2036  itsBunch_m->Ef[i], itsBunch_m->Bf[i]);
2037  }
2039 
2040  // Kick particles for full step
2041  flagNeedUpdate |= kick(h);
2042 
2043  // push particles for second half step
2044  flagNeedUpdate |= push(0.5 * h);
2045 
2046  // apply the plugin elements: probe, collimator, stripper, septum
2047  flagNeedUpdate |= applyPluginElements(h);
2048  // destroy particles if they are marked as Bin=-1 in the plugin elements or out of global apeture
2049  deleteParticle(flagNeedUpdate);
2050 }
2051 
2052 
2055 
2056  for(beamline_list::iterator sindex = ++(FieldDimensions.begin()); sindex != FieldDimensions.end(); ++sindex) {
2057  if(((*sindex)->first) == ElementBase::VACUUM) {
2058  Vacuum* vac = static_cast<Vacuum*>(((*sindex)->second).second);
2059  vac->checkVacuum(itsBunch_m, cycl_m);
2060  }
2061  }
2062 
2063  bool flag = false;
2064  for (PluginElement* element : pluginElements_m) {
2065  bool tmp = element->check(itsBunch_m,
2066  turnnumber_m,
2067  itsBunch_m->getT(),
2068  dt);
2069  flag |= tmp;
2070 
2071  if ( tmp ) {
2073  *gmsg << "* Total number of particles after PluginElement= "
2074  << itsBunch_m->getTotalNum() << endl;
2075  }
2076  }
2077 
2079  return flag;
2080 }
2081 
2084  // Update immediately if any particles are lost during this step
2085 
2086  if ((step_m + 1) % Options::delPartFreq != 0) {
2088  return false;
2089  }
2090 
2091  allreduce(flagNeedUpdate, 1, std::logical_or<bool>());
2092 
2093  if(flagNeedUpdate) {
2094  short bunchCount = itsBunch_m->getNumBunch();
2095  std::vector<size_t> locLostParticleNum(bunchCount, 0);
2096 
2097  const int leb = itsBunch_m->getLastemittedBin();
2098  std::unique_ptr<size_t[]> localBinCount;
2099 
2100  if ( isMultiBunch() ) {
2101  localBinCount = std::unique_ptr<size_t[]>(new size_t[leb]);
2102  for (int i = 0; i < leb; ++i)
2103  localBinCount[i] = 0;
2104  }
2105 
2106  for(unsigned int i = 0; i < itsBunch_m->getLocalNum(); i++) {
2107  if(itsBunch_m->Bin[i] < 0) {
2108  ++locLostParticleNum[itsBunch_m->bunchNum[i]];
2109  itsBunch_m->destroy(1, i);
2110  } else if ( isMultiBunch() ) {
2111  /* we need to count the local number of particles
2112  * per energy bin
2113  */
2114  ++localBinCount[itsBunch_m->Bin[i]];
2115  }
2116  }
2117 
2118  if ( isMultiBunch() ) {
2119  // set the local bin count
2120  for (int i = 0; i < leb; ++i) {
2121  itsBunch_m->setLocalBinCount(localBinCount[i], i);
2122  }
2123  }
2124 
2125  std::vector<size_t> localnum(bunchCount + 1);
2126  for (size_t i = 0; i < localnum.size() - 1; ++i) {
2127  localnum[i] = itsBunch_m->getLocalNumPerBunch(i) - locLostParticleNum[i];
2128  itsBunch_m->setLocalNumPerBunch(localnum[i], i);
2129  }
2130 
2131  /* We need to destroy the particles now
2132  * before we compute the means. We also
2133  * have to update the total number of particles
2134  * otherwise the statistics are wrong.
2135  */
2136  itsBunch_m->performDestroy(true);
2137 
2138  /* total number of particles of individual bunches
2139  * last index of vector contains total number over all
2140  * bunches, used as a check
2141  */
2142  std::vector<size_t> totalnum(bunchCount + 1);
2143  localnum[bunchCount] = itsBunch_m->getLocalNum();
2144 
2145  allreduce(localnum.data(), totalnum.data(), localnum.size(), std::plus<size_t>());
2146  itsBunch_m->setTotalNum(totalnum[bunchCount]);
2147 
2148  for (short i = 0; i < bunchCount; ++i) {
2149  itsBunch_m->setTotalNumPerBunch(totalnum[i], i);
2150  }
2151 
2152  size_t sum = std::accumulate(totalnum.begin(),
2153  totalnum.end() - 1, 0);
2154 
2155  if ( sum != totalnum[bunchCount] ) {
2156  throw OpalException("ParallelCyclotronTracker::deleteParticle()",
2157  "Total number of particles " + std::to_string(totalnum[bunchCount]) +
2158  " != " + std::to_string(sum) + " (sum over all bunches)");
2159  }
2160 
2161  size_t globLostParticleNum = 0;
2162  size_t locNumLost = std::accumulate(locLostParticleNum.begin(),
2163  locLostParticleNum.end(), 0);
2164 
2165  reduce(locNumLost, globLostParticleNum, 1, std::plus<size_t>());
2166 
2167  if ( globLostParticleNum > 0 ) {
2168  *gmsg << level3 << "At step " << step_m
2169  << ", lost " << globLostParticleNum << " particles" << endl;
2170  }
2171 
2172  if (totalnum[bunchCount] == 0) {
2174  return flagNeedUpdate;
2175  }
2176 
2177  Vector_t const meanR = calcMeanR();
2178  Vector_t const meanP = calcMeanP();
2179 
2180  // Bunch (local) azimuth at meanR w.r.t. y-axis
2181  double const phi = calculateAngle(meanP(0), meanP(1)) - 0.5 * Physics::pi;
2182 
2183  // Bunch (local) elevation at meanR w.r.t. xy plane
2184  double const psi = 0.5 * Physics::pi - std::acos(meanP(2) / std::sqrt(dot(meanP, meanP)));
2185 
2186  // For statistics data, the bunch is transformed into a local coordinate system
2187  // with meanP in direction of y-axis -DW
2188  globalToLocal(itsBunch_m->R, phi, psi, meanR);
2189  globalToLocal(itsBunch_m->P, phi, psi, Vector_t(0.0)); // P should be rotated, but not shifted
2190 
2191  //itsBunch_m->R *= Vector_t(0.001); // mm --> m
2192 
2193  // Now destroy particles and update pertinent parameters in local frame
2194  // Note that update() will be called within boundp() -DW
2195  itsBunch_m->boundp();
2196  //itsBunch_m->update();
2197 
2199 
2200  //itsBunch_m->R *= Vector_t(1000.0); // m --> mm
2201 
2202  localToGlobal(itsBunch_m->R, phi, psi, meanR);
2203  localToGlobal(itsBunch_m->P, phi, psi, Vector_t(0.0));
2204 
2205  // If particles were deleted, recalculate bingamma and reset BinID for remaining particles
2206  if ( isMultiBunch() )
2207  mbHandler_m->updateParticleBins(itsBunch_m);
2208  }
2209 
2211  return flagNeedUpdate;
2212 }
2213 
2215 
2216  std::string f = OpalData::getInstance()->getInputBasename() + std::string("-trackOrbit.dat");
2217 
2218  outfTrackOrbit_m.setf(std::ios::scientific, std::ios::floatfield);
2219  outfTrackOrbit_m.precision(8);
2220 
2221  if(myNode_m == 0) {
2222 
2223  if(OpalData::getInstance()->inRestartRun()) {
2224 
2225  outfTrackOrbit_m.open(f.c_str(), std::ios::app);
2226  outfTrackOrbit_m << "# Restart at integration step " << itsBunch_m->getLocalTrackStep() << std::endl;
2227  } else {
2228 
2229  outfTrackOrbit_m.open(f.c_str());
2230  outfTrackOrbit_m << "# The six-dimensional phase space data in the global Cartesian coordinates" << std::endl;
2231  outfTrackOrbit_m << "# Part. ID x [m] beta_x*gamma y [m] beta_y*gamma z [m] beta_z*gamma" << std::endl;
2232  }
2233  }
2234 }
2235 
2237  if(!OpalData::getInstance()->inRestartRun()) {
2238  // Start a new run (no restart)
2239 
2240  double const initialReferenceTheta = referenceTheta * Physics::deg2rad;
2241 
2242  // TODO: Replace with TracerParticle
2243  // Force the initial phase space values of the particle with ID = 0 to zero,
2244  // to set it as a reference particle.
2245  if(initialTotalNum_m > 2) {
2246  for(size_t i = 0; i < initialLocalNum_m; ++i) {
2247  if(itsBunch_m->ID[i] == 0) {
2248  itsBunch_m->R[i] = Vector_t(0.0);
2249  itsBunch_m->P[i] = Vector_t(0.0);
2250  }
2251  }
2252  }
2253 
2254  // Initialize global R
2255  //itsBunch_m->R *= Vector_t(1000.0); // m --> mm
2256 
2257  // NEW OPAL 2.0: Immediately change to m -DW
2258  Vector_t const initMeanR = Vector_t(0.001 * referenceR * cosRefTheta_m, // mm --> m
2259  0.001 * referenceR * sinRefTheta_m, // mm --> m
2260  0.001 * referenceZ); // mm --> m
2261 
2262  localToGlobal(itsBunch_m->R, initialReferenceTheta, initMeanR);
2263 
2264  // Initialize global P (Cartesian, but input P_ref is in Pr, Ptheta, Pz,
2265  // so translation has to be done before the rotation this once)
2266  // Cave: In the local frame, the positive y-axis is the direction of movement -DW
2267  for(size_t i = 0; i < initialLocalNum_m; ++i) {
2268  itsBunch_m->P[i](0) += referencePr;
2269  itsBunch_m->P[i](1) += referencePt;
2270  itsBunch_m->P[i](2) += referencePz;
2271  }
2272 
2273  // Out of the three coordinates of meanR (R, Theta, Z) only the angle
2274  // changes the momentum vector...
2275  localToGlobal(itsBunch_m->P, initialReferenceTheta);
2276 
2277  // Initialize the bin number of the first bunch to 0
2278  for(size_t i = 0; i < initialLocalNum_m; ++i) {
2279  itsBunch_m->Bin[i] = 0;
2280  }
2281 
2282  // Backup initial distribution if multi bunch mode
2283  if ((initialTotalNum_m > 2) && isMultiBunch() && mbHandler_m->isForceMode()) {
2284  mbHandler_m->saveBunch(itsBunch_m);
2285  }
2286 
2287  // Else: Restart from the distribution in the h5 file
2288  } else {
2289 
2290  // Do a local frame restart (we have already checked that the old h5 file was saved in local
2291  // frame as well).
2293 
2294  *gmsg << "* Restart in the local frame" << endl;
2295 
2296  //itsBunch_m->R *= Vector_t(1000.0); // m --> mm
2297 
2298  // referenceR and referenceZ are already in mm
2299  // New OPAL 2.0: Init in m -DW
2300  Vector_t const initMeanR = Vector_t(0.001 * referenceR * cosRefTheta_m,
2301  0.001 * referenceR * sinRefTheta_m,
2302  0.001 * referenceZ);
2303 
2304  // Do the tranformations
2307 
2308  // Initialize the bin number of the first bunch to 0
2309  for(size_t i = 0; i < initialLocalNum_m; ++i) {
2310  itsBunch_m->Bin[i] = 0;
2311  }
2312 
2313  // Or do a global frame restart (no transformations necessary)
2314  } else {
2315 
2316  *gmsg << "* Restart in the global frame" << endl;
2317 
2319  //itsBunch_m->R *= Vector_t(1000.0); // m --> mm
2320  }
2321  }
2322 
2323  // set the number of particles per bunch
2325 
2326  // ------------ Get some Values ---------------------------------------------------------- //
2327  Vector_t const meanR = calcMeanR();
2328  Vector_t const meanP = calcMeanP();
2329 
2330  // Bunch (local) azimuth at meanR w.r.t. y-axis
2331  double const phi = calculateAngle(meanP(0), meanP(1)) - 0.5 * Physics::pi;
2332 
2333  // Bunch (local) elevation at meanR w.r.t. xy plane
2334  double const psi = 0.5 * Physics::pi - std::acos(meanP(2) / std::sqrt(dot(meanP, meanP)));
2335 
2336  double radius = std::sqrt(meanR[0] * meanR[0] + meanR[1] * meanR[1]); // [m]
2337 
2338  if ( isMultiBunch() )
2339  mbHandler_m->setRadiusTurns(radius);
2340 
2341  // Do boundp and repartition in the local frame at beginning of this run
2342  globalToLocal(itsBunch_m->R, phi, psi, meanR);
2343  globalToLocal(itsBunch_m->P, phi, psi); // P should be rotated, but not shifted
2344 
2345  //itsBunch_m->R *= Vector_t(0.001); // mm --> m
2346 
2347  itsBunch_m->boundp();
2348 
2349  checkNumPart(std::string("\n* Before repartition: "));
2350  repartition();
2351  checkNumPart(std::string("\n* After repartition: "));
2352 
2354 
2355  *gmsg << endl << "* *********************** Bunch information in local frame: ************************";
2356  *gmsg << *itsBunch_m << endl;
2357 
2358  //itsBunch_m->R *= Vector_t(1000.0); // m --> mm
2359 
2360  localToGlobal(itsBunch_m->R, phi, psi, meanR);
2361  localToGlobal(itsBunch_m->P, phi, psi);
2362 
2363  // Save initial distribution if not a restart
2364  if(!OpalData::getInstance()->inRestartRun()) {
2365 
2366  step_m -= 1;
2367 
2370 
2371  step_m += 1;
2372  }
2373 
2374  // Print out the Bunch information at beginning of the run. Because the bunch information
2375  // displays in units of m we have to change back and forth one more time.
2376  //itsBunch_m->R *= Vector_t(0.001); // mm --> m
2377 
2379 
2380  // multi-bunch simulation only
2381  saveInjectValues();
2382 
2383  *gmsg << endl << "* *********************** Bunch information in global frame: ***********************";
2384  *gmsg << *itsBunch_m << endl;
2385 
2386  //itsBunch_m->R *= Vector_t(1000.0); // m --> mm
2387 }
2388 
2389 //TODO: This can be completely rewritten with TracerParticle -DW
2392 
2393  if(Ippl::getNodes() > 1 ) {
2394 
2395  double x;
2396  int id;
2397  dvector_t tmpr;
2398  ivector_t tmpi;
2399 
2401 
2402  // for all nodes, find the location of particle with ID = 0 & 1 in bunch containers
2403  int found[2] = {-1, -1};
2404  int counter = 0;
2405 
2406  for(size_t i = 0; i < itsBunch_m->getLocalNum(); ++i) {
2407  if(itsBunch_m->ID[i] == 0) {
2408  found[counter] = i;
2409  counter++;
2410  }
2411  if(itsBunch_m->ID[i] == 1) {
2412  found[counter] = i;
2413  counter++;
2414  }
2415  }
2416 
2417  if(myNode_m == 0) {
2418  int notReceived = Ippl::getNodes() - 1;
2419  int numberOfPart = 0;
2420  // receive other nodes
2421  while(notReceived > 0) {
2422 
2423  int node = COMM_ANY_NODE;
2424  Message *rmsg = Ippl::Comm->receive_block(node, tag);
2425 
2426  if(rmsg == nullptr)
2427  ERRORMSG("Could not receive from client nodes in main." << endl);
2428 
2429  --notReceived;
2430 
2431  rmsg->get(&numberOfPart);
2432 
2433  for(int i = 0; i < numberOfPart; ++i) {
2434  rmsg->get(&id);
2435  tmpi.push_back(id);
2436  for(int ii = 0; ii < 6; ii++) {
2437  rmsg->get(&x);
2438  tmpr.push_back(x);
2439  }
2440  }
2441  delete rmsg;
2442  }
2443  // own node
2444  for(int i = 0; i < counter; ++i) {
2445 
2446  tmpi.push_back(itsBunch_m->ID[found[i]]);
2447 
2448  for(int j = 0; j < 3; ++j) {
2449 
2450  tmpr.push_back(itsBunch_m->R[found[i]](j));
2451  tmpr.push_back(itsBunch_m->P[found[i]](j));
2452  }
2453  }
2454  // store
2455  dvector_t::iterator itParameter = tmpr.begin();
2456 
2457  for(auto tmpid : tmpi) {
2458 
2459  outfTrackOrbit_m << "ID" << tmpid;
2460 
2461  if (tmpid == 0) { // for stat file
2462  itsBunch_m->RefPartR_m[0] = *itParameter;
2463  itsBunch_m->RefPartR_m[1] = *(itParameter + 2);
2464  itsBunch_m->RefPartR_m[2] = *(itParameter + 4);
2465  itsBunch_m->RefPartP_m[0] = *(itParameter + 1);
2466  itsBunch_m->RefPartP_m[1] = *(itParameter + 3);
2467  itsBunch_m->RefPartP_m[2] = *(itParameter + 5);
2468  }
2469  for(int ii = 0; ii < 6; ii++) {
2470 
2471  outfTrackOrbit_m << " " << *itParameter;
2472  ++itParameter;
2473  }
2474 
2476  }
2477  } else {
2478  // for other nodes
2479  Message *smsg = new Message();
2480  smsg->put(counter);
2481 
2482  for(int i = 0; i < counter; i++) {
2483 
2484  smsg->put(itsBunch_m->ID[found[i]]);
2485 
2486  for(int j = 0; j < 3; j++) {
2487 
2488  smsg->put(itsBunch_m->R[found[i]](j));
2489  smsg->put(itsBunch_m->P[found[i]](j));
2490  }
2491  }
2492 
2493  if(!Ippl::Comm->send(smsg, 0, tag))
2494  ERRORMSG("Ippl::Comm->send(smsg, 0, tag) failed " << endl);
2495  }
2496 
2497  Ippl::Comm->barrier();
2498 
2499  } else {
2500 
2501  for(size_t i = 0; i < itsBunch_m->getLocalNum(); i++) {
2502  if(itsBunch_m->ID[i] == 0 || itsBunch_m->ID[i] == 1) {
2503 
2504  outfTrackOrbit_m << "ID" << itsBunch_m->ID[i] << " ";
2505  outfTrackOrbit_m << itsBunch_m->R[i](0) << " " << itsBunch_m->P[i](0) << " ";
2506  outfTrackOrbit_m << itsBunch_m->R[i](1) << " " << itsBunch_m->P[i](1) << " ";
2507  outfTrackOrbit_m << itsBunch_m->R[i](2) << " " << itsBunch_m->P[i](2) << std::endl;
2508 
2509  if (itsBunch_m->ID[i] == 0) { // for stat file
2512  }
2513  }
2514  }
2515  }
2516 
2518 }
2519 
2521 
2523 
2524  // dump stat file per bunch in case of multi-bunch mode
2525  if (isMultiBunch()) {
2526  double phi = 0.0, psi = 0.0;
2527  Vector_t meanR = calcMeanR();
2528 
2529  // Bunch (global) angle w.r.t. x-axis (cylinder coordinates)
2530  double theta = calculateAngle(meanR(0), meanR(1)) * Physics::rad2deg;
2531 
2532  // fix azimuth_m --> make monotonically increasing
2534 
2536 
2538  Vector_t meanP = calcMeanP();
2539 
2540  // Bunch (local) azimuth at meanR w.r.t. y-axis
2541  phi = calculateAngle(meanP(0), meanP(1)) - 0.5 * Physics::pi;
2542 
2543  // Bunch (local) elevation at meanR w.r.t. xy plane
2544  psi = 0.5 * Physics::pi - std::acos(meanP(2) / std::sqrt(dot(meanP, meanP)));
2545 
2546  // Rotate so Pmean is in positive y direction. No shift, so that normalized emittance and
2547  // unnormalized emittance as well as centroids are calculated correctly in
2548  // PartBunch::calcBeamParameters()
2549  globalToLocal(itsBunch_m->R, phi, psi, meanR);
2550  globalToLocal(itsBunch_m->P, phi, psi);
2551  }
2552 
2554 
2556  localToGlobal(itsBunch_m->R, phi, psi, meanR);
2557  localToGlobal(itsBunch_m->P, phi, psi);
2558  }
2559 
2561  return;
2562  }
2563 
2564  // --------------------------------- Get some Values ---------------------------------------- //
2565  double const temp_t = itsBunch_m->getT() * 1e9; // s -> ns
2566  Vector_t meanR;
2567  Vector_t meanP;
2569  meanR = calcMeanR();
2570  meanP = calcMeanP();
2571  } else if (itsBunch_m->getLocalNum() > 0) {
2572  meanR = itsBunch_m->R[0];
2573  meanP = itsBunch_m->P[0];
2574  }
2575  double phi = 0;
2576  double psi = 0;
2577 
2578  // Bunch (global) angle w.r.t. x-axis (cylinder coordinates)
2579  double azimuth = calculateAngle(meanR(0), meanR(1)) * Physics::rad2deg;
2580 
2581  // fix azimuth_m --> make monotonically increasing
2582  dumpAngle(azimuth, prevAzimuth_m, azimuth_m);
2583 
2584  // -------------- Calculate the external fields at the center of the bunch ----------------- //
2585  beamline_list::iterator DumpSindex = FieldDimensions.begin();
2586 
2587  extE_m = Vector_t(0.0, 0.0, 0.0);
2588  extB_m = Vector_t(0.0, 0.0, 0.0);
2589 
2590  (((*DumpSindex)->second).second)->apply(meanR, meanP, temp_t, extE_m, extB_m);
2591 
2592  // If we are saving in local frame, bunch and fields at the bunch center have to be rotated
2593  // TODO: Make decision if we maybe want to always save statistics data in local frame? -DW
2595  // -------------------- ----------- Do Transformations ---------------------------------- //
2596  // Bunch (local) azimuth at meanR w.r.t. y-axis
2597  phi = calculateAngle(meanP(0), meanP(1)) - 0.5 * Physics::pi;
2598 
2599  // Bunch (local) elevation at meanR w.r.t. xy plane
2600  psi = 0.5 * Physics::pi - std::acos(meanP(2) / std::sqrt(dot(meanP, meanP)));
2601 
2602  // Rotate so Pmean is in positive y direction. No shift, so that normalized emittance and
2603  // unnormalized emittance as well as centroids are calculated correctly in
2604  // PartBunch::calcBeamParameters()
2605  globalToLocal(extB_m, phi, psi);
2606  globalToLocal(extE_m, phi, psi);
2607  globalToLocal(itsBunch_m->R, phi, psi);
2608  globalToLocal(itsBunch_m->P, phi, psi);
2609  }
2610 
2611  //itsBunch_m->R *= Vector_t(0.001); // mm -> m
2612 
2613  FDext_m[0] = extB_m / 10.0; // kgauss --> T
2614  FDext_m[1] = extE_m; // kV/mm? -DW
2615 
2616  // Save the stat file
2618 
2619  //itsBunch_m->R *= Vector_t(1000.0); // m -> mm
2620 
2621  // If we are in local mode, transform back after saving
2623  localToGlobal(itsBunch_m->R, phi, psi);
2624  localToGlobal(itsBunch_m->P, phi, psi);
2625  }
2626 
2628 }
2629 
2630 
2632  // --------------------------------- Particle dumping --------------------------------------- //
2633  // Note: Don't dump when
2634  // 1. after one turn
2635  // in order to sychronize the dump step for multi-bunch and single bunch for comparison
2636  // with each other during post-process phase.
2637  // ------------------------------------------------------------------------------------------ //
2639 
2640  // --------------------------------- Get some Values ---------------------------------------- //
2641  double const temp_t = itsBunch_m->getT() * 1.0e9; // s -> ns
2642 
2643  Vector_t meanR;
2644  Vector_t meanP;
2645 
2646  // in case of multi-bunch mode take always bunch mean (although it takes all bunches)
2648  meanR = calcMeanR();
2649  meanP = calcMeanP();
2650  } else if (itsBunch_m->getLocalNum() > 0) {
2651  meanR = itsBunch_m->R[0];
2652  meanP = itsBunch_m->P[0];
2653  }
2654 
2655  double const betagamma_temp = std::sqrt(dot(meanP, meanP));
2656 
2657  double const E = itsBunch_m->get_meanKineticEnergy();
2658 
2659  // Bunch (global) angle w.r.t. x-axis (cylinder coordinates)
2660  double const theta = std::atan2(meanR(1), meanR(0));
2661 
2662  // Bunch (local) azimuth at meanR w.r.t. y-axis
2663  double const phi = calculateAngle(meanP(0), meanP(1)) - 0.5 * Physics::pi;
2664 
2665  // Bunch (local) elevation at meanR w.r.t. xy plane
2666  double const psi = 0.5 * Physics::pi - std::acos(meanP(2) / std::sqrt(dot(meanP, meanP)));
2667 
2668  // ---------------- Re-calculate reference values in format of input values ----------------- //
2669  // Position:
2670  // New OPAL 2.0: Init in m (back to mm just for output) -DW
2671  referenceR = computeRadius(meanR); // includes m --> mm conversion
2672  referenceTheta = theta / Physics::deg2rad;
2673  referenceZ = 1000.0 * meanR(2);
2674 
2675  // Momentum in Theta-hat, R-hat, Z-hat coordinates at position meanR:
2676  referencePtot = betagamma_temp;
2677  referencePz = meanP(2);
2678  referencePr = meanP(0) * std::cos(theta) + meanP(1) * std::sin(theta);
2681 
2682  // ----- Calculate the external fields at the center of the bunch (Cave: Global Frame) ----- //
2683  beamline_list::iterator DumpSindex = FieldDimensions.begin();
2684 
2685  extE_m = Vector_t(0.0, 0.0, 0.0);
2686  extB_m = Vector_t(0.0, 0.0, 0.0);
2687 
2688  (((*DumpSindex)->second).second)->apply(meanR, meanP, temp_t, extE_m, extB_m);
2689  FDext_m[0] = extB_m * 0.1; // kgauss --> T
2690  FDext_m[1] = extE_m;
2691 
2692  // -------------- If flag psDumpFrame is global, dump bunch in global frame ------------- //
2694  bool dumpLocalFrame = true;
2695  std::string dumpString = "local";
2697  dumpLocalFrame = false;
2698  dumpString = "global";
2699  }
2700 
2701  if (dumpLocalFrame == true) {
2702  // ---------------- If flag psDumpFrame is local, dump bunch in local frame ---------------- //
2703 
2704  // The bunch is transformed into a local coordinate system with meanP in direction of y-axis
2705  globalToLocal(itsBunch_m->R, phi, psi, meanR);
2706  //globalToLocal(itsBunch_m->R, phi, psi, meanR * Vector_t(0.001));
2707  globalToLocal(itsBunch_m->P, phi, psi); // P should only be rotated
2708 
2709  globalToLocal(extB_m, phi, psi);
2710  globalToLocal(extE_m, phi, psi);
2711  }
2712 
2713  FDext_m[0] = extB_m * 0.1; // kgauss --> T
2714  FDext_m[1] = extE_m;
2715 
2716  lastDumpedStep_m = itsDataSink->dumpH5(itsBunch_m, // Local and in m
2717  FDext_m, E,
2718  referencePr,
2719  referencePt,
2720  referencePz,
2721  referenceR,
2723  referenceZ,
2724  phi / Physics::deg2rad, // P_mean azimuth
2725  // at ref. R/Th/Z
2726  psi / Physics::deg2rad, // P_mean elevation
2727  // at ref. R/Th/Z
2728  dumpLocalFrame); // Flag localFrame
2729 
2730  if (dumpLocalFrame == true) {
2731  // Return to global frame
2732  localToGlobal(itsBunch_m->R, phi, psi, meanR);
2733  //localToGlobal(itsBunch_m->R, phi, psi, meanR * Vector_t(0.001));
2734  localToGlobal(itsBunch_m->P, phi, psi);
2735  }
2736 
2737 
2738  // Tell user in which mode we are dumping
2739  // New: no longer dumping for num part < 3, omit phase space dump number info
2740  if (lastDumpedStep_m == -1){
2741  *gmsg << endl << "* Integration step " << step_m + 1
2742  << " (no phase space dump for <= 2 particles)" << endl;
2743  } else {
2744  *gmsg << endl << "* Phase space dump " << lastDumpedStep_m
2745  << " (" << dumpString << " frame) at integration step " << step_m + 1 << endl;
2746  }
2747  }
2748 
2749  // Print dump information on screen
2750  *gmsg << "* T = " << temp_t << " ns"
2751  << ", Live Particles: " << itsBunch_m->getTotalNum() << endl;
2752  *gmsg << "* E = " << E << " MeV"
2753  << ", beta * gamma = " << betagamma_temp << endl;
2754  *gmsg << "* Bunch position: R = " << referenceR << " mm"
2755  << ", Theta = " << referenceTheta << " Deg"
2756  << ", Z = " << referenceZ << " mm" << endl;
2757  *gmsg << "* Local Azimuth = " << phi / Physics::deg2rad << " Deg"
2758  << ", Local Elevation = " << psi / Physics::deg2rad << " Deg" << endl;
2759 
2761 }
2762 
2764 {
2765  return (step_m > 10) && (((step_m + 1) %setup_m.stepsPerTurn) == 0);
2766 }
2767 
2768 void ParallelCyclotronTracker::update_m(double& t, const double& dt,
2769  const bool& finishedTurn)
2770 {
2771  // Reference parameters
2772  t += dt;
2773 
2774  updateTime(dt);
2775 
2777  if (!(step_m + 1 % 1000))
2778  *gmsg << "Step " << step_m + 1 << endl;
2779 
2780  updatePathLength(dt);
2781 
2782  // Here is global frame, don't do itsBunch_m->boundp();
2783 
2784  if (itsBunch_m->getTotalNum()>0) {
2785  // Only dump last step if we have particles left.
2786  // Check separately for phase space (ps) and statistics (stat) data dump frequency
2787  if ( mode_m != MODE::SEO && ( ((step_m + 1) % Options::psDumpFreq == 0) ||
2788  (Options::psDumpEachTurn && finishedTurn)))
2789  {
2790  // Write phase space data to h5 file
2792  }
2793 
2794  if ( mode_m != MODE::SEO && ( ((step_m + 1) % Options::statDumpFreq == 0) ||
2795  (Options::psDumpEachTurn && finishedTurn)))
2796  {
2797  // Write statistics data to stat file
2799  }
2800  }
2801 
2802  if (Options::psDumpEachTurn && finishedTurn)
2803  for (PluginElement* element : pluginElements_m)
2804  element->save();
2805 }
2806 
2807 
2808 std::tuple<double, double, double> ParallelCyclotronTracker::initializeTracking_m() {
2809  // Read in some control parameters
2812 
2813  // Define 3 special azimuthal angles where dump particle's six parameters
2814  // at each turn into 3 ASCII files. only important in single particle tracking
2815  azimuth_angle_m.resize(3);
2816  azimuth_angle_m[0] = 0.0;
2817  azimuth_angle_m[1] = 22.5 * Physics::deg2rad;
2818  azimuth_angle_m[2] = 45.0 * Physics::deg2rad;
2819 
2820  double harm = getHarmonicNumber();
2821  double dt = itsBunch_m->getdT() * 1.0e9 * harm; // time step size (s --> ns)
2822  double t = itsBunch_m->getT() * 1.0e9; // current time (s --> ns)
2823 
2824  double oldReferenceTheta = referenceTheta * Physics::deg2rad; // init here, reset each step
2825  setup_m.deltaTheta = Physics::pi / (setup_m.stepsPerTurn); // half of the average angle per step
2826 
2827  //int stepToLastInj = itsBunch_m->getSteptoLastInj(); // TODO: Do we need this? -DW
2828 
2829  // Record how many bunches have already been injected. ONLY FOR MBM
2830  if (isMultiBunch())
2831  mbHandler_m->setNumBunch(itsBunch_m->getNumBunch());
2832 
2834 
2835  // Get data from h5 file for restart run and reset current step
2836  // to last step of previous simulation
2837  if(OpalData::getInstance()->inRestartRun()) {
2838 
2841 
2843 
2844  *gmsg << "* Restart at integration step " << restartStep0_m
2845  << " at turn " << turnnumber_m - 1 << endl;
2846 
2847  initPathLength();
2848  }
2849 
2850  setup_m.stepsNextCheck = step_m + setup_m.stepsPerTurn; // Steps to next check for transition
2851 
2853 
2854  if (isMultiBunch())
2855  mbHandler_m->updateParticleBins(itsBunch_m);
2856 
2857  // --- Output to user --- //
2858  *gmsg << "* Beginning of this run is at t = " << t << " [ns]" << endl;
2859  *gmsg << "* The time step is set to dt = " << dt << " [ns]" << endl;
2860 
2861  if ( isMultiBunch() ) {
2862 
2863  *gmsg << "* MBM: Time interval between neighbour bunches is set to "
2864  << setup_m.stepsPerTurn * dt << "[ns]" << endl;
2865  *gmsg << "* MBM: The particles energy bin reset frequency is set to "
2866  << Options::rebinFreq << endl;
2867  }
2868 
2869  *gmsg << "* Single particle trajectory dump frequency is set to " << Options::sptDumpFreq << endl;
2870  *gmsg << "* The frequency to solve space charge fields is set to " << setup_m.scSolveFreq << endl;
2871  *gmsg << "* The repartition frequency is set to " << Options::repartFreq << endl;
2872 
2873 
2874  switch ( mode_m )
2875  {
2876  case MODE::SEO:
2877  *gmsg << endl;
2878  *gmsg << "* ------------------------- STATIC EQUILIBRIUM ORBIT MODE ----------------------------- *" << endl
2879  << "* Instruction: When the total particle number is equal to 2, SEO mode is triggered *" << endl
2880  << "* automatically. This mode does NOT include any RF cavities. The initial distribution *" << endl
2881  << "* file must be specified. In the file the first line is for reference particle and the *" << endl
2882  << "* second line is for off-center particle. The tune is calculated by FFT routines based *" << endl
2883  << "* on these two particles. *" << endl
2884  << "* ---------------- NOTE: SEO MODE ONLY WORKS SERIALLY ON SINGLE NODE ------------------ *" << endl;
2885 
2886  if(Ippl::getNodes() != 1)
2887  throw OpalException("Error in ParallelCyclotronTracker::initializeTracking_m",
2888  "SEO MODE ONLY WORKS SERIALLY ON SINGLE NODE!");
2889  break;
2890  case MODE::SINGLE:
2891  *gmsg << endl;
2892  *gmsg << "* ------------------------------ SINGLE PARTICLE MODE --------------------------------- *" << endl
2893  << "* Instruction: When the total particle number is equal to 1, single particle mode is *" << endl
2894  << "* triggered automatically. The initial distribution file must be specified which should *" << endl
2895  << "* contain only one line for the single particle *" << endl
2896  << "* ---------NOTE: SINGLE PARTICLE MODE ONLY WORKS SERIALLY ON A SINGLE NODE ------------ *" << endl;
2897 
2898  if(Ippl::getNodes() != 1)
2899  throw OpalException("Error in ParallelCyclotronTracker::initializeTracking_m",
2900  "SINGLE PARTICLE MODE ONLY WORKS SERIALLY ON A SINGLE NODE!");
2901 
2902  // For single particle mode open output files
2904  break;
2905  case MODE::BUNCH:
2906  break;
2907  case MODE::UNDEFINED:
2908  default:
2909  throw OpalException("ParallelCyclotronTracker::initializeTracking_m()",
2910  "No such tracking mode.");
2911  }
2912 
2913  return std::make_tuple(t, dt, oldReferenceTheta);
2914 }
2915 
2916 
2918  dvector_t& Tdeltr,
2919  dvector_t& Tdeltz, ivector_t& TturnNumber)
2920 {
2921  for(size_t ii = 0; ii < (itsBunch_m->getLocalNum()); ii++) {
2922  if(itsBunch_m->ID[ii] == 0) {
2923  double FinalMomentum2 = std::pow(itsBunch_m->P[ii](0), 2.0) + std::pow(itsBunch_m->P[ii](1), 2.0) + std::pow(itsBunch_m->P[ii](2), 2.0);
2924  double FinalEnergy = (std::sqrt(1.0 + FinalMomentum2) - 1.0) * itsBunch_m->getM() * 1.0e-6;
2925  *gmsg << "* Final energy of reference particle = " << FinalEnergy << " [MeV]" << endl;
2926  *gmsg << "* Total phase space dump number(includes the initial distribution) = " << lastDumpedStep_m + 1 << endl;
2927  *gmsg << "* One can restart simulation from the last dump step (--restart " << lastDumpedStep_m << ")" << endl;
2928  }
2929  }
2930 
2931  Ippl::Comm->barrier();
2932 
2933  switch ( mode_m )
2934  {
2935  case MODE::SEO:
2936  {
2937  // Calculate tunes after tracking.
2938  *gmsg << endl;
2939  *gmsg << "* **************** The result for tune calculation (NO space charge) ******************* *" << endl
2940  << "* Number of tracked turns: " << TturnNumber.back() << endl;
2941  double nur, nuz;
2942  getTunes(Ttime, Tdeltr, Tdeltz, TturnNumber.back(), nur, nuz);
2943  break;
2944  }
2945  case MODE::SINGLE:
2946  closeFiles();
2947  // fall through
2948  case MODE::BUNCH: // we do nothing
2949  case MODE::UNDEFINED:
2950  default:
2951  {
2952  // not for multibunch
2953  if (!isMultiBunch()) {
2954  *gmsg << "*" << endl;
2955  *gmsg << "* Finished during turn " << turnnumber_m << " (" << turnnumber_m - 1 << " turns completed)" << endl;
2956  *gmsg << "* Cave: Turn number is not correct for restart mode"<< endl;
2957  }
2958  }
2959  }
2960 
2961  Ippl::Comm->barrier();
2962 
2963  if (myNode_m == 0)
2964  outfTrackOrbit_m.close();
2965 
2966  *gmsg << endl << "* *********************** Bunch information in global frame: ***********************";
2967 
2968  if (itsBunch_m->getTotalNum() > 0){
2969  // Print out the Bunch information at end of the run.
2971  *gmsg << *itsBunch_m << endl;
2972 
2973  } else {
2974 
2975  *gmsg << endl << "* No Particles left in bunch!" << endl;
2976  *gmsg << "* **********************************************************************************" << endl;
2977 
2978  }
2979 }
2980 
2981 
2982 void ParallelCyclotronTracker::seoMode_m(double& t, const double dt, bool& /*finishedTurn*/,
2983  dvector_t& Ttime, dvector_t& Tdeltr,
2984  dvector_t& Tdeltz, ivector_t& TturnNumber)
2985 {
2986 
2987  // 2 particles: Trigger SEO mode
2988  // (Switch off cavity and calculate betatron oscillation tuning)
2989  double r_tuning[2], z_tuning[2];
2990 
2992  for(size_t i = 0; i < (itsBunch_m->getLocalNum()); i++) {
2993 
2994  if((step_m % Options::sptDumpFreq == 0)) {
2995 
2996  outfTrackOrbit_m << "ID" << (itsBunch_m->ID[i]);
2997  outfTrackOrbit_m << " " << itsBunch_m->R[i](0)
2998  << " " << itsBunch_m->P[i](0)
2999  << " " << itsBunch_m->R[i](1)
3000  << " " << itsBunch_m->P[i](1)
3001  << " " << itsBunch_m->R[i](2)
3002  << " " << itsBunch_m->P[i](2)
3003  << std::endl;
3004  }
3005 
3006  double OldTheta = calculateAngle(itsBunch_m->R[i](0), itsBunch_m->R[i](1));
3007  r_tuning[i] = itsBunch_m->R[i](0) * std::cos(OldTheta) +
3008  itsBunch_m->R[i](1) * std::sin(OldTheta);
3009 
3010  z_tuning[i] = itsBunch_m->R[i](2);
3011 
3012 
3013  // Integrate for one step in the lab Cartesian frame (absolute value).
3014  itsStepper_mp->advance(itsBunch_m, i, t, dt);
3015 
3016  if( (i == 0) && isTurnDone() )
3017  turnnumber_m++;
3018 
3019  } // end for: finish one step tracking for all particles for initialTotalNum_m == 2 mode
3021 
3022  // store dx and dz for future tune calculation if higher precision needed, reduce freqSample.
3023  if(step_m % Options::sptDumpFreq == 0) {
3024 
3025  Ttime.push_back(t * 1.0e-9);
3026  Tdeltz.push_back(z_tuning[1]);
3027  Tdeltr.push_back(r_tuning[1] - r_tuning[0]);
3028  TturnNumber.push_back(turnnumber_m);
3029  }
3030 }
3031 
3032 
3033 void ParallelCyclotronTracker::singleMode_m(double& t, const double dt,
3034  bool& finishedTurn, double& oldReferenceTheta) {
3035  // 1 particle: Trigger single particle mode
3036 
3037  // ********************************************************************************** //
3038  // * This was moved here b/c collision should be tested before the actual * //
3039  // * timestep (bgf_main_collision_test() predicts the next step automatically) * //
3040 
3041  // apply the plugin elements: probe, collimator, stripper, septum
3042  bool flagNeedUpdate = applyPluginElements(dt);
3043 
3044  // check if we lose particles at the boundary
3046  // ********************************************************************************** //
3047 
3048  if (itsBunch_m->getLocalNum() == 0) return; // might happen if particle is in collimator
3049 
3051 
3052  unsigned int i = 0; // we only have a single particle
3053 
3054  if ( step_m % Options::sptDumpFreq == 0 ) {
3055 
3056  outfTrackOrbit_m << "ID" <<itsBunch_m->ID[i]
3057  << " " << itsBunch_m->R[i](0)
3058  << " " << itsBunch_m->P[i](0)
3059  << " " << itsBunch_m->R[i](1)
3060  << " " << itsBunch_m->P[i](1)
3061  << " " << itsBunch_m->R[i](2)
3062  << " " << itsBunch_m->P[i](2)
3063  << std::endl;
3064  }
3065 
3066  double temp_meanTheta = calculateAngle2(itsBunch_m->R[i](0),
3067  itsBunch_m->R[i](1)); // [-pi, pi]
3068 
3069 
3071  temp_meanTheta, finishedTurn);
3072 
3074  oldReferenceTheta, temp_meanTheta);
3075 
3076  oldReferenceTheta = temp_meanTheta;
3077 
3078  // used for gap crossing checking
3079  Vector_t Rold = itsBunch_m->R[i]; // [x,y,z] (mm)
3080  Vector_t Pold = itsBunch_m->P[i]; // [px,py,pz] (beta*gamma)
3081 
3082  // integrate for one step in the lab Cartesian frame (absolute value).
3083  itsStepper_mp->advance(itsBunch_m, i, t, dt);
3084 
3085  // If gap crossing happens, do momenta kicking (not if gap crossing just happened)
3086  if (itsBunch_m->cavityGapCrossed[i] == true)
3087  itsBunch_m->cavityGapCrossed[i] = false;
3088  else
3089  gapCrossKick_m(i, t, dt, Rold, Pold);
3091 
3092  // Destroy particles if they are marked as Bin = -1 in the plugin elements
3093  // or out of the global aperture
3094  flagNeedUpdate |= (itsBunch_m->Bin[i] < 0);
3095  deleteParticle(flagNeedUpdate);
3096 }
3097 
3098 
3099 void ParallelCyclotronTracker::bunchMode_m(double& t, const double dt, bool& finishedTurn) {
3100 
3101  // Flag for transition from single-bunch to multi-bunches mode
3102  static bool flagTransition = false;
3103 
3104  // single particle dumping
3105  if(step_m % Options::sptDumpFreq == 0)
3107 
3108  // Find out if we need to do bunch injection
3109  injectBunch(flagTransition);
3110 
3111 // oldReferenceTheta = calculateAngle2(meanR(0), meanR(1));
3112 
3113  // Calculate SC field before each time step and keep constant during integration.
3114  // Space Charge effects are included only when total macropaticles number is NOT LESS THAN 1000.
3115  if (itsBunch_m->hasFieldSolver()) {
3116 
3117  if (step_m % setup_m.scSolveFreq == 0) {
3119  } else {
3120  // If we are not solving for the space charge fields at this time step
3121  // we will apply the fields from the previous step and have to rotate them
3122  // accordingly. For this we find the quaternion between the previous mean momentum (PreviousMeanP)
3123  // and the current mean momentum (meanP) and rotate the fields with this quaternion.
3124 
3125  Vector_t const meanP = calcMeanP();
3126 
3127  Quaternion_t quaternionToNewMeanP;
3128 
3129  getQuaternionTwoVectors(PreviousMeanP, meanP, quaternionToNewMeanP);
3130 
3131  // Reset PreviousMeanP. Cave: This HAS to be after the quaternion is calculated!
3133 
3134  // Rotate the fields
3135  globalToLocal(itsBunch_m->Ef, quaternionToNewMeanP);
3136  globalToLocal(itsBunch_m->Bf, quaternionToNewMeanP);
3137  }
3138  }
3139 
3140  // *** This was moved here b/c collision should be tested before the **********************
3141  // *** actual timestep (bgf_main_collision_test() predicts the next step automatically) -DW
3142  // Apply the plugin elements: probe, collimator, stripper, septum
3143  bool flagNeedUpdate = applyPluginElements(dt);
3144 
3145  // check if we lose particles at the boundary
3147 
3149 
3150  for(size_t i = 0; i < itsBunch_m->getLocalNum(); i++) {
3151 
3152  // used for gap crossing checking
3153  Vector_t Rold = itsBunch_m->R[i]; // [x,y,z] (mm)
3154  Vector_t Pold = itsBunch_m->P[i]; // [px,py,pz] (beta*gamma)
3155 
3156  // Integrate for one step in the lab Cartesian frame (absolute value).
3157  itsStepper_mp->advance(itsBunch_m, i, t, dt);
3158 
3159  // If gap crossing happens, do momenta kicking (not if gap crossing just happened)
3160  if (itsBunch_m->cavityGapCrossed[i] == true)
3161  itsBunch_m->cavityGapCrossed[i] = false;
3162  else
3163  gapCrossKick_m(i, t, dt, Rold, Pold);
3164 
3165  flagNeedUpdate |= (itsBunch_m->Bin[i] < 0);
3166  }
3167 
3169 
3170  // Destroy particles if they are marked as Bin = -1 in the plugin elements
3171  // or out of global aperture
3172  deleteParticle(flagNeedUpdate);
3173 
3174  // Recalculate bingamma and reset the BinID for each particles according to its current gamma
3175  if (isMultiBunch() && step_m % Options::rebinFreq == 0) {
3176  mbHandler_m->updateParticleBins(itsBunch_m);
3177  }
3178 
3179  // Some status output for user after each turn
3180  if ( isTurnDone() ) {
3181  turnnumber_m++;
3182  finishedTurn = true;
3183 
3184  *gmsg << endl;
3185  *gmsg << "*** Finished turn " << turnnumber_m - 1
3186  << ", Total number of live particles: "
3187  << itsBunch_m->getTotalNum() << endl;
3188  }
3189 
3190  Ippl::Comm->barrier();
3191 }
3192 
3193 
3195  double dt,
3196  const Vector_t& Rold,
3197  const Vector_t& Pold)
3198 {
3199  for (beamline_list::iterator sindex = ++(FieldDimensions.begin());
3200  sindex != FieldDimensions.end(); ++sindex)
3201  {
3202  bool tag_crossing = false;
3203  double DistOld = 0.0; //mm
3204  RFCavity * rfcav;
3205 
3206  if (((*sindex)->first) == ElementBase::RFCAVITY) {
3207  // here check gap cross in the list, if do , set tag_crossing to TRUE
3208  rfcav = static_cast<RFCavity *>(((*sindex)->second).second);
3209  tag_crossing = checkGapCross(Rold, itsBunch_m->R[i], rfcav, DistOld);
3210  }
3211 
3212  if ( tag_crossing ) {
3213  itsBunch_m->cavityGapCrossed[i] = true;
3214 
3215  double oldMomentum2 = dot(Pold, Pold);
3216  double oldBetgam = std::sqrt(oldMomentum2);
3217  double oldGamma = std::sqrt(1.0 + oldMomentum2);
3218  double oldBeta = oldBetgam / oldGamma;
3219  double dt1 = DistOld / (Physics::c * oldBeta * 1.0e-6); // ns
3220  double dt2 = dt - dt1;
3221 
3222  // retrack particle from the old postion to cavity gap point
3223  // restore the old coordinates and momenta
3224  itsBunch_m->R[i] = Rold;
3225  itsBunch_m->P[i] = Pold;
3226 
3227  if (dt / dt1 < 1.0e9)
3228  itsStepper_mp->advance(itsBunch_m, i, t, dt1);
3229 
3230  // Momentum kick
3231  RFkick(rfcav, t, dt1, i);
3232 
3233  /* Retrack particle from cavity gap point for
3234  * the left time to finish the entire timestep
3235  */
3236  if (dt / dt2 < 1.0e9)
3237  itsStepper_mp->advance(itsBunch_m, i, t, dt2);
3238  }
3239  }
3240 }
3241 
3242 
3244  const Vector_t& R,
3245  const Vector_t& P,
3246  const double& oldReferenceTheta,
3247  const double& temp_meanTheta)
3248 {
3249  for (unsigned int i=0; i<=2; i++) {
3250  if ((oldReferenceTheta < azimuth_angle_m[i] - setup_m.deltaTheta) &&
3251  ( temp_meanTheta >= azimuth_angle_m[i] - setup_m.deltaTheta)) {
3252  *(outfTheta_m[i]) << "#Turn number = " << turnnumber_m
3253  << ", Time = " << t << " [ns]" << std::endl
3254  << " " << std::hypot(R(0), R(1))
3255  << " " << P(0) * std::cos(temp_meanTheta) + P(1) * std::sin(temp_meanTheta)
3256  << " " << temp_meanTheta * Physics::rad2deg
3257  << " " << - P(0) * std::sin(temp_meanTheta) + P(1) * std::cos(temp_meanTheta)
3258  << " " << R(2)
3259  << " " << P(2) << std::endl;
3260  }
3261  }
3262 }
3263 
3265  const Vector_t& R,
3266  const Vector_t& P,
3267  const double& temp_meanTheta,
3268  bool& finishedTurn)
3269 {
3270  if ( isTurnDone() ) {
3271 
3272  ++turnnumber_m;
3273 
3274  finishedTurn = true;
3275 
3276  *gmsg << "* SPT: Finished turn " << turnnumber_m - 1 << endl;
3277 
3278  *(outfTheta_m[3]) << "#Turn number = " << turnnumber_m
3279  << ", Time = " << t << " [ns]" << std::endl
3280  << " " << std::sqrt(R(0) * R(0) + R(1) * R(1))
3281  << " " << P(0) * std::cos(temp_meanTheta) +
3282  P(1) * std::sin(temp_meanTheta)
3283  << " " << temp_meanTheta / Physics::deg2rad
3284  << " " << - P(0) * std::sin(temp_meanTheta) +
3285  P(1) * std::cos(temp_meanTheta)
3286  << " " << R(2)
3287  << " " << P(2) << std::endl;
3288  }
3289 }
3290 
3291 
3293  // Firstly reset E and B to zero before fill new space charge field data for each track step
3294  itsBunch_m->Bf = Vector_t(0.0);
3295  itsBunch_m->Ef = Vector_t(0.0);
3296 
3297  if (spiral_flag && itsBunch_m->getFieldSolverType() == "SAAMG") {
3298  // --- Single bunch mode with spiral inflector --- //
3299 
3300  // If we are doing a spiral inflector simulation and are using the SAAMG solver
3301  // we don't rotate or translate the bunch and gamma is 1.0 (non-relativistic).
3302 
3303  //itsBunch_m->R *= Vector_t(0.001); // mm --> m
3304 
3305  itsBunch_m->setGlobalMeanR(Vector_t(0.0, 0.0, 0.0));
3306  itsBunch_m->setGlobalToLocalQuaternion(Quaternion_t(1.0, 0.0, 0.0, 0.0));
3307 
3309 
3310  //itsBunch_m->R *= Vector_t(1000.0); // m --> mm
3311 
3312  } else {
3313 
3314  Vector_t const meanR = calcMeanR(); // (m)
3315 
3317 
3318  // Since calcMeanP takes into account all particles of all bins (TODO: Check this! -DW)
3319  // Using the quaternion method with PreviousMeanP and yaxis should give the correct result
3320 
3321  Quaternion_t quaternionToYAxis;
3322 
3323  getQuaternionTwoVectors(PreviousMeanP, yaxis, quaternionToYAxis);
3324 
3325  globalToLocal(itsBunch_m->R, quaternionToYAxis, meanR);
3326 
3327  //itsBunch_m->R *= Vector_t(0.001); // mm --> m
3328 
3329  if ((step_m + 1) % Options::boundpDestroyFreq == 0)
3331  else
3332  itsBunch_m->boundp();
3333 
3334  if (hasMultiBunch()) {
3335  // --- Multibunch mode --- //
3336 
3337  // Calculate gamma for each energy bin
3339 
3340  repartition();
3341 
3342  // Calculate space charge field for each energy bin
3343  for(int b = 0; b < itsBunch_m->getLastemittedBin(); b++) {
3344 
3346  //itsBunch_m->setGlobalMeanR(0.001 * meanR);
3347  itsBunch_m->setGlobalMeanR(meanR);
3348  itsBunch_m->setGlobalToLocalQuaternion(quaternionToYAxis);
3350  }
3351 
3353 
3354  } else {
3355  // --- Single bunch mode --- //
3356 
3357  double temp_meangamma = std::sqrt(1.0 + dot(PreviousMeanP, PreviousMeanP));
3358 
3359  repartition();
3360 
3361  //itsBunch_m->setGlobalMeanR(0.001 * meanR);
3362  itsBunch_m->setGlobalMeanR(meanR);
3363  itsBunch_m->setGlobalToLocalQuaternion(quaternionToYAxis);
3364 
3365  itsBunch_m->computeSelfFields_cycl(temp_meangamma);
3366 
3367  }
3368 
3369  //scale coordinates back
3370  //itsBunch_m->R *= Vector_t(1000.0); // m --> mm
3371 
3372  // Transform coordinates back to global
3373  localToGlobal(itsBunch_m->R, quaternionToYAxis, meanR);
3374 
3375  // Transform self field back to global frame (rotate only)
3376  localToGlobal(itsBunch_m->Ef, quaternionToYAxis);
3377  localToGlobal(itsBunch_m->Bf, quaternionToYAxis);
3378  }
3379 }
3380 
3381 
3382 bool ParallelCyclotronTracker::computeExternalFields_m(const size_t& i, const double& t,
3383  Vector_t& Efield, Vector_t& Bfield)
3384 {
3385  beamline_list::iterator sindex = FieldDimensions.begin();
3386 
3387  // Flag whether a particle is out of field
3388  bool outOfBound = (((*sindex)->second).second)->apply(i, t, Efield, Bfield);
3389 
3390  Bfield *= 0.10; // kGauss --> T
3391  Efield *= 1.0e6; // kV/mm --> V/m
3392 
3393  return outOfBound;
3394 }
3395 
3396 
3397 void ParallelCyclotronTracker::injectBunch(bool& flagTransition) {
3398  if (!isMultiBunch() || step_m != setup_m.stepsNextCheck) {
3399  return;
3400  }
3401 
3402  const short result = mbHandler_m->injectBunch(itsBunch_m, itsReference,
3403  flagTransition);
3404 
3405  switch ( result ) {
3406  case 0: {
3407  // nothing happened
3408  break;
3409  }
3410  case 1: {
3411  // bunch got saved
3412  saveInjectValues();
3414  if ( flagTransition ) {
3415  *gmsg << "* MBM: Saving beam distribution at turn " << turnnumber_m << endl;
3416  *gmsg << "* MBM: After one revolution, Multi-Bunch Mode will be invoked" << endl;
3417  }
3418  break;
3419  }
3420  case 2: {
3421  // bunch got injected
3423  break;
3424  }
3425  default:
3426  throw OpalException("ParallelCyclotronTracker::injectBunch()",
3427  "Unknown return value " + std::to_string(result));
3428  }
3429 }
3430 
3431 
3433  if ( !isMultiBunch() ) {
3434  return;
3435  }
3436 
3437  Vector_t meanR = calcMeanR();
3438 
3439  // Bunch (global) angle w.r.t. x-axis (cylinder coordinates)
3440  double theta = calculateAngle(meanR(0), meanR(1)) * Physics::rad2deg;
3441 
3442  // fix azimuth_m --> make monotonically increasing
3444 
3445  const double radius = computeRadius(meanR);
3446 
3447  MultiBunchHandler::injection_t& inj = mbHandler_m->getInjectionValues();
3448 
3449  inj.time = itsBunch_m->getT() * 1.0e9; /*ns*/
3450  inj.pathlength = itsBunch_m->get_sPos();
3451  inj.azimuth = azimuth_m;
3452  inj.radius = radius;
3453 }
3454 
3455 
3457  /* the last element includes all particles,
3458  * all other elements are bunch number specific
3459  */
3460  std::vector<double> lpaths(1);
3461 
3462  if ( isMultiBunch() ) {
3463  lpaths.resize(mbHandler_m->getNumBunch() + 1);
3464  }
3465 
3466  computePathLengthUpdate(lpaths, dt);
3467 
3468  pathLength_m += lpaths.back();
3470 
3471  if ( isMultiBunch() ) {
3472  mbHandler_m->updatePathLength(lpaths);
3473  }
3474 }
3475 
3476 
3478  // t is in seconds
3479  double t = itsBunch_m->getT();
3480 
3481  // dt: ns --> s
3482  itsBunch_m->setT(t + dt * 1.0e-9);
3483 
3484  if ( isMultiBunch() ) {
3485  mbHandler_m->updateTime(dt);
3486  }
3487 }
3488 
3489 
3491  if (!isMultiBunch()) {
3492  return;
3493  }
3494 
3495  for (short b = 0; b < mbHandler_m->getNumBunch(); ++b) {
3496  Vector_t meanR = calcMeanR(b);
3497  MultiBunchHandler::beaminfo_t& binfo = mbHandler_m->getBunchInfo(b);
3498 
3499  binfo.radius = computeRadius(meanR);
3500  double azimuth = calculateAngle(meanR(0), meanR(1)) * Physics::rad2deg;
3501  dumpAngle(azimuth, binfo.prevAzimuth, binfo.azimuth, b);
3502  }
3503 }
3504 
3505 
3507  if ( isMultiBunch() ) {
3508  // we need to reset the path length of each bunch
3510  }
3511 }
constexpr double c_mmtns
Inform * gmsg
Definition: Main.cpp:62
Tps< T > cos(const Tps< T > &x)
Cosine.
Definition: TpsMath.h:129
Tps< T > pow(const Tps< T > &x, int y)
Integer power.
Definition: TpsMath.h:76
Tps< T > sin(const Tps< T > &x)
Sine.
Definition: TpsMath.h:111
Tps< T > sqrt(const Tps< T > &x)
Square root.
Definition: TpsMath.h:91
Quaternion Quaternion_t
Definition: Quaternion.h:44
Vector3D cross(const Vector3D &lhs, const Vector3D &rhs)
Vector cross product.
Definition: Vector3D.cpp:111
double dot(const Vector3D &lhs, const Vector3D &rhs)
Vector dot product.
Definition: Vector3D.cpp:118
bool for_each(const BareFieldIterator< T, D > &p, SameFieldID s, C)
Definition: AssignDefs.h:30
T::PETE_Expr_t::PETE_Return_t max(const PETE_Expr< T > &expr, NDIndex< D > &loc)
Definition: ReductionLoc.h:84
const int COMM_ANY_NODE
Definition: Communicate.h:40
void allreduce(const T *input, T *output, int count, Op op)
Definition: GlobalComm.hpp:510
bool reduce(Communicate &, InputIterator, InputIterator, OutputIterator, const ReduceOp &, bool *IncludeVal=0)
Definition: GlobalComm.hpp:55
#define IPPL_APP_CYCLE
Definition: Tags.h:103
#define IPPL_APP_TAG4
Definition: Tags.h:97
PETE_TUTree< FnAbs, typename T::PETE_Expr_t > abs(const PETE_Expr< T > &l)
PETE_TBTree< FnArcTan2, PETE_Scalar< Vektor< T1, Dim > >, typename T2::PETE_Expr_t > atan2(const Vektor< T1, Dim > &l, const PETE_Expr< T2 > &r)
T::PETE_Expr_t::PETE_Return_t sum(const PETE_Expr< T > &expr)
Definition: PETE.h:1111
PETE_TUTree< FnArcCos, typename T::PETE_Expr_t > acos(const PETE_Expr< T > &l)
Definition: PETE.h:725
Inform & endl(Inform &inf)
Definition: Inform.cpp:42
Inform & level4(Inform &inf)
Definition: Inform.cpp:48
Inform & level3(Inform &inf)
Definition: Inform.cpp:47
#define INFORM_ALL_NODES
Definition: Inform.h:39
#define ERRORMSG(msg)
Definition: IpplInfo.h:350
constexpr double deg2rad
The conversion factor from degrees to radians.
Definition: Physics.h:48
constexpr double q_e
The elementary charge in As.
Definition: Physics.h:75
constexpr double c
The velocity of light in m/s.
Definition: Physics.h:51
constexpr double pi
The value of.
Definition: Physics.h:30
constexpr double rad2deg
The conversion factor from radians to degrees.
Definition: Physics.h:45
std::string::iterator iterator
Definition: MSLang.h:16
T deg(T x)
Convert radians to degrees.
Definition: matheval.hpp:74
@ BUNCH_MEAN
Definition: OptionTypes.h:7
@ GLOBAL
Definition: OptionTypes.h:6
int mtsSubsteps
Definition: Options.cpp:59
int psDumpFreq
The frequency to dump the phase space, i.e.dump data when steppsDumpFreq==0.
Definition: Options.cpp:39
int boundpDestroyFreq
Definition: Options.cpp:87
bool psDumpEachTurn
phase space dump flag for OPAL-cycl
Definition: Options.cpp:43
bool asciidump
Definition: Options.cpp:85
int sptDumpFreq
The frequency to dump single particle trajectory of particles with ID = 0 & 1.
Definition: Options.cpp:47
unsigned int delPartFreq
The frequency to delete particles (currently: OPAL-cycl only)
Definition: Options.cpp:109
int scSolveFreq
The frequency to solve space charge fields.
Definition: Options.cpp:57
int repartFreq
The frequency to do particles repartition for better load balance between nodes.
Definition: Options.cpp:49
int rebinFreq
The frequency to reset energy bin ID for all particles.
Definition: Options.cpp:55
DumpFrame psDumpFrame
flag to decide in which coordinate frame the phase space will be dumped for OPAL-cycl
Definition: Options.cpp:45
int statDumpFreq
The frequency to dump statistical values, e.e. dump data when stepstatDumpFreq==0.
Definition: Options.cpp:41
@ LF2
Definition: Steppers.h:29
@ MTS
Definition: Steppers.h:30
@ RK4
Definition: Steppers.h:28
boost::function< boost::tuple< double, bool >arguments_t)> type
Definition: function.hpp:21
const std::string & getOpalName() const
Return object name.
Definition: Object.cpp:281
ParticleAttrib< Vector_t > Ef
double get_meanKineticEnergy() const
ParticlePos_t & R
ParticleAttrib< int > Bin
Vector_t RefPartP_m
void boundp_destroyCycl()
double getQ() const
Access to reference data.
double getChargePerParticle() const
get the macro particle charge
size_t getLocalNum() const
void set_sPos(double s)
void setLocalTrackStep(long long n)
step in a TRACK command
void setLocalBinCount(size_t num, int bin)
ParticleAttrib< double > M
size_t getTotalNum() const
ParticleAttrib< Vector_t > P
double getdT() const
void setLocalNumPerBunch(size_t numpart, short n)
size_t getLocalNumPerBunch(short n) const
void setGlobalToLocalQuaternion(Quaternion_t globalToLocalQuaternion)
virtual void computeSelfFields_cycl(double gamma)=0
Vector_t RefPartR_m
ParticleAttrib< double > Q
void calcBeamParameters()
size_t getTotalNumPerBunch(short n) const
ParticleAttrib< short > cavityGapCrossed
void setTotalNum(size_t n)
long long getLocalTrackStep() const
void setGlobalMeanR(Vector_t globalMeanR)
short getNumBunch() const
virtual void do_binaryRepart()
int getStepsPerTurn() const
void countTotalNumPerBunch()
void calcGammas_cycl()
virtual void setBinCharge(int bin, double q)
Set the charge of one bin to the value of q and all other to zero.
void performDestroy(bool updateLocalNum=false)
ParticleAttrib< short > bunchNum
void setTotalNumPerBunch(size_t numpart, short n)
void destroy(size_t M, size_t I, bool doNow=false)
ParticleAttrib< Vector_t > Bf
virtual void boundp()
void setT(double t)
std::string getFieldSolverType() const
Return the fieldsolver type if we have a fieldsolver.
ParticleIndex_t & ID
double get_sPos() const
double getM() const
double getT() const
void setOpenMode(OPENMODE openMode)
Definition: OpalData.cpp:348
std::string getInputBasename()
get input file name without extension
Definition: OpalData.cpp:658
static OpalData * getInstance()
Definition: OpalData.cpp:195
BoundaryGeometry * getGlobalGeometry()
Definition: OpalData.cpp:460
bool inRestartRun()
true if we do a restart run
Definition: OpalData.cpp:311
int lombAnalysis(double *x, double *y, int Ndat, int nhis)
Definition: Ctunes.cpp:146
void operator()(double x)
std::pair< ElementBase::ElementType, element_pair > type_pair
void computePathLengthUpdate(std::vector< double > &dl, const double &dt)
std::vector< PluginElement * > pluginElements_m
void dumpAzimuthAngles_m(const double &t, const Vector_t &R, const Vector_t &P, const double &oldReferenceTheta, const double &temp_meanTheta)
IpplTimings::TimerRef IntegrationTimer_m
IpplTimings::TimerRef PluginElemTimer_m
virtual void visitDegrader(const Degrader &)
Apply the algorithm to a degrader.
virtual void visitRBend(const RBend &)
Apply the algorithm to a rectangular bend.
static Vector_t const xaxis
The positive axes unit vectors.
virtual void visitProbe(const Probe &)
Apply the algorithm to a probe.
virtual void visitVacuum(const Vacuum &)
Apply the algorithm to a vacuum space.
std::function< bool(const double &, const size_t &, Vector_t &, Vector_t &)> function_t
std::vector< double > azimuth_angle_m
the different azimuthal angles for the outfTheta_m output files
std::unique_ptr< MultiBunchHandler > mbHandler_m
std::list< Component * > myElements
void injectBunch(bool &flagTransition)
void rotateAroundZ(ParticleAttrib< Vector_t > &particleVectors, double const phi)
virtual void visitStripper(const Stripper &)
Apply the algorithm to a particle stripper.
void normalizeQuaternion(Quaternion_t &quaternion)
virtual void visitCCollimator(const CCollimator &)
Apply the algorithm to a collimator.
void singleMode_m(double &t, const double dt, bool &finishedTurn, double &oldReferenceTheta)
void update_m(double &t, const double &dt, const bool &finishedTurn)
Update time and path length, write to output files.
std::vector< std::unique_ptr< std::ofstream > > outfTheta_m
output coordinates at different azimuthal angles and one after every turn
void rotateAroundX(ParticleAttrib< Vector_t > &particleVectors, double const psi)
double calculateAngle(double x, double y)
bool isTurnDone()
Check if turn done.
virtual void visitBeamline(const Beamline &)
Apply the algorithm to a beam line.
bool checkGapCross(Vector_t Rold, Vector_t Rnew, RFCavity *rfcavity, double &DistOld)
virtual void visitOffset(const Offset &)
Apply the algorithm to a offset (placement).
IpplTimings::TimerRef DelParticleTimer_m
void normalizeVector(Vector_t &vector)
bool RFkick(RFCavity *rfcavity, const double t, const double dt, const int Pindex)
virtual void visitScalingFFAMagnet(const ScalingFFAMagnet &bend)
Apply the algorithm to a scaling FFA magnet.
double computeRadius(const Vector_t &meanR) const
void updatePathLength(const double &dt)
virtual void visitMultipoleTStraight(const MultipoleTStraight &)
Apply the algorithm to an arbitrary straight multipole.
void openFiles(size_t numFiles, std::string fn)
@ open / close output coordinate files
virtual void visitSBend3D(const SBend3D &)
Apply the algorithm to a sector bend with 3D field map.
double bega
The reference variables.
void dumpAngle(const double &theta, double &prevAzimuth, double &azimuth, const short &bunchNr=0)
bool applyPluginElements(const double dt)
virtual void visitCorrector(const Corrector &)
Apply the algorithm to a closed orbit corrector.
std::tuple< double, double, double > initializeTracking_m()
virtual void visitRing(const Ring &ring)
Apply the algorithm to a ring.
IpplTimings::TimerRef BinRepartTimer_m
void globalToLocal(ParticleAttrib< Vector_t > &vectorArray, double phi, Vector_t const translationToGlobal=0)
bool getFieldsAtPoint(const double &t, const size_t &Pindex, Vector_t &Efield, Vector_t &Bfield)
std::vector< CavityCrossData > cavCrossDatas_m
virtual void visitDrift(const Drift &)
Apply the algorithm to a drift space.
std::unique_ptr< Stepper< function_t > > itsStepper_mp
struct ParallelCyclotronTracker::settings setup_m
void finalizeTracking_m(dvector_t &Ttime, dvector_t &Tdeltr, dvector_t &Tdeltz, ivector_t &TturnNumber)
virtual void visitVariableRFCavityFringeField(const VariableRFCavityFringeField &cav)
Apply the algorithm to a variable RF cavity with Fringe Field.
void gapCrossKick_m(size_t i, double t, double dt, const Vector_t &Rold, const Vector_t &Pold)
void getQuaternionTwoVectors(Vector_t u, Vector_t v, Quaternion_t &quaternion)
virtual void visitSBend(const SBend &)
Apply the algorithm to a sector bend.
virtual void visitMarker(const Marker &)
Apply the algorithm to a marker.
virtual void execute()
Apply the algorithm to the top-level beamline.
void dumpThetaEachTurn_m(const double &t, const Vector_t &R, const Vector_t &P, const double &temp_meanTheta, bool &finishedTurn)
void bunchMode_m(double &t, const double dt, bool &finishedTurn)
std::unique_ptr< LossDataSink > lossDs_m
virtual void visitMultipoleT(const MultipoleT &)
Apply the algorithm to an arbitrary multipole.
virtual void visitVariableRFCavity(const VariableRFCavity &cav)
Apply the algorithm to a variabel RF cavity.
bool computeExternalFields_m(const size_t &i, const double &t, Vector_t &Efield, Vector_t &Bfield)
void rotateWithQuaternion(ParticleAttrib< Vector_t > &vectorArray, Quaternion_t const quaternion)
virtual void visitMultipole(const Multipole &)
Apply the algorithm to a multipole.
virtual void visitSolenoid(const Solenoid &)
Apply the algorithm to a solenoid.
std::vector< double > dvector_t
IpplTimings::TimerRef TransformTimer_m
void buildupFieldList(double BcParameter[], ElementBase::ElementType elementType, Component *elptr)
Vector_t calcMeanR(short bunchNr=-1) const
double calculateAngle2(double x, double y)
virtual void visitCyclotron(const Cyclotron &cycl)
Apply the algorithm to a cyclotron.
void localToGlobal(ParticleAttrib< Vector_t > &vectorArray, double phi, Vector_t const translationToGlobal=0)
virtual void visitRFCavity(const RFCavity &)
Apply the algorithm to a RF cavity.
bool getTunes(dvector_t &t, dvector_t &r, dvector_t &z, int lastTurn, double &nur, double &nuz)
virtual void visitFlexibleCollimator(const FlexibleCollimator &)
Apply the algorithm to a flexible collimator.
virtual void visitMultipoleTCurvedVarRadius(const MultipoleTCurvedVarRadius &)
Apply the algorithm to an arbitrary curved multipole of variable radius.
virtual void visitVerticalFFAMagnet(const VerticalFFAMagnet &bend)
Apply the algorithm to a vertical FFA magnet.
virtual void visitSeptum(const Septum &)
Apply the algorithm to a septum.
IpplTimings::TimerRef DumpTimer_m
virtual void visitMultipoleTCurvedConstRadius(const MultipoleTCurvedConstRadius &)
Apply the algorithm to an arbitrary curved multipole of constant radius.
void seoMode_m(double &t, const double dt, bool &finishedTurn, dvector_t &Ttime, dvector_t &Tdeltr, dvector_t &Tdeltz, ivector_t &TturnNumber)
int maxSteps_m
The maximal number of steps the system is integrated.
virtual void visitMonitor(const Monitor &)
Apply the algorithm to a beam position monitor.
static void writeFields(Component *field)
static void writeFields(Component *field)
Definition: DumpFields.cpp:129
double getWidth()
Definition: CCollimator.h:100
double getZStart()
Member variable access.
Definition: CCollimator.h:90
double getZEnd()
Definition: CCollimator.h:95
Interface for a single beam element.
Definition: Component.h:50
Interface for general corrector.
Definition: Corrector.h:35
virtual double getCyclHarm() const
Definition: Cyclotron.cpp:292
virtual bool getSpiralFlag() const
Definition: Cyclotron.cpp:174
virtual double getPRinit() const
Definition: Cyclotron.cpp:134
virtual double getPZinit() const
Definition: Cyclotron.cpp:158
virtual std::string getFieldMapFN() const
Definition: Cyclotron.cpp:182
virtual double getRmin() const
Definition: Cyclotron.cpp:296
virtual double getMaxR() const
Definition: Cyclotron.cpp:320
virtual bool getSuperpose(unsigned int i) const
Definition: Cyclotron.cpp:234
virtual double getRmax() const
Definition: Cyclotron.cpp:300
virtual double getMaxZ() const
Definition: Cyclotron.cpp:340
virtual double getBScale() const
Definition: Cyclotron.cpp:271
virtual double getZinit() const
Definition: Cyclotron.cpp:150
virtual double getEScale(unsigned int i) const
Definition: Cyclotron.cpp:279
virtual double getPHIinit() const
Definition: Cyclotron.cpp:142
double getRfPhi(unsigned int i) const
Definition: Cyclotron.cpp:208
virtual double getSymmetry() const
Definition: Cyclotron.cpp:247
virtual double getMinZ() const
Definition: Cyclotron.cpp:330
virtual void initialise(PartBunchBase< double, 3 > *bunch, double &startField, double &endField)
Definition: Cyclotron.cpp:932
unsigned int getNumberOfTrimcoils() const
Definition: Cyclotron.cpp:288
virtual double getRinit() const
Definition: Cyclotron.cpp:126
virtual double getMinR() const
Definition: Cyclotron.cpp:316
const std::string & getCyclotronType() const
Definition: Cyclotron.cpp:255
Interface for drift space.
Definition: Drift.h:33
virtual const std::string & getName() const
Get element name.
virtual double getElementLength() const
Get design length.
Definition: ElementBase.h:432
virtual void accept(BeamlineVisitor &visitor) const =0
Apply visitor.
virtual bool hasAttribute(const std::string &aKey) const
Test for existence of an attribute.
std::string getTypeString() const
Definition: ElementBase.h:596
virtual ElementBase * clone() const =0
Return clone.
Interface for a marker.
Definition: Marker.h:32
Interface for general multipole.
Definition: Multipole.h:47
ElementBase * clone() const override
Definition: MultipoleT.cpp:84
virtual ElementBase * clone() const override
virtual ElementBase * clone() const override
virtual ElementBase * clone() const override
Definition: Offset.h:66
void updateGeometry(Vector_t startPosition, Vector_t startDirection)
Definition: Offset.cpp:183
double getYStart() const
virtual void initialise(PartBunchBase< double, 3 > *bunch, double &startField, double &endField) override
Pure virtual implementation of Component.
double getXEnd() const
double getXStart() const
Member variable access.
double getYEnd() const
Definition: Probe.h:28
Definition: RBend.h:58
Interface for RF cavity.
Definition: RFCavity.h:37
virtual std::string getComponentType() const override
Definition: RFCavity.cpp:347
std::string getPhaseModelName()
Definition: RFCavity.h:483
virtual double getRmax() const
Definition: RFCavity.cpp:297
void getMomentaKick(const double normalRadius, double momentum[], const double t, const double dtCorrt, const int PID, const double restMass, const int chargenumber)
used in OPAL-cycl
Definition: RFCavity.cpp:368
virtual double getAzimuth() const
Definition: RFCavity.cpp:301
std::string getAmplitudeModelName()
Definition: RFCavity.h:468
virtual double getCosAzimuth() const
Definition: RFCavity.cpp:309
virtual void initialise(PartBunchBase< double, 3 > *bunch, double &startField, double &endField) override
Definition: RFCavity.cpp:165
virtual double getSinAzimuth() const
Definition: RFCavity.cpp:305
virtual std::string getFieldMapFN() const
Definition: RFCavity.h:363
virtual double getCycFrequency() const
Definition: RFCavity.cpp:354
virtual double getGapWidth() const
Definition: RFCavity.cpp:317
std::string getFrequencyModelName()
Definition: RFCavity.h:498
virtual double getPerpenDistance() const
Definition: RFCavity.cpp:313
virtual double getPhi0() const
Definition: RFCavity.cpp:321
virtual double getRmin() const
Definition: RFCavity.cpp:293
Ring describes a ring type geometry for tracking.
Definition: Ring.h:64
double getBeamRInit() const
Definition: Ring.h:235
Vector_t getNextPosition() const
Definition: Ring.cpp:213
Vector_t getNextNormal() const
Definition: Ring.cpp:222
double getBeamPRInit() const
Definition: Ring.h:247
double getSymmetry() const
Definition: Ring.h:286
virtual void initialise(PartBunchBase< double, 3 > *bunch, double &startField, double &endField) override
Definition: Ring.cpp:163
double getBeamPhiInit() const
Definition: Ring.h:241
virtual ElementBase * clone() const override
Definition: Ring.h:155
double getHarmonicNumber()
Definition: Ring.h:222
void lockRing()
Definition: Ring.cpp:291
void appendElement(const Component &element)
Definition: Ring.cpp:231
Definition: SBend.h:68
Definition: Septum.h:23
virtual void initialise(PartBunchBase< double, 3 > *bunch, double &startField, double &endField) override
Pure virtual implementation of Component.
Definition: Septum.cpp:47
double getWidth() const
Definition: Septum.cpp:57
Interface for solenoids.
Definition: Solenoid.h:36
double getOPMass() const
Definition: Stripper.cpp:84
double getOPCharge() const
Definition: Stripper.cpp:80
bool getStop() const
Definition: Stripper.cpp:92
Definition: Vacuum.h:67
double getPressure() const
Definition: Vacuum.cpp:97
virtual void initialise(PartBunchBase< double, 3 > *bunch, double &startField, double &endField)
Definition: Vacuum.cpp:206
virtual std::string getPressureMapFN() const
Definition: Vacuum.cpp:123
virtual double getPScale() const
Definition: Vacuum.cpp:131
virtual bool checkVacuum(PartBunchBase< double, 3 > *bunch, Cyclotron *cycl)
Definition: Vacuum.cpp:176
double getTemperature() const
Definition: Vacuum.cpp:110
std::string getResidualGasName()
Definition: Vacuum.cpp:152
virtual bool getStop() const
Definition: Vacuum.cpp:171
static std::shared_ptr< AbstractTimeDependence > getTimeDependence(std::string name)
const PartData itsReference
The reference information.
Particle reference data.
Definition: PartData.h:35
double getBeta() const
The relativistic beta per particle.
Definition: PartData.h:124
double getGamma() const
The relativistic gamma per particle.
Definition: PartData.h:129
PartBunchBase< double, 3 > * itsBunch_m
The bunch of particles to be tracked.
Definition: Tracker.h:151
An abstract sequence of beam line components.
Definition: Beamline.h:34
virtual void iterate(BeamlineVisitor &, bool r2l) const
Apply visitor to all elements of the line.
Definition: TBeamline.h:203
void kick(const Vector_t &R, Vector_t &P, const Vector_t &Ef, const Vector_t &Bf, const double &dt) const
Definition: BorisPusher.h:65
Leap-Frog 2nd order.
Definition: LF2.h:26
4-th order Runnge-Kutta stepper
Definition: RK4.h:26
int partInside(const Vector_t &r, const Vector_t &v, const double dt, Vector_t &intecoords, int &triId)
void setMultiBunchInitialPathLengh(MultiBunchHandler *mbhandler_p)
Definition: DataSink.cpp:222
void dumpSDDS(PartBunchBase< double, 3 > *beam, Vector_t FDext[], const double &azimuth=-1) const
Definition: DataSink.cpp:109
void dumpH5(PartBunchBase< double, 3 > *beam, Vector_t FDext[]) const
Definition: DataSink.cpp:90
void writeMultiBunchStatistics(PartBunchBase< double, 3 > *beam, MultiBunchHandler *mbhandler)
Definition: DataSink.cpp:201
The base class for all OPAL exceptions.
Definition: OpalException.h:28
Message * receive_block(int &node, int &tag)
void barrier(void)
Message & put(const T &val)
Definition: Message.h:406
Message & get(const T &cval)
Definition: Message.h:476
int next_tag(int t, int s=1000)
Definition: TagMaker.h:39
Definition: Inform.h:42
static int getNodes()
Definition: IpplInfo.cpp:670
static Communicate * Comm
Definition: IpplInfo.h:84
static TimerRef getTimer(const char *nm)
Definition: IpplTimings.h:182
static void stopTimer(TimerRef t)
Definition: IpplTimings.h:192
static void startTimer(TimerRef t)
Definition: IpplTimings.h:187
Vektor< double, 3 > Vector_t
Definition: Vektor.h:6