MCTDH-X  v2.22
 All Classes Files Functions Variables Pages
global_parameters Module Reference

Global_Parameters collects some numbers which are useful in almost all of the program's routines. In this module, almost all variables are determined from the input file. More...

Public Attributes

integer, public dim_mctdh =1
 Dimensionality of the Orbitals in the treated problem. More...
 
integer, public morb =2
 The number of orbitals. More...
 
complex *16, public job_prefactor = dcmplx(-1.d0, 0.d0)
 Prefactor selecting relaxation or (backward) propagation. Relaxation for (-1.0,0.0), propagation for (0.0,-1.0), and backward propagation for (0.0,1.0). More...
 
character *4, public guess = 'HAND'
 Specify initial state of the calculation. 'binr' starts from binary files, 'hand' starts calling the routines Get_Initial_Coefficients and Get_Initial_Orbitals, 'data' starts from ASCII files. More...
 
character *3, public job_type = 'BOS'
 Do full configuration interaction ('FCI') or MCTDHB ('BOS') or MCTDHF ('FER') calculation. More...
 
logical, public do_oct = .FALSE.
 Do a parameter optimization with the CRAB optimal control algorithm. More...
 
logical, public oct_restart = .FALSE.
 Restart a previous OCT computation. More...
 
integer, public oct_nc = 0
 How many fourier components to take for CRAB. More...
 
real *8, dimension(10) oct_alpha = 0.8d0
 Weight of first part of cost functional. More...
 
real *8, dimension(20) oct_upperbounds = 0.d0
 Upper bounds for each of the Fourier components of the CRAB controls. More...
 
real *8, dimension(20) oct_lowerbounds = 0.d0
 Lower bounds for each of the Fourier components of the CRAB controls. More...
 
integer, public oct_ngoals = 0
 Number of goals for optimization. More...
 
real *8, dimension(10) oct_beta = 0.2d0
 Weight for the penalty for every goal in the cost functional. More...
 
integer, public oct_timesteps = 10000
 Number of time points for the representation of the control parameters. More...
 
real *8, public oct_func_tolerance =0.0001
 Error threshold for the convergence of the Optimal Control Functional. More...
 
real *8, public oct_crab_tolerance =0.0001
 Error threshold for the convergence of the Controls. More...
 
logical, public dcrab = .FALSE.
 instead of updating the controls multiplicatively, do it additively (then bounds are used to constrain Gamma) More...
 
logical, public do_fejer = .FALSE.
 use Fejer series instead of Fourier series for CRAB More...
 
logical, public simann = .FALSE.
 Toggle if simulated annealing is used to minimize the cost functional. More...
 
logical, public truncatednewton = .FALSE.
 Toggle if truncated Newton conjugate gradient method is used to minimize cost functional. More...
 
logical, public quasinewton = .FALSE.
 Toggle if Quasi-Newton method is used to minimize cost functional. More...
 
logical, public orb_binr = .FALSE.
 Restart from binary files,yes or no? More...
 
integer, public nprojections = 2
 Number of times to apply the projection operator in the orbital equations of motion in each timestep. More...
 
logical, public multi_level = .FALSE.
 Treat problem with multi-level orbitals. More...
 
integer, public nlevel = 1
 Number of levels if Multi_level computation. More...
 
logical, public interlevel_interparticle = .FALSE.
 Interlevel interparticle interactions in a multilevel computation. More...
 
logical, public spinor = .FALSE.
 Interlevel interparticle interaction is realized as a spin algebra? More...
 
logical, public spinorbit = .FALSE.
 Toggles inclusion of spin-orbit-interaction in the Hamiltonian. More...
 
real *8 rashba_prefactor
 Magnitude of Rashba-spin-orbit-interaction. More...
 
real *8 dresselhaus_prefactor
 Magnitude of Dresselhaus-spin-orbit-interaction. More...
 
real *8 spinorbit_prefactor
 Magnitude of total spin-orbit (== Rashba + Dresselhaus) term. More...
 
logical, public conical_intersection = .FALSE.
 If the different internal levels of the considered atoms are coupled through a conical intersection. More...
 
logical, public noninteracting = .FALSE.
 Treat a noninteracting system (2body Hamiltonian not evaluated at all) More...
 
real *8 xlambda1
 Intra-level interaction strength for multilevel computations. More...
 
real *8 xlambda2
 Intra-level interaction strength for multilevel computations. More...
 
real *8 xlambda12
 Inter-level interaction strength for multilevel computations. More...
 
real *8 xlambda3
 Intra-level interaction strength for multilevel computations. More...
 
real *8, dimension(10) lambda1
 array of interaction strengths used for the spin-independent part of the interparticle interaction for spinors More...
 
real *8, dimension(10) lambda2
 array of interaction strengths used for the spin-dependent part of the interparticle interaction for spinors Bose Hubbard Parameters Bose Hubbard Parameters More...
 
logical, public bose_hubbard =.FALSE.
 if Full CI computation is done, select to use Bose-Hubbard Hamiltonian. More...
 
logical, public periodic_bh =.FALSE.
 Bose-Hubbard Hamiltonian boundary conditions. More...
 
logical, public calculate_rho2 =.TRUE.
 Toggle calculation of the two-body density in Bose-Hubbard. More...
 
complex *16 bh_j = dcmplx(0.d0, 0.d0)
 Bose-Hubbard Hamiltonian coupling of nearest neighbors. More...
 
real *8 bh_u = 0.d0
 Bose-Hubbard Hamiltonian interparticle interaction. Bose Hubbard Parameters Bose Hubbard Parameters. More...
 
logical cavity_bec = .FALSE.
 toggle to couple the MCTDHB equations to a cavity field More...
 
integer ncavity_modes = 1
 Number of cavity modes. More...
 
real *8 cavity_pumprate = 0.d0
 Rate at which the cavity is pumped. More...
 
real *8 cavity_lossrate = 0.d0
 Rate at which it loses photons. More...
 
real *8 cavity_detuning = 0.d0
 Cavity detuning. More...
 
real *8 cavity_k0 = 0.d0
 Cavity resonance. More...
 
real *8 cavityatom_coupling = 0.d0
 Coupling strength of the atoms to the cavity. More...
 
real *8 x_cavity_pump_waist = 0.d0
 For 2D systems: X- Waist of pump beam. More...
 
real *8 cavity_mode_waist = 0.d0
 For 2D systems: Waist of cavity beam. More...
 
logical pump_switch = .FALSE.
 Smoothly switch on cavity pump laser. More...
 
real *8 rampuptime = 0.d0
 Rampup time for exponential ramp. More...
 
real *8 rampdowntime = 0.d0
 Rampdown time for exponential ramp. More...
 
real *8 plateautime = 0.d0
 Plateau time in pump power. More...
 
logical pump_oscillate = .FALSE.
 Pump power is oscillating when the plateau is reached? More...
 
real *8 pump_amplitude = 0.d0
 Amplitude of the oscillation of the pump's power as a fraction of Cavity_PumpRate. More...
 
real *8 pump_period = 0.d0
 At what period the power is oscillating. Cavity-BEC Parameters Cavity-BEC Parameters. More...
 
real *8 binary_start_time = 0.d0
 Starting time of binary files. More...
 
integer restart_state = 1
 From which state in a Block-diagonalization run to restart. More...
 
character *18, public restart_orbital_filename = ' '
 If Guess='data', this variable contains the filename of the ASCII file with the orbitals. More...
 
character *18, public restart_coefficients_filename = ' '
 If Guess='data', this variable contains the filename of the ASCII file with the coefficients. More...
 
logical, public coefficients_restart
 
logical, public orbital_restart
 
logical, public diagonalize_onebodyh = .FALSE.
 Diagonalize one-body Hamiltonian for initial orbitals. More...
 
logical, public fft_2d
 if ==true 2D FFTs are used instead of 1d FFTs More...
 
integer, public ndvr_x = 256
 Number of DVR functions for X dimension. More...
 
integer, public ndvr_y = 1
 Number of DVR functions for Y dimension. More...
 
integer, public ndvr_z = 1
 Number of DVR functions for Z dimension. More...
 
real *8, public time_begin = 0.d0
 Starting time in the writing of binary files. More...
 
real *8, public time_final = 10.d0
 Stopping time of the computation. More...
 
real *8, public time_max = 1.d99
 Maximal total time (main loop in the Master Process runs up to this time). More...
 
real *8, public output_timestep = 1.d0
 When to write data. More...
 
real *8, public output_coefficients = 1
 How often (in units of Output_TimeStep) the coefficients are written. More...
 
real *8, public integration_stepsize = 0.05d0
 Stepsize of the 7-step integration scheme. More...
 
real *8, public error_tolerance = 1.d-9
 Error tolerance in the 7-step integration scheme. More...
 
real *8, public minimal_occupation = 1.d-12
 Minimal allowed occupation in the inversion of the density matrix. More...
 
integer, public minimal_krylov = 4
 Minimal number of Krylov vectors in coefficients integrator. More...
 
integer, public maximal_krylov = 10
 Maximal number of Krylov vectors in coefficients integrator. More...
 
character *18, public orbital_integrator = 'RK'
 Orbital equations integration routine. Can be ABM,OMPABM,BS,RK or STIFF. More...
 
character *3, public coefficients_integrator = 'MCS'
 Coefficients equations integration routine. Can be MCS,DSL or DAV. More...
 
integer, public blocksize = 4
 If Block Davidson is used then this selects the number of coefficient vectors in the block. More...
 
real *8, public rlx_emin = -1.d90
 If Block Davidson is used then this selects the lower energy bound for the block. More...
 
real *8, public rlx_emax = 1.d90
 If Block Davidson is used then this selects the upper energy bound for the block. More...
 
logical, public olsen = .FALSE.
 If Block Davidson is used then this selects if the Olsen correction is applied. More...
 
integer, public orbital_integrator_order = 5
 Orbital Integration order for ABM<=8, for BS <=16, for RK 5 or 8, and for STIFF 1 or 2. More...
 
integer orbitalintegrator_steps
 Total number of steps needed to integrate Orbital equations. More...
 
real *8 orbital_integrator_maximalstep = 0.01d0
 Maximal integration step allowed. More...
 
logical, public write_ascii = .FALSE.
 Toggle output of ASCII data. More...
 
logical, public write_ft = .FALSE.
 Toggle output of ASCII data. More...
 
real *8 error_rescale_td = 1.d0
 Error rescaling for time-dependent potentials. More...
 
real *8 error_rescale_cavity = 1.d0
 Error rescaling for Cavity computations. More...
 
logical, public lz = .FALSE.
 Angular Momentum part in the Hamiltonian (ONLY 2D and 3D SUPPORTED). More...
 
logical, public fixed_lz = .FALSE.
 If the orbital angular momenta are fixed to the values specified in OrbLz. More...
 
integer, dimension(10) orblz
 Values, at which to fix the orbital angular momenta – if -666 is set, the respective orbital is not projected. More...
 
logical, public vortex_imprint
 Apply vortex profile augmented projection operator in relaxations. More...
 
logical, public vortex_seeding
 Multiply first orbital of initial state with vortex profile. More...
 
character *20 profile
 Select what functional dependence the profile has. More...
 
real *8, public omegaz = 0.d0
 Angular frequency, i.e. prefactor of the L_z operator in the Hamiltonian (ONLY 2D SUPPORTED). More...
 
integer, public state = 1
 Which state should be computed in a relaxation. More...
 
character *20 whichpot
 Variables for Get_1bodyPotential. More...
 
real *8 parameter1
 Parameter 1. More...
 
real *8 parameter2
 Parameter 2. More...
 
real *8 parameter3
 Parameter 3. More...
 
real *8 parameter4
 Parameter 4. More...
 
real *8 parameter5
 Parameter 5. More...
 
real *8 parameter6
 Parameter 6. More...
 
real *8 parameter7
 Parameter 7. More...
 
real *8 parameter8
 Parameter 8. More...
 
real *8 parameter9
 Parameter 8. More...
 
real *8 parameter10
 Parameter 10. More...
 
real *8 parameter11
 Parameter 11. More...
 
real *8 parameter12
 Parameter 12. More...
 
real *8 parameter13
 Parameter 13. More...
 
real *8 parameter14
 Parameter 14. More...
 
real *8 parameter15
 Parameter 15. More...
 
real *8 parameter16
 Parameter 16. More...
 
real *8 parameter17
 Parameter 17. More...
 
real *8 parameter18
 Parameter 18. More...
 
real *8 parameter19
 Parameter 19. More...
 
real *8 parameter20
 Parameter 20. More...
 
real *8 parameter21
 Parameter 21. More...
 
real *8 parameter22
 Parameter 22. More...
 
real *8 parameter23
 Parameter 23. More...
 
real *8 parameter24
 Parameter 24. More...
 
real *8 parameter25
 Parameter 25. More...
 
real *8 parameter26
 Parameter 26. More...
 
real *8 parameter27
 Parameter 27. More...
 
real *8 parameter28
 Parameter 28. More...
 
real *8 parameter29
 Parameter 29. More...
 
real *8 parameter30
 Parameter 30. More...
 
logical, public ci_v3 =.FALSE.
 
integer nproc_op1b
 
integer nproc_ci
 
integer nproc_op2b
 
character *20 which_interaction
 Select predefined Interaction potential. 'gauss' is a normalized Gaussian, 'HIM' is the harmonic interaction (acronym is Harmonic Interaction Model). More...
 
real *8 interaction_parameter1
 Interaction Parameter 1. More...
 
real *8 interaction_parameter2
 Interaction Parameter 2. More...
 
real *8 interaction_parameter3
 Interaction Parameter 3. More...
 
real *8 interaction_parameter4
 Interaction Parameter 4. More...
 
real *8 interaction_parameter5
 Interaction Parameter 5. More...
 
real *8 interaction_parameter6
 Interaction Parameter 6. More...
 
real *8 interaction_parameter7
 Interaction Parameter 7. More...
 
real *8 interaction_parameter8
 Interaction Parameter 8. More...
 
real *8 interaction_parameter9
 Interaction Parameter 8. More...
 
real *8 interaction_parameter10
 Interaction Parameter 10. More...
 
real *8 xlambda_0
 Interaction strength. More...
 
real *8 interaction_width
 Interaction Width in Gaussian interaction potential (input variable). More...
 
integer interaction_type
 Type of the interaction potential. Interaction_Type=0 means delta-contact interaction, 1 means the interaction potential is factorizable into the different spatial dimensions, 2 means the interaction depends only on the interparticle distance, 3 means the full interaction is represented on the full grid, 4 is like 2 but the IMEST (see Kaspars/Axels PhD) is used (should be a lot faster than Interaction_Type=2). More...
 
character *3, public previous_coefficients_integrator
 Global variable to handle IO from Block relaxations. More...
 
integer, public previous_blocksize
 Global variable to handle IO of Block diagonalizations. More...
 
real *8 energy
 
real *8, dimension(10) timecpu
 
integer, public ci_scf
 Slave processes work on Coefficients (CI_SCF=0) or slave processes work on Orbitals (CI_SCF=1). More...
 
complex *16, parameter zero =(0.0d0, 0.0d0)
 
complex *16, parameter zoner =(1.0d0, 0.0d0)
 
complex *16, parameter zonei =(0.0d0, 1.0d0)
 
real *8, parameter pi =3.141592653589793238462643d0
 
character *80, dimension(10),
parameter 
banner0 = (/ "@@@@@@@@@@ @@@@@@@ @@@@@@@ @@@@@@@ @@@ @@@ @@@ @@@" , "@@@@@@@@@@@ @@@@@@@@ @@@@@@@ @@@@@@@@ @@@ @@@ @@@ @@@" , "@@! @@! @@! !@@ @@! @@! @@@ @@! @@@ @@! !@@" , "!@! !@! !@! !@! !@! !@! @!@ "@ "!@! ! !@! !!! !!! !@! !!! " "::: :: ::: ::: :: :::: :: :: ::: :: :::" , " : : :: :: : : :: : : : : : : :: " /)
 

Detailed Description

Global_Parameters collects some numbers which are useful in almost all of the program's routines. In this module, almost all variables are determined from the input file.

Todo:
Create input data type to unify reading/writing from/to files.

Member Data Documentation

character*80, dimension(10), parameter global_parameters::banner0 = (/ "@@@@@@@@@@ @@@@@@@ @@@@@@@ @@@@@@@ @@@ @@@ @@@ @@@" , "@@@@@@@@@@@ @@@@@@@@ @@@@@@@ @@@@@@@@ @@@ @@@ @@@ @@@" , "@@! @@! @@! !@@ @@! @@! @@@ @@! @@@ @@! !@@" , "!@! !@! !@! !@! !@! !@! @!@ "@ "!@! ! !@! !!! !!! !@! !!! " "::: :: ::: ::: :: :::: :: :: ::: :: :::" , " : : :: :: : : :: : : : : : : :: " /)
complex*16 global_parameters::bh_j = dcmplx(0.d0, 0.d0)

Bose-Hubbard Hamiltonian coupling of nearest neighbors.

real*8 global_parameters::bh_u = 0.d0

Bose-Hubbard Hamiltonian interparticle interaction. Bose Hubbard Parameters Bose Hubbard Parameters.

real*8 global_parameters::binary_start_time = 0.d0

Starting time of binary files.

integer, public global_parameters::blocksize = 4

If Block Davidson is used then this selects the number of coefficient vectors in the block.

logical, public global_parameters::bose_hubbard =.FALSE.

if Full CI computation is done, select to use Bose-Hubbard Hamiltonian.

logical, public global_parameters::calculate_rho2 =.TRUE.

Toggle calculation of the two-body density in Bose-Hubbard.

logical global_parameters::cavity_bec = .FALSE.

toggle to couple the MCTDHB equations to a cavity field

real*8 global_parameters::cavity_detuning = 0.d0

Cavity detuning.

real*8 global_parameters::cavity_k0 = 0.d0

Cavity resonance.

real*8 global_parameters::cavity_lossrate = 0.d0

Rate at which it loses photons.

real*8 global_parameters::cavity_mode_waist = 0.d0

For 2D systems: Waist of cavity beam.

real*8 global_parameters::cavity_pumprate = 0.d0

Rate at which the cavity is pumped.

real*8 global_parameters::cavityatom_coupling = 0.d0

Coupling strength of the atoms to the cavity.

integer, public global_parameters::ci_scf

Slave processes work on Coefficients (CI_SCF=0) or slave processes work on Orbitals (CI_SCF=1).

logical, public global_parameters::ci_v3 =.FALSE.
character*3, public global_parameters::coefficients_integrator = 'MCS'

Coefficients equations integration routine. Can be MCS,DSL or DAV.

logical, public global_parameters::coefficients_restart
logical, public global_parameters::conical_intersection = .FALSE.

If the different internal levels of the considered atoms are coupled through a conical intersection.

logical, public global_parameters::dcrab = .FALSE.

instead of updating the controls multiplicatively, do it additively (then bounds are used to constrain Gamma)

logical, public global_parameters::diagonalize_onebodyh = .FALSE.

Diagonalize one-body Hamiltonian for initial orbitals.

integer, public global_parameters::dim_mctdh =1

Dimensionality of the Orbitals in the treated problem.

logical, public global_parameters::do_fejer = .FALSE.

use Fejer series instead of Fourier series for CRAB

logical, public global_parameters::do_oct = .FALSE.

Do a parameter optimization with the CRAB optimal control algorithm.

real*8 global_parameters::dresselhaus_prefactor

Magnitude of Dresselhaus-spin-orbit-interaction.

real*8 global_parameters::energy
real*8 global_parameters::error_rescale_cavity = 1.d0

Error rescaling for Cavity computations.

real*8 global_parameters::error_rescale_td = 1.d0

Error rescaling for time-dependent potentials.

real*8, public global_parameters::error_tolerance = 1.d-9

Error tolerance in the 7-step integration scheme.

logical, public global_parameters::fft_2d

if ==true 2D FFTs are used instead of 1d FFTs

logical, public global_parameters::fixed_lz = .FALSE.

If the orbital angular momenta are fixed to the values specified in OrbLz.

character*4, public global_parameters::guess = 'HAND'

Specify initial state of the calculation. 'binr' starts from binary files, 'hand' starts calling the routines Get_Initial_Coefficients and Get_Initial_Orbitals, 'data' starts from ASCII files.

real*8, public global_parameters::integration_stepsize = 0.05d0

Stepsize of the 7-step integration scheme.

real*8 global_parameters::interaction_parameter1

Interaction Parameter 1.

real*8 global_parameters::interaction_parameter10

Interaction Parameter 10.

real*8 global_parameters::interaction_parameter2

Interaction Parameter 2.

real*8 global_parameters::interaction_parameter3

Interaction Parameter 3.

real*8 global_parameters::interaction_parameter4

Interaction Parameter 4.

real*8 global_parameters::interaction_parameter5

Interaction Parameter 5.

real*8 global_parameters::interaction_parameter6

Interaction Parameter 6.

real*8 global_parameters::interaction_parameter7

Interaction Parameter 7.

real*8 global_parameters::interaction_parameter8

Interaction Parameter 8.

real*8 global_parameters::interaction_parameter9

Interaction Parameter 8.

integer global_parameters::interaction_type

Type of the interaction potential. Interaction_Type=0 means delta-contact interaction, 1 means the interaction potential is factorizable into the different spatial dimensions, 2 means the interaction depends only on the interparticle distance, 3 means the full interaction is represented on the full grid, 4 is like 2 but the IMEST (see Kaspars/Axels PhD) is used (should be a lot faster than Interaction_Type=2).

real*8 global_parameters::interaction_width

Interaction Width in Gaussian interaction potential (input variable).

logical, public global_parameters::interlevel_interparticle = .FALSE.

Interlevel interparticle interactions in a multilevel computation.

complex*16, public global_parameters::job_prefactor = dcmplx(-1.d0, 0.d0)

Prefactor selecting relaxation or (backward) propagation. Relaxation for (-1.0,0.0), propagation for (0.0,-1.0), and backward propagation for (0.0,1.0).

character*3, public global_parameters::job_type = 'BOS'

Do full configuration interaction ('FCI') or MCTDHB ('BOS') or MCTDHF ('FER') calculation.

real*8, dimension(10) global_parameters::lambda1

array of interaction strengths used for the spin-independent part of the interparticle interaction for spinors

real*8, dimension(10) global_parameters::lambda2

array of interaction strengths used for the spin-dependent part of the interparticle interaction for spinors Bose Hubbard Parameters Bose Hubbard Parameters

logical, public global_parameters::lz = .FALSE.

Angular Momentum part in the Hamiltonian (ONLY 2D and 3D SUPPORTED).

integer, public global_parameters::maximal_krylov = 10

Maximal number of Krylov vectors in coefficients integrator.

integer, public global_parameters::minimal_krylov = 4

Minimal number of Krylov vectors in coefficients integrator.

real*8, public global_parameters::minimal_occupation = 1.d-12

Minimal allowed occupation in the inversion of the density matrix.

integer, public global_parameters::morb =2

The number of orbitals.

logical, public global_parameters::multi_level = .FALSE.

Treat problem with multi-level orbitals.

integer global_parameters::ncavity_modes = 1

Number of cavity modes.

integer, public global_parameters::ndvr_x = 256

Number of DVR functions for X dimension.

integer, public global_parameters::ndvr_y = 1

Number of DVR functions for Y dimension.

integer, public global_parameters::ndvr_z = 1

Number of DVR functions for Z dimension.

integer, public global_parameters::nlevel = 1

Number of levels if Multi_level computation.

logical, public global_parameters::noninteracting = .FALSE.

Treat a noninteracting system (2body Hamiltonian not evaluated at all)

integer global_parameters::nproc_ci
integer global_parameters::nproc_op1b
integer global_parameters::nproc_op2b
integer, public global_parameters::nprojections = 2

Number of times to apply the projection operator in the orbital equations of motion in each timestep.

real*8, dimension(10) global_parameters::oct_alpha = 0.8d0

Weight of first part of cost functional.

real*8, dimension(10) global_parameters::oct_beta = 0.2d0

Weight for the penalty for every goal in the cost functional.

real*8, public global_parameters::oct_crab_tolerance =0.0001

Error threshold for the convergence of the Controls.

real*8, public global_parameters::oct_func_tolerance =0.0001

Error threshold for the convergence of the Optimal Control Functional.

real*8, dimension(20) global_parameters::oct_lowerbounds = 0.d0

Lower bounds for each of the Fourier components of the CRAB controls.

integer, public global_parameters::oct_nc = 0

How many fourier components to take for CRAB.

integer, public global_parameters::oct_ngoals = 0

Number of goals for optimization.

logical, public global_parameters::oct_restart = .FALSE.

Restart a previous OCT computation.

integer, public global_parameters::oct_timesteps = 10000

Number of time points for the representation of the control parameters.

real*8, dimension(20) global_parameters::oct_upperbounds = 0.d0

Upper bounds for each of the Fourier components of the CRAB controls.

logical, public global_parameters::olsen = .FALSE.

If Block Davidson is used then this selects if the Olsen correction is applied.

real*8, public global_parameters::omegaz = 0.d0

Angular frequency, i.e. prefactor of the L_z operator in the Hamiltonian (ONLY 2D SUPPORTED).

logical, public global_parameters::orb_binr = .FALSE.

Restart from binary files,yes or no?

character*18, public global_parameters::orbital_integrator = 'RK'

Orbital equations integration routine. Can be ABM,OMPABM,BS,RK or STIFF.

real*8 global_parameters::orbital_integrator_maximalstep = 0.01d0

Maximal integration step allowed.

integer, public global_parameters::orbital_integrator_order = 5

Orbital Integration order for ABM<=8, for BS <=16, for RK 5 or 8, and for STIFF 1 or 2.

logical, public global_parameters::orbital_restart
integer global_parameters::orbitalintegrator_steps

Total number of steps needed to integrate Orbital equations.

integer, dimension(10) global_parameters::orblz

Values, at which to fix the orbital angular momenta – if -666 is set, the respective orbital is not projected.

real*8, public global_parameters::output_coefficients = 1

How often (in units of Output_TimeStep) the coefficients are written.

real*8, public global_parameters::output_timestep = 1.d0

When to write data.

real*8 global_parameters::parameter1

Parameter 1.

real*8 global_parameters::parameter10

Parameter 10.

real*8 global_parameters::parameter11

Parameter 11.

real*8 global_parameters::parameter12

Parameter 12.

real*8 global_parameters::parameter13

Parameter 13.

real*8 global_parameters::parameter14

Parameter 14.

real*8 global_parameters::parameter15

Parameter 15.

real*8 global_parameters::parameter16

Parameter 16.

real*8 global_parameters::parameter17

Parameter 17.

real*8 global_parameters::parameter18

Parameter 18.

real*8 global_parameters::parameter19

Parameter 19.

real*8 global_parameters::parameter2

Parameter 2.

real*8 global_parameters::parameter20

Parameter 20.

real*8 global_parameters::parameter21

Parameter 21.

real*8 global_parameters::parameter22

Parameter 22.

real*8 global_parameters::parameter23

Parameter 23.

real*8 global_parameters::parameter24

Parameter 24.

real*8 global_parameters::parameter25

Parameter 25.

real*8 global_parameters::parameter26

Parameter 26.

real*8 global_parameters::parameter27

Parameter 27.

real*8 global_parameters::parameter28

Parameter 28.

real*8 global_parameters::parameter29

Parameter 29.

real*8 global_parameters::parameter3

Parameter 3.

real*8 global_parameters::parameter30

Parameter 30.

real*8 global_parameters::parameter4

Parameter 4.

real*8 global_parameters::parameter5

Parameter 5.

real*8 global_parameters::parameter6

Parameter 6.

real*8 global_parameters::parameter7

Parameter 7.

real*8 global_parameters::parameter8

Parameter 8.

real*8 global_parameters::parameter9

Parameter 8.

logical, public global_parameters::periodic_bh =.FALSE.

Bose-Hubbard Hamiltonian boundary conditions.

real*8, parameter global_parameters::pi =3.141592653589793238462643d0
real*8 global_parameters::plateautime = 0.d0

Plateau time in pump power.

integer, public global_parameters::previous_blocksize

Global variable to handle IO of Block diagonalizations.

character*3, public global_parameters::previous_coefficients_integrator

Global variable to handle IO from Block relaxations.

character*20 global_parameters::profile

Select what functional dependence the profile has.

real*8 global_parameters::pump_amplitude = 0.d0

Amplitude of the oscillation of the pump's power as a fraction of Cavity_PumpRate.

logical global_parameters::pump_oscillate = .FALSE.

Pump power is oscillating when the plateau is reached?

real*8 global_parameters::pump_period = 0.d0

At what period the power is oscillating. Cavity-BEC Parameters Cavity-BEC Parameters.

logical global_parameters::pump_switch = .FALSE.

Smoothly switch on cavity pump laser.

logical, public global_parameters::quasinewton = .FALSE.

Toggle if Quasi-Newton method is used to minimize cost functional.

real*8 global_parameters::rampdowntime = 0.d0

Rampdown time for exponential ramp.

real*8 global_parameters::rampuptime = 0.d0

Rampup time for exponential ramp.

real*8 global_parameters::rashba_prefactor

Magnitude of Rashba-spin-orbit-interaction.

character*18, public global_parameters::restart_coefficients_filename = ' '

If Guess='data', this variable contains the filename of the ASCII file with the coefficients.

character*18, public global_parameters::restart_orbital_filename = ' '

If Guess='data', this variable contains the filename of the ASCII file with the orbitals.

integer global_parameters::restart_state = 1

From which state in a Block-diagonalization run to restart.

real*8, public global_parameters::rlx_emax = 1.d90

If Block Davidson is used then this selects the upper energy bound for the block.

real*8, public global_parameters::rlx_emin = -1.d90

If Block Davidson is used then this selects the lower energy bound for the block.

logical, public global_parameters::simann = .FALSE.

Toggle if simulated annealing is used to minimize the cost functional.

logical, public global_parameters::spinor = .FALSE.

Interlevel interparticle interaction is realized as a spin algebra?

logical, public global_parameters::spinorbit = .FALSE.

Toggles inclusion of spin-orbit-interaction in the Hamiltonian.

real*8 global_parameters::spinorbit_prefactor

Magnitude of total spin-orbit (== Rashba + Dresselhaus) term.

integer, public global_parameters::state = 1

Which state should be computed in a relaxation.

real*8, public global_parameters::time_begin = 0.d0

Starting time in the writing of binary files.

real*8, public global_parameters::time_final = 10.d0

Stopping time of the computation.

real*8, public global_parameters::time_max = 1.d99

Maximal total time (main loop in the Master Process runs up to this time).

real*8, dimension(10) global_parameters::timecpu
logical, public global_parameters::truncatednewton = .FALSE.

Toggle if truncated Newton conjugate gradient method is used to minimize cost functional.

logical, public global_parameters::vortex_imprint

Apply vortex profile augmented projection operator in relaxations.

logical, public global_parameters::vortex_seeding

Multiply first orbital of initial state with vortex profile.

character*20 global_parameters::which_interaction

Select predefined Interaction potential. 'gauss' is a normalized Gaussian, 'HIM' is the harmonic interaction (acronym is Harmonic Interaction Model).

character*20 global_parameters::whichpot

Variables for Get_1bodyPotential.

logical, public global_parameters::write_ascii = .FALSE.

Toggle output of ASCII data.

logical, public global_parameters::write_ft = .FALSE.

Toggle output of ASCII data.

real*8 global_parameters::x_cavity_pump_waist = 0.d0

For 2D systems: X- Waist of pump beam.

real*8 global_parameters::xlambda1

Intra-level interaction strength for multilevel computations.

real*8 global_parameters::xlambda12

Inter-level interaction strength for multilevel computations.

real*8 global_parameters::xlambda2

Intra-level interaction strength for multilevel computations.

real*8 global_parameters::xlambda3

Intra-level interaction strength for multilevel computations.

real*8 global_parameters::xlambda_0

Interaction strength.

complex*16, parameter global_parameters::zero =(0.0d0, 0.0d0)
complex*16, parameter global_parameters::zonei =(0.0d0, 1.0d0)
complex*16, parameter global_parameters::zoner =(1.0d0, 0.0d0)

The documentation for this module was generated from the following file: