WARPXM v1.10.0
Loading...
Searching...
No Matches
sheath Namespace Reference

Variables

str torder = 'SSPRK3'
 
str sorder = 'thirdOrder'
 
float cfl = 0.209
 
str mesh_res = '32x192x32'
 
meshfile = f'sheath_mesh_{mesh_res}.inp'
 
warpy mesh
 
float density_min = 0.01
 
float pressure_min = 0.01
 
float gamma = 3.0
 
bool use_limiter_mr = False
 
int limiter_alpha_coefficient = 2.
 
bool use_phmaxwell = False
 
float phchi = 1.5
 
float phgamma = phchi
 
argparse parser = argparse.ArgumentParser(description='1d Sheath problem')
 
 type
 
 str
 
 nargs
 
 help
 
 default
 
argparse args = parser.parse_args()
 
argparse model = args.model
 
list tf_sds = ['middle']
 
list tf_vds = ['left','right']
 
list kinetic_sds = ['left','right']
 
list kinetic_vds = ['middle']
 
 else :
 
float qe = 1.602177e-19
 
float mp = 1.672622e-27
 
float mu0 = 1.256637e-6
 
float eps0 = 8.854187e-12
 
int c_light = 1/(mu0*eps0)**.5
 
tuple L_debye = (eps0*qe*1/(1e19*qe**2))**0.5
 
tuple L = L_debye
 
float ompt = 1.0
 
float omct = 3.265e-5
 
float c_tilde = ompt/omct
 
int skin_depth_norm = 1/omct
 
float omega_p_norm = ompt
 
float n0 = mp*omct**2/(mu0*L**2*qe**2)
 
float tau = ompt*L/(omct*c_light)
 
float b0 = mp*c_light*omct**2/(qe*L*ompt)
 
float e0 = b0**2/mu0
 
float T0 = e0/(n0*qe)
 
float Z_i = +1.0
 
float Z_e = -1.0
 
float mass_ratio = 1836.0
 
float A_i = 1.0
 
float A_e = A_i / mass_ratio
 
float n_i = 1.0
 
float n_e = 1.0
 
float rho_i = A_i * n_i
 
float rho_e = A_e * n_e
 
float charge_to_mass_ion = Z_i/A_i
 
float charge_to_mass_electron = Z_e/A_e
 
int T_i = 10
 
int T_e = 10
 
float P_i = n_i * T_i
 
float P_e = n_e * T_e
 
math v_th_i = math.sqrt(P_i/A_i/n_i)
 
math v_th_e = math.sqrt(P_e/A_e/n_e)
 
float nu_p_tau_bgk = 1.0
 
float vth_factor = +6.0
 
list v_space_num_elements = [48]
 
list min_v_ion = [-vth_factor*v_th_i]
 
list dv_ion = [0.25* v_th_i]
 
list min_v_electron = [-vth_factor*v_th_e]
 
list dv_electron = [0.25* v_th_e]
 
list fluid_comps = ['rho', 'px', 'py', 'pz', 'e']
 
list field_comps = ['Ex', 'Ey', 'Ez', 'Bx', 'By', 'Bz']
 
warpy ions
 
warpy electrons
 
warpy field
 
warpy electron_distribution
 
warpy ion_distribution
 
warpy kinetic_electron_fluid
 
warpy kinetic_ion_fluid
 
warpy ion_maxwellian_distribution
 
warpy electron_maxwellian_distribution
 
warpy chi_metric_i
 
warpy chi_metric_e
 
tuple ic_fun_i
 
tuple ic_fun_e
 
tuple ic_fun_EM
 
warpy electron_ic
 
warpy ion_ic
 
warpy ic_fun_i_va
 
warpy ic_fun_e_va
 
warpy ic_fun_EM_va
 
warpy electron_ic_va
 
warpy ion_ic_va
 
warpy tf_ic_ha
 
warpy field_ic_ha
 
warpy distribution_ic_ha
 
list ic_ha = []
 
list bc_apps = []
 
list values_in = [A_e*1e-4,0,0,0,1e-4/(gamma-1)]
 
list electron_distribution_wall_bcs = []
 
list ion_distribution_wall_bcs = []
 
list maxwell_bcs = []
 
list virtual_bc_apps_tf = []
 
list virtual_bc_apps_kinetic_ions = []
 
list virtual_bc_apps_kinetic_electrons = []
 
list applications_moments_ions = []
 
list applications_moments_electrons = []
 
list applications_2nd_moments_ions = []
 
list applications_2nd_moments_electrons = []
 
list applications_maxwellian_metric_ions = []
 
list applications_maxwellian_metric_electrons = []
 
list limiter_apps_electron = []
 
list limiter_apps_ion = []
 
list variable_adjusters_tf = []
 
list variable_adjusters_kinetic = []
 
list kinetic_to_tf_va = []
 
list tf_to_kinetic_va_ions = []
 
list tf_to_kinetic_va_electrons = []
 
warpy ion_timestep_start_moment_taker
 add these same moment takers that can be done at the beginning of each timestep before writeout
 
warpy electron_timestep_start_moment_taker
 
warpy ion_timestep_start_second_moment_taker
 
warpy electron_timestep_start_second_moment_taker
 
warpy ion_timestep_start_chi_metric_moment_taker
 
warpy electron_timestep_start_chi_metric_moment_taker
 
list extra_timestep_start_writer = []
 
warpy moment_takers_timestep_start_ha
 
warpy fluid_ions_to_maxwellian_function
 
warpy fluid_electrons_to_maxwellian_function
 
list maxwellian_evalution_timestep_start_va = []
 add these maxwellian conversions that can be done at the beginning of each timestep before writeout
 
warpy maxwellian_evaluation_timestep_start_ha
 
list solver_apps_tf = []
 
list solver_apps_maxwell_flux = []
 
list solver_apps_maxwell_tf_fluid_source = []
 
list solver_apps_maxwell_kinetic_fluid_source = []
 
list apps_kinetic_ions = []
 
list apps_kinetic_electrons = []
 
warpy spatial_solver_tf
 Spatial solver.
 
warpy spatial_solver_kinetic_ions
 
warpy spatial_solver_kinetic_electrons
 
warpy spatial_solver_kinetic_field
 
list ss_s = [spatial_solver_tf]
 
list va_s = variable_adjusters_tf
 
warpy time_integrator = warpy.host_actions.erk(name="ti", scheme=torder, spatial_solvers=ss_s, variable_adjusters=va_s)
 
list write_vars = [ions, electrons, field]
 
warpy writer
 
int dt = 1e-4
 Simulation (dg) dt = 1e-6.
 
tuple ompe = (1e19*qe**2/(eps0*A_e*mp))**0.5
 
float t_final = 20.0/ompe/tau
 
warpy dt_controller = warpy.dt_calc.stability_dt(dt)
 
int write_steps = 100
 
datetime now = datetime.datetime.now().strftime("%Y_%m_%d")
 
sim_name = f'sheath_vm_{v_space_num_elements[0]}_{mesh_res}_{model}'
 
warpy config_args = warpy.load_configs()
 
warpy case_loc = config_args['test_rundir'](f'hybrid/sheath/{now}', '')
 
sim_param
 
warpy sim
 
 gen_xdmf
 Run Simulation ...
 
 detect_nonscalar
 

Variable Documentation

◆ A_e

float sheath.A_e = A_i / mass_ratio

◆ A_i

float sheath.A_i = 1.0

◆ applications_2nd_moments_electrons

list sheath.applications_2nd_moments_electrons = []

◆ applications_2nd_moments_ions

list sheath.applications_2nd_moments_ions = []

◆ applications_maxwellian_metric_electrons

list sheath.applications_maxwellian_metric_electrons = []

◆ applications_maxwellian_metric_ions

list sheath.applications_maxwellian_metric_ions = []

◆ applications_moments_electrons

list sheath.applications_moments_electrons = []

◆ applications_moments_ions

list sheath.applications_moments_ions = []

◆ apps_kinetic_electrons

list sheath.apps_kinetic_electrons = []

◆ apps_kinetic_ions

list sheath.apps_kinetic_ions = []

◆ args

argparse sheath.args = parser.parse_args()

◆ b0

float sheath.b0 = mp*c_light*omct**2/(qe*L*ompt)

◆ bc_apps

list sheath.bc_apps = []

◆ c_light

int sheath.c_light = 1/(mu0*eps0)**.5

◆ c_tilde

float sheath.c_tilde = ompt/omct

◆ case_loc

warpy sheath.case_loc = config_args['test_rundir'](f'hybrid/sheath/{now}', '')

◆ cfl

float sheath.cfl = 0.209

◆ charge_to_mass_electron

float sheath.charge_to_mass_electron = Z_e/A_e

◆ charge_to_mass_ion

float sheath.charge_to_mass_ion = Z_i/A_i

◆ chi_metric_e

warpy sheath.chi_metric_e
Initial value:
1= warpy.variable(name = 'chi_metric_e',
2 components = ['chi'],
3 basis_array_set = sorder,
4 subdomains = kinetic_sds,
5 virtual_subdomains=kinetic_vds,
6 explodable=False)
Definition: variable.py:4

◆ chi_metric_i

warpy sheath.chi_metric_i
Initial value:
1= warpy.variable(name = 'chi_metric_i',
2 components = ['chi'],
3 basis_array_set = sorder,
4 subdomains = kinetic_sds,
5 virtual_subdomains=kinetic_vds,
6 explodable=False)

◆ config_args

warpy sheath.config_args = warpy.load_configs()

◆ default

sheath.default

◆ density_min

float sheath.density_min = 0.01

◆ detect_nonscalar

sheath.detect_nonscalar

◆ distribution_ic_ha

warpy sheath.distribution_ic_ha
Initial value:
1= warpy.host_actions.va_runner("distribution_ic_ha",
2 variable_adjusters=[electron_ic_va, ion_ic_va])
Runs a list of host actions.
Definition: va_runner.py:5

◆ dt

int sheath.dt = 1e-4

Simulation (dg) dt = 1e-6.

◆ dt_controller

warpy sheath.dt_controller = warpy.dt_calc.stability_dt(dt)

◆ dv_electron

list sheath.dv_electron = [0.25* v_th_e]

◆ dv_ion

list sheath.dv_ion = [0.25* v_th_i]

◆ e0

float sheath.e0 = b0**2/mu0

◆ electron_distribution

warpy sheath.electron_distribution
Initial value:
1= warpy.variable(name = 'electron_distribution',
2 components = ['f'],
3 basis_array_set = sorder,
4 phase_space_basis_array_set = sorder,
5 v_space_num_elements = v_space_num_elements,
6 subdomains=kinetic_sds,
7 virtual_subdomains=kinetic_vds)

◆ electron_distribution_wall_bcs

list sheath.electron_distribution_wall_bcs = []

◆ electron_ic

warpy sheath.electron_ic
Initial value:
2 distribution=electron_distribution,
3 mass=A_e,
4 density=n_e*A_e,
5 velocity=[0,0,0],
6 pressure=P_e)
Function which sets a maxwellian distribution.
Definition: kinetics.py:127

◆ electron_ic_va

warpy sheath.electron_ic_va
Initial value:
2 priority=0,
3 spatial_order=sorder,
4 phase_space_spatial_order=sorder,
5 v_space_num_elements = v_space_num_elements,
6 min_v = min_v_electron,
7 dv = dv_electron,
8 on_subdomains=kinetic_sds,
9 applications=[electron_ic])
phase_space function evaluator
Definition: function_evaluation.py:42

◆ electron_maxwellian_distribution

warpy sheath.electron_maxwellian_distribution
Initial value:
1= warpy.variable(name = 'electron_maxwellian_distribution',
2 components = ['f'],
3 basis_array_set = sorder,
4 phase_space_basis_array_set = sorder,
5 v_space_num_elements = v_space_num_elements,
6 subdomains=tf_sds,
7 virtual_subdomains=tf_vds,
8 explodable=False)

◆ electron_timestep_start_chi_metric_moment_taker

warpy sheath.electron_timestep_start_chi_metric_moment_taker
Initial value:
1= warpy.variable_adjusters.moment_takers.velocity_space_moment_taker(name = 'moment_taker_chi_electrons_timestep_start',
2 priority = 3,
3 spatial_order=sorder,
4 phase_space_basis_array_set=sorder,
5 v_space_num_elements = v_space_num_elements,
6 min_v = min_v_electron,
7 dv = dv_electron,
8 applications = applications_maxwellian_metric_electrons,
9 on_subdomains = kinetic_sds
10)
velocity_space_moment_taker takes moments in velocity space
Definition: moment_takers.py:48

◆ electron_timestep_start_moment_taker

warpy sheath.electron_timestep_start_moment_taker
Initial value:
1= warpy.variable_adjusters.moment_takers.velocity_space_moment_taker(name='moment_taker_electrons_timestep_start',
2 priority=1,
3 spatial_order=sorder,
4 phase_space_basis_array_set = sorder,
5 v_space_num_elements = v_space_num_elements,
6 min_v = min_v_electron,
7 dv = dv_electron,
8 applications=applications_moments_electrons,
9 on_subdomains=kinetic_sds
10)

◆ electron_timestep_start_second_moment_taker

warpy sheath.electron_timestep_start_second_moment_taker
Initial value:
1= warpy.variable_adjusters.moment_takers.velocity_space_moment_taker(name='second_moment_taker_electrons_timestep_start',
2 priority=2,
3 spatial_order=sorder,
4 phase_space_basis_array_set = sorder,
5 v_space_num_elements = v_space_num_elements,
6 min_v = min_v_electron,
7 dv = dv_electron,
8 applications=applications_2nd_moments_electrons,
9 on_subdomains=kinetic_sds
10)

◆ electrons

warpy sheath.electrons
Initial value:
1= warpy.variable(name='electrons',
2 components=fluid_comps,
3 basis_array_set=sorder,
4 subdomains=tf_sds,
5 virtual_subdomains=tf_vds)

◆ else

sheath.else :

◆ eps0

float sheath.eps0 = 8.854187e-12

◆ extra_timestep_start_writer

list sheath.extra_timestep_start_writer = []

◆ field

warpy sheath.field
Initial value:
1= warpy.variable(name='field',
2 components=field_comps,
3 basis_array_set=sorder,
4 subdomains=['left','middle','right'],
5 virtual_subdomains=None
6 )

◆ field_comps

list sheath.field_comps = ['Ex', 'Ey', 'Ez', 'Bx', 'By', 'Bz']

◆ field_ic_ha

warpy sheath.field_ic_ha
Initial value:
1= warpy.host_actions.va_runner(name="field_ic_ha",
2 variable_adjusters=[ic_fun_EM_va])

◆ fluid_comps

list sheath.fluid_comps = ['rho', 'px', 'py', 'pz', 'e']

◆ fluid_electrons_to_maxwellian_function

warpy sheath.fluid_electrons_to_maxwellian_function
Initial value:
1= warpy.apps.functions.five_moment_to_kinetic(name='fluid_electrons_to_maxwellian',
2 mass=A_e,
3 gamma=gamma,
4 fluid=electrons,
5 distribution = electron_maxwellian_distribution)
5-moment to Kinetic
Definition: kinetics.py:164

◆ fluid_ions_to_maxwellian_function

warpy sheath.fluid_ions_to_maxwellian_function
Initial value:
1= warpy.apps.functions.five_moment_to_kinetic(name='fluid_ions_to_maxwellian',
2 mass=A_i,
3 gamma=gamma,
4 fluid=ions,
5 distribution = ion_maxwellian_distribution)

◆ gamma

float sheath.gamma = 3.0

◆ gen_xdmf

sheath.gen_xdmf

Run Simulation ...

◆ help

sheath.help

◆ ic_fun_e

tuple sheath.ic_fun_e
Initial value:
1= (
3 fluid=electrons,
4 ic_type=2,
5 var_type=1,
6 params=[gamma, A_e, n_e, T_e]))
Function which sets IC for 5-moment electron-ion-neutral problem.
Definition: five_moment.py:169

◆ ic_fun_e_va

warpy sheath.ic_fun_e_va
Initial value:
2 priority=0,
3 spatial_order=sorder,
4 on_subdomains=tf_sds,
5 applications=[ic_fun_e])
function evaluator
Definition: function_evaluation.py:4

◆ ic_fun_EM

tuple sheath.ic_fun_EM
Initial value:
1= (
3 fields=field,
4 fields_components=['Ex', 'Ey', 'Ez', 'Bx', 'By', 'Bz'],
5 ic_type=1))
Function which sets IC for EM fields in 5-moment electron-ion-neutral problem.
Definition: maxwell.py:4

◆ ic_fun_EM_va

warpy sheath.ic_fun_EM_va
Initial value:
2 priority=0,
3 spatial_order=sorder,
4 on_subdomains=['all'],
5 applications=[ic_fun_EM])

◆ ic_fun_i

tuple sheath.ic_fun_i
Initial value:
1= (
3 fluid=ions,
4 ic_type=2,
5 var_type=2,
6 params = [gamma, A_i, n_i, T_i]))

◆ ic_fun_i_va

warpy sheath.ic_fun_i_va
Initial value:
2 priority=0,
3 spatial_order=sorder,
4 on_subdomains=tf_sds,
5 applications=[ic_fun_i])

◆ ic_ha

list sheath.ic_ha = []

◆ ion_distribution

warpy sheath.ion_distribution
Initial value:
1= warpy.variable(name = 'ion_distribution',
2 components = ['f'],
3 basis_array_set = sorder,
4 phase_space_basis_array_set = sorder,
5 v_space_num_elements = v_space_num_elements,
6 subdomains=kinetic_sds,
7 virtual_subdomains=kinetic_vds)

◆ ion_distribution_wall_bcs

list sheath.ion_distribution_wall_bcs = []

◆ ion_ic

warpy sheath.ion_ic
Initial value:
2 distribution=ion_distribution,
3 mass=A_i,
4 density=n_i*A_i,
5 velocity=[0,0,0],
6 pressure=P_i)

◆ ion_ic_va

warpy sheath.ion_ic_va
Initial value:
2 priority=0,
3 spatial_order=sorder,
4 phase_space_spatial_order=sorder,
5 v_space_num_elements = v_space_num_elements,
6 min_v = min_v_ion,
7 dv = dv_ion,
8 on_subdomains=kinetic_sds,
9 applications=[ion_ic])

◆ ion_maxwellian_distribution

warpy sheath.ion_maxwellian_distribution
Initial value:
1= warpy.variable(name = 'ion_maxwellian_distribution',
2 components = ['f'],
3 basis_array_set = sorder,
4 phase_space_basis_array_set = sorder,
5 v_space_num_elements = v_space_num_elements,
6 subdomains=tf_sds,
7 virtual_subdomains=tf_vds,
8 explodable=False)

◆ ion_timestep_start_chi_metric_moment_taker

warpy sheath.ion_timestep_start_chi_metric_moment_taker
Initial value:
1= warpy.variable_adjusters.moment_takers.velocity_space_moment_taker(name = 'moment_taker_chi_ions_timestep_start',
2 priority = 3,
3 spatial_order=sorder,
4 phase_space_basis_array_set=sorder,
5 v_space_num_elements = v_space_num_elements,
6 min_v = min_v_ion,
7 dv = dv_ion,
8 applications = applications_maxwellian_metric_ions,
9 on_subdomains = kinetic_sds
10)

◆ ion_timestep_start_moment_taker

warpy sheath.ion_timestep_start_moment_taker
Initial value:
1= warpy.variable_adjusters.moment_takers.velocity_space_moment_taker(name='moment_taker_ions_timestep_start',
2 priority=1,
3 spatial_order=sorder,
4 phase_space_basis_array_set = sorder,
5 v_space_num_elements = v_space_num_elements,
6 min_v = min_v_ion,
7 dv = dv_ion,
8 applications=applications_moments_ions,
9 on_subdomains=kinetic_sds
10)

add these same moment takers that can be done at the beginning of each timestep before writeout

◆ ion_timestep_start_second_moment_taker

warpy sheath.ion_timestep_start_second_moment_taker
Initial value:
1= warpy.variable_adjusters.moment_takers.velocity_space_moment_taker(name='second_moment_taker_ions_timestep_start',
2 priority=2,
3 spatial_order=sorder,
4 phase_space_basis_array_set = sorder,
5 v_space_num_elements = v_space_num_elements,
6 min_v = min_v_ion,
7 dv = dv_ion,
8 applications=applications_2nd_moments_ions,
9 on_subdomains=kinetic_sds
10)

◆ ions

warpy sheath.ions
Initial value:
1= warpy.variable(name='ions',
2 components=fluid_comps,
3 basis_array_set=sorder,
4 subdomains=tf_sds,
5 virtual_subdomains=tf_vds)

◆ kinetic_electron_fluid

warpy sheath.kinetic_electron_fluid
Initial value:
1= warpy.variable(name = 'kinetic_electron_fluid',
2 components = ['n','nvx','nvy','nvz','nT'],
3 basis_array_set = sorder,
4 subdomains=kinetic_sds,
5 virtual_subdomains=kinetic_vds,
6 explodable=False)

◆ kinetic_ion_fluid

warpy sheath.kinetic_ion_fluid
Initial value:
1= warpy.variable(name = 'kinetic_ion_fluid',
2 components = ['n','nvx','nvy','nvz','nT'],
3 basis_array_set = sorder,
4 subdomains=kinetic_sds,
5 virtual_subdomains=kinetic_vds,
6 explodable=False)

◆ kinetic_sds

list sheath.kinetic_sds = ['left','right']

◆ kinetic_to_tf_va

list sheath.kinetic_to_tf_va = []

◆ kinetic_vds

None sheath.kinetic_vds = ['middle']

◆ L

tuple sheath.L = L_debye

◆ L_debye

tuple sheath.L_debye = (eps0*qe*1/(1e19*qe**2))**0.5

◆ limiter_alpha_coefficient

int sheath.limiter_alpha_coefficient = 2.

◆ limiter_apps_electron

list sheath.limiter_apps_electron = []

◆ limiter_apps_ion

list sheath.limiter_apps_ion = []

◆ mass_ratio

float sheath.mass_ratio = 1836.0

◆ maxwell_bcs

list sheath.maxwell_bcs = []

◆ maxwellian_evaluation_timestep_start_ha

warpy sheath.maxwellian_evaluation_timestep_start_ha
Initial value:
1= warpy.host_actions.va_runner(name='maxwellian_evaluation_timestep_start_ha',
2 variable_adjusters = maxwellian_evalution_timestep_start_va)

◆ maxwellian_evalution_timestep_start_va

list sheath.maxwellian_evalution_timestep_start_va = []

add these maxwellian conversions that can be done at the beginning of each timestep before writeout

◆ mesh

warpy sheath.mesh
Initial value:
1= warpy.mesh.arbitrary(meshfile,
2 NumLayers=1,
3 basis_array_set=sorder)
general unstructured mesh
Definition: mesh.py:56

◆ mesh_res

str sheath.mesh_res = '32x192x32'

◆ meshfile

f sheath.meshfile = f'sheath_mesh_{mesh_res}.inp'

◆ min_v_electron

list sheath.min_v_electron = [-vth_factor*v_th_e]

◆ min_v_ion

list sheath.min_v_ion = [-vth_factor*v_th_i]

◆ model

argparse sheath.model = args.model

◆ moment_takers_timestep_start_ha

warpy sheath.moment_takers_timestep_start_ha
Initial value:
1= warpy.host_actions.va_runner(name='moment_takers_timestep_start_ha',
2 variable_adjusters = [ion_timestep_start_moment_taker,
3 electron_timestep_start_moment_taker,
4 ion_timestep_start_second_moment_taker,
5 electron_timestep_start_second_moment_taker,
6 ion_timestep_start_chi_metric_moment_taker,
7 electron_timestep_start_chi_metric_moment_taker])

◆ mp

float sheath.mp = 1.672622e-27

◆ mu0

float sheath.mu0 = 1.256637e-6

◆ n0

float sheath.n0 = mp*omct**2/(mu0*L**2*qe**2)

◆ n_e

float sheath.n_e = 1.0

◆ n_i

float sheath.n_i = 1.0

◆ nargs

sheath.nargs

◆ now

datetime sheath.now = datetime.datetime.now().strftime("%Y_%m_%d")

◆ nu_p_tau_bgk

float sheath.nu_p_tau_bgk = 1.0

◆ omct

float sheath.omct = 3.265e-5

◆ omega_p_norm

float sheath.omega_p_norm = ompt

◆ ompe

tuple sheath.ompe = (1e19*qe**2/(eps0*A_e*mp))**0.5

◆ ompt

float sheath.ompt = 1.0

◆ P_e

float sheath.P_e = n_e * T_e

◆ P_i

float sheath.P_i = n_i * T_i

◆ parser

argparse sheath.parser = argparse.ArgumentParser(description='1d Sheath problem')

◆ phchi

float sheath.phchi = 1.5

◆ phgamma

float sheath.phgamma = phchi

◆ pressure_min

float sheath.pressure_min = 0.01

◆ qe

float sheath.qe = 1.602177e-19

◆ rho_e

float sheath.rho_e = A_e * n_e

◆ rho_i

float sheath.rho_i = A_i * n_i

◆ sim

warpy sheath.sim
Initial value:
1= warpy.dg_sim(name = sim_name,
2 meshes = [mesh],
3 initial_conditions = ic_ha,
4 temporal_solvers = [time_integrator],
5 writers = extra_timestep_start_writer + [writer],
6 time = [0,t_final],
7 dt_controller = dt_controller,
8 flexible_writeout = False,
9 write_steps = write_steps,
10 verbosity = 'info'
11)
Discontinuous finite element RK simulation.
Definition: dg_sim.py:11

◆ sim_name

f sheath.sim_name = f'sheath_vm_{v_space_num_elements[0]}_{mesh_res}_{model}'

◆ sim_param

sheath.sim_param
Initial value:
1= \
2f'''case_loc={case_loc}
3specific_case={sim_name}
4start_frame=0
5end_frame={write_steps}
6domain=left
7ion_variable={ion_distribution.name()}
8electron_variable={electron_distribution.name()}
9v_space_num_vx={v_space_num_elements[0]}
10basis_name={sorder}
11mass_ion={A_i}
12mass_ratio={mass_ratio}
13temperature_ion={T_i}
14temperature_electron={T_e}
15min_vxi_factor={-vth_factor}
16max_vxi_factor={vth_factor}
17min_vxe_factor={-vth_factor}
18max_vxe_factor={vth_factor}
19'''

◆ skin_depth_norm

int sheath.skin_depth_norm = 1/omct

◆ solver_apps_maxwell_flux

list sheath.solver_apps_maxwell_flux = []

◆ solver_apps_maxwell_kinetic_fluid_source

list sheath.solver_apps_maxwell_kinetic_fluid_source = []

◆ solver_apps_maxwell_tf_fluid_source

list sheath.solver_apps_maxwell_tf_fluid_source = []

◆ solver_apps_tf

list sheath.solver_apps_tf = []

◆ sorder

str sheath.sorder = 'thirdOrder'

◆ spatial_solver_kinetic_electrons

warpy sheath.spatial_solver_kinetic_electrons
Initial value:
1= warpy.spatial_solvers.dg_kinetic(name="dg_kinetic_electrons",
2 spatial_order = sorder,
3 phase_space_spatial_order = sorder,
4 v_space_num_elements = v_space_num_elements,
5 min_v = min_v_electron,
6 dv = dv_electron,
7 applications = apps_kinetic_electrons,
8 on_subdomains = kinetic_sds,
9 cfl = cfl)

◆ spatial_solver_kinetic_field

warpy sheath.spatial_solver_kinetic_field
Initial value:
1= warpy.spatial_solvers.dg(name="dg_kinetic_field",
2 spatial_order=sorder,
3 applications=solver_apps_maxwell_flux + solver_apps_maxwell_kinetic_fluid_source,
4 cfl = cfl,
5 on_subdomains=kinetic_sds)

◆ spatial_solver_kinetic_ions

warpy sheath.spatial_solver_kinetic_ions
Initial value:
1= warpy.spatial_solvers.dg_kinetic(name="dg_kinetic_ions",
2 spatial_order = sorder,
3 phase_space_spatial_order = sorder,
4 v_space_num_elements = v_space_num_elements,
5 min_v = min_v_ion,
6 dv = dv_ion,
7 applications = apps_kinetic_ions,
8 on_subdomains = kinetic_sds,
9 cfl = cfl)

◆ spatial_solver_tf

warpy sheath.spatial_solver_tf
Initial value:
1= warpy.spatial_solvers.dg(name="dg_tf",
2 spatial_order=sorder,
3 applications=solver_apps_tf + solver_apps_maxwell_flux + solver_apps_maxwell_tf_fluid_source,
4 cfl = cfl,
5 on_subdomains=tf_sds)

Spatial solver.

◆ ss_s

list sheath.ss_s = [spatial_solver_tf]

◆ str

sheath.str

◆ T0

float sheath.T0 = e0/(n0*qe)

◆ T_e

int sheath.T_e = 10

◆ t_final

float sheath.t_final = 20.0/ompe/tau

◆ T_i

int sheath.T_i = 10

◆ tau

float sheath.tau = ompt*L/(omct*c_light)

◆ tf_ic_ha

warpy sheath.tf_ic_ha
Initial value:
1= warpy.host_actions.va_runner(name="tf_ic_ha",
2 variable_adjusters=[ic_fun_i_va, ic_fun_e_va])

◆ tf_sds

None sheath.tf_sds = ['middle']

◆ tf_to_kinetic_va_electrons

list sheath.tf_to_kinetic_va_electrons = []

◆ tf_to_kinetic_va_ions

list sheath.tf_to_kinetic_va_ions = []

◆ tf_vds

None sheath.tf_vds = ['left','right']

◆ time_integrator

warpy sheath.time_integrator = warpy.host_actions.erk(name="ti", scheme=torder, spatial_solvers=ss_s, variable_adjusters=va_s)

◆ torder

str sheath.torder = 'SSPRK3'

◆ type

sheath.type

◆ use_limiter_mr

bool sheath.use_limiter_mr = False

◆ use_phmaxwell

bool sheath.use_phmaxwell = False

◆ v_space_num_elements

list sheath.v_space_num_elements = [48]

◆ v_th_e

math sheath.v_th_e = math.sqrt(P_e/A_e/n_e)

◆ v_th_i

math sheath.v_th_i = math.sqrt(P_i/A_i/n_i)

◆ va_s

list sheath.va_s = variable_adjusters_tf

◆ values_in

list sheath.values_in = [A_e*1e-4,0,0,0,1e-4/(gamma-1)]

◆ variable_adjusters_kinetic

list sheath.variable_adjusters_kinetic = []

◆ variable_adjusters_tf

list sheath.variable_adjusters_tf = []

◆ virtual_bc_apps_kinetic_electrons

list sheath.virtual_bc_apps_kinetic_electrons = []

◆ virtual_bc_apps_kinetic_ions

list sheath.virtual_bc_apps_kinetic_ions = []

◆ virtual_bc_apps_tf

list sheath.virtual_bc_apps_tf = []

◆ vth_factor

float sheath.vth_factor = +6.0

◆ write_steps

int sheath.write_steps = 100

◆ write_vars

list sheath.write_vars = [ions, electrons, field]

◆ writer

warpy sheath.writer
Initial value:
1= warpy.host_actions.writer(name='writer',
2 ReadVars=write_vars)
Writes out a list of variables.
Definition: writer.py:4

◆ Z_e

float sheath.Z_e = -1.0

◆ Z_i

float sheath.Z_i = +1.0