File List

Here is a list of all files with brief descriptions:
ath_array.c [code]Functions that construct and destruct 1D, 2D and 3D arrays of any type
ath_files.c [code]Function for creating descriptive output filenames
ath_log.c [code]Functions for controlling output to stderr and stdout
ath_signal.c [code]Implements very simple signal handling
athena.h [code]Contains definitions of many data types and structures
baton.c [code]Stage independent processes by passing a baton
bvals_mhd.c [code]Sets boundary conditions (quantities in ghost zones) on each edge of a Grid for the MHD variables
bvals_shear.c [code]Shearing sheet boundary conditions at ix1 and ox1 for both 2D and 3D
cc_pos.c [code]Functions to compute (x1,x2,x3) positions of cells i,j,k
convert_var.c [code]Functions to convert conservative->primitive variables, and <->
copyright.h [code]Copyright and license information
dump_binary.c [code]Function to write an unformatted dump of the field variables
dump_history.c [code]Functions to write dumps of scalar "history" variables in a formatted table
dump_tab.c [code]Functions to write a dump as a formatted table
dump_vtk.c [code]Function to write a dump in VTK "legacy" format
globals.h [code]Contains global variables
init_grid.c [code]Initializes most variables in the Grid structure
init_mesh.c [code]General initialization of the nested mesh hierarchy
main.c [code]Athena main program file
new_dt.c [code]Computes timestep using CFL condition
output.c [code]Controls output of data
output_pdf.c [code]Outputs Probability Distribution Functions of selected variables in formatted tabular form
output_pgm.c [code]Writes Portable Gray Map (PGM) outputs
output_ppm.c [code]Writes single variable as a PPM image with color table
output_tab.c [code]Functions for writing output in tabular format
output_vtk.c [code]Function to write a single variable in VTK "legacy" format
palette.h [code]Look-up tables (palettes) for inclusion in ppm images written by output_ppm()
par.c [code]Set of routines to provide simple access to a R/O parameter file
prototypes.h [code]
restart.c [code]Functions for writing and reading restart files
show_config.c [code]Outputs information on configuration of Athena
smr.c [code]Functions to handle static mesh refinement (SMR)
utils.c [code]A variety of useful utility functions
fftsrc/ath_fft.c [code]Simple wrappers for 2D and 3D FFT functions
fftsrc/prototypes.h [code]
gravity/bvals_grav.c [code]Sets boundary conditions (quantities in ghost zones) for the gravitational potential on each edge of a Grid
gravity/prototypes.h [code]
gravity/selfg.c [code]Contains functions to control solution of Poisson's equation for self-gravity
gravity/selfg_fft.c [code]Contains functions to solve Poisson's equation for self-gravity in 1D, 2D and 3D using FFTs (actually, the 1D algorithm uses Forward Elimination followed by Back Substitution: FEBS)
gravity/selfg_fft_obc.c [code]Contains functions to solve Poisson's equation for self-gravity in 3D using FFTs, using OPEN BCs in all three directions
gravity/selfg_multigrid.c [code]Contains functions to solve Poisson's equation for self-gravity in 3D using multigrid
integrators/integrate.c [code]Contains public functions to set integrator
integrators/integrate_1d_ctu.c [code]Integrate MHD equations using 1D version of the CTU integrator
integrators/integrate_1d_vl.c [code]Integrate MHD equations using 1D version of MUSCL-Hancock (VL) integrator
integrators/integrate_1d_vl_sr.c [code]Integrate SRMHD equations using 1D version of MUSCL-Hancock (VL) integrator
integrators/integrate_2d_ctu.c [code]Integrate MHD equations in 2D using the directionally unsplit CTU method of Colella (1990)
integrators/integrate_2d_vl.c [code]Integrate MHD equations using 2D version of the directionally unsplit MUSCL-Hancock (VL) integrator
integrators/integrate_2d_vl_sr.c [code]Integrate MHD equations using 2D version of the directionally unsplit MUSCL-Hancock (VL) integrator
integrators/integrate_3d_ctu.c [code]Integrate MHD equations using 3D version of the directionally unsplit CTU integrator of Colella (1990)
integrators/integrate_3d_vl.c [code]Integrate MHD equations using 3D version of the directionally unsplit MUSCL-Hancock (VL) integrator
integrators/integrate_3d_vl_sr.c [code]Integrate MHD equations using 3D version of the directionally unsplit MUSCL-Hancock (VL) integrator
integrators/prototypes.h [code]
microphysics/conduction.c [code]Adds explicit thermal conduction term to the energy equation, dE/dt = Div(Q)
microphysics/cool.c [code]Implements various optically thin cooling functions
microphysics/diff_dt.c [code]Computes diffusion timestep using CFL condition, for all diffusive processes currently implemented in code
microphysics/get_eta.c [code]Functions to calculate the diffusion coefficients for resistivity
microphysics/integrate_diffusion.c [code]Contains public functions to integrate explicit diffusion terms using operator splitting
microphysics/prototypes.h [code]
microphysics/resistivity.c [code]Adds explicit resistivity terms to the induction and energy eqns
microphysics/viscosity.c [code]Adds explicit viscosity terms to the momentum and energy equations
particles/bvals_particle.c [code]Sets boundary conditions for particles
particles/dump_particle_history.c [code]Functions to write dumps of particle "history" variables in a formatted table
particles/feedback.c [code]Exchange particle feedback between boundary cells
particles/init_particle.c [code]Initialize particle related structures and functions
particles/integrators_particle.c [code]Provide three kinds of particle integrators
particles/output_particle.c [code]Contains routines necessary for outputting particles
particles/particle.h [code]Global variables for all functions in in the src/particles directory
particles/prototypes.h [code]
particles/utils_particle.c [code]Contains most of the utilities for the particle code
prob/blast.c [code]Problem generator for spherical blast wave problem
prob/bubble.c [code]Problem generator for bubble in spherical isothermal atmosphere
prob/carbuncle.c [code]Problem generator for carbuncle instability
prob/collapse3d.c [code]Problem generator for spherical collapse
prob/cpaw1d.c [code]Problem generator for 1-D circularly polarized Alfven wave (CPAW) test
prob/cpaw2d.c [code]Problem generator for 2-D circularly polarized Alfven wave (CPAW) test
prob/cpaw3d.c [code]Problem generator for circularly polarized Alfven wave (CPAW) in 3D test
prob/cshock1d.c [code]Problem generator for 1-D standing C-type shock test
prob/current_sheet.c [code]Problem generator for current sheet test
prob/cyladvect.c [code]A simple density-pulse advection test in cylindrical coordinates with no pressure or tension forces
prob/cylblast.c [code]Problem generator for blast wave in cylindrical coords
prob/cylbphi.c [code]A simple magnetostatic test of pressure balance using a B-field with uniform phi-component
prob/cylbr.c [code]A dynamic test of force balance using a B_R-only, time-dependent, non-axisymmetric magnetic field
prob/cylfieldloop.c [code]Problem generator for advection of a field loop test in cylindrical coordinates
prob/cylnewtmri.c [code]Test of the evolution/saturation of the MRI in an unstratified/uniform Newtonian disk
prob/cylrayleigh.c [code]A test of the Rayleigh instability using omega(R) = omega_0/R^q
prob/cylunif.c [code]A test of conservation using uniform initial conditions
prob/cylwind.c [code]The cylindrical analogue of the Bondi accretion (Parker wind) problem
prob/cylwindrot.c [code]The cylindrical analogue of the Bondi accretion (Parker wind) problem with rotation
prob/cylwindrotb.c [code]The cylindrical analogue of the Bondi accretion (Parker wind) problem with rotation and magnetic field
prob/dmr.c [code]Problem generator for double Mach reflection test
prob/field_loop.c [code]Problem generator for advection of a field loop test
prob/firehose.c [code]Problem generator for firehose test of Braginskii viscosity
prob/hb3.c [code]Problem generator for 2D MRI simulations using the shearing sheet based on "A powerful local shear instability in weakly magnetized disks
prob/hgb.c [code]Problem generator for 3D shearing sheet
prob/hkdisk.c [code]Problem generator for Hawley Krolik disk (Specifically, GT4)
prob/jeans.c [code]Problem generator for simple self-gravity test
prob/jet.c [code]Sets up a jet introduced through L-x1 boundary (left edge)
prob/kh.c [code]Problem generator for KH instability
prob/linear_wave1d.c [code]Problem generator for plane-parallel, grid-aligned linear wave tests
prob/linear_wave2d.c [code]Problem generator for linear wave convergence tests in 2D
prob/linear_wave3d.c [code]Linear wave problem generator for 3D problems
prob/lw_implode.c [code]Problem generator for square implosion problem
prob/noh.c [code]Spherical Noh implosion problem, from Liska & Wendroff, section 4.5 (figure 4.7)
prob/orszag-tang.c [code]Problem generator for Orszag-Tang vortex problem
prob/par_circ.c [code]Problem generator for particle code test, works for 2D or 3D
prob/par_collision.c [code]Problem generator for particle feedback test in 2D
prob/par_epicycle.c [code]Problem generator for particle epicycle trajectory presicion test
prob/par_friction.c [code]Problem generator for particle code test, works for 2D and 3D
prob/par_linearwave1d.c [code]Problem generator for plane-parallel, grid-aligned linear wave tests with Lagrangian particles
prob/par_linearwave2d.c [code]Problem generator for oblique linear waves with Lagrangian particles
prob/par_shwave1d.c [code]Problem generator radial epicyclic wave test with Lagrangian particles
prob/par_shwave2d.c [code]Problem generator shear wave test with Lagrangian particles
prob/par_strat2d.c [code]Problem generator for non-linear streaming instability in stratified disks
prob/par_strat3d.c [code]Problem generator for non-linear streaming instability in stratified disks
prob/pgflow.c [code]Problem generator for steady planar gravitational flow in a simple 1D gravitational field
prob/planet-disk.c [code]Problem generator for planet embedded in a disk, using the shearing sheet approximation
prob/rotor.c [code]Sets up 2D rotor test problem
prob/rt.c [code]Problem generator for RT instabilty
prob/shk_cloud.c [code]Problem generator for shock-cloud problem; planar shock impacting a single spherical cloud
prob/shkset1d.c [code]Problem generator for 1-D Riemann problems
prob/shkset2d.c [code]Sets up shock at angle to grid to test multidimensional algorithm
prob/shkset3d.c [code]Sets up shock at angle to grid to test 3D algorithms
prob/shu-osher.c [code]Problem generator for Shu-Osher shocktube test, involving interaction of a Mach 3 shock with a sine wave density distribution
prob/strat.c [code]Problem generator for stratified 3D shearing sheet
prob/streaming2d_multi.c [code]Problem generator for non-linear streaming instability in non-stratified disks
prob/streaming2d_single.c [code]Problem generator for streaming instability test in non-stratified disks
prob/streaming3d_multi.c [code]Problem generator for non-linear streaming instability in non-stratified disks
prob/streaming3d_single.c [code]Problem generator for streaming instability test in non-stratified disks
prob/ti.c [code]Problem generator for thermal instability
prob/turb.c [code]Problem generator for driven and decaying turbulence
prob/twoibw.c [code]Problem generator for two interacting blast waves test
reconstruction/esystem_prim.c [code]Functions to evaluate the eigenvalues, and left- and right-eigenvectors for the linearized system in the PRIMITIVE variables
reconstruction/lr_states_dc.c [code]First order (donor cell, piecewise constant) spatial reconstruction
reconstruction/lr_states_plm.c [code]Second order (piecewise linear) spatial reconstruction using characteristic interpolation in the primitive variables
reconstruction/lr_states_ppm.c [code]Third order (piecewise parabolic) spatial reconstruction using characteristic interpolation in the primitive variables
reconstruction/lr_states_prim2.c [code]Second order (piecewise linear) spatial reconstruction in the primitive variables
reconstruction/lr_states_prim3.c [code]Third order (piecewise parabolic) spatial reconstruction in the primitive variables using the extremum-preserving limiters of Colella & Sekora
reconstruction/prototypes.h [code]
rsolvers/esystem_roe.c [code]Functions to evaluate the eigenvalues, and left- and right-eigenvectors of "Roe's matrix A" for the linearized system in the CONSERVED variables
rsolvers/exact.c [code]Computes 1D fluxes using exact nonlinear Riemann solver
rsolvers/exact_sr.c [code]Computes 1D fluxes using exact special relativistic Riemann solver
rsolvers/force.c [code]Computes 1D fluxes using a Riemann solver similar, but not identical, to Toro's FORCE (First-ORder-CEntred) flux
rsolvers/hllc.c [code]Computes 1D fluxes using the HLLC Riemann solver
rsolvers/hllc_sr.c [code]Computes 1D fluxes using the relativistic HLLC Riemann solver
rsolvers/hlld.c [code]Computes 1D fluxes using the HLLD Riemann solver
rsolvers/hlld_sr.c [code]Compute 1D fluxes using the relativistic HLLD Riemann solver described by Mignone, Ugliano, and Bodo
rsolvers/hlle.c [code]Computes 1D fluxes using the Harten-Lax-van Leer (HLLE) Riemann solver
rsolvers/hlle_sr.c [code]Compute 1D fluxes using an HLLE-type relativistic Riemann solver
rsolvers/prototypes.h [code]
rsolvers/roe.c [code]Computes 1D fluxes using Roe's linearization
rsolvers/two_shock.c [code]Computes 1D fluxes using simple two-shock Riemann solver