PB3D
[2.45]
Ideal linear high-n MHD stability in 3-D
|
Numerical variables used by most other modules. More...
Variables | |
integer, parameter, public | dp = REAL64 |
double precision More... | |
integer, parameter, public | dpi = INT64 |
double precision More... | |
real(dp), parameter, public | weight_dp = 0.008 |
size of double precision in kB More... | |
integer, parameter, public | max_str_ln = 120 |
maximum length of strings More... | |
integer, parameter, public | max_name_ln = 30 |
maximum length of filenames More... | |
integer, parameter, public | max_deriv = 2 |
highest derivatives for metric factors in Flux coords. More... | |
integer, public | prog_style |
program style (1: PB3D, 2: PB3D_POST) More... | |
character(len=4), public | prog_name |
name of program, used for info More... | |
character(len=3), parameter, public | output_name = 'out' |
name of output file More... | |
character(len=14), parameter, public | shell_commands_name = 'shell_commands' |
name of shell commands file More... | |
character(len=9), parameter, public | mem_usage_name = 'mem_usage' |
name of memory usage file More... | |
integer, public | mem_usage_count |
counter for memory usage output More... | |
real(dp), parameter, public | prog_version = 2.45_dp |
version number More... | |
real(dp), parameter, public | min_pb3d_version = 2.43_dp |
minimum PB3D version for POST More... | |
logical, public | debug_version = .true. |
debug version used More... | |
integer, public | rank |
MPI rank. More... | |
integer, public | n_procs |
nr. of MPI processes More... | |
integer, public | sol_n_procs |
nr. of MPI processes for solution with SLEPC More... | |
integer(kind=8), public | time_start |
start time of simulation More... | |
real(dp), public | max_tot_mem |
maximum total memory for all processes [MB] More... | |
real(dp), public | max_x_mem |
maximum memory for perturbation calculations for all processes [MB] More... | |
integer, dimension(:,:), allocatable, public | x_jobs_lims |
data about X jobs: [ \(\min_k\), \(\max_k\), \(\min_m\), \(\max_m\)] for all jobs More... | |
integer, dimension(:,:), allocatable, public | eq_jobs_lims |
data about eq jobs: [ \(\min_\theta\), \(\max_\theta\)] for all jobs More... | |
integer, public | x_job_nr |
nr. of X job More... | |
integer, public | eq_job_nr |
nr. of eq job More... | |
real(dp), parameter, public | mem_scale_fac = 6.0 |
empirical scale factor of memory to calculate eq compared to just storing it More... | |
real(dp), parameter, public | pi =4_dp*datan(1.0_dp) |
\(\pi\) More... | |
real(dp), parameter, public | mu_0_original = 4E-7_dp*pi |
permeability of free space More... | |
complex(dp), parameter, public | iu = (0, 1) |
complex unit More... | |
integer, public | ev_style |
determines the method used for solving an EV problem More... | |
integer, public | eq_style |
either 1 (VMEC) or 2 (HELENA) More... | |
integer, public | rho_style |
style for equilibrium density profile More... | |
integer, public | u_style |
style for calculation of U (1: ord.2, 2: ord.1, 1: ord.0) More... | |
integer, public | norm_style |
style for normalization More... | |
integer, public | k_style |
style for kinetic energy More... | |
integer, dimension(2), public | bc_style |
style for BC left and right More... | |
integer, public | x_style |
style for secondary mode numbers (1: prescribed, 2: fast) More... | |
integer, public | matrix_slepc_style |
style for matrix storage (1: sparse, 2: shell) More... | |
integer, public | solver_slepc_style |
style for solver (1: Krylov-Schur, 2: GD) More... | |
integer, public | post_style |
style for POST (1: extended grid, 2: B-aligned grid) More... | |
integer, public | x_grid_style |
style for normal component of X grid (1: eq, 2: sol, 3: enriched) More... | |
integer, public | alpha_style |
style for alpha (1: one field line, many turns, 2: many field lines, one turn) More... | |
integer, public | max_it_slepc |
maximum nr. of iterations for SLEPC More... | |
logical, public | plot_resonance |
whether to plot the q-profile or iota-profile with resonances More... | |
logical, public | plot_magn_grid |
whether to plot the grid in real coordinates More... | |
logical, public | plot_b |
whether to plot the magnetic field in real coordinates More... | |
logical, public | plot_j |
whether to plot the current in real coordinates More... | |
logical, public | plot_flux_q |
whether to plot flux quantities in real coordinates More... | |
logical, public | plot_kappa |
whether to plot curvature More... | |
logical, public | plot_sol_xi |
whether to plot plasma perturbation of solution in POST More... | |
logical, public | plot_sol_q |
whether to plot magnetic perturbation of solution in POST More... | |
logical, public | plot_vac_pot |
whether to plot vacuum potential in POST More... | |
logical, public | plot_e_rec |
whether to plot energy reconstruction in POST More... | |
logical, public | ltest |
whether or not to call the testing routines More... | |
logical, public | use_pol_flux_e |
whether poloidal flux is used in E coords. More... | |
logical, public | use_pol_flux_f |
whether poloidal flux is used in F coords. More... | |
logical, public | use_normalization |
whether to use normalization or not More... | |
real(dp), public | ev_bc |
value of artificial Eigenvalue for boundary condition More... | |
real(dp), public | ev_guess |
first guess for eigenvalue More... | |
real(dp), dimension(:), allocatable, public | tol_slepc |
tolerance for SLEPC for different Richardson levels More... | |
real(dp), public | max_njq_change |
maximum change of prim. mode number times saf. fac. / rot. transf. when using X_style 2 (fast) More... | |
integer, public | norm_disc_prec_eq |
precision for normal discretization for equilibrium More... | |
integer, public | norm_disc_prec_x |
precision for normal discretization for perturbation More... | |
integer, public | norm_disc_prec_sol |
precision for normal discretization for solution More... | |
integer, public | norm_disc_style_sol |
style for normal discretization for solution (1: central fin. diff., 2: left fin. diff.) More... | |
integer, public | magn_int_style |
style for magnetic integrals (1: trapezoidal, 2: Simpson 3/8) More... | |
integer, public | max_it_rich |
number of levels for Richardson extrapolation More... | |
real(dp), public | tol_rich |
tolerance for Richardson extrapolation More... | |
integer, public | max_it_zero |
maximum number of iterations to find zeros More... | |
integer, public | max_nr_backtracks_hh |
maximum number of backtracks for Householder, relax. factors More... | |
real(dp), public | tol_zero |
tolerance for zeros More... | |
real(dp), public | tol_norm |
tolerance for normal range (normalized to 0..1) More... | |
integer, parameter, public | ex_max_size = 10000 |
maximum size of matrices for external plot More... | |
character(len=max_str_ln), public | eq_name |
name of equilibrium file from VMEC or HELENA More... | |
character(len=max_str_ln), public | pb3d_name |
name of PB3D output file More... | |
logical, public | no_plots = .false. |
no plots made More... | |
logical, public | jump_to_sol = .false. |
jump to solution More... | |
logical, public | export_hel = .false. |
export HELENA More... | |
logical, public | plot_vmec_modes = .false. |
plot VMEC modes More... | |
logical, public | invert_top_bottom_h = .false. |
invert top and bottom for HELENA equilibria More... | |
logical, public | no_output = .false. |
no output shown More... | |
logical, public | post_output_full = .false. |
POST has output on full grids. More... | |
logical, public | post_output_sol = .false. |
POST has outputs of solution. More... | |
logical, public | do_execute_command_line = .false. |
call "execute_command_line" inside program More... | |
logical, public | print_mem_usage = .false. |
print memory usage is printed More... | |
logical, public | swap_angles = .false. |
swap angles theta and zeta in plots (only for POST) More... | |
logical, public | compare_tor_pos = .false. |
compare quantities at toroidal positions (only for POST) More... | |
logical, public | retain_all_sol |
retain also faulty solutions More... | |
character(len=5), public | plot_dir = 'Plots' |
directory where to save plots More... | |
character(len=7), public | script_dir = 'Scripts' |
directory where to save scripts for plots More... | |
character(len=4), public | data_dir = 'Data' |
directory where to save data for plots More... | |
integer, public | n_theta_plot |
nr. of poloidal points in plot More... | |
integer, public | n_zeta_plot |
nr. of toroidal points in plot More... | |
integer, dimension(2), public | n_vac_plot |
nr. of points in R and Z in vacuum More... | |
real(dp), public | min_theta_plot |
min. of theta_plot More... | |
real(dp), public | max_theta_plot |
max. of theta_plot More... | |
real(dp), public | min_zeta_plot |
min. of zeta_plot More... | |
real(dp), public | max_zeta_plot |
max. of zeta_plot More... | |
real(dp), public | min_r_plot |
min. of r_plot More... | |
real(dp), public | max_r_plot |
max. of r_plot More... | |
real(dp), public | min_rvac_plot |
min. of R in which to plot vacuum More... | |
real(dp), public | max_rvac_plot |
max. of R in which to plot vacuum More... | |
real(dp), public | min_zvac_plot |
min. of Z in which to plot vacuum More... | |
real(dp), public | max_zvac_plot |
max. of Z in which to plot vacuum More... | |
integer, public | plot_grid_style |
style for POST plot grid (0: 3-D plots, 1: slab plots, 2: slab plots with folding, 3: straight cylinder)) More... | |
integer, public | n_sol_requested |
how many solutions requested More... | |
integer, dimension(4), public | n_sol_plotted |
how many solutions to be plot (first unstable, last unstable, first stable, last stable) More... | |
integer, dimension(2), public | plot_size |
size of plot in inches More... | |
integer, public | rich_restart_lvl |
starting Richardson level (0: none [default]) More... | |
character(len=max_str_ln), public | input_name |
will hold the full name of the input file More... | |
integer, public | ex_plot_style |
external plot style (1: GNUPlot, 2: Bokeh for 2D, Mayavi for 3D) More... | |
real(dp), public | pert_mult_factor_post |
factor with which to multiply perturbation strength for POST More... | |
real(dp), dimension(2), public | rz_0 |
origin of geometrical poloidal coordinate More... | |
integer, parameter, public | input_i = 50 |
file number of input file More... | |
integer, parameter, public | eq_i = 51 |
file number of equilibrium file from VMEC or HELENA More... | |
integer, parameter, public | pb3d_i = 52 |
file number of PB3D output file More... | |
integer, parameter, public | output_i = 53 |
file number of output file More... | |
integer, parameter, public | shell_commands_i = 54 |
file number of shell commands file More... | |
integer, parameter, public | mem_usage_i = 55 |
file number of memory usage file More... | |
integer, parameter, public | output_ev_i = 56 |
file number of output of EV More... | |
integer, parameter, public | decomp_i = 57 |
file number of output of EV decomposition More... | |
integer, parameter, public | hel_export_i = 59 |
file number of output of HELENA equilibrium export file More... | |
integer, parameter, public | hel_pert_i = 58 |
file number of HELENA equilibrium perturbation file More... | |
integer, parameter, public | prop_b_tor_i = 60 |
file number of \(B_\phi\) proportionality factor file More... | |
Numerical variables used by most other modules.
integer, public num_vars::alpha_style |
style for alpha (1: one field line, many turns, 2: many field lines, one turn)
Definition at line 100 of file num_vars.f90.
integer, dimension(2), public num_vars::bc_style |
style for BC left and right
Definition at line 94 of file num_vars.f90.
logical, public num_vars::compare_tor_pos = .false. |
compare quantities at toroidal positions (only for POST)
Definition at line 151 of file num_vars.f90.
character(len=4), public num_vars::data_dir = 'Data' |
directory where to save data for plots
Definition at line 155 of file num_vars.f90.
logical public num_vars::debug_version = .true. |
integer, parameter, public num_vars::decomp_i = 57 |
file number of output of EV decomposition
Definition at line 189 of file num_vars.f90.
logical, public num_vars::do_execute_command_line = .false. |
call "execute_command_line" inside program
Definition at line 148 of file num_vars.f90.
integer, parameter, public num_vars::dp = REAL64 |
double precision
Definition at line 46 of file num_vars.f90.
integer, parameter, public num_vars::dpi = INT64 |
double precision
Definition at line 48 of file num_vars.f90.
integer, parameter, public num_vars::eq_i = 51 |
file number of equilibrium file from VMEC or HELENA
Definition at line 183 of file num_vars.f90.
integer, public num_vars::eq_job_nr |
nr. of eq job
Definition at line 79 of file num_vars.f90.
integer, dimension(:,:), allocatable, public num_vars::eq_jobs_lims |
data about eq jobs: [ \(\min_\theta\), \(\max_\theta\)] for all jobs
Definition at line 77 of file num_vars.f90.
character(len=max_str_ln), public num_vars::eq_name |
name of equilibrium file from VMEC or HELENA
Definition at line 138 of file num_vars.f90.
integer, public num_vars::eq_style |
either 1 (VMEC) or 2 (HELENA)
Definition at line 89 of file num_vars.f90.
real(dp), public num_vars::ev_bc |
value of artificial Eigenvalue for boundary condition
Definition at line 116 of file num_vars.f90.
real(dp), public num_vars::ev_guess |
first guess for eigenvalue
Definition at line 117 of file num_vars.f90.
integer, public num_vars::ev_style |
determines the method used for solving an EV problem
Definition at line 88 of file num_vars.f90.
integer, parameter, public num_vars::ex_max_size = 10000 |
maximum size of matrices for external plot
Definition at line 137 of file num_vars.f90.
integer, public num_vars::ex_plot_style |
external plot style (1: GNUPlot, 2: Bokeh for 2D, Mayavi for 3D)
Definition at line 175 of file num_vars.f90.
logical, public num_vars::export_hel = .false. |
export HELENA
Definition at line 142 of file num_vars.f90.
integer, parameter, public num_vars::hel_export_i = 59 |
file number of output of HELENA equilibrium export file
Definition at line 190 of file num_vars.f90.
integer, parameter, public num_vars::hel_pert_i = 58 |
file number of HELENA equilibrium perturbation file
Definition at line 191 of file num_vars.f90.
integer, parameter, public num_vars::input_i = 50 |
file number of input file
Definition at line 182 of file num_vars.f90.
character(len=max_str_ln), public num_vars::input_name |
will hold the full name of the input file
Definition at line 174 of file num_vars.f90.
logical, public num_vars::invert_top_bottom_h = .false. |
invert top and bottom for HELENA equilibria
Definition at line 144 of file num_vars.f90.
complex(dp), parameter, public num_vars::iu = (0, 1) |
complex unit
Definition at line 85 of file num_vars.f90.
logical, public num_vars::jump_to_sol = .false. |
jump to solution
Definition at line 141 of file num_vars.f90.
integer, public num_vars::k_style |
style for kinetic energy
Definition at line 93 of file num_vars.f90.
logical, public num_vars::ltest |
whether or not to call the testing routines
Definition at line 112 of file num_vars.f90.
integer, public num_vars::magn_int_style |
style for magnetic integrals (1: trapezoidal, 2: Simpson 3/8)
Definition at line 124 of file num_vars.f90.
integer, public num_vars::matrix_slepc_style |
style for matrix storage (1: sparse, 2: shell)
Definition at line 96 of file num_vars.f90.
integer, parameter, public num_vars::max_deriv = 2 |
highest derivatives for metric factors in Flux coords.
Definition at line 52 of file num_vars.f90.
integer, public num_vars::max_it_rich |
number of levels for Richardson extrapolation
Definition at line 127 of file num_vars.f90.
integer, public num_vars::max_it_slepc |
maximum nr. of iterations for SLEPC
Definition at line 101 of file num_vars.f90.
integer, public num_vars::max_it_zero |
maximum number of iterations to find zeros
Definition at line 131 of file num_vars.f90.
integer, parameter, public num_vars::max_name_ln = 30 |
maximum length of filenames
Definition at line 51 of file num_vars.f90.
real(dp), public num_vars::max_njq_change |
maximum change of prim. mode number times saf. fac. / rot. transf. when using X_style 2 (fast)
Definition at line 119 of file num_vars.f90.
integer, public num_vars::max_nr_backtracks_hh |
maximum number of backtracks for Householder, relax. factors
Definition at line 132 of file num_vars.f90.
real(dp), public num_vars::max_r_plot |
max. of r_plot
Definition at line 164 of file num_vars.f90.
real(dp), public num_vars::max_rvac_plot |
max. of R
in which to plot vacuum
Definition at line 166 of file num_vars.f90.
integer, parameter, public num_vars::max_str_ln = 120 |
maximum length of strings
Definition at line 50 of file num_vars.f90.
real(dp), public num_vars::max_theta_plot |
max. of theta_plot
Definition at line 160 of file num_vars.f90.
real(dp), public num_vars::max_tot_mem |
maximum total memory for all processes [MB]
Definition at line 74 of file num_vars.f90.
real(dp), public num_vars::max_x_mem |
maximum memory for perturbation calculations for all processes [MB]
Definition at line 75 of file num_vars.f90.
real(dp), public num_vars::max_zeta_plot |
max. of zeta_plot
Definition at line 162 of file num_vars.f90.
real(dp), public num_vars::max_zvac_plot |
max. of Z
in which to plot vacuum
Definition at line 168 of file num_vars.f90.
real(dp), parameter, public num_vars::mem_scale_fac = 6.0 |
empirical scale factor of memory to calculate eq compared to just storing it
Definition at line 80 of file num_vars.f90.
integer, public num_vars::mem_usage_count |
counter for memory usage output
Definition at line 58 of file num_vars.f90.
integer, parameter, public num_vars::mem_usage_i = 55 |
file number of memory usage file
Definition at line 187 of file num_vars.f90.
character(len=9), parameter, public num_vars::mem_usage_name = 'mem_usage' |
name of memory usage file
Definition at line 57 of file num_vars.f90.
real(dp), parameter, public num_vars::min_pb3d_version = 2.43_dp |
minimum PB3D version for POST
Definition at line 60 of file num_vars.f90.
real(dp), public num_vars::min_r_plot |
min. of r_plot
Definition at line 163 of file num_vars.f90.
real(dp), public num_vars::min_rvac_plot |
min. of R
in which to plot vacuum
Definition at line 165 of file num_vars.f90.
real(dp), public num_vars::min_theta_plot |
min. of theta_plot
Definition at line 159 of file num_vars.f90.
real(dp), public num_vars::min_zeta_plot |
min. of zeta_plot
Definition at line 161 of file num_vars.f90.
real(dp), public num_vars::min_zvac_plot |
min. of Z
in which to plot vacuum
Definition at line 167 of file num_vars.f90.
permeability of free space
Definition at line 84 of file num_vars.f90.
integer, public num_vars::n_procs |
nr. of MPI processes
Definition at line 69 of file num_vars.f90.
integer, dimension(4), public num_vars::n_sol_plotted |
how many solutions to be plot (first unstable, last unstable, first stable, last stable)
Definition at line 171 of file num_vars.f90.
integer, public num_vars::n_sol_requested |
how many solutions requested
Definition at line 170 of file num_vars.f90.
integer, public num_vars::n_theta_plot |
nr. of poloidal points in plot
Definition at line 156 of file num_vars.f90.
integer, dimension(2), public num_vars::n_vac_plot |
nr. of points in R and Z in vacuum
Definition at line 158 of file num_vars.f90.
integer, public num_vars::n_zeta_plot |
nr. of toroidal points in plot
Definition at line 157 of file num_vars.f90.
logical, public num_vars::no_output = .false. |
no output shown
Definition at line 145 of file num_vars.f90.
logical, public num_vars::no_plots = .false. |
no plots made
Definition at line 140 of file num_vars.f90.
integer, public num_vars::norm_disc_prec_eq |
precision for normal discretization for equilibrium
Definition at line 120 of file num_vars.f90.
integer, public num_vars::norm_disc_prec_sol |
precision for normal discretization for solution
Definition at line 122 of file num_vars.f90.
integer, public num_vars::norm_disc_prec_x |
precision for normal discretization for perturbation
Definition at line 121 of file num_vars.f90.
integer, public num_vars::norm_disc_style_sol |
style for normal discretization for solution (1: central fin. diff., 2: left fin. diff.)
Definition at line 123 of file num_vars.f90.
integer, public num_vars::norm_style |
style for normalization
Definition at line 92 of file num_vars.f90.
integer, parameter, public num_vars::output_ev_i = 56 |
file number of output of EV
Definition at line 188 of file num_vars.f90.
integer, parameter, public num_vars::output_i = 53 |
file number of output file
Definition at line 185 of file num_vars.f90.
character(len=3), parameter, public num_vars::output_name = 'out' |
name of output file
Definition at line 55 of file num_vars.f90.
integer, parameter, public num_vars::pb3d_i = 52 |
file number of PB3D output file
Definition at line 184 of file num_vars.f90.
character(len=max_str_ln), public num_vars::pb3d_name |
name of PB3D output file
Definition at line 139 of file num_vars.f90.
real(dp), public num_vars::pert_mult_factor_post |
factor with which to multiply perturbation strength for POST
Definition at line 176 of file num_vars.f90.
real(dp), parameter, public num_vars::pi =4_dp*datan(1.0_dp) |
\(\pi\)
Definition at line 83 of file num_vars.f90.
logical, public num_vars::plot_b |
whether to plot the magnetic field in real coordinates
Definition at line 104 of file num_vars.f90.
character(len=5), public num_vars::plot_dir = 'Plots' |
directory where to save plots
Definition at line 153 of file num_vars.f90.
logical, public num_vars::plot_e_rec |
whether to plot energy reconstruction in POST
Definition at line 111 of file num_vars.f90.
logical, public num_vars::plot_flux_q |
whether to plot flux quantities in real coordinates
Definition at line 106 of file num_vars.f90.
integer, public num_vars::plot_grid_style |
style for POST plot grid (0: 3-D plots, 1: slab plots, 2: slab plots with folding, 3: straight cylinder))
Definition at line 169 of file num_vars.f90.
logical, public num_vars::plot_j |
whether to plot the current in real coordinates
Definition at line 105 of file num_vars.f90.
logical, public num_vars::plot_kappa |
whether to plot curvature
Definition at line 107 of file num_vars.f90.
logical, public num_vars::plot_magn_grid |
whether to plot the grid in real coordinates
Definition at line 103 of file num_vars.f90.
logical, public num_vars::plot_resonance |
whether to plot the q-profile or iota-profile with resonances
Definition at line 102 of file num_vars.f90.
integer, dimension(2), public num_vars::plot_size |
size of plot in inches
Definition at line 172 of file num_vars.f90.
logical, public num_vars::plot_sol_q |
whether to plot magnetic perturbation of solution in POST
Definition at line 109 of file num_vars.f90.
logical, public num_vars::plot_sol_xi |
whether to plot plasma perturbation of solution in POST
Definition at line 108 of file num_vars.f90.
logical, public num_vars::plot_vac_pot |
whether to plot vacuum potential in POST
Definition at line 110 of file num_vars.f90.
logical, public num_vars::plot_vmec_modes = .false. |
plot VMEC modes
Definition at line 143 of file num_vars.f90.
logical, public num_vars::post_output_full = .false. |
POST has output on full grids.
Definition at line 146 of file num_vars.f90.
logical, public num_vars::post_output_sol = .false. |
POST has outputs of solution.
Definition at line 147 of file num_vars.f90.
integer, public num_vars::post_style |
style for POST (1: extended grid, 2: B-aligned grid)
Definition at line 98 of file num_vars.f90.
logical, public num_vars::print_mem_usage = .false. |
print memory usage is printed
Definition at line 149 of file num_vars.f90.
character(len=4), public num_vars::prog_name |
name of program, used for info
Definition at line 54 of file num_vars.f90.
integer, public num_vars::prog_style |
program style (1: PB3D, 2: PB3D_POST)
Definition at line 53 of file num_vars.f90.
real(dp), parameter, public num_vars::prog_version = 2.45_dp |
version number
Definition at line 59 of file num_vars.f90.
integer, parameter, public num_vars::prop_b_tor_i = 60 |
file number of \(B_\phi\) proportionality factor file
Definition at line 192 of file num_vars.f90.
integer, public num_vars::rank |
MPI rank.
Definition at line 68 of file num_vars.f90.
logical, public num_vars::retain_all_sol |
retain also faulty solutions
Definition at line 152 of file num_vars.f90.
integer, public num_vars::rho_style |
style for equilibrium density profile
Definition at line 90 of file num_vars.f90.
integer, public num_vars::rich_restart_lvl |
starting Richardson level (0: none [default])
Definition at line 173 of file num_vars.f90.
real(dp), dimension(2), public num_vars::rz_0 |
origin of geometrical poloidal coordinate
Definition at line 179 of file num_vars.f90.
character(len=7), public num_vars::script_dir = 'Scripts' |
directory where to save scripts for plots
Definition at line 154 of file num_vars.f90.
integer, parameter, public num_vars::shell_commands_i = 54 |
file number of shell commands file
Definition at line 186 of file num_vars.f90.
character(len=14), parameter, public num_vars::shell_commands_name = 'shell_commands' |
name of shell commands file
Definition at line 56 of file num_vars.f90.
integer, public num_vars::sol_n_procs |
nr. of MPI processes for solution with SLEPC
Definition at line 70 of file num_vars.f90.
integer, public num_vars::solver_slepc_style |
style for solver (1: Krylov-Schur, 2: GD)
Definition at line 97 of file num_vars.f90.
logical, public num_vars::swap_angles = .false. |
swap angles theta and zeta in plots (only for POST)
Definition at line 150 of file num_vars.f90.
integer(kind=8), public num_vars::time_start |
start time of simulation
Definition at line 71 of file num_vars.f90.
real(dp), public num_vars::tol_norm |
tolerance for normal range (normalized to 0..1)
Definition at line 134 of file num_vars.f90.
real(dp), public num_vars::tol_rich |
tolerance for Richardson extrapolation
Definition at line 128 of file num_vars.f90.
real(dp), dimension(:), allocatable, public num_vars::tol_slepc |
tolerance for SLEPC for different Richardson levels
Definition at line 118 of file num_vars.f90.
real(dp), public num_vars::tol_zero |
tolerance for zeros
Definition at line 133 of file num_vars.f90.
integer, public num_vars::u_style |
style for calculation of U (1: ord.2, 2: ord.1, 1: ord.0)
Definition at line 91 of file num_vars.f90.
logical, public num_vars::use_normalization |
whether to use normalization or not
Definition at line 115 of file num_vars.f90.
logical, public num_vars::use_pol_flux_e |
whether poloidal flux is used in E coords.
Definition at line 113 of file num_vars.f90.
logical, public num_vars::use_pol_flux_f |
whether poloidal flux is used in F coords.
Definition at line 114 of file num_vars.f90.
real(dp), parameter, public num_vars::weight_dp = 0.008 |
size of double precision in kB
Definition at line 49 of file num_vars.f90.
integer, public num_vars::x_grid_style |
style for normal component of X grid (1: eq, 2: sol, 3: enriched)
Definition at line 99 of file num_vars.f90.
integer, public num_vars::x_job_nr |
nr. of X job
Definition at line 78 of file num_vars.f90.
integer, dimension(:,:), allocatable, public num_vars::x_jobs_lims |
data about X jobs: [ \(\min_k\), \(\max_k\), \(\min_m\), \(\max_m\)] for all jobs
Definition at line 76 of file num_vars.f90.
integer, public num_vars::x_style |
style for secondary mode numbers (1: prescribed, 2: fast)
Definition at line 95 of file num_vars.f90.