Skip to content

Latest commit

 

History

History
489 lines (401 loc) · 126 KB

REGGIE.md

File metadata and controls

489 lines (401 loc) · 126 KB

PICLas Regression Testing

PICLas utilizes the Reggie2.0 toolbox for regression testing. A detailed documentation on its usage is available at this repository. A list detailing the test cases and which features are tested is given below.

List of Cases

Check-in

Overview of the test cases performed after a commit.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
1 run_basic maxwell,RK4 DG-Operator nProcs=1,2,5,8 L2,Linf
2 CHE_maxwell maxwell, RK4, Particles=OFF, PICLAS_DEBUG_MEMORY=T DG-Operator, only Maxwell field solver, hard compiled N=1 nProcs=1,2,5,8 L2,Linf
3 CHE_poisson/poisson Poisson,RK3 HDG-Operator, secondary electron emission (SEE-I model, does not happen because ions are too slow), hard compiled N=1, CalcBoundaryParticleOutput=T,CalcElectricTimeDerivative=T, UseH5IOLoadBalance=T,F nProcs=1,2,5,8 L2,Linf Link
3 CHE_poisson/SurfFlux_ThermionicEmission_Schottky Poisson,RK3 Thermionic emission modelling with Schottky effect nProcs=4 Emission Current Link
4 CHE_PIC_maxwell_RK4 PIC (maxwell, RK4) PIC-variableExternalField
5 CHE_DSMC DSMC
6 CHE_PIC_maxwell_implicitBC maxwell,PIC,ImplicitO4 Implicit reflective particle BC nProcs=1 Particle Position
7 CHE_BGK BGK-Flow
8 CHE_FPFlow FP-Flow

CHE_PIC_maxwell_RK4

Regression testing for PIC, solving the complete Maxwell equations with RK4: Link to build.

No. Case Feature Execution Comparing Readme
01 2D_variable_B external magnetic field from .h5 (equidistant) nProcs=1,2,3,4,5,10,15,25,80 PartAnalyze.csv, PIC-EMField.h5 Link
02 2D_variable_particle_init_n_T_v particle emission from a distribution in 2D nProcs=1,2,5 PartAnalyze.csv Link
03 3D_variable_B external magnetic field from .h5 (equidistant) nProcs=1,2,3,4,5,10,15,25,32 PartAnalyze.csv, PIC-EMField.h5 Link
04 gyrotron_variable_Bz variable Bz nProcs=1,2 Database.csv, relative Link
05 IMD_coupling mapping from IMP to PICLas nProcs=1 PartData in Box Link
06 initialIonization nProcs=2 PartData Link
06 single_particle_PML PML particle nProcs=1,2,5,8,10 Link

CHE_DSMC

Small test cases to check features with DSMC timedisc: Link to build.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
1D_Two_Hot_Plates 1D problem: heating of cold gas between 2 hot walls nProcs=1 Temperature Link
2D_VTS_Insert_CellLocal 2D/Axisymmetric, linear time step scaling: Initial particle insertion by cell_local nProcs=2 PartAnalyze: NumDens, Temp Link
2D_VTS_SurfFlux_Tria 2D/Axisymmetric, linear time step scaling: Particle emission through surface flux nProcs=2 PartAnalyze: NumDens, Temp Link
BackgroundGas_RegionsDefinition Reservoir simulation setting different background gas regions nProcs=1,6 DSMCState: NumDens, Temp, Velo Link
BackgroundGas_VHS_MCC Reservoir simulation of an ionization using a background gas with DSMC and MCC-based collision probabilities, hard compiled N=1 nProcs=1 PartAnalyze: NumDens, Temp Link
BC_DiffuseWall_EnergyAccommodation Reservoir relaxing towards wall temperature, hard compiled N=1 nProcs=1,4 Temperature Link
BC_DiffuseWall_TempGrad Reservoir with a boundary temperature gradient along the x-axis, hard compiled N=1 nProcs=1,4 Temperature Link
BC_InnerReflective_8elems Inner reflective BC (dielectric surfaces) low error tolerance, runs piclas2vtk after piclas execution and converts PartData to .vtk, hard compiled N=1 nProcs=1,2,4,8 h5diff: DSMCSurfState Link
BC_InnerReflective_36elems Inner reflective BC (dielectric surfaces) high error tolerance, hard compiled N=1 nProcs=1,2,4,8,12 h5diff: DSMCSurfState Link
BC_PorousBC PorousBC as a pump with 2 species, hard compiled N=1 nProcs=3 Total # of removed part through BC
BC_PorousBC_2DAxi PorousBC as a pump with 2 species (axisymmetric, with/without radial weighting), hard compiled N=1 nProcs=1,2 Total number density Link
BC_RotationalPeriodic Rotationally periodic BC with "worst-case" mesh based on tetrahedrons nProcs=1,5 Particle number Link
BPO_SpeciesTimeStep Species-specific time step with BoundaryParticleOutput nProcs=4 PartAnalyze, SurfaceAnalyze Link
cube Collismode=2,3, hard compiled N=1 nProcs=2
Rotational_Reference_Frame_Regions Rotational reference frame with several regions, switching between stationary and rotating frame nProcs=1,2,3,4 Particle trajectory Link
Rotational_Reference_Frame_RotBC Rotational reference frame in combination with the rotationally periodic BC nProcs=1,2,3,4 Particle trajectory Link
Rotational_Reference_Frame_Temperature Rotational reference frame: Many particles, multiple revolutions nProcs=1,2,4 Temperature Link
Rotational_Reference_Frame_Subcycling Time subcycling method within the rotational reference frame nProcs=1 Particle trajectory [Link](regressioncheck/CHE_DSMC/Rotational_Reference_Frame_Subcycling/readme.md
SurfaceOutput Test of CalcSurfaceImpact and CalcBoundaryParticleOutput through defined electron flux nProcs=1,4 PartAnalyze, SurfaceAnalyze, DSMCSurfState Link
DSMC_QualityFactors Quality factors: mean/max collision probability, MCS over MFP, mean free path, ResolvedCellPercentage nProcs=1 PartAnalyze Link
DSMC_QualityFactors_MPI Quality factors: ResolvedTimestep, max collision probability, MCS over MFP, ResolvedCellPercentage nProcs=4 PartAnalyze Link
MCC_SpeciesTimeStep Species-specific time step with MCC nProcs=4 PartAnalyze: Number density Link
SurfFlux_RefMapping_Tracing_TriaTracking Surface flux emission (collisionless) with ARM (with all three trackings) and TriaSurfaceFlux (only TriaTracking) nProcs=1 PartAnalyze: nPart, TransTemp Link
SurfFlux_Tria_Adaptive_ConstPressure TriaSurfaceFlux with AdaptiveType=1/2 nProcs=4 Integrated mass flux Link
SurfFlux_Tria_Adaptive_ConstMassflow TriaSurfaceFlux with AdaptiveType=3,4, hard compiled N=1 nProcs=1 Integrated mass flux Link
SurfFlux_Tria_CircularInflow_Circle TriaSurfaceFlux with Circular Inflow: inflow only through defined circle nProcs=4 Number density in domain Link
SurfFlux_Tria_CircularInflow_CircleCutout TriaSurfaceFlux with Circular Inflow: inflow only outside of defined circle nProcs=4 Number density in domain Link
SurfFlux_Tria_CircularInflow_Ring TriaSurfaceFlux with Circular Inflow: inflow through a ring nProcs=4 Number density in domain Link
SurfFlux_Tria_CurrentMassflow Surface flux with an emission current or mass flow at fixed velocity nProcs=4 # of particles per time step Link
vMPF_BGG_CellLocalInsertion Variable weighting factor: Cell local particle insertion at constant density and constant particle number per cell nProcs=6 PartAnalyze: nPart, DSMCState: NumDens Link
vMPF_BGG_CellLocalInsertion_LimitLocation Variable weighting factor: Limited cell local particle insertion at constant density and constant particle number per cell nProcs=6 PartAnalyze: nPart, DSMCState: NumDens Link
vMPF_BGG_ChannelFlow_Merge Variable weighting factor: Flow through channel, merging particle in large cells after mortar interface nProcs=1,4 PartAnalyze: nPart, NumDens Link
vMPF_BGG_MultiSpec_Merge_TraceSpec Variable weighting factor: Multi-species background gas with trace species split and merging nProcs=1 PartAnalyze: nPart, NumDens Link
Symmetry_Initial_Particle_Emission(2) Initial Particle Insertion with Symmerty-Order.NE.3, Axisymmetric and RadialWeighting nProcs=1,4 PartAnalyze: NumDens, Temp Link

CHE_BGK/FPFlow

Both methods share the same regression tests in the different folders, CHE_BGK: BGK build, CHE_FPFlow: FPFlow build

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
2D_VTS_Insert_CellLocal 2D/Axisymmetric, linear time step scaling: Initial particle insertion by cell_local, particle latency hiding (BGK only) nProcs=1,2 PartAnalyze: NumDens, Temp Link
2D_VTS_SurfFlux_Tria 2D/Axisymmetric, linear time step scaling: Particle emission through surface flux nProcs=1,2 PartAnalyze: NumDens, Temp Link
MultiSpec_Reservoir_Ar-He only BGK, not FP nProcs=1 PartAnalyze.csv Link
MultiSpec_Reservoir_N2-O2 only BGK, not FP nProcs=1 PartAnalyze.csv Link
RELAX_CH4 CH4: Relax to thermal equi. continuous/quantized vibration nProcs=1 T_rot,T_vib,T_trans Link
RELAX_N2 N2: Relax to thermal equi. continuous/quantized vibration nProcs=1 T_rot,T_vib,T_trans Link

Nightly

Overview of the test cases performed during the nightly regression testing.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
- NIG_convtest_maxwell maxwell, RK4 Spatial order of convergence for Maxwell field solver
- NIG_convtest_poisson poisson, RK3 Spatial order of convergence for HDG field solver
- NIG_convtest_t_maxwell maxwell, RK3,RK4,CN,ImplicitO3,ImplicitO4,ROS46 Temporal order of convergence for particle push
- NIG_convtest_t_poisson maxwell, RK3,RK4,CN,ImplicitO3,ImplicitO4,ROS46 Temporal order of convergence for particle push
- NIG_DSMC maxwell, DSMC DSMC test cases
- NIG_Reservoir maxwell, DSMC Relaxation, (Surface-) Chemistry
- NIG_tracking_DSMC maxwell, DSMC Tracking
- NIG_PIC_poisson_RK3 poisson, PIC, RK3
- NIG_PIC_maxwell_RK4 maxwell, PIC, RK4
- NIG_maxwell_RK4 maxwell, RK4, Particles=OFF, POSTI_BUILD_DMD=ON
- NIG_LoadBalance maxwell, DSMC, Particles=ON Loadbalance
- NIG_poisson Poisson, Code Analyze=ON, PARTICLES=OFF Poisson solver without particles
- NIG_poisson_PETSC Poisson, PETSC, Code Analyze=ON, PARTICLES=OFF Poisson solver without particles, with PETSC library
- NIG_Photoionization Poisson, Code Analyze=ON Photoionization of H2 and secondary electron emission and initial load balance
- NIG_Radiation Radiation Radiation timedisc, cell-local emission and radiative transfer (2D rot sym and 3D)
1 NIG_PIC_maxwell_bgfield maxwell,PIC,RK4 External Background-field,h5 nProcs=2 DG_Solution
2 NIG_PIC_poisson_powerdensity Poisson, Crank-Nicolson Implicit, CalcTimeAvg DoRefMapping=T/F, nProcs=2 Final TimeAvg, h5diff
3 feature_emission_gyrotron maxwell,RK4 Part-Inflow,TimeDep N=1,3,6,9,10, nProcs=1,2,10,25, gyro-circle LineIntegration of nPartIn
4 feature_TWT_recordpoints maxwell,RK4 RPs, ExactFlux nProcs=1,4, RPs, interior TE-Inflow RP_State, RP_Daata
5 NIG_PIC_poisson_plasma_wave poisson,RK4,CN Poisson-PIC,Shape-Function-1D for normal, charge conserving and adaptive SF, auto initial LB nProcs=1,(2), (Imex for CN) W_el LineIntegration over 2Per
6 NIG_PIC_Deposition/Plasma_Ball_cell_volweight_mean maxwell,RK3 Maxwell-PIC,CVWM deposition nProcs=1,5,10 Particle_ref.csv Link
7 NIG_PIC_Deposition/Plasma_Ball_cell_volweight_mean_save_CVWM maxwell,RK3 Maxwell-PIC, CVWM deposition + fallback algorithm + BGField (superB) (+surf charge) nProcs=1,2 Particle_ref.csv Link
8 NIG_PIC_Deposition/Plasma_Ball_Shape-function-xDir maxwell,RK3 Maxwell-PIC,deposition shape_function, shape_function_cc, shape_function_adaptive nProcs=1,5,10 PartAnalyze.csv vs. reference Link
9 NIG_PIC_Deposition/Plasma_Ball_Shape-function-yDir maxwell,RK3 Maxwell-PIC,deposition shape_function, shape_function_cc, shape_function_adaptive nProcs=1,5,10 PartAnalyze.csv vs. reference Link
10 NIG_PIC_Deposition/Plasma_Ball_Shape-function-zDir maxwell,RK3 Maxwell-PIC,deposition shape_function, shape_function_cc, shape_function_adaptive nProcs=1,5,10 PartAnalyze.csv vs. reference Link
11 NIG_piclas2vtk/State-DSMCState-DSMCSurfState Poisson,RK3 piclas2vtk: conversion of h5 files to VTK, based on CHE_poisson test case nProcs=1 Link

NIG_code_analyze

Compilation of the code the CODE_ANALYZE option, which includes many different tests and outputs. For example, the energy and momentum conservation is tested for every reaction with this option for DSMC. Build: Link CMAKE-CONFIG

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
1 CHEM_CONS_QK_ion_recomb_H Chemistry routine with three reactants (recomb) and three products (ionization) nProcs=1 Energy and momentum conservation Link
2 CHEM_CONS_XSec_diss_ion_H2 Chemistry routine with three (ionization) and four (dissociative ionization) products nProcs=1 Energy and momentum conservation Link
3 FieldIonization nProcs= Link
4 periodic nProcs= Link
5 Semicircle nProcs= Link
6 vMPF_SplitAndMerge_Reservoir DSMC only Split and Mergin routines nProcs=1 Energy and momentum conservation, PartAnalyze: number density, energy and particle numbers Link
7 Rotational_Reference_Frame DSMC only acceleration by fictitious forces nProcs=1 L2 Link
8 Rotational_Reference_Frame_Wall_Specular DSMC only acceleration by fictitious forces, specular reflection at wall nProcs=1 L2 Link

NIG Convergence Tests

NIG_convtest_maxwell

Convergence tests (spatially by varying either the polynomial degree of the solution or the number of mesh cells) for Maxwell's equations on conforming, non-conforming (hanging nodes/Mortars) Cartesian or non-orthogonal meshes with open or PEC boundaries: Link CMAKE-CONFIG.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
1 h_mortar h-convergence (non-conforming mesh) nProcs=1
2 h_N2 h-convergence (conforming Cartesian mesh with N=2) nProcs=1
3 h_N4 h-convergence (conforming Cartesian mesh with N=2) nProcs=1
4 h_non_orthogonal h-convergence (non-orthogonal mesh) nProcs=4
5 p p-convergence nProcs=1
6 p_cylinder_TE_wave_circular p-convergence (cylindrical mesh periodic in z and PEC walls, circular polarization) nProcs=4
7 p_cylinder_TE_wave_linear p-convergence (cylindrical mesh periodic in z and PEC walls, linear polarization) nProcs=4
8 p_mortar p-convergence (non-conforming mesh) nProcs=1

NIG_convtest_poisson

Convergence tests (spatially by varying either the number of mesh cells) for Poisson's equations on conforming, non-conforming (hanging nodes/Mortars) Cartesian meshes with exact Dirichlet boundaries: Link CMAKE-CONFIG.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
Dielectric_slab_FPC h-convergence (N=1) nProcs=1,2,7 analytical solution Link
Dielectric_sphere_in_sphere_curved_mortar h-convergence (N=2) nProcs=1,2,7 analytical solution Link
23-x h_N1_mortar h-convergence (N=1, non-conforming mesh) nProcs=1,3,7 analytical solution Link

NIG_convtest_t_Maxwell

Convergence tests (temporally by varying the time step) for integrating the path of a single particle in a spatially varying and temporally constant magnetic field: Link CMAKE-CONFIG.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
1 PIC_CN_magnetostatic_Bz_exp spiral drift, Crank-Nickolson method nProcs=1 L2 error of position
3 PIC_ImplicitO3_magnetostatic_Bz_exp spiral particle drift, implicit 3rd order nProcs=1 L2 error of position
4 PIC_ImplicitO4_magnetostatic_Bz_exp spiral particle drift, implicit 4th order nProcs=1 L2 error of position
5 PIC_RK3_magnetostatic_Bz_exp spiral particle drift, Runge-Kutta 3rd order nProcs=1 L2 error of position
6 PIC_RK3_magnetostatic_Bz_exp_I particle deflection, Runge-Kutta 3rd order nProcs=1 L2 error of position
7 PIC_RK3_magnetostatic_Bz_exp_II particle undergoing a single loop, Runge-Kutta 3rd order nProcs=1 L2 error of position
8 PIC_RK3_magnetostatic_Bz_exp_III spiral particle drift, Runge-Kutta 3rd order nProcs=1 L2 error of position
9 PIC_RK4_magnetostatic_Bz_exp spiral particle drift, Runge-Kutta 4th order nProcs=1 L2 error of position
10 PIC_ROS46_magnetostatic_Bz_exp spiral particle drift, Rosenbrock 4th order (resulting in 1st order) nProcs=1 L2 error of position

NIG_convtest_t_Poisson

Convergence tests (temporally by varying the time step) for integrating the path of a single particle in a spatially varying and temporally constant magnetic field: Link CMAKE-CONFIG.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
1 PIC_constant_electric_field_in_x E-field acceleration nProcs=1 L2 Link
2 PIC_constant_electric_field_in_x_relativistic-Kuehn2021 relativistic E-field acceleration - L2 Link
3 PIC_constant_electric_field_in_x_relativistic_O2 relativistic E-field acceleration O2 - L2, EOC Link
4 PIC_constant_electric_field_in_x_relativistic_O3 relativistic E-field acceleration O3 - L2, EOC Link
5 PIC_constant_electromagnetic_field_Leapfrog (TODO) piral ExB drift, Leapfrog method - TODO Link
6 PIC_constant_magnetic_field_in_z_O1 B-field gyration (circle $Bz=const.$) O1 - L2, EOC Link
7 PIC_constant_magnetic_field_in_z_O2 B-field gyration (circle $Bz=const.$) O2 - L2, EOC Link
8 PIC_constant_magnetic_field_in_z_relativistic_O2 relativistic B-field gyration (circle $Bz=const.$) O2 - L2, EOC Link
9 PIC_constant_magnetic_field_in_z_relativistic_O3 relativistic B-field gyration (circle $Bz=const.$) O3 - L2, EOC Link
10 PIC_magnetostatic_Bz_exp_III_Leapfrog B-field gyration O1 Leapfrog - L2, EOC Link
11 PIC_magnetostatic_Bz_exp_III_O1 B-field gyration O1 - L2, EOC Link
12 PIC_magnetostatic_Bz_exp_III_O2 B-field gyration O2 - L2, EOC Link

NIG_DSMC

Testing more complex DSMC routines: Link CMAKE-CONFIG.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
1 2D_VTS_Distribution Release nProcs=1,2,4 h5diff ElemTimeStep Link
2 Ambipolar_Diffusion Release nProcs=6 PartAnalyze.csv Link
3 Macroscopic_Restart Release nProcs=6 PartAnalyze.csv Link
MCC_BGG_Elec_XSec_Sampling Release Cell-local sampling of electronic excitation rate nProcs=2,5 ExcitationData in DSMCState Link
4 RotPeriodicBC Release One rot-periodic BC angle nProcs=1,2,7,15,25 h5 bounds check PartData and PartAnalyze.csv Link
5 RotPeriodicBCMulti Release Multiple rot-periodic BC angles and interplane nProcs=1,2,7,15,25 h5 bounds check PartData, PartAnalyze.csv, and min/max of rot BCs Link
5 RotPeriodicBCMultiInterPlane Release (same as RotPeriodicBCMulti) nProcs=1,2,7,15,25 position of interplanes Link
5 SURF_PROB_DifferentProbs Release Probability-based surface chemistry model: Different probabilities nProcs=3,6 Number density of product species Link
5 SURF_PROB_MultiReac Release Probability-based surface chemistry model: Multiple reactions nProcs=3,6 Number density of product species Link
6 VirtualCellMerge Release Merge cells for collision operator nProcs=4 DSMCState: Number density with absolute value Link
7 VSS_VHS_SelfDiffusion Release + Debug Testing the VHS/VSS collision model nProcs=6 Number Density Link

NIG_Dielectric

Different dielectric regions in combination with the HDG solver (Poisson's equation)

No. Case Feature Execution Comparing Readme
1 HDG_cylinder cylindrical dielectric region nProcs=1 reference solution for DielectricGlobal Link
2 HDG_point_charge_CVWM_surf_charge single charged particle and dielectric region nProcs=5 L2 error (analytical solution) Link
3 HDG_point_charge_SF single charged particle and dielectric region nProcs=5 reference solution for DielectricGlobal N=3 to N=9, 2 error (analytical solution) Link
4 HDG_slab dielectric slab nProcs=1 reference solution for DielectricGlobal
5 HDG_sphere_in_box_analytical_BC single charged particle and dielectric region nProcs=1 analytic reference solution and p-convergence rate
6 HDG_sphere_in_box_potential_BC single charged particle and dielectric region nProcs=1 analytic reference solution and p-convergence rate
7 HDG_sphere_in_sphere_analytical_BC single charged particle and dielectric region nProcs=1 analytic reference solution and p-convergence rate

NIG_Reservoir

Testing more complex DSMC routines with reservoir (heat bath) simulations: Link CMAKE-CONFIG.

No. Case Feature Execution Comparing Readme
BGG_MultiSpec_vMPF Multi-species background gas (VHS): Basic variable weighting and trace background species nProcs=1,4 Link
CAT_RATES_ER Eley-Rideal reaction rates for the recombination of atomic oxygen on a SiO2-surface nProcs=1 Link
CAT_RATES_LH Langmuir-Hinshelwood reaction rates for the recombination of atomic oxygen on a SiO2-surface nProcs=1 Link
1 CHEM_BGG_MultiSpec_TCE_Air_5Spec Multi-species background gas: TCE rates for N2/O2 + N/O dissociation and N2 + O exchange nProcs=1 Link
2 CHEM_DeleteProduct Reaction products are deleted after the chemical reaction nProcs=1 Link
3 CHEM_EQUI_TCE_Air_5Spec Reservoir of high-temperature air (N2, O2) nProcs=1 Link
3 CHEM_EQUI_TCE_Air_5Spec_Database Reservoir of high-temperature air (N2, O2), using species/reaction data from the species database nProcs=1 Link
4 CHEM_QK_multi-ionization_C_to_C6+ QK impact ionization, from neutral to fully ionized nProcs=1 Link
5 CHEM_RATES_BGG_diss_CO2 Background gas: TCE rates for a dissociation: CO2 + CO/O <-> CO + O + CO/O nProcs=1 Link
6 CHEM_RATES_BGG_TCE_diss_QK_ion_CO2 Background gas: TCE rates for a CO2 + e dissociation/ionization nProcs=1 Link
7 CHEM_RATES_diss_recomb_CH4 TCE rates for a (non-linear) polyatomic dissociation + recombination: CH4 + M <-> CH3 + H + M nProcs=1 Link
8 CHEM_RATES_diss_recomb_CO2 TCE rates for a (linear) polyatomic dissociation + recombination: CO2 + M <-> CO + O + M nProcs=1 Link
9 CHEM_RATES_diss_recomb_N2 TCE rates for a diatomic dissociation + recombination: N2 + M <-> N + N + M nProcs=1 Link
10 CHEM_RATES_exchange_CH4_H TCE rates for an exchange: CH4 + H <-> CH3 + H2 nProcs=1 Link
11 CHEM_RATES_QK_diss_ion_N2 QK rates for a dissociation and ionization : N2 + M -> N + N + M and N2 + M -> N2+ e- + M nProcs=1 Link
12 CHEM_RATES_QK_diss_N2 QK rates for a dissociation : N2 + M -> N + N + M nProcs=1 Link
13 CHEM_RATES_QK_ionization-recomb_H QK rates for ionization and recombination: H + e <-> HIon + e + e nProcs=1 Link
14 CHEM_RATES_QK_recomb_N2 QK rates for a recombination: N + N + M -> N2 + M nProcs=1 Link
15 CHEM_RATES_XSec_Chem_H2_Plasma Testing total collision rates through cross-section data (H2+e/H/HIon1/H2Ion1/H3Ion1) nProcs=1 Link
15 CHEM_RATES_XSec_Chem_H2_Plasma_Database Testing total collision rates through cross-section data (H2+e/H/HIon1/H2Ion1/H3Ion1) from the species database nProcs=1 Link
16 CHEM_RATES_XSec_Chem_Ar-e_100keV Testing reaction rates through cross-section data (Ar+e: 1 reaction path, relativistic velocity) nProcs=1 Link
16 CHEM_RATES_XSec_Chem_H2-e Testing reaction rates through cross-section data (H2+e: EFFECTIVE, 3 reaction paths, vib. relax.) nProcs=1 Link
16 CHEM_RATES_XSec_Chem_H2-e_ELASTIC Testing reaction rates through cross-section data (H2+e: ELASTIC, 3 reaction paths, vib. relax.) nProcs=1 Link
17 CHEM_RATES_XSec_Chem_H2-H2Ion1 Testing reaction rates through cross-section data (H2+H2Ion: 3 reaction paths) nProcs=1 Link
18 CHEM_RATES_XSec_Chem_H2-H3Ion1 Testing reaction rates through cross-section data (H2+H3Ion: 4 reaction paths) nProcs=1 Link
19 MCC_BGG_MultiSpec_XSec Multi-species background gas: Collision rates for neutral-electrons through cross-section data nProcs=1 Link
20 MCC_BGG_MultiSpec_XSec_Elec Multi-species background gas: Electronic relaxation rates for neutral-electrons through cross-section data nProcs=1 Link
21 MCC_BGG_MultiSpec_XSec_Vib Multi-species background gas: Vibrational relaxation probabilities through cross-section data nProcs=1 Link
22 MCC_BGG_MultiSpec_XSec_TCE_QK_Chem Multi-species background gas: QK ionization and TCE dissociation nProcs=1 Link
23 MCC_BGG_MultiSpec_XSec_vMPF Multi-species background gas (MCC/XSec): Basic variable weighting and trace background species nProcs=1,4 Link
24 RELAX_CH4 Rotational, vibrational relaxation towards equilibrium temperature nProcs=2 Link
25 RELAX_CH4_PDR Relaxation towards equilibrium with prohibiting double relaxation (single/multi mode for CH4) nProcs=2 Link
26 RELAX_CO2 Rotational, vibrational relaxation towards equilibrium temperature nProcs=2 Link
27 RELAX_N2 Rotational, vibrational, electronic relaxation of N2 nProcs=1 Link
27 RELAX_N2_XSec_Elec Electronic excitation of N2 to 13 eV level using cross-section data nProcs=1 Link
28 RELAX_N2Ion Rotational, vibrational, electronic relaxation of N2Ion nProcs=1 Link
29 VarRelaxProb_cold Relaxation of a cold reservoir of N2 with variable relaxation probabilities nProcs=1,2,3 Link
30 VarRelaxProb_hot Relaxation of a hot reservoir of N2 and O2 with variable relaxation probabilities nProcs=2,3 Link
31 VarRelaxProb_Restart Initial Autorestart with variable relaxation probabilities nProcs=1,2 Link

NIG_tracking_DSMC

Testing of different tracking routines with DSMC: Link to build.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
1 ANSA box DoRefMapping=T,F; TriaTracking=F,T; nProcs=1,2 PartInt, PartPos in bounding box
2 curved DoRefMapping=T , nProcs=1,2 PartInt with relative tolerance
3 mortar DoRefMapping=T,F; TriaTracking=F,T; nProcs=1,2 PartInt, PartPos in bounding box
4 mortar_hexpress Mortar mesh built with HEXPRESS TriaTracking=T; nProcs=2,4 PartInt
5 periodic DoRefMapping=T,F, nProcs=1,2,5,10 PartInt, PartPos in bounding box
6 periodic_2cells DoRefMapping=T,F;TriaTracking=T,F, nProcs=1 PartPos in bounding box
7 semicircle DoRefMapping=T,F, nProcs=1,2 PartPos in bounding box
8 sphere_soft DoRefMapping=T;RefMappingGuess=1,3,nProcs=1,2 PartPos in bounding box
11 2D_VTS_Distribution Restart with a DSMCState to calculate the variable time step PartState Link
12 Macroscopic_Restart Restart with a DSMCState with an increased weighting factor Total particle number Link

NIG_SuperB

Testing of different SuperB examples (via piclas or standalone superB binary), which generate a 3D magnetic field distribution to be used in piclas: Link to build.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
1 LinearConductor PICLAS_BUILD_POSTI=ON, POSTI_BUILD_SUPERB=ON straight conducting line piclas, superB binaries (single-core) convergence test with number of segments of the linear conductor Link
2 CircularCoil - circular shaped coil - reference solution h5diff Link
3 CircularCoilTimeDependent - circular shaped coil, time-dependent current (sin function) nProcs=1,4 - Link
4 CircularCoilTimeDependentMuli - three circular shaped coils, time-dependent current (sin function) nProcs=1,4 - Link
5 RectangularCoil - rectangular shaped coil - reference solution h5diff Link
6 SphericalMagnet - spherically shaped hard magnet - convergence test with number of nodes of the spherical magnet Link
7 CubicMagnet - cubic shaped hard magnet - magnetic field reference solution h5diff Link
8 CylindricalMagnet - cylindrically shaped hard magnet - magnetic field reference solution h5diff Link
9 HollowCylinderMagnet - hollow cylinder hard magnet, placed outside of simulation domain - magnetic field reference solution h5diff Link
10 HollowCylinderMagnetCurved - hollow cylinder hard magnet (analytic solution along z-axis available), curvilinear grid - magnetic field reference solution h5diff Link

NIG_PIC_poisson_Leapfrog

Testing PIC compiled with Leapfrog integration (poisson,Leapfrog), solving Poisson's equation: Link to build.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
1 2D_innerBC_dielectric_surface_charge PICLAS_PETSC = ON Poisson-PIC,Dielectric surface charging,Cartesian geometry, CalcElectricTimeDerivative=T nProcs=1,2,5,7,12 DG_Source,DG_SourceExt,ElemData Link
4 MCC_EBeam_SpeciesSpecificTimestep 1D-PIC-MCC electron beam, emission current surface flux and species-specific time step for electrons, using ManualTimeStep for MCC nProcs=4 Number density (PartAnalyze.csv) Link
2 parallel_plates - Poisson-PIC,CalcCoupledPower,Part-LorentzType=non-relativistic (0), linear potential BC nProcs=1 PartAnalyzeLeapfrog_ref.csv Link
3 parallel_plates_AC - Poisson-PIC,CalcCoupledPower nProcs=1 PartAnalyzeLeapfrog_ref.csv Link
4 parallel_plates_fixed_power_input PICLAS_PETSC = ON Poisson-PIC,CalcCoupledPower+fixed input power (via potential BC) nProcs=1,2,4,5 PartAnalyzeLeapfrog_ref.csv Link
5 parallel_plates_SEE_Dunaevsky2003 - Poisson-PIC (no deposition), secondary electron emission (SEE-E model by Dunaevsky) nProcs=1,2,5,8,10 different SEE yields depending on bombarding e- energy on quartz (SiO2) Link
6 parallel_plates_SEE-I - Poisson-PIC (no deposition), secondary electron emission (SEE-I model) nProcs=1,2,5,10 13 % and 1 % of bombarding ions create secondary electrons Link
7 parallel_plates_SEE_Morozov2004 - Poisson-PIC (no deposition), secondary electron emission (SEE-E model by Morozov) nProcs=1,2,5,8,10 1 and 2 SEE from bombarding electrons on dielectric surfaces Link
8 parallel_plates_SEE_Phelps1999 - Poisson-PIC (no deposition), secondary electron emission (SEE-E model by Phelps) nProcs=1,2,5,8,10 different SEE yields depending on bombarding Ar+ energy on copper Link
9 Dielectric_sphere_surface_charging - Poisson-PIC,Dielectric surface charging nProcs=1,2,3,7,12 DG_Source,DG_SourceExt,ElemData,DielectricGlobal Link
10 Dielectric_sphere_surface_charging_mortar - Poisson-PIC,Dielectric surface charging,mortars nProcs=1,2,3,7,12 DG_Source,DG_SourceExt,ElemData,DielectricGlobal Link
11 Dielectric_sphere_surface_charging_PStateBound - Poisson-PIC,Dielectric surface charging,PartStateBoundary nProcs=1,2 PartStateBoundary,DSMCSurfState,DG_Source,DG_SourceExt,ElemData,DielectricGlobal Link

NIG_PIC_poisson_Boris-Leapfrog

Testing PIC compiled with Boris-Leapfrog integration (poisson,Boris-Leapfrog), solving Poisson's equation: Link to build.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
1 2D_HET_Liu2010 CMAKE_BUILD_TYPE = Release,Debug 2D Poisson-PIC, BGGas distribution, null collision on/off, pre-defined external magnetic field, neutralization BC, SEE model with variable electron bulk temperature, particle flux, total electric current and emitted SEE over time into SurfaceAnalyze.csv nProcs=3,6,12 integrate number of electrons impinging the anode (SurfaceAnalyze.csv) Link
2 2D_Landmark CMAKE_BUILD_TYPE = Release,Debug 2D Poisson-PIC, emission models for Landmark (volumetric ionization and neutralizer) nProcs=4 integrate number of electrons impinging the anode (SurfaceAnalyze.csv) Link
3 3D_HET_Liu2010 CMAKE_BUILD_TYPE = Release,Debug 3D Poisson-PIC, BGGas distribution, null collision on/off, pre-defined external magnetic field, neutralization BC, SEE model with variable electron bulk temperature, dielectric surface charging (hollow cylinder), vMPF=T restart from vMPF=F restart file nProcs=6 integrate number of electrons impinging the anode (SurfaceAnalyze.csv) Link
4 MCC_EBeam_SpeciesSpecificTimestep CMAKE_BUILD_TYPE = Release,Debug 1D-PIC-MCC electron beam, emission current surface flux and species-specific time step for electrons, using ManualTimeStep for MCC nProcs=4 Number density (PartAnalyze.csv) Link

NIG_PIC_poisson_RK3

Testing PIC compiled with Runge-Kutta 3 integration, solving Poisson's equation: Link to build.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
1 parallel_plates CalcCoupledPower nProcs=1 PartAnalyzeRK3_ref.csv Link
2 parallel_plates_AC CalcCoupledPower nProcs=1 PartAnalyzeRK3_ref.csv Link
3 plasma_sheath_BR-electrons_conforming non-linear HDG (BR electrons) nProcs=2 TimeAvg Link
4 plasma_sheath_BR-electrons_conforming_auto-switch non-linear HDG (BR electrons), automatic switching BR/kinetic nProcs=1,2,4 - Link
5 plasma_sheath_BR-electrons_conforming_auto-switch_auto-ref non-linear HDG (BR electrons), automatic switching BR/kinetic, automatic ref. values, change nSkipAnalyze during the simulation nProcs=1,2,4,11 integrate Te over time (PartAnalyze.csv) Link
6 plasma_sheath_BR-electrons_conforming_auto-switch_variable_Te non-linear HDG (BR electrons), automatic switching BR/kinetic, variable Te, change nSkipAnalyze during the simulation nProcs=1,2,4,11 integrate Te over time (PartAnalyze.csv) Link
7 plasma_sheath_BR-electrons_mortar non-linear HDG (BR electrons), Mortars nProcs=2 TimeAvg Link
8 turner nProcs=4 L2 error, PartAnalyze.csv
9 turner_bias-voltage_AC-DC bias voltage for AC with BCType=51 and 52 (power control) and DC with BCType=50 potential boundaries nProcs=1,2,4,10 PartAnalyze.csv, SurfaceAnalyze.csv Link

NIG_PIC_maxwell_RK4

Testing PIC compiled with Runge-Kutta 4 integration, solving Maxwell's equations: Link to build.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
1 external_bgfield External Background-field,h5 nProcs=2 DG_Solution
2 emission_gyrotron Part-Inflow,TimeDep N=1,3,6,9,10, nProcs=1,2,10,25, gyro-circle LineIntegration of nPartIn
3 single_particle nProcs=1,2,3,4,5 L2 error, DG_Source
4 TWT_recordpoints RPs, ExactFlux nProcs=1,4, RPs, interior TE-Inflow RP_State, RP_Data

NIG_maxwell_RK4

Testing the field solver (without compiling particle related routines) with Runge-Kutta 4 integration, solving Maxwell's equations: Link to build.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
1 CoaxialCable_DMD coaxial TE mode, DMD analysis nProcs=4,8 L2 error, FieldAnalyze Link
2 dipole_cylinder_PML EM dipole, PML nProcs=1,4 L2 error, DG_Solution
3 ExactFlux_PML exact DG flux nProcs=1,4,8 L2 error, FieldAnalyze
4 ExactFlux_PML_CoaxialCable_dielectricZones exact DG flux, PML, coaxial TE mode, dielectric zones nProcs=8 L2 error, FieldAnalyze Link
5 MortarPlaneWave Mortars nProcs=1,2,5,7,12 DG_Solution,FieldAnalyze Link

NIG_LoadBalance

Testing the LoadBalance feature with different timediscs: Link to build.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
1 sphere_soft_DSMC
1 sphere_soft_RK4_with_DSMC
1 sphere_soft_RK4_without_DSMC
1 SurfaceModel LoadBalance with surfacemodels 0, 2 and 3 with DSMC nProcs=4, DoLoadBalance=T,F ,PartWeightLoadBalance=F,T ,DoInitialAutRestart=T,T ,InitialAutoRestart-PartWeightLoadBalance=F,F Link

NIG_poisson

Pure Poisson solver without particles: Link to build.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
1 poisson_box_Dirichlet restart of lambda solution nProcs=1-13 number of HDG iterations, which should be 0 on restart as the already correct solution is used Link

NIG_poisson_PETSC

Pure Poisson solver without particles: Link to build.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
1 electric_potential_condition_discharge Poisson,RK3 HDG-Operator in PETSc with electric potential condition (EPC) + feature of using multiple EPCs nProcs=1,2,3,4,5,7,10,12 FieldAnalyze.csv Link
2 floating_boundary_condition_multi_FPC - HDG-Operator in PETSc with floating boundary condition (FPC) + feature of using multiple FPCs nProcs=1,2,3,4,5,7,10,12 FieldAnalyze.csv Link
3 floating_boundary_condition_p-convergence - HDG-Operator in PETSc with floating boundary condition (FPC) + analytical solution coaxial cable nProcs=1,2,5,16 FieldAnalyze.csv + p-convergence test (L2 error converges to zero for increasing polynomial degree N) Link
4 poisson - HDG-Operator, secondary electron emission (SEE-I model, does not happen because ions are too slow), nProcs=1,2,5,8 L2,Linf Link
hard compiled N=1, CalcBoundaryParticleOutput=T,CalcElectricTimeDerivative=T (electric displacement current),
UseH5IOLoadBalance=T,F, PETSC with PrecondType=1,2,3,10 (4 and 11 currently fail)
5 poisson_box_Dirichlet - restart of lambda solution nProcs=1-13 number of HDG iterations, which should be 0 on restart as the already correct solution is used Link

NIG_Photoionization

Test all features of photoionization within the HDG solver (without interpolation and deposition): Link to build.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
1 surface_emission/ Photoionization: Surface Emission via SEE nProcs= 1,2,5,8 the total number of real electrons in the system with an analytical expression Link
2 surface_emission_rectangle/ Secondary electron emission from a surface (rectangle), PartBCIndex=1 (BoundaryParticleOutput), emission-specific MPF (vMPF) nProcs= 1,2,5,8 the total number of real electrons in the system with a numerical ref. solution Link
3 surface_emission_rectangle_ray_trace/ Photoionization: Surface Emission via SEE for ray tracing nProcs= 1,2,5,8,11,25 RadiationSurfState.h5 and RadiationVolState.h5 with reference files, the total number of real electrons in the system with a numerical ref. solution Link
4 surface_emission_rectangle_ray_trace_high-order/ Photoionization: Surface Emission via SEE for ray tracing with high-order refinement nProcs= 1,2,5,8,11,25 RadiationSurfState.h5 and RadiationVolState.h5 with reference files, the total number of real electrons in the system with a numerical ref. solution Link
5 volume_emission/ Photoionization in the volume (circle and honeycomb) nProcs= 1,2,5,8 the total number of real electrons in the system with an analytical expression Link
6 volume_emission_polychromatic/ Photoionization in the volume with polychromatic photon spectrum and energy-dependent cross-section data nProcs= 1,2,5,8 the total number of real electrons in the system with a reference solution and particle numbers for different MPFs Link
7 volume_emission_rectangle/ Photoionization in the volume (rectangle) nProcs= 1,2,5,8 the total number of real electrons in the system with a numerical ref. solution Link
8 volume_emission_rectangle_ray_trace_high-order/ Photoionization in the volume (rectangle) for ray tracing with high-order refinement nProcs= 1,2,5,8 the total number of real electrons in the system with a numerical ref. solution Link
9 volume_emission_rectangle_ray_trace_high-order_Cubit_3to1/ Photoionization in the volume (rectangle) for ray tracing with high-order refinement and bilinear tracking nProcs= 1,2,5,8 the total number of real electrons in the system with a numerical ref. solution Link
10 volume_emission_vMPF/ Photoionization in the volume with vMPF nProcs= 1,2,5,8 the total number of real electrons in the system with an analytical expression and particle numbers for different MPFs Link

NIG_Radiation

Test all features of radiation timedisc (cell-local emission using the radiation solver and radiative transfer using the radiative transfer solver): Link to build.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
1 Rad_Emission_SingleCell_N Radiation: Cell-local emission of atomic nitrogen nProcs= 1 emission spectrum of N Link
2 Rad_Emission_SingleCell_O Radiation: Cell-local emission of atomic oxygen nProcs= 1 emission spectrum of O Link
3 RadTrans_Cylinder_2D Radiation: two-dimensional rotationally symmetric radiative transfer (semi-infinite cylinder with with a homogeneous medium emitting blackbody radiation) nProcs= 1,2,3,6 divergence of the heatflux Link
4 RadTrans_Cylinder_3D Radiation: three-dimensional radiative transfer (semi-infinite cylinder with with a homogeneous medium emitting blackbody radiation) nProcs= 1,2,3,6 divergence of the heatflux Link

Weekly

Overview of the test cases performed every week.

No. Case CMAKE-CONFIG Feature Execution Comparing Readme
1 plasma_wave PIC-Maxwell Maxwell-PIC,SF1D, FastPeriodic nProcs=6, IMEX for ImplicitO4 W_el LineIntegration (FieldAnalyze.csv) Link
** 3D_periodic_shape_function ** Maxwell-PIC,shape function deposition over periodic sides 3D nProcs= 1,2,6,10,20 L2 error and PartAnalyze.csv Link
** 3D_periodic_CVWM ** Maxwell-PIC,CVWM over periodic sides 3D with 1000 elements nProcs= 1,2,6,10,15,20,30 L2 error and PartAnalyze.csv Link
** 3D_periodic_CVWM_split2hex ** Maxwell-PIC,CVWM over periodic sides 3D and split2hex grid with 768 hex elements nProcs= 1,2,6,10,15,20,30 L2 error and PartAnalyze.csv Link
2 HEMPT-90deg-symmetry PIC-HDG create mesh (hopr) and external magnetic field (superB) and use both in simulation nProcs=1,10,20 Link
3 CHEM_EQUI_diss_CH4 Reservoir Relaxation into equilibrium with dissociation and recombination of CH4 nProcs=2 PartAnalyze_ref.csv Link
** CHEM_EQUI_exch_CH3-H ** Relaxation into equilibrium with exchange/radical reaction of CH3+H <-> CH2+H2 nProcs=2 PartAnalyze_ref.csv Link
** CHEM_EQUI_ionization_H ** Relaxation into equilibrium with ionization and recombination of H nProcs=1 PartAnalyze_ref.csv Link
** CHEM_EQUI_diss_CH4_2DAxi_RadWeight ** Analogous to CHEM_EQUI_diss_CH4 with 2D axisymmetric mesh with radial weighting nProcs=2 PartAnalyze_ref.csv Link
** CHEM_EQUI_Titan_Chemistry ** Reservoir simulation with Titan's atmosphere (18 species, 28 reactions) nProcs=6 PartAnalyze_ref.csv Link
** CHEM_EQUI_Titan_Chemistry_Database ** Reservoir simulation with Titan's atmosphere (18 species, 28 reactions) using species/reaction data from the species database nProcs=6 PartAnalyze_ref.csv Link
** MCC_MultiSpec_XSec ** Multi-species reservoir: Collision rates for neutral-electrons through cross-section data nProcs=1 Link
** MCC_MultiSpec_XSec_TCE_QK_Chem ** Multi-species reservoir: QK ionization and TCE dissociation nProcs=2 Link
** BGG_MultiSpec_XSec_Elec ** Background gas reservoir with VHS: Electronic excitation rates for neutral-electrons through cross-section data nProcs=1 Link
** MCC_N2_XSec_Elec ** Regular reservoir with MCC/VHS: Electronic excitation rates for neutral-electrons through cross-section data nProcs=1 Link
** 1D_Sod_Shocktube DSMC 1D test case shock tube nProcs=6 DSMCState Link
4 2DAxi_ChannelFlow_ConstPressure_TruncAverage ** 2D axisymmetric: Pressure gradient driven pipe flow with adaptive surface flux, using a truncated running average nProcs=6 PartAnalyze: Average pressure and mass flow rate at the adaptive surface flux BCs Link
4 ChannelFlow_AdaptiveBoundary_ConstMassflow ** Constant massflow driven channel flow with adaptive surface flux nProcs=6 PartAnalyze: Average pressure and mass flow rate at the adaptive surface flux BCs Link
4 ChannelFlow_AdaptiveBoundary_ConstPressure_FixedAverage ** Pressure gradient driven channel flow with adaptive surface flux, using a fixed average for the sampling nProcs=6 PartAnalyze: Average pressure at the adaptive surface flux BCs Link
4 ChannelFlow_AdaptiveBoundary_ConstPressure_Relaxation ** Pressure gradient driven channel flow with adaptive surface flux, using a relaxation factor for the sampling nProcs=6 PartAnalyze: Average pressure at the adaptive surface flux BCs Link
4 ChannelFlow_AdaptiveBoundary_ConstPressure_TruncAverage ** Pressure gradient driven channel flow with adaptive surface flux, using a truncated running average for the sampling nProcs=6 PartAnalyze: Average pressure at the adaptive surface flux BCs Link
ChannelFlow_SurfChem_AdsorpDesorp_CO_O2 ** Channel flow with surface chemistry, testing adsorption/desorption of CO and O2 nProcs=6 Coverage (DSMCSurfChemStatePartAnalyze), Number density, temperature (PartAnalyze) Link
** Flow_Argon_Cylinder_Curved ** Hypersonic Argon flow around a cylinder (pseudo 2D) with DSMC on a curved mesh nProcs=2 Link
** Flow_Argon_Cylinder_LinearMesh ** Hypersonic Argon flow around a cylinder (2D) with DSMC on a linear mesh nProcs=4 Link
** Flow_N2_70degCone ** 2D axisymmetric 70 degree cone nProcs=6 Surface Sampling, includes CalcSurfaceImpact and adaptive wall temperature Link
** fully_periodic_3D ** Periodic boundary conditions in all three directions nProcs=10,20,30 Check whether particles end up outside of the domain Link
** Surface_Sticking_Coefficient ** Channel flow with a sticking coefficient model nProcs=5 Surface sampling Link
5 Flow_N2_70degCone BGK 2D axisymmetric 70 degree cone nProcs=6 Link
** MultiSpec_Supersonic_Couette_Ar-He ** Supersonic Couette flow with an Ar-He mixture nProcs=5 Temperature Link
** MultiSpec_Supersonic_Couette_CO2-N2 ** Supersonic Couette flow with a CO2-N2 mixture nProcs=5 Temperature Link
6 Flow_N2_70degCone FP 2D axisymmetric 70 degree cone nProcs=6 Surface Sampling, includes CalcSurfaceImpact Link
7 Flow_N2-N_70degConeHot DSMC 2D axisymmetric 70 degree cone (hotter and with N to get some radiation in the next step) nProcs=6 Surface Sampling Link
** Flow_N2-N_70degConeHot Radiation using previously simulated WEK_DSMC/Flow_N2_70degCone results to check radiation tool chain (write out DSMC results, readin those results, radiation solver, radiative transfer, piclas2vtk) nProcs=6 Surface heat flux Link