27 #ifndef CLOSEDORBITFINDER_H
28 #define CLOSEDORBITFINDER_H
49 #include <boost/numeric/odeint/integrate/integrate_n_steps.hpp>
50 #include <boost/filesystem.hpp>
54 template<
typename Value_type,
typename Size_type,
class Stepper>
81 Cyclotron* cycl,
bool domain =
true,
int Nsectors = 1);
93 std::pair<value_type,value_type>
getTunes();
135 bool isTuneMode =
false);
160 std::array<value_type,2>
x_m;
164 std::array<value_type,2>
z_m;
249 std::function<double(
double,
double)>
bcon_m = [
this](
double e0,
double wo) {
260 template<
typename Value_type,
typename Size_type,
class Stepper>
266 bool domain,
int nSectors)
271 , wo_m(cycl->getRfFrequ(0)*1E6/cycl->getCyclHarm()*2.0*
Physics::
pi)
279 , nSectors_m(nSectors)
285 throw OpalException(
"ClosedOrbitFinder::ClosedOrbitFinder()",
286 "Incorrect cyclotron energy (MeV) bounds: Maximum cyclotron energy smaller than minimum cyclotron energy.");
311 template<
typename Value_type,
typename Size_type,
class Stepper>
316 return rotate(angle, h_m);
321 template<
typename Value_type,
typename Size_type,
class Stepper>
326 return rotate(angle, ds_m);
331 template<
typename Value_type,
typename Size_type,
class Stepper>
336 return rotate(angle, fidx_m);
340 template<
typename Value_type,
typename Size_type,
class Stepper>
343 value_type nur = computeTune(x_m,px_m[1],nxcross_m);
346 value_type nuz = computeTune(z_m,pz_m[1],nzcross_m);
348 return std::make_pair(nur,nuz);
351 template<
typename Value_type,
typename Size_type,
class Stepper>
356 return rotate(angle, r_m);
361 template<
typename Value_type,
typename Size_type,
class Stepper>
368 pr = rotate(angle, pr);
393 template<
typename Value_type,
typename Size_type,
class Stepper>
400 template<
typename Value_type,
typename Size_type,
class Stepper>
413 template<
typename Value_type,
typename Size_type,
class Stepper>
455 E_fin = cycl_m->getFMHighE();
458 namespace fs = boost::filesystem;
461 std::string tunefile = (dir /
"tunes.dat").
string();
464 std::ofstream out(tunefile, std::ios::out);
467 << std::setw(15) <<
"# energy[MeV]"
468 << std::setw(15) <<
"radius_ini[m]"
469 << std::setw(15) <<
"momentum_ini[Beta Gamma]"
470 << std::setw(15) <<
"radius_avg[m]"
471 << std::setw(15) <<
"nu_r"
472 << std::setw(15) <<
"nu_z"
477 enum Guess {
NONE, FIRST, SECOND};
484 *
gmsg <<
level3 <<
"Start iteration to find closed orbit of energy " << E_fin <<
" MeV "
485 <<
"in steps of " << dE <<
" MeV." <<
endl;
487 for (; E <= E_fin + eps; E += dE) {
503 init = {beta * acon, 0.0, 0.0, 1.0};
505 init[0] = rguess * 0.001;
508 }
else if (guess == FIRST) {
510 init[0] = (beta*acon) * rn1;
513 }
else if (guess == SECOND) {
515 init[0] = (beta*acon) * (rn1 + (rn1-rn2));
516 init[1] = p*(pn1 + (pn1-pn2));
519 std::fill( r_m.begin(), r_m.end(), 0);
520 std::fill( pr_m.begin(), pr_m.end(), 0);
521 std::fill( vz_m.begin(), vz_m.end(), 0);
522 std::fill(vpz_m.begin(), vpz_m.end(), 0);
530 *
gmsg <<
level3 <<
" Try to find orbit for " << E <<
" MeV ... ";
532 if ( !this->findOrbitOfEnergy_m(E, init, error, accuracy, maxit) ) {
533 *
gmsg <<
endl <<
"ClosedOrbitFinder didn't converge for energy " + std::to_string(E) +
" MeV." <<
endl;
543 rn1 = r_m[0] / (acon * beta);
548 this->computeOrbitProperties(E);
549 value_type reo = this->getOrbit( cycl_m->getPHIinit())[0];
550 value_type peo = this->getMomentum(cycl_m->getPHIinit())[0];
551 std::pair<value_type , value_type > tunes = this->getTunes();
554 <<
"* ----------------------------" <<
endl
555 <<
"* Closed orbit info (Gordon units):" <<
endl
557 <<
"* kinetic energy: " << std::setw(12) << E <<
" [MeV]" <<
endl
558 <<
"* average radius: " << std::setw(12) << ravg_m <<
" [m]" <<
endl
559 <<
"* initial radius: " << std::setw(12) << reo <<
" [m]" <<
endl
560 <<
"* initial momentum: " << std::setw(12) << peo <<
" [Beta Gamma]" <<
endl
561 <<
"* frequency error: " << phase_m <<
endl
562 <<
"* horizontal tune: " << tunes.first <<
endl
563 <<
"* vertical tune: " << tunes.second <<
endl
564 <<
"* ----------------------------" <<
endl <<
endl;
566 std::ofstream out(tunefile, std::ios::app);
568 << std::setw(15) << E
569 << std::setw(15) << reo
570 << std::setw(15) << peo
571 << std::setw(15) << ravg_m
572 << std::setw(15) << tunes.first
573 << std::setw(15) << tunes.second <<
std::endl;
578 *
gmsg <<
level3 <<
"Finished closed orbit finder successfully." <<
endl;
594 phase_m *= cycl_m->getSymmetry();
597 return error < accuracy;
600 template<
typename Value_type,
typename Size_type,
class Stepper>
612 value_type invbcon = 1.0 / bcon_m(E0_m, wo_m);
628 nxcross_m += (idx > 0) * (y[4] * xold < 0);
632 nzcross_m += (idx > 0) * (y[10] * zold < 0);
655 value_type invgamma4 = 1.0 / (gamma2 * gamma2);
670 throw OpalException(
"ClosedOrbitFinder::findOrbitOfEnergy_m()",
671 "p_{r}^2 > p^{2} (defined in Gordon paper) --> Square root of negative number.");
675 invptheta = 1.0 / ptheta;
677 brint=0.0, btint=0.0, bint=0.0;
678 for (
int i = 0; i<nSectors_m; i++) {
680 double tmpbr, tmpbt, tmpb;
682 cycl_m->apply(y[0], y[6], angle, tmpbr, tmpbt, tmpb);
696 dydt[0] = y[0] * y[1] * invptheta;
698 dydt[1] = ptheta - y[0] * bint;
701 dydt[i] = (y[1] * y[i] + y[0] * p2 * y[i+1] * invptheta * invptheta) * invptheta;
702 dydt[i+1] = - y[1] * y[i+1] * invptheta - (bint + y[0] * brint) * y[i];
707 dydt[i] = y[0] * y[i+1] * invptheta;
708 dydt[i+1] = (y[0] * brint - y[1] * invptheta * btint) * y[i];
712 dydt[12] = y[0] * invptheta * gamma - 1;
733 y = {init[0],init[1],
734 x_m[0], px_m[0], x_m[1], px_m[1],
736 z_m[0], pz_m[0], z_m[1], pz_m[1],
742 boost::numeric::odeint::integrate_n_steps(stepper_m, orbit_integration,y,0.0,dtheta_m,N_m,store);
762 err[0] = r_m[N_m] - r_m[0];
763 err[1] = pr_m[N_m] - pr_m[0];
766 value_type invdenom = 1.0 / (x_m[0] + px_m[1] - 2.0);
767 delta[0] = ((px_m[1] - 1.0) * err[0] - x_m[1] * err[1]) * invdenom;
768 delta[1] = (( x_m[0] - 1.0) * err[1] - px_m[0] * err[0]) * invdenom;
775 error =
std::sqrt(delta[0] * delta[0] + delta[1] * delta[1] * invgamma4) / r_m[0];
779 }
while ((error > accuracy) && (niterations++ < maxit));
781 if (error > accuracy)
782 *
gmsg <<
"findOrbit not converged after " << niterations <<
" iterations with error: " << error <<
". Needed accuracy " << accuracy <<
endl;
784 return (error < accuracy);
787 template<
typename Value_type,
typename Size_type,
class Stepper>
799 bool negative = std::signbit(y[1]);
801 bool uneven = (ncross % 2);
811 muPrime = -std::acosh(abscos);
827 if (!negative && std::signbit(
std::sin(mu))) {
829 }
else if (negative && !std::signbit(
std::sin(mu))) {
840 mu *= cycl_m->getSymmetry();
845 template<
typename Value_type,
typename Size_type,
class Stepper>
857 value_type invbcon = 1.0 / bcon_m(E0_m, wo_m);
871 cycl_m->apply(r_m[i], vz_m[i], theta, brint, btint, bint);
881 throw OpalException(
"ClosedOrbitFinder::computeOrbitProperties()",
882 "p_{r}^2 > p^{2} " + std::to_string(p) +
" " + std::to_string(pr_m[i]) +
" (defined in Gordon paper) --> Square root of negative number.");
884 ptheta =
std::sqrt(p2 - pr_m[i] * pr_m[i]);
886 fidx_m[i] = (brint * ptheta - btint * pr_m[i] / r_m[i]) / p2;
889 ds_m[i] = std::hypot(r_m[i] * pr_m[i] / ptheta,r_m[i]) * dtheta_m;
896 ravg_m = std::accumulate(r_m.begin(),r_m.end(),0.0) /
value_type(r_m.size());
899 template<
typename Value_type,
typename Size_type,
class Stepper>
909 angle = 360.0 + angle;
913 unsigned int start = deg_step * angle;
915 start %= orbitProperty.size();
918 std::copy(orbitProperty.begin() + start, orbitProperty.end(), orbitPropertyCopy.begin());
921 std::copy_n(orbitProperty.begin(), start, orbitPropertyCopy.end() - start);
923 return orbitPropertyCopy;
T * value_type(const SliceIterator< T > &)
Tps< T > cos(const Tps< T > &x)
Cosine.
Tps< T > sin(const Tps< T > &x)
Sine.
Tps< T > sqrt(const Tps< T > &x)
Square root.
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)
PETE_TUTree< FnAbs, typename T::PETE_Expr_t > abs(const PETE_Expr< T > &l)
PETE_TUTree< FnArcCos, typename T::PETE_Expr_t > acos(const PETE_Expr< T > &l)
Inform & endl(Inform &inf)
Inform & level3(Inform &inf)
constexpr double u_two_pi
The value of.
constexpr double two_pi
The value of.
constexpr double c
The velocity of light in m/s.
constexpr double pi
The value of.
std::string getInputBasename()
get input file name without extension
static OpalData * getInstance()
std::string getAuxiliaryOutputDirectory() const
get the name of the the additional data directory
void read(const double &scaleFactor)
virtual double getFMHighE() const
virtual double getBScale() const
virtual double getSymmetry() const
virtual double getFMLowE() const
std::vector< value_type > container_type
Type of container for storing quantities (path length, orbit, etc.)
std::pair< value_type, value_type > getTunes()
Returns the radial and vertical tunes (in that order)
std::array< value_type, 2 > px_m
Stores current momenta in horizontal direction for the solutions of the ODE with different initial va...
size_type N_m
Number of integration steps.
ClosedOrbitFinder(value_type E0, value_type q, size_type N, Cyclotron *cycl, bool domain=true, int Nsectors=1)
Sets the initial values for the integration and calls findOrbit().
container_type vz_m
Stores the vertical oribt (size: N_m+1)
size_type nzcross_m
Counts the number of zero-line crossings in vertical direction (used for computing vertical tune)
value_type phase_m
Is the phase.
bool findOrbitOfEnergy_m(const value_type &, container_type &, value_type &, const value_type &, size_type)
std::vector< value_type > state_type
Type for holding state of ODE values.
void computeOrbitProperties(const value_type &E)
Fills in the values of h_m, ds_m, fidx_m.
std::array< value_type, 2 > z_m
Stores current position in vertical direction for the solutions of the ODE with different initial val...
container_type fidx_m
Stores the field index.
value_type wo_m
Is the nominal orbital frequency.
container_type ds_m
Stores the step length.
bool findOrbit(value_type accuracy, size_type maxit, value_type ekin, value_type dE=1.0, value_type rguess=-1.0, bool isTuneMode=false)
Computes the closed orbit.
container_type h_m
Stores the inverse bending radius.
std::function< double(double, double)> bcon_m
Cyclotron unit (Tesla)
container_type r_m
Stores the radial orbit (size: N_m+1)
Size_type size_type
Type for specifying sizes.
container_type vpz_m
Stores the vertical momentum.
value_type getAverageRadius()
Returns the average orbit radius.
std::function< double(double)> acon_m
value_type dtheta_m
Is the angle step size.
std::function< void(const state_type &, state_type &, const double)> function_t
container_type getFieldIndex(const value_type &angle=0)
Returns the field index (size of container N+1)
Value_type value_type
Type of variables.
container_type getMomentum(value_type angle=0)
container_type getOrbit(value_type angle=0)
container_type rotate(value_type angle, const container_type &orbitProperty)
This function computes nzcross_ which is used to compute the tune in z-direction and the frequency er...
bool isConverged()
Returns true if a closed orbit could be found.
container_type getPathLength(const value_type &angle=0)
Returns the step lengths of the path (size of container N+1)
std::array< value_type, 2 > pz_m
Stores current momenta in vertical direction for the solutions of the ODE with different initial valu...
std::array< value_type, 2 > x_m
Stores current position in horizontal direction for the solutions of the ODE with different initial v...
value_type ravg_m
Is the average radius.
container_type pr_m
Stores the radial momentum.
container_type getInverseBendingRadius(const value_type &angle=0)
Returns the inverse bending radius (size of container N+1)
value_type getFrequencyError()
Returns the frequency error.
value_type computeTune(const std::array< value_type, 2 > &, value_type, size_type)
This function is called by the function getTunes().
value_type E0_m
Is the rest mass [MeV / c**2].
size_type nxcross_m
Counts the number of zero-line crossings in horizontal direction (used for computing horizontal tune)
Stepper stepper_m
Defines the stepper for integration of the ODE's.
The base class for all OPAL exceptions.
virtual const std::string & what() const
Return the message string for the exception.
virtual const std::string & where() const
Return the name of the method or function which detected the exception.