▼ Src | |
► Chombo | |
PatchStartup.cpp | Compute magnetic field from vector potential |
PatchTools.cpp | Contains some implementation of the PatchPluto class |
► Cooling | |
► H2_COOL | |
comp_equil.c | Compute equilibrium fractions for the H2_COOL module |
radiat.c | Right hand side for H2_COOL cooling |
► MINEq | |
cooling_defs.h | |
radiat.c | Right hand side for MINEq cooling |
► Power_Law | |
cooling.c | Take a source step using power-law cooling |
► SNEq | |
radiat.c | Right hand side for SNEq cooling |
► Tabulated | |
radiat.c | Compute right hand side for Tabulated cooling |
cooling.h | Cooling main header file |
cooling_ode_solver.c | Integration methods for cooling netowrk ODEs |
cooling_source.c | Integrate cooling and reaction source terms |
► Dust_Fluid | |
dust_fluid.c | Riemann solver for dust (pressuless gas) |
dust_fluid.h | Set labels, indexes and prototypes for the dust module |
init.c | Contains basic functions for problem initialization |
► EOS | |
► Ideal | |
eos.c | Ideal (constant gamma) EOS |
eos.h | |
► Isothermal | |
eos.c | Implementation of the isothermal EOS |
eos.h | |
► PVTE | |
eos.h | PVTE EoS header file |
fundamental_derivative.c | PVTE_LAW for a partially ionized gas |
internal_energy.c | Thermodynamic relations for the caloric EoS, e=e(T,rho) and T=T(e,rho) |
pvte_law.c | Basic interface definition for the PVTE_LAW EoS |
pvte_law_dAngelo.c | Basic interface definition for the PVTE_LAW EoS |
pvte_law_H+.c | PVTE_LAW for a partially ionized gas |
pvte_law_template.c | Templeate file for the PVTE_LAW EoS |
scvh.c | Read SCvH table |
thermal_eos.c | Thermodynamic relations for the thermal EoS, p=nkT and T=p/(nK) |
► Taub | |
eos.c | Taub-Matthews (TM) EOS for relativistic hydro and MHD |
eos.h | |
► Fargo | |
fargo.c | Solves the linear transport step of the FARGO-MHD algorithm |
fargo.h | FARGO-MHD module header file |
fargo_io.c | Write / Read orbital velocity to / from disk |
fargo_source.c | Add source terms before the FARGO advection step |
fargo_velocity.c | Functions for computing/retrieving the mean aziumthal velocity |
► Forced_Turb | |
forced_turb.c | Forced Turbulence Module |
forced_turb.h | |
► HD | |
eigenv.c | Wave-speeds and characteristic decomposition for the HD equations |
fluxes.c | Compute the hydro (HD) flux |
hll.c | HLL Riemann solver for HD |
hll_speed.c | Compute the outermost wave speeds for HLL-based solvers |
hllc.c | HLLC Riemann solver for MHD |
mappers.c | Convert between primitive and conservative variables |
mod_defs.h | Set labels, indexes and prototypes for the HD module |
roe.c | Roe Riemann solver for the HD equations |
tvdlf.c | Lax-Friedrechs (Rusanov) Riemann solver for HD |
two_shock.c | Two-shock Riemann solver for the HD equations |
► Math_Tools | |
math_interp.c | Miscellaneous functions for handling interpolation |
math_lu_decomp.c | Functions for LU decomposition and matrix inversion |
math_misc.c | Miscellaneous math functions |
math_ode.c | Ordinary differential equation solvers |
math_qr_decomp.c | Functions for QR decomposition and matrix inversion |
math_quadrature.c | Collection of handy numerical math tools |
math_random.c | Miscellaneous random number generator functions |
math_root_finders.c | Collection of root-finder algorithms |
math_table2D.c | Miscellaneous functions for handling 2D tables |
math_tools.h | Math tools header file |
► MHD | |
► CT | |
ct.h | Header file for Constrained-Transport (CT) module |
ct_emf.c | Store or retrieve the Electromotive Force (EMF) |
ct_emf_average.c | Collects different EMF averaging schemes |
ct_field_average.c | Average staggered magnetic field to zone center |
ct_fill_mag_field.c | Assign the normal component of the staggered magnetic field in the ghost zone-faces. Using the div.B = 0 condition in staggered MHD, this function computes the staggered component of magnetic field lying on the zone-faces parallel to the boundary specified by "side". This is preformed by solving the div.B = 0 condition for one variable only which in 2-D requires the knowledge of the other 3 components while in 3-D required the knowledge of the other 5 staggered components.
|
ct_flux.c | Define point and diffusive fluxes for CT |
ct_imex_update_ELR.c | Update staggered electric field in resistive RMHD |
ct_maxwell_solver.c | Maxwell solver for the Resistive RMHD equations |
ct_maxwell_solver_balsara_rec.c | Maxwell solver for the Resistive RMHD equations |
ct_update.c | Update staggered magnetic field |
► GLM | |
glm.c | GLM module implementation |
glm.h | Header file for GLM Divergence Cleaning |
► Hall_MHD | |
hall_mhd.h | Header file for Hall MHD |
hall_ne.c | Define the 'ne' term in Hall-MHD |
hall_whistler_speed.c | Compute the whistler speed for the Hall MHD equations |
► Resistivity | |
res.h | Resistive MHD module header file |
res_eta.c | Define the components of the diagonal resistive tensor |
res_flux.c | Compute the resistive MHD flux for cell-centered field |
res_functions.c | Compute resistivity |
res_rhs.c | Build the right hand side for the resistivity operator |
► ShearingBox | |
sb_boundary.c | Wrapper function to assign shearing-box boundary conditions |
sb_flux.c | Enforce conservation at the X1 boundaries in the shearing-box module |
sb_tools.c | Miscellaneous functions for implementing the shearing-box boundary condition |
shearingbox.h | Shearing-Box module header file |
bckgrnd_field.c | Compute background magnetic field at the desired location |
eigenv.c | Wave-speeds and characteristic decomposition for the MHD equations |
fluxes.c | Compute the MHD flux |
get_current.c | Compute the curl of magnetic field |
get_efield.c | Compute the total electric field |
gforce.c | GFORCE Riemann solver for the classical MHD equations |
hll.c | HLL Riemann solver for MHD |
hll_speed.c | Compute the outermost wave speeds for HLL-based solvers |
hllc.c | HLLC Riemann solver for MHD |
hlld.c | HLLD Riemann solver for the classical MHD equations |
hlld_arithm.c | HLLD Riemann solver for the classical MHD equations |
hllem.c | HLLEM Riemann solver for MHD |
mappers.c | Convert between primitive and conservative variables |
mod_defs.h | Set labels, indexes and prototypes for the MHD module |
prim_eqn.c | Compute the right hand side of the primitive HD/MHD equations |
rhs.c | Compute the right hand side of the conservative HD/MHD equations |
rhs_source.c | Add source terms to the right hand side of HD/MHD eqns |
roe.c | Implementation of the Roe Riemann solver for the MHD equations |
set_solver.c | Return a pointer to a Riemann solver function |
source.c | Compute source terms for Powell formulation |
tvdlf.c | Lax-Friedrechs (Rusanov) Riemann solver for MHD |
► Parallel | |
al.h | ArrayLib main header file |
al_alloc.c | ArrayLib allocation routine |
al_boundary.c | Check if the local beginnings or endings of an array correspond to the global beginnings or endings |
al_codes.h | ArrayLib codes header file |
al_decomp_.c | Miscellaneous of functions act to find the processors distribution |
al_decompose.c | ArrayLib functions to decompose the domain among the MPI processes |
al_defs.h | ArrayLib function definitions header file |
al_exchange.c | Fill the ghost boundaries |
al_exchange_dim.c | Fill the ghost boundaries along selected dimensions |
al_finalize.c | ArrayLib Finalization routine |
al_hidden.h | Internal include file for the ArrayLib |
al_init.c | ArrayLib Initialization routines |
al_io.c | Miscellaneous functions for IO operations |
al_proto.h | ArrayLib function prototypes header file |
al_sort_.c | Internal routine to sort an integer array |
al_subarray_.c | Creates a datatype describing a subarray of a multidimensional array |
al_sz_free.c | Dellocate a distributed array descriptor |
al_sz_get.c | Miscellaneous functions to obtain informations about the properties of the distributed array |
al_sz_init.c | Allocate and initialize a distributed array descriptor |
al_sz_set.c | Miscellaneous functions to define the properties of the distributed array by setting various parameters via the isz descriptor |
al_szptr_.c | Miscellaneous of internal routines to convert sz pointers to integer pointers |
al_write_array_async.c | ArrayLib routines for asynchronous MPI-IO |
► Particles | |
particles.h | Particle module header file |
particles_boundary.c | Set boundary conditions on particles |
particles_cr_feedback.c | File containing functions for feedback from CR to the fluid |
particles_cr_force.c | Compute CR-related quantities (like force) from the particles to the grid |
particles_cr_predictor.c | Predictor step for CR particles |
particles_cr_update.c | Update CR particles (with feedback) using Boris scheme |
particles_cr_update_gc.c | Update CR particles (without feedback) using guiding center approximation |
particles_deposit.c | Particle to grid deposition functions |
particles_distrib_regular.c | Assign particle coordinates from distribution function |
particles_dust_feedback.c | Miscellaneous function to compute feedback from dust to fluid |
particles_dust_force.c | Compute dust-gas drag term |
particles_dust_update_cart.c | Dust particle mover in Cartesian coordinates |
particles_dust_update_curv.c | Dust particle mover in non-Cartesian (curvilinear) coordinates |
particles_dust_update_rk2.c | Update Dust particles |
particles_dust_update_zhu.c | Dust particle mover in non-Cartesian (curvilinear) coordinates |
particles_init.c | Initialize particle distrbution, set B.C. and injection |
particles_load.c | Initial particle loading |
particles_lp_dsa.c | Shock-related function for LP spectra update |
particles_lp_emissivity.c | Functions to compute the emissivity due to synchrotron and Inverse compton processes from isotropic radiation source of Cosmic Microwave Background (CMB) photons for each particle based on its spectral dustribution |
particles_lp_restart.c | Restart the simulation using particles.nnnn.dbl file |
particles_lp_spectra.c | Tools needed to compute the quantities required to evolve the spectra and estimate the Emission coefficient |
particles_lp_tools.c | Collection of tools for the LAGRANGIAN particle module at particle positions |
particles_lp_update.c | Push lagrangian particles |
particles_lp_write_bin.c | Writer for particles binary data in .dbl, .flt and ASCII in .tab (only for serial version) format |
particles_mpi_datatype.c | Define MPI data-type structure for MPI communications |
particles_restart.c | Restart the simulation using particles.nnnn.dbl file |
particles_set.c | Placing the particles on the grid and interpolating dervied quantites at particle positions |
particles_set_output.c | Set particles output data attributes |
particles_tools.c | Tools required to define the Particle MPI struct and Interpolating quantities from grid to particles |
particles_weights.c | Compute particle's weights needed for interpolation |
particles_write_bin.c | Writer for particles binary data in .dbl, .flt and ASCII in .tab (only for serial version) format |
particles_write_data.c | Main driver of particles output data called during the CheckForOutput stage |
particles_write_trajectory.c | Write trajectoy of a particle |
particles_write_vtk.c | Writer for particles binary data in .vtk format |
plist_tools.c | Tools for handling the particle linked list |
► Poisson | |
multigrid.c | Multigrid Poisson solver |
► ResRMHD | |
► v00 | |
rk_step_imex.c | Advance equations with IMEX Runge Kutta time integrators |
eigenv.c | Compute the eigenvalues for the relativisitc MHD equations |
fluxes.c | Compute the Resistive RMHD flux |
hll_speed.c | Compute the outermost wave speeds for HLL-based solvers |
imex_source.c | Solve the stiff-implicit part of the RK-Imex method |
mappers.c | Convert between primitive and conservative variables |
mhllc.c | MHLLC Riemann solver for resistive RMHD |
mod_defs.h | Resistive RMHD module header file |
res_eta.c | Define the scalar resistivity for the RMHD equations |
rhs.c | Compute the right hand side of the resistive RMHD equations |
rhs_source.c | Add source terms to the right hand side of RMHD eqns |
rk_step_imex.c | Advance equations with IMEX Runge Kutta time integrators |
rk_step_imex_ct_explicit.c | Advance equations with Runge Kutta time integrators |
set_solver.c | Return a pointer to a Riemann solver function |
tvdlf.c | Lax-Friedrechs (Rusanov) Riemann solver for resistive RMHD |
► RHD | |
eigenv.c | Wave-speeds and characteristic decomposition for the RHD equations |
fluxes.c | Compute the flux for the relativistic hydro (RHD) equations |
hll_speed.c | Compute the outermost wave speeds for HLL-based solvers |
hllc.c | Implement the HLLC Riemann solver for relativistic HD |
mappers.c | Convert between primitive and conservative variables |
mod_defs.h | Set labels, indexes and prototypes for the RHD module |
prim_eqn.c | Compute the right hand side of the relativistic hydro (RHD) equations in primitive form |
rhd_energy_solve.c | Inversion scheme for RHD using total energy density |
rhd_entropy_solve.c | Inversion scheme for RHD using entropy |
rhd_pressure_fix.c | Inversion scheme for RHD using a pressure fix |
tvdlf.c | Lax-Friedrechs (Rusanov) Riemann solver for RHD |
two_shock.c | Implementation of the two-shock Riemann solver for the relativistic hydro equations |
► RMHD | |
► Radiation | |
flux_lim.c | Radiation flux limiting |
newtonsolve.c | Newton's method, main functions |
rad_errors.c | Error computation for the radiation implicit step |
rad_flux.c | Compute the flux for the (M1) radiation transport equations |
rad_hll.c | HLL Riemann solver for the (M1) radiation transport equations |
rad_hllc.c | HLL Riemann solver for the (M1) radiation transport equations |
rad_set_solver.c | Return a pointer to a Riemann solver function for the radiation module |
rad_speed.c | Compute the outermost wave speeds of the radiation part |
rad_step.c | Radiation implicit step |
rad_tools.c | Some functions used by the radiation module |
rad_tvdlf.c | Lax-Friedrechs (Rusanov) Riemann solver for the radiation fields |
radiation.h | Header file for the radiation module |
eigenv.c | Compute the eigenvalues for the relativisitc MHD equations |
fluxes.c | Compute the RMHD flux |
gforce.c | GFORCE Riemann solver for the relativistic MHD equations |
hll.c | HLL Riemann solver for RMHD |
hll_speed.c | Compute the outermost wave speeds for HLL-based solvers |
hllc.c | Implement the HLLC Riemann solver for relativistic MHD |
hlld.c | HLLD Riemann solver for the relativistic MHD equations |
hllem.c | HLLEM Riemann solver for RMHD |
mappers.c | Convert between primitive and conservative variables |
mod_defs.h | Module header file for relativistic MHD (RMHD) |
quartic.c | Solve quartic and cubic equations |
rhs_source.c | Add source terms to the right hand side of relativistic HD/MHD eqns |
rmhd_energy_solve.c | Inversion scheme for RMHD using total energy density |
rmhd_entropy_solve.c | Inversion scheme for RMHD using entropy |
rmhd_pressure_fix.c | Inversion scheme for RMHD using a pressure fix |
set_solver.c | Return a pointer to a Riemann solver function |
tvdlf.c | Rusanov Lax-Friedrichs flux for RMHD Eqns |
vel_limiter.c | Velocity limiter for relativistic hydro or MHD |
► States | |
char_tracing.c | Compute time-centered interface states using characteristic tracing |
flat_states.c | Compute time-centered interface states using characteristic tracing |
hancock.c | MUSCL-Hancock predictor step |
limo3_states.c | LimO3 reconstruction |
mp5_states.c | MP5 states |
plm_coeffs.c | Compute linear reconstruction coefficients |
plm_coeffs.h | Reconstruction coefficients header file |
plm_states.c | Piecewise linear reconstruction |
ppm_coeffs.c | Compute coefficients for high-order reconstruction methods |
ppm_coeffs.h | |
ppm_states.c | Piecewise parabolic reconstruction |
► Templates | |
init.c | Contains basic functions for problem initialization |
► Thermal_Conduction | |
tc.h | Thermal conduction (TC) module header file |
tc_flux.c | Compute the thermal conduction flux |
tc_kappa.c | Define the thermal conduction coefficients |
tc_rhs.c | Compute rhs for thermal conduction |
► Time_Stepping | |
ctu_step.c | Advance equations using Corner Transport Upwind (CTU) |
rk_step.c | Advance equations with Runge Kutta time integrators |
rk_step_failsafe.c | Advance equations with Runge Kutta time integrators |
update_stage.c | Single stage integration for RK time stepping |
► Viscosity | |
visc_nu.c | Specification of explicit first and second viscosity coefficients |
viscosity.h | |
viscous_flux.c | Computes viscous fluxes and source terms for the HD/MHD equations |
viscous_rhs.c | Build the right hand side for the viscosity operator |
adv_flux.c | Compute flux for passive scalars |
array_reconstruct.c | Reconstruct an array along a given direction |
arrays.c | Memory allocation functions |
bin_io.c | Functions for handling binary I/O |
boundary.c | Set boundary conditions |
check_states.c | Check if primitive states are physically admissible |
cmd_line_opt.c | Parse command line options |
debug_tools.c | Collection of functions for debugging purposes |
doxy-comment.c | Documentation template for C source files |
entropy_switch.c | Compute entropy after boundary condition have been set |
fd_flux.c | Compute finite difference fluxes |
flag_shock.c | Shock finding algorithm |
get_nghost.c | Return the number of ghost zones |
globals.h | Collects global variables definitions |
hdf5_io.c | HDF5 I/O main driver for static grid implementation |
initialize.c | Initialize PLUTO |
input_data.c | Provide basic functionality for reading input data files |
int_bound_reset.c | Reset to zero the right hand side in the internal boundary |
jet_domain.c | Adjust the effective domain size when the -xNjet option is given |
macros.h | PLUTO header file for function-like macros |
main.c | PLUTO main function |
mappers3D.c | 3D wrapper for conservative/primitive conversion |
mean_mol_weight.c | Compute the mean molecular weight |
output_log.c | Output log file driver |
parabolic_update.c | Compute right hand side from parabolic (diffusion) terms |
parse_file.c | File parser utilities |
pluto.h | PLUTO main header file |
prototypes.h | |
rbox.c | Collects various functions to operate on the RBox structure |
reconstruct.c | General-purpose reconstruction algorithms |
restart.c | Restart PLUTO from binary or HDF5 double precision data files |
ring_average.c | Ring-average method to treat singularity at a polar axis |
rkc.c | Runge-Kutta-Chebyshev driver for integration of diffusion terms |
rkl.c | Runge-Kutta-Legendre driver for integration of diffusion terms |
rotate.c | Rotate a 1D problem |
rotate.h | |
runtime_setup.c | Read runtime information from pluto.ini |
set_geometry.c | Initialize geometry-dependent grid quantities |
set_grid.c | Create global and local grid |
set_indexes.c | Perform index permutation and set domain integration indexes |
set_output.c | Set/retrieve output data attributes |
show_config.c | Print useful information about the current computations |
split_source.c | Include source terms using operator splitting |
startup.c | Loop on the computational cells to assign initial conditions |
structs.h | PLUTO header file for structure declarations |
sts.c | Super Time Stepping driver for integration of diffusion terms |
tools.c | Collection of general-purpose functions |
var_names.c | Set default variable names |
vec_pot_diff.c | Compute magnetic field from vector potential |
vec_pot_update.c | Function to handle vector potential |
write_data.c | Main output driver for fluid variables |
write_tab.c | Write tabulated 1D or 2D ascii data files |
write_vtk.c | Write data in VTK format |
write_vtk_proc.c | Write data in VTK format (single proc mode) |