114 bool revBeam,
bool revTrack,
115 int maxSTEPS,
int timeIntegrator,
118 const double& mbPara,
119 const std::string& mbMode,
120 const std::string& mbBinning)
121 :
Tracker(beamline, bunch, reference, revBeam, revTrack)
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)
134 if ( numBunch > 1 ) {
137 mbPara, mbMode, mbBinning)
158 if ( timeIntegrator == 0 ) {
160 }
else if ( timeIntegrator == 1) {
162 }
else if ( timeIntegrator == 2) {
188 Inform msg(
"bgf_main_collision_test ");
202 dtime, intecoords, triId);
212 <<
" lost on boundary geometry" <<
endl;
221 const short& bunchNr)
223 if ( prevAzimuth < 0.0 ) {
228 azimuth = theta + plus;
230 double dtheta = theta - prevAzimuth;
234 if ( dtheta > 180 ) {
245 return 1000.0 *
std::sqrt(meanR(0) * meanR(0) + meanR(1) * meanR(1));
253 std::vector<double> dotP(dl.size());
260 allreduce(dotP.data(), dotP.size(), std::plus<double>());
263 double sum = std::accumulate(dotP.begin(), dotP.end() - 1, 0);
267 for (
short b = 0; b < (short)dotP.size() - 1; ++b) {
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;
295 for (
unsigned int i=0; i<numFiles; i++) {
296 std::string SfileName2 = SfileName;
298 SfileName2 += std::string(
"-Angle" + std::to_string(
int(i)) +
".dat");
302 SfileName2 += std::string(
"-afterEachTurn.dat");
305 outfTheta_m.emplace_back(
new std::ofstream(SfileName2.c_str()));
307 outfTheta_m.back()->setf(std::ios::scientific, std::ios::floatfield);
309 <<
"theta [deg] beta_theta*gamma "
332 *
gmsg <<
"* ----------------------------- Cyclotron -------------------------------- *" <<
endl;
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;
369 if (referenceTheta <= -180.0 || referenceTheta > 180.0) {
370 throw OpalException(
"Error in ParallelCyclotronTracker::visitCyclotron",
371 "PHIINIT is out of [-180, 180)!");
382 if (insqrt > -1.0e-10) {
385 throw OpalException(
"Error in ParallelCyclotronTracker::visitCyclotron",
405 throw OpalException(
"Error in ParallelCyclotronTracker::visitCyclotron",
406 "You are trying a local restart from a global h5 file!");
412 throw OpalException(
"Error in ParallelCyclotronTracker::visitCyclotron",
413 "You are trying a global restart from a local h5 file!");
421 if (referenceTheta <= -180.0 || referenceTheta > 180.0) {
422 throw OpalException(
"Error in ParallelCyclotronTracker::visitCyclotron",
423 "PHIINIT is out of [-180, 180)!");
431 *
gmsg <<
"* Bunch global starting position:" <<
endl;
436 *
gmsg <<
"* Bunch global starting momenta:" <<
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;
446 *
gmsg <<
"* " << sym <<
"-fold field symmetry " <<
endl;
453 *
gmsg <<
"* Field map file = " << fmfn <<
" " <<
endl;
456 *
gmsg <<
"* Type of cyclotron = " <<
type <<
" " <<
endl;
460 *
gmsg <<
"* Radial aperture = " << rmin <<
" ... " << rmax<<
" [m] "<<
endl;
464 *
gmsg <<
"* Vertical aperture = " << zmin <<
" ... " << zmax<<
" [m]"<<
endl;
468 *
gmsg <<
"* Harmonic number h = " << h <<
" " <<
endl;
470 if (
type == std::string(
"BANDRF")) {
472 *
gmsg <<
"* RF field scale factor = " << escale <<
endl;
476 *
gmsg << std::boolalpha <<
"* Superpose electric field maps -> " << superpose <<
endl;
482 double BcParameter[8] = {};
497 *
gmsg <<
"* ----------------------------- Collimator ------------------------------- *" <<
endl;
505 *
gmsg <<
"* XStart = " << xstart <<
" [m]" <<
endl;
507 double xend = elptr->
getXEnd();
508 *
gmsg <<
"* XEnd = " << xend <<
" [m]" <<
endl;
511 *
gmsg <<
"* YStart = " << ystart <<
" [m]" <<
endl;
513 double yend = elptr->
getYEnd();
514 *
gmsg <<
"* YEnd = " << yend <<
" [m]" <<
endl;
517 *
gmsg <<
"* ZStart = " << zstart <<
" [m]" <<
endl;
519 double zend = elptr->
getZEnd();
520 *
gmsg <<
"* ZEnd = " << zend <<
" [m]" <<
endl;
523 *
gmsg <<
"* Width = " << width <<
" [m]" <<
endl;
527 double BcParameter[8] = {};
529 BcParameter[0] = xstart;
530 BcParameter[1] = xend;
531 BcParameter[2] = ystart;
532 BcParameter[3] = yend;
533 BcParameter[4] = width;
554 *
gmsg <<
"In Degrader; L= " <<
deg.getElementLength() <<
endl;
586 "ParallelCylcotronTracker::visitOffset",
587 "Attempt to place an offset when Ring not defined");
632 *
gmsg <<
"Adding MultipoleT" <<
endl;
636 throw OpalException(
"ParallelCyclotronTracker::visitMultipoleT",
637 "Need to define a RINGDEFINITION to use MultipoleT element");
648 *
gmsg <<
"Adding MultipoleTStraight" <<
endl;
652 throw OpalException(
"ParallelCyclotronTracker::visitMultipoleTStraight",
653 "Need to define a RINGDEFINITION to use MultipoleTStraight element");
664 *
gmsg <<
"Adding MultipoleTCurvedConstRadius" <<
endl;
668 throw OpalException(
"ParallelCyclotronTracker::visitMultipoleTCurvedConstRadius",
669 "Need to define a RINGDEFINITION to use MultipoleTCurvedConstRadius element");
680 *
gmsg <<
"Adding MultipoleTCurvedVarRadius" <<
endl;
684 throw OpalException(
"ParallelCyclotronTracker::visitMultipoleTCurvedVarRadius",
685 "Need to define a RINGDEFINITION to use MultipoleTCurvedVarRadius element");
696 *
gmsg <<
"* ----------------------------- Probe ------------------------------------ *" <<
endl;
704 *
gmsg <<
"* XStart = " << xstart <<
" [m]" <<
endl;
706 double xend = elptr->
getXEnd();
707 *
gmsg <<
"* XEnd = " << xend <<
" [m]" <<
endl;
710 *
gmsg <<
"* YStart = " << ystart <<
" [m]" <<
endl;
712 double yend = elptr->
getYEnd();
713 *
gmsg <<
"* YEnd = " << yend <<
" [m]" <<
endl;
718 double BcParameter[8] = {};
720 BcParameter[0] = xstart;
721 BcParameter[1] = xend;
722 BcParameter[2] = ystart;
723 BcParameter[3] = yend;
745 *
gmsg <<
"* ----------------------------- RFCavity --------------------------------- * " <<
endl;
752 throw OpalException(
"ParallelCyclotronTracker::visitRFCavity",
753 "The ParallelCyclotronTracker can only play with cyclotron type RF system currently ...");
758 double rmin = elptr->
getRmin();
759 *
gmsg <<
"* Minimal radius of cavity= " << rmin <<
" [mm]" <<
endl;
761 double rmax = elptr->
getRmax();
762 *
gmsg <<
"* Maximal radius of cavity= " << rmax <<
" [mm]" <<
endl;
765 *
gmsg <<
"* RF frequency (2*pi*f)= " << rff <<
" [rad/s]" <<
endl;
768 *
gmsg <<
"* RF Field map file = " << fmfn <<
endl;
771 *
gmsg <<
"* Cavity azimuth position= " << angle <<
" [deg] " <<
endl;
774 *
gmsg <<
"* Cavity gap width= " << gap <<
" [mm] " <<
endl;
777 *
gmsg <<
"* Cavity Shift distance= " << pdis <<
" [mm] " <<
endl;
779 double phi0 = elptr->
getPhi0();
780 *
gmsg <<
"* Initial RF phase (t=0)= " << phi0 <<
" [deg] " <<
endl;
787 std::shared_ptr<AbstractTimeDependence> freq_atd =
nullptr;
788 std::shared_ptr<AbstractTimeDependence> ampl_atd =
nullptr;
789 std::shared_ptr<AbstractTimeDependence> phase_atd =
nullptr;
792 unityVec.push_back(1.);
793 unityVec.push_back(0.);
794 unityVec.push_back(0.);
795 unityVec.push_back(0.);
820 double BcParameter[8] = {};
822 BcParameter[0] = 0.001 * rmin;
823 BcParameter[1] = 0.001 * rmax;
824 BcParameter[2] = 0.001 * pdis;
825 BcParameter[3] = angle;
835 *
gmsg <<
"* ----------------------------- Ring ------------------------------------- *" <<
endl;
849 if(referenceTheta <= -180.0 || referenceTheta > 180.0) {
850 throw OpalException(
"Error in ParallelCyclotronTracker::visitRing",
851 "PHIINIT is out of [-180, 180)!");
866 double BcParameter[8] = {};
901 throw OpalException(
"ParallelCyclotronTracker::visitSBend3D",
902 "Need to define a RINGDEFINITION to use SBend3D element");
906 *
gmsg <<
"Adding ScalingFFAMagnet" <<
endl;
910 throw OpalException(
"ParallelCyclotronTracker::visitScalingFFAMagnet",
911 "Need to define a RINGDEFINITION to use ScalingFFAMagnet element");
921 *
gmsg <<
"* ----------------------------- Septum ----------------------------------- *" <<
endl;
929 *
gmsg <<
"* XStart = " << xstart <<
" [m]" <<
endl;
931 double xend = elptr->
getXEnd();
932 *
gmsg <<
"* XEnd = " << xend <<
" [m]" <<
endl;
935 *
gmsg <<
"* YStart = " << ystart <<
" [m]" <<
endl;
937 double yend = elptr->
getYEnd();
938 *
gmsg <<
"* YEnd = " << yend <<
" [m]" <<
endl;
941 *
gmsg <<
"* Width = " << width <<
" [m]" <<
endl;
946 double BcParameter[8] = {};
948 BcParameter[0] = xstart;
949 BcParameter[1] = xend;
950 BcParameter[2] = ystart;
951 BcParameter[3] = yend;
952 BcParameter[4] = width;
966 *
gmsg <<
"Solenoid: no position of the element given!" <<
endl;
977 *
gmsg <<
"* ----------------------------- Stripper --------------------------------- *" <<
endl;
985 *
gmsg <<
"* XStart = " << xstart <<
" [m]" <<
endl;
987 double xend = elptr->
getXEnd();
988 *
gmsg <<
"* XEnd = " << xend <<
" [m]" <<
endl;
991 *
gmsg <<
"* YStart = " << ystart <<
" [m]" <<
endl;
993 double yend = elptr->
getYEnd();
994 *
gmsg <<
"* YEnd = " << yend <<
" [m]" <<
endl;
997 *
gmsg <<
"* Charge of outcoming particle = +e * " << opcharge <<
endl;
1000 *
gmsg <<
"* Mass of the outcoming particle = " << opmass <<
" [GeV/c^2]" <<
endl;
1003 *
gmsg << std::boolalpha
1004 <<
"* Particles stripped will be deleted after interaction -> "
1009 double BcParameter[8] = {};
1011 BcParameter[0] = xstart;
1012 BcParameter[1] = xend;
1013 BcParameter[2] = ystart;
1014 BcParameter[3] = yend;
1016 BcParameter[5] = opcharge;
1017 BcParameter[6] = opmass;
1028 *
gmsg <<
"* ----------------------------- Vacuum ----------------------------------- *" <<
endl;
1033 double BcParameter[8] = {};
1039 *
gmsg <<
"* Pressure field map file = " << pmfn <<
" " <<
endl;
1040 *
gmsg <<
"* Default pressure = " << pressure <<
" [mbar]" <<
endl;
1042 *
gmsg <<
"* Pressure = " << pressure <<
" [mbar]" <<
endl;
1046 *
gmsg <<
"* Temperature = " << temperature <<
" [K]" <<
endl;
1049 *
gmsg <<
"* Residual gas = " << gas <<
endl;
1052 *
gmsg << std::boolalpha
1053 <<
"* Particles stripped will be deleted after interaction -> "
1058 BcParameter[0] = pressure;
1059 BcParameter[1] = temperature;
1070 *
gmsg <<
"Adding Variable RF Cavity" <<
endl;
1074 throw OpalException(
"ParallelCyclotronTracker::visitVariableRFCavity",
1075 "Need to define a RINGDEFINITION to use VariableRFCavity element");
1085 *
gmsg <<
"Adding Variable RF Cavity with Fringe Field" <<
endl;
1089 throw OpalException(
"ParallelCyclotronTracker::visitVariableRFCavityFringeField",
1090 "Need to define a RINGDEFINITION to use VariableRFCavity element");
1099 *
gmsg <<
"Adding Vertical FFA Magnet" <<
endl;
1103 throw OpalException(
"ParallelCyclotronTracker::visitVerticalFFAMagnet",
1104 "Need to define a RINGDEFINITION to use VerticalFFAMagnet element");
1119 localpair->first = elementType;
1121 for(
int i = 0; i < 8; i++)
1122 *(((localpair->second).first) + i) = *(BcParameter + i);
1124 (localpair->second).second = elptr;
1148 int maxnlp = 111111;
1151 *
gmsg << s <<
"min local particle number: "<< minnlp <<
endl;
1152 *
gmsg <<
"* max local particle number: " << maxnlp <<
endl;
1180 *
gmsg <<
"* ------------------------------------------------------------------------ *" <<
endl;
1181 *
gmsg <<
"* The selected Beam line elements are :" <<
endl;
1197 *
gmsg <<
"* ------------------------------------------------------------------------ *" <<
endl <<
endl;
1205 for (
int k = 0; k < 2; k++)
1215 std::placeholders::_1,
1216 std::placeholders::_2,
1217 std::placeholders::_3,
1218 std::placeholders::_4);
1222 *
gmsg <<
"* 2nd order Leap-Frog integrator" <<
endl;
1227 *
gmsg <<
"* Multiple time stepping (MTS) integrator" <<
endl;
1232 *
gmsg <<
"* 4th order Runge-Kutta integrator" <<
endl;
1244 *
gmsg <<
"* ------------------------------------------------------------------------ *" <<
endl;
1245 *
gmsg <<
"* Finalizing i.e. write data and close files :" <<
endl;
1247 ((fd->second).second)->finalise();
1249 *
gmsg <<
"* ------------------------------------------------------------------------ *" <<
endl;
1264 double t = 0, dt = 0, oldReferenceTheta = 0;
1268 *
gmsg <<
"* MTS: Number of substeps per step is " << numSubsteps <<
endl;
1270 double const dt_inner = dt / double(numSubsteps);
1271 *
gmsg <<
"* MTS: The inner time step is therefore " << dt_inner <<
" [ns]" <<
endl;
1275 bool flagTransition =
false;
1277 *
gmsg <<
"* ---------------------- Start tracking ---------------------------------- *" <<
endl;
1284 bool finishedTurn =
false;
1298 for (
int n = 0;
n < numSubsteps; ++
n)
1340 temp_meanTheta, finishedTurn);
1343 oldReferenceTheta, temp_meanTheta);
1345 oldReferenceTheta = temp_meanTheta;
1352 finishedTurn =
true;
1356 <<
", Total number of live particles: "
1373 *
gmsg <<
"* ---------------------- DONE TRACKING PARTICLES ------------------------- *" <<
endl;
1404 double t = 0, dt = 0, oldReferenceTheta = 0;
1423 *
gmsg <<
"* ---------------------- Start tracking ---------------------------------- *" <<
endl;
1427 bool finishedTurn =
false;
1432 seoMode_m(t, dt, finishedTurn, Ttime, Tdeltr, Tdeltz, TturnNumber);
1448 throw OpalException(
"ParallelCyclotronTracker::GenericTracker()",
1449 "No such tracking mode.");
1459 *
gmsg <<
"* ---------------------- DONE TRACKING PARTICLES ------------------------- *" <<
endl;
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;
1507 Dold = 1.0e3 * distOld;
1515 double rmin = rfcavity->
getRmin();
1516 double rmax = rfcavity->
getRmax();
1517 double nomalRadius = (radius - rmin) / (rmax - rmin);
1519 if(nomalRadius <= 1.0 && nomalRadius >= 0.0) {
1521 for(
int j = 0; j < 3; j++)
1527 for(
int j = 0; j < 3; j++)
1554 int lastTurn,
double &,
double &) {
1557 int Ndat = t.size();
1564 for(
int i = 0; i < Ndat; i++)
1569 for(
int i = 0; i < Ndat; i++)
1571 double ti = *(t.begin());
1572 double tf = t[t.size()-1];
1573 double T = (tf - ti);
1576 for(
int i = 0; i < Ndat; i++) {
1583 *
gmsg <<
"* ************************************* nuR ******************************************* *" <<
endl;
1584 *
gmsg <<
endl <<
"* ===> " << Ndat <<
" data points Ti=" << ti <<
" Tf= " << tf <<
" -> T= " <<
T <<
endl;
1592 *
gmsg <<
"* TUNE: Lomb analysis failed" <<
endl;
1593 *
gmsg <<
"* ************************************************************************************* *" <<
endl;
1603 *
gmsg <<
"* ************************************* nuZ ******************************************* *" <<
endl;
1604 *
gmsg <<
endl <<
"* ===> " << Ndat <<
" data points Ti=" << ti <<
" Tf= " << tf <<
" -> T= " <<
T <<
endl;
1610 *
gmsg <<
"* TUNE: Lomb analysis failed" <<
endl;
1611 *
gmsg <<
"* ************************************************************************************* *" <<
endl;
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"));
1640 for(
int d = 0; d < 3; ++d) {
1659 for(
int d = 0; d < 3; ++d) {
1678 double phi,
Vector_t const translationToGlobal) {
1680 particleVectors -= translationToGlobal;
1688 particleVectors[i] =
dot(rotation, particleVectors[i]);
1694 double phi,
Vector_t const translationToGlobal) {
1702 particleVectors[i] =
dot(rotation, particleVectors[i]);
1705 particleVectors += translationToGlobal;
1716 particleVectors -= meanR;
1729 reverseQuaternion(0) *= -1.0;
1735 particleVectors += meanR;
1748 particleVectors -= meanR;
1798 particleVectors += meanR;
1825 Vector_t const quaternionVectorComponent =
Vector_t(quaternion(1), quaternion(2), quaternion(3));
1826 double const quaternionScalarComponent = quaternion(0);
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]);
1839 double tolerance = 1.0e-10;
1840 double length2 =
dot(quaternion, quaternion);
1842 if (
std::abs(length2) > tolerance &&
std::abs(length2 - 1.0f) > tolerance) {
1845 quaternion /= length;
1851 double tolerance = 1.0e-10;
1852 double length2 =
dot(vector, vector);
1854 if (
std::abs(length2) > tolerance &&
std::abs(length2 - 1.0f) > tolerance) {
1870 particleVectors[i] =
dot(rotation, particleVectors[i]);
1881 myVector =
dot(rotation, myVector);
1893 particleVectors[i] =
dot(rotation, particleVectors[i]);
1904 myVector =
dot(rotation, myVector);
1913 double k_cos_theta =
dot(u, v);
1915 double tolerance1 = 1.0e-5;
1916 double tolerance2 = 1.0e-8;
1919 if (
std::abs(k_cos_theta / k + 1.0) < tolerance1) {
1926 if (
dot(resultVectorComponent, resultVectorComponent) < tolerance2) {
1932 double sinHalfAngle =
std::sin(halfAngle);
1934 resultVectorComponent *= sinHalfAngle;
1941 resultVectorComponent =
cross(u, v);
1945 quaternion(0) = k_cos_theta + k;
1946 quaternion(1) = resultVectorComponent(0);
1947 quaternion(2) = resultVectorComponent(1);
1948 quaternion(3) = resultVectorComponent(2);
1964 bool flagNeedUpdate =
false;
1972 double const distNew = (
itsBunch_m->
R[i][0] * ccd.sinAzimuth -
itsBunch_m->
R[i][1] * ccd.cosAzimuth) - ccd.perpenDistance;
1973 bool tagCrossing =
false;
1975 if(distNew <= 0.0) {
1976 distOld = (oldR[0] * ccd.sinAzimuth - oldR[1] * ccd.cosAzimuth) - ccd.perpenDistance;
1977 if(distOld > 0.0) tagCrossing =
true;
1981 double const dt2 = h - dt1;
1998 return flagNeedUpdate;
2005 bool flagNeedUpdate =
false;
2018 return flagNeedUpdate;
2026 bool flagNeedUpdate =
push(0.5 * h);
2041 flagNeedUpdate |=
kick(h);
2044 flagNeedUpdate |=
push(0.5 * h);
2058 Vacuum* vac =
static_cast<Vacuum*
>(((*sindex)->second).second);
2073 *
gmsg <<
"* Total number of particles after PluginElement= "
2091 allreduce(flagNeedUpdate, 1, std::logical_or<bool>());
2093 if(flagNeedUpdate) {
2095 std::vector<size_t> locLostParticleNum(bunchCount, 0);
2098 std::unique_ptr<size_t[]> localBinCount;
2101 localBinCount = std::unique_ptr<size_t[]>(
new size_t[leb]);
2102 for (
int i = 0; i < leb; ++i)
2103 localBinCount[i] = 0;
2120 for (
int i = 0; i < leb; ++i) {
2125 std::vector<size_t> localnum(bunchCount + 1);
2126 for (
size_t i = 0; i < localnum.size() - 1; ++i) {
2142 std::vector<size_t> totalnum(bunchCount + 1);
2145 allreduce(localnum.data(), totalnum.data(), localnum.size(), std::plus<size_t>());
2148 for (
short i = 0; i < bunchCount; ++i) {
2152 size_t sum = std::accumulate(totalnum.begin(),
2153 totalnum.end() - 1, 0);
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)");
2161 size_t globLostParticleNum = 0;
2162 size_t locNumLost = std::accumulate(locLostParticleNum.begin(),
2163 locLostParticleNum.end(), 0);
2165 reduce(locNumLost, globLostParticleNum, 1, std::plus<size_t>());
2167 if ( globLostParticleNum > 0 ) {
2169 <<
", lost " << globLostParticleNum <<
" particles" <<
endl;
2172 if (totalnum[bunchCount] == 0) {
2174 return flagNeedUpdate;
2211 return flagNeedUpdate;
2294 *
gmsg <<
"* Restart in the local frame" <<
endl;
2316 *
gmsg <<
"* Restart in the global frame" <<
endl;
2336 double radius =
std::sqrt(meanR[0] * meanR[0] + meanR[1] * meanR[1]);
2355 *
gmsg <<
endl <<
"* *********************** Bunch information in local frame: ************************";
2383 *
gmsg <<
endl <<
"* *********************** Bunch information in global frame: ***********************";
2403 int found[2] = {-1, -1};
2419 int numberOfPart = 0;
2421 while(notReceived > 0) {
2427 ERRORMSG(
"Could not receive from client nodes in main." <<
endl);
2431 rmsg->
get(&numberOfPart);
2433 for(
int i = 0; i < numberOfPart; ++i) {
2436 for(
int ii = 0; ii < 6; ii++) {
2444 for(
int i = 0; i < counter; ++i) {
2448 for(
int j = 0; j < 3; ++j) {
2457 for(
auto tmpid : tmpi) {
2469 for(
int ii = 0; ii < 6; ii++) {
2482 for(
int i = 0; i < counter; i++) {
2486 for(
int j = 0; j < 3; j++) {
2494 ERRORMSG(
"Ippl::Comm->send(smsg, 0, tag) failed " <<
endl);
2526 double phi = 0.0, psi = 0.0;
2590 (((*DumpSindex)->second).second)->apply(meanR, meanP, temp_t,
extE_m,
extB_m);
2655 double const betagamma_temp =
std::sqrt(
dot(meanP, meanP));
2660 double const theta =
std::atan2(meanR(1), meanR(0));
2688 (((*DumpSindex)->second).second)->apply(meanR, meanP, temp_t,
extE_m,
extB_m);
2694 bool dumpLocalFrame =
true;
2695 std::string dumpString =
"local";
2697 dumpLocalFrame =
false;
2698 dumpString =
"global";
2701 if (dumpLocalFrame ==
true) {
2730 if (dumpLocalFrame ==
true) {
2742 <<
" (no phase space dump for <= 2 particles)" <<
endl;
2745 <<
" (" << dumpString <<
" frame) at integration step " <<
step_m + 1 <<
endl;
2750 *
gmsg <<
"* T = " << temp_t <<
" ns"
2752 *
gmsg <<
"* E = " << E <<
" MeV"
2753 <<
", beta * gamma = " << betagamma_temp <<
endl;
2769 const bool& finishedTurn)
2777 if (!(
step_m + 1 % 1000))
2858 *
gmsg <<
"* Beginning of this run is at t = " << t <<
" [ns]" <<
endl;
2859 *
gmsg <<
"* The time step is set to dt = " << dt <<
" [ns]" <<
endl;
2863 *
gmsg <<
"* MBM: Time interval between neighbour bunches is set to "
2865 *
gmsg <<
"* MBM: The particles energy bin reset frequency is set to "
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;
2887 throw OpalException(
"Error in ParallelCyclotronTracker::initializeTracking_m",
2888 "SEO MODE ONLY WORKS SERIALLY ON SINGLE NODE!");
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;
2899 throw OpalException(
"Error in ParallelCyclotronTracker::initializeTracking_m",
2900 "SINGLE PARTICLE MODE ONLY WORKS SERIALLY ON A SINGLE NODE!");
2909 throw OpalException(
"ParallelCyclotronTracker::initializeTracking_m()",
2910 "No such tracking mode.");
2913 return std::make_tuple(t, dt, oldReferenceTheta);
2925 *
gmsg <<
"* Final energy of reference particle = " << FinalEnergy <<
" [MeV]" <<
endl;
2939 *
gmsg <<
"* **************** The result for tune calculation (NO space charge) ******************* *" <<
endl
2940 <<
"* Number of tracked turns: " << TturnNumber.back() <<
endl;
2942 getTunes(Ttime, Tdeltr, Tdeltz, TturnNumber.back(), nur, nuz);
2956 *
gmsg <<
"* Cave: Turn number is not correct for restart mode"<<
endl;
2966 *
gmsg <<
endl <<
"* *********************** Bunch information in global frame: ***********************";
2975 *
gmsg <<
endl <<
"* No Particles left in bunch!" <<
endl;
2976 *
gmsg <<
"* **********************************************************************************" <<
endl;
2989 double r_tuning[2], z_tuning[2];
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]);
3034 bool& finishedTurn,
double& oldReferenceTheta) {
3071 temp_meanTheta, finishedTurn);
3074 oldReferenceTheta, temp_meanTheta);
3076 oldReferenceTheta = temp_meanTheta;
3102 static bool flagTransition =
false;
3182 finishedTurn =
true;
3186 <<
", Total number of live particles: "
3202 bool tag_crossing =
false;
3203 double DistOld = 0.0;
3208 rfcav =
static_cast<RFCavity *
>(((*sindex)->second).second);
3212 if ( tag_crossing ) {
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);
3220 double dt2 = dt - dt1;
3227 if (dt / dt1 < 1.0e9)
3231 RFkick(rfcav, t, dt1, i);
3236 if (dt / dt2 < 1.0e9)
3246 const double& oldReferenceTheta,
3247 const double& temp_meanTheta)
3249 for (
unsigned int i=0; i<=2; i++) {
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)
3257 <<
" " << - P(0) *
std::sin(temp_meanTheta) + P(1) *
std::cos(temp_meanTheta)
3267 const double& temp_meanTheta,
3274 finishedTurn =
true;
3279 <<
", Time = " << t <<
" [ns]" <<
std::endl
3281 <<
" " << P(0) *
std::cos(temp_meanTheta) +
3284 <<
" " << - P(0) *
std::sin(temp_meanTheta) +
3388 bool outOfBound = (((*sindex)->second).second)->apply(i, t, Efield, Bfield);
3414 if ( flagTransition ) {
3416 *
gmsg <<
"* MBM: After one revolution, Multi-Bunch Mode will be invoked" <<
endl;
3426 throw OpalException(
"ParallelCyclotronTracker::injectBunch()",
3427 "Unknown return value " + std::to_string(result));
3460 std::vector<double> lpaths(1);
3495 for (
short b = 0; b <
mbHandler_m->getNumBunch(); ++b) {
Tps< T > cos(const Tps< T > &x)
Cosine.
Tps< T > pow(const Tps< T > &x, int y)
Integer power.
Tps< T > sin(const Tps< T > &x)
Sine.
Tps< T > sqrt(const Tps< T > &x)
Square root.
Vector3D cross(const Vector3D &lhs, const Vector3D &rhs)
Vector cross product.
double dot(const Vector3D &lhs, const Vector3D &rhs)
Vector dot product.
bool for_each(const BareFieldIterator< T, D > &p, SameFieldID s, C)
T::PETE_Expr_t::PETE_Return_t max(const PETE_Expr< T > &expr, NDIndex< D > &loc)
void allreduce(const T *input, T *output, int count, Op op)
bool reduce(Communicate &, InputIterator, InputIterator, OutputIterator, const ReduceOp &, bool *IncludeVal=0)
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)
PETE_TUTree< FnArcCos, typename T::PETE_Expr_t > acos(const PETE_Expr< T > &l)
Inform & endl(Inform &inf)
Inform & level4(Inform &inf)
Inform & level3(Inform &inf)
constexpr double deg2rad
The conversion factor from degrees to radians.
constexpr double q_e
The elementary charge in As.
constexpr double c
The velocity of light in m/s.
constexpr double pi
The value of.
constexpr double rad2deg
The conversion factor from radians to degrees.
std::string::iterator iterator
T deg(T x)
Convert radians to degrees.
int psDumpFreq
The frequency to dump the phase space, i.e.dump data when steppsDumpFreq==0.
bool psDumpEachTurn
phase space dump flag for OPAL-cycl
int sptDumpFreq
The frequency to dump single particle trajectory of particles with ID = 0 & 1.
unsigned int delPartFreq
The frequency to delete particles (currently: OPAL-cycl only)
int scSolveFreq
The frequency to solve space charge fields.
int repartFreq
The frequency to do particles repartition for better load balance between nodes.
int rebinFreq
The frequency to reset energy bin ID for all particles.
DumpFrame psDumpFrame
flag to decide in which coordinate frame the phase space will be dumped for OPAL-cycl
int statDumpFreq
The frequency to dump statistical values, e.e. dump data when stepstatDumpFreq==0.
boost::function< boost::tuple< double, bool >arguments_t)> type
const std::string & getOpalName() const
Return object name.
ParticleAttrib< Vector_t > Ef
double get_meanKineticEnergy() const
ParticleAttrib< int > Bin
void boundp_destroyCycl()
double getQ() const
Access to reference data.
double getChargePerParticle() const
get the macro particle charge
size_t getLocalNum() const
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
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
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()
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
std::string getFieldSolverType() const
Return the fieldsolver type if we have a fieldsolver.
void setOpenMode(OPENMODE openMode)
std::string getInputBasename()
get input file name without extension
static OpalData * getInstance()
BoundaryGeometry * getGlobalGeometry()
bool inRestartRun()
true if we do a restart run
int lombAnalysis(double *x, double *y, int Ndat, int nhis)
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.
Vector_t calcMeanP() const
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.
ParallelCyclotronTracker()
virtual ~ParallelCyclotronTracker()
std::vector< std::unique_ptr< std::ofstream > > outfTheta_m
output coordinates at different azimuthal angles and one after every turn
void computeSpaceChargeFields_m()
bool hasMultiBunch() const
double getHarmonicNumber() const
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 updateTime(const double &dt)
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.
void borisExternalFields(double h)
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.
static Vector_t const yaxis
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)
static Vector_t const zaxis
void updateAzimuthAndRadius()
const size_t initialLocalNum_m
bool getFieldsAtPoint(const double &t, const size_t &Pindex, Vector_t &Efield, Vector_t &Bfield)
std::vector< CavityCrossData > cavCrossDatas_m
beamline_list FieldDimensions
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
std::ofstream outfTrackOrbit_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)
void initTrackOrbitFile()
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.
const size_t initialTotalNum_m
void bgf_main_collision_test()
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.
stepper::INTEGRATOR stepper_m
virtual void visitSolenoid(const Solenoid &)
Apply the algorithm to a solenoid.
std::vector< double > dvector_t
void bunchDumpPhaseSpaceData()
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.
bool deleteParticle(bool=false)
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.
void checkNumPart(std::string s)
void singleParticleDump()
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.
bool isMultiBunch() const
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.
void initDistInGlobalFrame()
virtual void visitMonitor(const Monitor &)
Apply the algorithm to a beam position monitor.
std::vector< int > ivector_t
static void writeFields(Component *field)
static void writeFields(Component *field)
double getZStart()
Member variable access.
Interface for a single beam element.
Interface for general corrector.
virtual double getCyclHarm() const
virtual bool getSpiralFlag() const
virtual double getPRinit() const
virtual double getPZinit() const
virtual std::string getFieldMapFN() const
virtual double getRmin() const
virtual double getMaxR() const
virtual bool getSuperpose(unsigned int i) const
virtual double getRmax() const
virtual double getMaxZ() const
virtual double getBScale() const
virtual double getZinit() const
virtual double getEScale(unsigned int i) const
virtual double getPHIinit() const
double getRfPhi(unsigned int i) const
virtual double getSymmetry() const
virtual double getMinZ() const
virtual void initialise(PartBunchBase< double, 3 > *bunch, double &startField, double &endField)
unsigned int getNumberOfTrimcoils() const
virtual double getRinit() const
virtual double getMinR() const
const std::string & getCyclotronType() const
Interface for drift space.
virtual const std::string & getName() const
Get element name.
virtual double getElementLength() const
Get design length.
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
virtual ElementBase * clone() const =0
Return clone.
Interface for general multipole.
ElementBase * clone() const override
virtual ElementBase * clone() const override
virtual ElementBase * clone() const override
virtual ElementBase * clone() const override
void updateGeometry(Vector_t startPosition, Vector_t startDirection)
virtual void initialise(PartBunchBase< double, 3 > *bunch, double &startField, double &endField) override
Pure virtual implementation of Component.
double getXStart() const
Member variable access.
virtual std::string getComponentType() const override
std::string getPhaseModelName()
virtual double getRmax() const
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
virtual double getAzimuth() const
std::string getAmplitudeModelName()
virtual double getCosAzimuth() const
virtual void initialise(PartBunchBase< double, 3 > *bunch, double &startField, double &endField) override
virtual double getSinAzimuth() const
virtual std::string getFieldMapFN() const
virtual double getCycFrequency() const
virtual double getGapWidth() const
std::string getFrequencyModelName()
virtual double getPerpenDistance() const
virtual double getPhi0() const
virtual double getRmin() const
Ring describes a ring type geometry for tracking.
double getBeamRInit() const
Vector_t getNextPosition() const
Vector_t getNextNormal() const
double getBeamPRInit() const
double getSymmetry() const
virtual void initialise(PartBunchBase< double, 3 > *bunch, double &startField, double &endField) override
double getBeamPhiInit() const
virtual ElementBase * clone() const override
double getHarmonicNumber()
void appendElement(const Component &element)
virtual void initialise(PartBunchBase< double, 3 > *bunch, double &startField, double &endField) override
Pure virtual implementation of Component.
double getOPCharge() const
double getPressure() const
virtual void initialise(PartBunchBase< double, 3 > *bunch, double &startField, double &endField)
virtual std::string getPressureMapFN() const
virtual double getPScale() const
virtual bool checkVacuum(PartBunchBase< double, 3 > *bunch, Cyclotron *cycl)
double getTemperature() const
std::string getResidualGasName()
virtual bool getStop() const
static std::shared_ptr< AbstractTimeDependence > getTimeDependence(std::string name)
const PartData itsReference
The reference information.
double getBeta() const
The relativistic beta per particle.
double getGamma() const
The relativistic gamma per particle.
PartBunchBase< double, 3 > * itsBunch_m
The bunch of particles to be tracked.
An abstract sequence of beam line components.
virtual void iterate(BeamlineVisitor &, bool r2l) const
Apply visitor to all elements of the line.
void kick(const Vector_t &R, Vector_t &P, const Vector_t &Ef, const Vector_t &Bf, const double &dt) const
4-th order Runnge-Kutta stepper
int partInside(const Vector_t &r, const Vector_t &v, const double dt, Vector_t &intecoords, int &triId)
void setMultiBunchInitialPathLengh(MultiBunchHandler *mbhandler_p)
void dumpSDDS(PartBunchBase< double, 3 > *beam, Vector_t FDext[], const double &azimuth=-1) const
void dumpH5(PartBunchBase< double, 3 > *beam, Vector_t FDext[]) const
void writeMultiBunchStatistics(PartBunchBase< double, 3 > *beam, MultiBunchHandler *mbhandler)
The base class for all OPAL exceptions.
Message * receive_block(int &node, int &tag)
Message & put(const T &val)
Message & get(const T &cval)
int next_tag(int t, int s=1000)
static Communicate * Comm
static TimerRef getTimer(const char *nm)
static void stopTimer(TimerRef t)
static void startTimer(TimerRef t)
Vektor< double, 3 > Vector_t