Index to C++ classes

Doxygen generates an HTML reference manual from stylized comments written into the EXP class definitions. This allows us to visualize the relationships between the various classes by providing dependency graphs, inheritance diagrams, and collaboration diagrams, which are all generated automatically.

In short, Doxygen is a development resource while this ReadTheDocs manual is a user resource. For this reason, Doxygen is optional and not built by default. You may opt-in to the Doxygen build when compiling EXP using the BUILD_DOCS feature (installing EXP). The resulting HTML directory is in source_dir/doc/html. Please see the Doxygen web site <https://www.doxygen.nl> to learn more.

A brief summary of the automatically-generated documentation is provide in the links below.

All classes, members, and utilities

Code reference with inheritance diagrams

template<typename T>
class abstract_value : public cxxopts::Value
#include <cxxopts.H>

Inheritence diagram for cxxopts::values::abstract_value:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="cxxopts::Value" tooltip="cxxopts::Value"]
    "1" [label="cxxopts::values::abstract_value< T >" tooltip="cxxopts::values::abstract_value< T >" fillcolor="#BFBFBF"]
    "4" [label="cxxopts::values::standard_value< T >" tooltip="cxxopts::values::standard_value< T >"]
    "3" [label="std::enable_shared_from_this< Value >" tooltip="std::enable_shared_from_this< Value >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for cxxopts::values::abstract_value:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="cxxopts::Value" tooltip="cxxopts::Value"]
    "1" [label="cxxopts::values::abstract_value< T >" tooltip="cxxopts::values::abstract_value< T >" fillcolor="#BFBFBF"]
    "3" [label="std::enable_shared_from_this< Value >" tooltip="std::enable_shared_from_this< Value >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Subclassed by cxxopts::values::standard_value< T >

Public Functions

inline abstract_value()
inline abstract_value(const abstract_value &rhs)
inline explicit abstract_value(T *t)
inline virtual std::shared_ptr<Value> default_value(const std::string &value) override
inline const T &get() const
inline virtual std::string get_default_value() const override
inline virtual std::string get_implicit_value() const override
inline virtual bool has_default() const override
inline virtual bool has_implicit() const override
inline virtual std::shared_ptr<Value> implicit_value(const std::string &value) override
inline virtual bool is_boolean() const override
inline virtual bool is_container() const override
inline virtual std::shared_ptr<Value> no_implicit_value() override
abstract_value &operator=(const abstract_value&) = default
inline virtual void parse() const override
inline virtual void parse(const std::string &text) const override
~abstract_value() override = default

Protected Attributes

bool m_default = false
std::string m_default_value = {}
bool m_implicit = false
std::string m_implicit_value = {}
std::shared_ptr<T> m_result = {}
T *m_store = {}

Private Types

using Self = abstract_value<T>
class AddDisk
#include <AddDisk.H>

Public Functions

AddDisk(std::shared_ptr<AxiSymModel> halo, std::shared_ptr<AxiSymModel> disk, double dmass)
inline std::shared_ptr<SphericalModelTable> get_model()
~AddDisk()

Public Static Attributes

static bool logarithmic
static int number
static double Rmin
static bool use_mpi

Private Members

std::vector<double> d
double dmass
std::vector<double> m
std::shared_ptr<SphericalModelTable> mod
std::vector<double> p
std::vector<double> r
class AddSpheres
#include <AddSpheres.H>

Public Functions

AddSpheres(std::shared_ptr<AxiSymModel> halo, std::shared_ptr<AxiSymModel> bulge, double bmass)
inline std::shared_ptr<SphericalModelTable> get_model()
~AddSpheres()

Public Static Attributes

static bool logarithmic
static int number
static double Rmin
static bool use_mpi

Private Members

double bmass
std::vector<double> d
std::vector<double> m
std::shared_ptr<SphericalModelTable> mod
std::vector<double> p
std::vector<double> r
struct ANGLE_GRID
#include <orbit.H>

Public Members

Eigen::MatrixXd dw1dt
Eigen::MatrixXd f
Eigen::MatrixXd fr
int num
Eigen::MatrixXd r
Eigen::MatrixXd t
Eigen::MatrixXd w1
struct ArguDesc
#include <cxxopts.H>

Public Members

std::string arg_name = ""
bool grouping = false
bool set_value = false
std::string value = ""
class argument_incorrect_type : public cxxopts::OptionParseException
#include <cxxopts.H>

Inheritence diagram for cxxopts::argument_incorrect_type:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "2" [label="cxxopts::OptionParseException" tooltip="cxxopts::OptionParseException"]
    "1" [label="cxxopts::argument_incorrect_type" tooltip="cxxopts::argument_incorrect_type" fillcolor="#BFBFBF"]
    "4" [label="std::exception" tooltip="std::exception"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for cxxopts::argument_incorrect_type:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "2" [label="cxxopts::OptionParseException" tooltip="cxxopts::OptionParseException"]
    "1" [label="cxxopts::argument_incorrect_type" tooltip="cxxopts::argument_incorrect_type" fillcolor="#BFBFBF"]
    "4" [label="std::exception" tooltip="std::exception"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline explicit argument_incorrect_type(const std::string &arg)
template<typename T = double>
class AsciiHisto
#include <AsciiHisto.H>

Process a std::vector into an ASCII histogram.

Public Functions

inline AsciiHisto(const std::vector<T> &d, int nbins = 0, bool logV = false)

Simple constructor.

inline AsciiHisto(const std::vector<T> &data, int nbins, double trim, bool logV = false)

Constructor with bin number and trim.

inline AsciiHisto(const std::vector<unsigned> &inbins, const T &inBeg, const T &inEnd, bool logV = false)

Constructor for pre-existing bins.

inline void operator()(std::ostream &out, unsigned hwid = 60)

Print the distribution.

Private Functions

inline void makeBins(const std::vector<T> &d, int nbins)

Private Members

T beg
std::vector<unsigned> bins
T dx
T end
bool logH
class AxiDisk
#include <EmpCylSL.H>

Inheritence diagram for EmpCylSL::AxiDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="DoubleExponential" tooltip="DoubleExponential"]
    "1" [label="EmpCylSL::AxiDisk" tooltip="EmpCylSL::AxiDisk" fillcolor="#BFBFBF"]
    "3" [label="Exponential" tooltip="Exponential"]
    "4" [label="FEED" tooltip="FEED"]
    "5" [label="Ferrers" tooltip="Ferrers"]
    "6" [label="MNdisk" tooltip="MNdisk"]
    "7" [label="PyModel" tooltip="PyModel"]
    "8" [label="Truncated" tooltip="Truncated"]
    "9" [label="diskbulge" tooltip="diskbulge"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
    "5" -> "1" [dir=forward tooltip="public-inheritance"]
    "6" -> "1" [dir=forward tooltip="public-inheritance"]
    "7" -> "1" [dir=forward tooltip="public-inheritance"]
    "8" -> "1" [dir=forward tooltip="public-inheritance"]
    "9" -> "1" [dir=forward tooltip="public-inheritance"]
}

Axisymmetric disk density function for deprojection.

Subclassed by DoubleExponential, Exponential, FEED, Ferrers, MNdisk, PyModel, Truncated, diskbulge

Public Functions

inline AxiDisk(double M = 1, std::string id = "AxiDisk")

Constructor.

inline std::string getID()

Get ID.

inline int getMass()

Get Mass.

inline std::vector<double> getParams()

Get parameters.

virtual double operator()(double R, double z, double phi = 0.) = 0

Density function.

Protected Attributes

std::string ID
double M
std::vector<double> params
class AxiSymBiorth : public Biorth
#include <biorth.H>

Inheritence diagram for AxiSymBiorth:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="AxiSymBiorth" tooltip="AxiSymBiorth" fillcolor="#BFBFBF"]
    "3" [label="BSDisk" tooltip="BSDisk"]
    "4" [label="BSSphere" tooltip="BSSphere"]
    "2" [label="Biorth" tooltip="Biorth"]
    "5" [label="BiorthGrid" tooltip="BiorthGrid"]
    "6" [label="CBDisk" tooltip="CBDisk"]
    "7" [label="CBSphere" tooltip="CBSphere"]
    "8" [label="HQSphere" tooltip="HQSphere"]
    "9" [label="SphereSL" tooltip="SphereSL"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
    "5" -> "1" [dir=forward tooltip="public-inheritance"]
    "6" -> "1" [dir=forward tooltip="public-inheritance"]
    "7" -> "1" [dir=forward tooltip="public-inheritance"]
    "8" -> "1" [dir=forward tooltip="public-inheritance"]
    "9" -> "1" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for AxiSymBiorth:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="AxiSymBiorth" tooltip="AxiSymBiorth" fillcolor="#BFBFBF"]
    "2" [label="Biorth" tooltip="Biorth"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Subclassed by BSDisk, BSSphere, BiorthGrid, CBDisk, CBSphere, HQSphere, SphereSL

Public Functions

inline AxiSymBiorth(int DOF = 0)
virtual double d_r_to_rb(double const) = 0
virtual double dens(const int, const int, const double) = 0
virtual void dens(const int, const int, const double, Eigen::VectorXd&) = 0
double get_dens(double r, int l, const Eigen::VectorXd &coef)
inline int get_dof(void)
double get_potl(double r, int l, const Eigen::VectorXd &coef)
virtual double potl(const int, const int, const double) = 0
virtual void potl(const int, const int, const double, Eigen::VectorXd&) = 0
virtual double potlR(const int, const int, const double) = 0
virtual double potlRZ(const int, const int, const double, const double) = 0
virtual double r_to_rb(double const) = 0
virtual double rb_max(void) = 0
virtual double rb_min(void) = 0
virtual double rb_to_r(double const) = 0
inline virtual ~AxiSymBiorth()

Protected Attributes

int dof

Friends

friend class BiorthWake
class AxisymmetricBasis : public Basis

Inheritence diagram for AxisymmetricBasis:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="AxisymmetricBasis" tooltip="AxisymmetricBasis" fillcolor="#BFBFBF"]
    "2" [label="Basis" tooltip="Basis"]
    "8" [label="Bessel" tooltip="Bessel"]
    "5" [label="CBDisk" tooltip="CBDisk"]
    "6" [label="FlatDisk" tooltip="FlatDisk"]
    "4" [label="PolarBasis" tooltip="PolarBasis"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "9" [label="Sphere" tooltip="Sphere"]
    "7" [label="SphericalBasis" tooltip="SphericalBasis"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "8" -> "7" [dir=forward tooltip="public-inheritance"]
    "5" -> "4" [dir=forward tooltip="public-inheritance"]
    "6" -> "4" [dir=forward tooltip="public-inheritance"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
    "9" -> "7" [dir=forward tooltip="public-inheritance"]
    "7" -> "1" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for AxisymmetricBasis:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="AxisymmetricBasis" tooltip="AxisymmetricBasis" fillcolor="#BFBFBF"]
    "2" [label="Basis" tooltip="Basis"]
    "5" [label="Component" tooltip="Component"]
    "7" [label="EL3" tooltip="EL3"]
    "6" [label="Orient" tooltip="Orient"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "8" [label="Timer" tooltip="Timer"]
    "4" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "5" -> "5" [dir=forward tooltip="usage"]
    "5" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "5" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
}

Defines a basis-based potential and acceleration class.

YAML configuration

Param Lmax:

is the maximum spherical harmonic order

Param Mmax:

is the maximum cylindrical harmonic order

Param nmax:

is the maximum radial order

Param dof:

is the dimensionality of the basis

Param npca:

is the frequency for pca analyses

Param npca0:

is the number of steps to skip before the first pca analysis

Param pcavar:

boolean turns on pca analyses

Param pcaeof:

boolean turns on emperical function recomputation

Param pcadiag:

boolean turns on diagnostic pca output

Param pcavtk:

boolean prints out visualizable representations of pca info

Param hexp:

is the Hall smoothing exponent

Param samplesz:

is the number of subsamples for pca variance analysis (default: 1). Value 0 means use sqrt number of particles

Param vtkfreq:

is the frequency for printing pca variance analysis info

Param tksmooth:

is the S/N for Hall truncation for VarianceCut method

Param tkcum:

is the cumulative fraction eigenvalue power for truncation for CmululativeCut method

Param tk_type:

is the smoothing type, one of: Hall, VarianceCut, CumulativeCut, VarianceWeighted

Param subsamp:

true sets partition variance computation (default: false)

Subclassed by PolarBasis, SphericalBasis

Public Types

enum TKType

Enum listing the possible selection algorithms for coefficient selection

Values:

enumerator Hall

Tapered signal-to-noise power defined by Hall

enumerator VarianceCut

Cut all coefficients below some S/N level

enumerator CumulativeCut

Cut coefficients below some cumulative fraction

enumerator VarianceWeighted

Weight coefficients be S/N for S/N<1

enumerator None

Compute the S/N but do not modify coefficients

Public Functions

AxisymmetricBasis(Component *c0, const YAML::Node &line)

Constructor.

inline VectorP getCoefs(int l) const

Access coefficients.

inline int getLmax()

Get angular order.

inline int getMmax()
inline int getNmax()

Get radial order.

inline virtual void multistep_reset()

Reset used particle counter.

void pca_hall(bool compute)

Compute component noise suppression using PCA analysis.

void pca_hall_2d(bool compute)
void pca_hall_3d(bool compute)
TKType setTK(const std::string &tk)

Set tk_type from string.

virtual ~AxisymmetricBasis()

Destructor.

Protected Types

typedef std::shared_ptr<Eigen::MatrixXd> MatrixP
typedef std::shared_ptr<Eigen::VectorXd> VectorP

Expansion coefficients (summed over all nodes)

The vector entries store coefficients for a multistep expansion. Move pointers rather than objects for efficiency.

Protected Functions

virtual void parallel_distribute_coefficients(void)

MPI routines to distribution the expansion coefficients (expcoef) from all nodes.

virtual void parallel_gather_coef2(void)

MPI routines to sum the expansion coefficients variance moments (cc) from all nodes.

virtual void parallel_gather_coefficients(void)

MPI routines to sum the expansion coefficients (expcoef) from all nodes.

inline void swap_coefs(std::vector<VectorP> &from, std::vector<VectorP> &to)

Swap coefficients.

Protected Attributes

unsigned defSampT
std::vector<VectorP> expcoef
std::vector<VectorP> expcoef1
std::vector<std::vector<VectorP>> expcoefL
std::vector<std::vector<MatrixP>> expcoefM
std::vector<std::vector<MatrixP>> expcoefM1
std::vector<std::vector<VectorP>> expcoefN

Interpolation arrays.

std::vector<VectorP> expcoefP
std::vector<std::vector<VectorP>> expcoefT

Covariance arrays.

std::vector<std::vector<VectorP>> expcoefT1
double hexp

Hall smoothing exponent (default: 1.0)

int Lmax

Maximum angular harmonic.

std::vector<double> massT

Mass and counts for subsample covariance.

std::vector<double> massT1
int Mmax
double muse

Accumulated mass for variance computation.

int nmax

Maximum radial basis index.

Eigen::MatrixXd normM

Normalization for covariance matrix based on the biorthogonal basis norm.

int npca

Frequency of PCA computation.

int npca0

First step for PCA computation.

bool pcadiag

Output PCA diagnostics.

bool pcaeof

Compute eof decomposition.

bool pcavar

Use principal component bootstrap analysis of variance to select coefficients

bool pcavtk

Output PCA diagnostics in vtk format.

unsigned sampT
double snr

Signal-to-noise scaling parameter (default: 1.0)

Eigen::MatrixXd sqnorm

Sqr root of the normalization.

bool subsamp

Partitioned variance computation.

std::vector<MatrixP> tvar

Test for eof trim.

unsigned vtkfreq

VTK diagnostic frequency.

Protected Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

Private Members

std::vector<Eigen::VectorXd> b_Hall
Eigen::MatrixXd covar
Eigen::VectorXd cuml
Eigen::VectorXd eval
std::vector<Eigen::MatrixXd> evec
double fac02
Eigen::VectorXd inv
int L0
int Ldim
std::vector<Eigen::VectorXd> s_Hall
Eigen::VectorXd smth
std::vector<Eigen::MatrixXd> Tevec
TKType tk_type
double tkcum
double tksmooth
std::vector<Eigen::VectorXd> weight
class AxiSymModel : public MassModel, public std::enable_shared_from_this<AxiSymModel>
#include <massmodel.H>

Inheritence diagram for AxiSymModel:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="AxiSymModel" tooltip="AxiSymModel" fillcolor="#BFBFBF"]
    "4" [label="CylDisk" tooltip="CylDisk"]
    "5" [label="DiskWithHalo" tooltip="DiskWithHalo"]
    "6" [label="EmbeddedDiskModel" tooltip="EmbeddedDiskModel"]
    "7" [label="ExponentialDisk" tooltip="ExponentialDisk"]
    "8" [label="GeneralizedPolytrope" tooltip="GeneralizedPolytrope"]
    "9" [label="HernquistSphere" tooltip="HernquistSphere"]
    "10" [label="HunterDisk" tooltip="HunterDisk"]
    "11" [label="HunterDiskX" tooltip="HunterDiskX"]
    "12" [label="IsothermalSphere" tooltip="IsothermalSphere"]
    "13" [label="KalnajsDisk" tooltip="KalnajsDisk"]
    "21" [label="KingSphere" tooltip="KingSphere"]
    "14" [label="LowSingIsothermalSphere" tooltip="LowSingIsothermalSphere"]
    "2" [label="MassModel" tooltip="MassModel"]
    "15" [label="MestelDisk" tooltip="MestelDisk"]
    "17" [label="PlummerSphere" tooltip="PlummerSphere"]
    "18" [label="SingIsothermalSphere" tooltip="SingIsothermalSphere"]
    "19" [label="SphericalModelMulti" tooltip="SphericalModelMulti"]
    "20" [label="SphericalModelTable" tooltip="SphericalModelTable"]
    "16" [label="TaperedMestelDisk" tooltip="TaperedMestelDisk"]
    "22" [label="ToomreDisk" tooltip="ToomreDisk"]
    "3" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "3" [dir=forward tooltip="public-inheritance"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
    "5" -> "1" [dir=forward tooltip="public-inheritance"]
    "6" -> "1" [dir=forward tooltip="public-inheritance"]
    "7" -> "1" [dir=forward tooltip="public-inheritance"]
    "8" -> "1" [dir=forward tooltip="public-inheritance"]
    "9" -> "1" [dir=forward tooltip="public-inheritance"]
    "10" -> "1" [dir=forward tooltip="public-inheritance"]
    "11" -> "1" [dir=forward tooltip="public-inheritance"]
    "12" -> "1" [dir=forward tooltip="public-inheritance"]
    "13" -> "1" [dir=forward tooltip="public-inheritance"]
    "21" -> "20" [dir=forward tooltip="public-inheritance"]
    "14" -> "1" [dir=forward tooltip="public-inheritance"]
    "15" -> "1" [dir=forward tooltip="public-inheritance"]
    "17" -> "1" [dir=forward tooltip="public-inheritance"]
    "18" -> "1" [dir=forward tooltip="public-inheritance"]
    "19" -> "1" [dir=forward tooltip="public-inheritance"]
    "20" -> "1" [dir=forward tooltip="public-inheritance"]
    "16" -> "15" [dir=forward tooltip="public-inheritance"]
    "22" -> "1" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for AxiSymModel:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "6" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "1" [label="AxiSymModel" tooltip="AxiSymModel" fillcolor="#BFBFBF"]
    "7" [label="GaussQuad" tooltip="GaussQuad"]
    "2" [label="MassModel" tooltip="MassModel"]
    "5" [label="RegularOrbit" tooltip="RegularOrbit"]
    "4" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "3" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "4" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="public-inheritance"]
    "4" -> "6" [dir=forward tooltip="usage"]
    "4" -> "7" [dir=forward tooltip="usage"]
}

A specification of a MassModel to the axisymmetric case.

Subclassed by CylDisk, DiskWithHalo, EmbeddedDiskModel, ExponentialDisk, GeneralizedPolytrope, HernquistSphere, HunterDisk, HunterDiskX, IsothermalSphere, KalnajsDisk, LowSingIsothermalSphere, MestelDisk, PlummerSphere, SingIsothermalSphere, SphericalModelMulti, SphericalModelTable, ToomreDisk

Public Types

using PSret = std::tuple<Eigen::VectorXd, int>

Public Functions

inline AxiSymModel(void)

Constructor.

virtual double d2fde2(double, double) = 0
virtual double dfde(double, double) = 0
virtual double dfdl(double, double) = 0
virtual double distf(double, double) = 0
inline virtual PSret gen_point()

Generate a phase-space point.

inline virtual PSret gen_point(double Emin, double Emax, double Kmin, double Kmax)

Generate a phase-space point at a particular energy and angular momentum.

inline virtual PSret gen_point(double r)

Generate a phase-space point at a particular radius.

inline virtual PSret gen_point(double r, double theta, double phi)

Generate a phase-space point at a particular radius, theta, and phi.

inline virtual PSret gen_point_iso(double r, double theta, double phi, int N, int nv, int na, double PHI, double THETA, double PSI)

Generate a phase-space point at a particular radius, theta, and phi.

inline virtual PSret gen_point_jeans()

Generate a phase-space point using Jeans’ equations.

virtual int gen_velocity(double *pos, double *vel)

Generate a the velocity variate from a position.

inline virtual double get_density(const double x1, const double x2, const double x3) override

The density at (x, y, z)

virtual double get_density(const double) = 0
virtual double get_dpot(const double) = 0
virtual double get_dpot2(const double) = 0
inline virtual double get_mass(const double x1, const double x2, const double x3) override

Get the mass inside of position (x, y, z) (this is ambiguous in general and will depend on the model)

virtual double get_mass(const double) = 0

Access the profile.

virtual double get_max_radius(void) = 0
virtual double get_min_radius(void) = 0
inline virtual double get_pot(const double x1, const double x2, const double x3) override

The potential at (x, y, z)

virtual double get_pot(const double) = 0
virtual void get_pot_dpot(const double, double&, double&) = 0
inline void set_Ecut(double cut)

Set cutoff on multimass realization grid.

inline void set_itmax(int s)

Maximum number of iterations for obtaining a valid variate.

inline virtual ~AxiSymModel()

Destructor.

Public Members

bool dist_defined

The distribution is defined and computed.

Public Static Attributes

static int gen_E
static bool gen_EJ

Stuff for gen_point.

static int gen_itmax
static int gen_K
static double gen_kmin
static int gen_logr
static int gen_N
static double gen_rmin
static double gen_tolE
static double gen_tolK
static int numj
static int numr

Protected Types

typedef vector<WRgrid> wrvector

Protected Functions

PSret gen_point_2d()
PSret gen_point_2d(double r)
PSret gen_point_3d()
PSret gen_point_3d(double Emin, double Emax, double Kmin, double Kmax)
PSret gen_point_3d(double r, double theta, double phi)
PSret gen_point_3d_iso(double r, double theta, double phi, int N, int nv, int na, double PHI = 0, double THETA = 0, double PSI = 0)
PSret gen_point_jeans_3d()

Protected Attributes

double dEgrid
double dKgrid
vector<double> Egrid
vector<double> EgridMass
double Emax_grid
double Emin_grid
std::normal_distribution Gauss
double gen_ecut
bool gen_firstime
bool gen_firstime_E
bool gen_firstime_jeans
Eigen::VectorXd gen_fmax
double gen_fomax
double gen_lastr = -1.0
Eigen::VectorXd gen_mass
SphericalOrbit gen_orb
Eigen::VectorXd gen_rloc
vector<double> Jmax
vector<double> Kgrid
vector<wrvector> Rgrid
std::uniform_real_distribution Unit

Stuff for gen_point.

class BadIndexException : public EXPException
#include <EXPException.H>

Inheritence diagram for BadIndexException:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="BadIndexException" tooltip="BadIndexException" fillcolor="#BFBFBF"]
    "2" [label="EXPException" tooltip="EXPException"]
    "3" [label="std::exception" tooltip="std::exception"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for BadIndexException:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="BadIndexException" tooltip="BadIndexException" fillcolor="#BFBFBF"]
    "2" [label="EXPException" tooltip="EXPException"]
    "3" [label="std::exception" tooltip="std::exception"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
}

Handle bad range related exception PartMap.

Public Functions

inline BadIndexException(int index, int num, const std::string sourcefilename, int sourcelinenumber, int errorcode = -1, bool deadlock = true)

Constructor.

class BarrierWrapper
#include <BarrierWrapper.H>

Collaboration diagram for BarrierWrapper:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="BarrierWrapper" tooltip="BarrierWrapper" fillcolor="#BFBFBF"]
    "2" [label="Timer" tooltip="Timer"]
    "1" -> "2" [dir=forward tooltip="usage"]
}

Public Functions

BarrierWrapper(const BarrierWrapper &inst)

Copy constructor.

BarrierWrapper(MPI_Comm comm, bool label = false)

Constructor.

std::vector<int> getMissing(BWPtr p)
inline double getTime()
inline void off()
inline void on()
inline void operator()(const string &label, const char *file, const int line)
inline void setHeavyWeight()
inline void setLightWeight()
~BarrierWrapper()

Destructor.

Public Static Attributes

static int cbufsz

Buffer size for checking working labels.

static bool debugging
static bool extra_verbose
static string flOper

The source file containing the call.

static bool inOper

Set to true while control is in the wrapper.

static string lbOper

The label supplied by the caller.

static int lnOper

The source file line number with the call.

static int loop_delay

Loop wait in microseconds for heavy operator mode (default: 100)

static bool verbose

Debugging output flag.

Private Types

typedef std::pair<CharPtr, ReqPtr> RecvElem

Private Functions

void finalReport(std::string&)
void heavy_operator(const string &label, const char *file, const int line)
void light_operator(const string &label, const char *file, const int line)
void listReport(const char*, std::map<std::string, BWPtr>::iterator)
void syncTest(const std::string &mesg, const std::string &label)
void updateMap(InfoPtr p)

Private Members

char *buffer
char *bufferT
bool check_label
MPI_Comm comm
int commsize
int localid
unsigned nrecv
bool onoff
std::map<std::string, BWPtr> pending
unsigned queued
std::list<RecvElem> req
Timer timer

Private Static Attributes

static bool light

Friends

friend class Info
class Basis : public PotAccel
#include <Basis.H>

Inheritence diagram for Basis:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="AxisymmetricBasis" tooltip="AxisymmetricBasis"]
    "1" [label="Basis" tooltip="Basis" fillcolor="#BFBFBF"]
    "8" [label="Bessel" tooltip="Bessel"]
    "5" [label="CBDisk" tooltip="CBDisk"]
    "10" [label="Cylinder" tooltip="Cylinder"]
    "6" [label="FlatDisk" tooltip="FlatDisk"]
    "4" [label="PolarBasis" tooltip="PolarBasis"]
    "2" [label="PotAccel" tooltip="PotAccel"]
    "9" [label="Sphere" tooltip="Sphere"]
    "7" [label="SphericalBasis" tooltip="SphericalBasis"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "8" -> "7" [dir=forward tooltip="public-inheritance"]
    "5" -> "4" [dir=forward tooltip="public-inheritance"]
    "10" -> "1" [dir=forward tooltip="public-inheritance"]
    "6" -> "4" [dir=forward tooltip="public-inheritance"]
    "4" -> "3" [dir=forward tooltip="public-inheritance"]
    "9" -> "7" [dir=forward tooltip="public-inheritance"]
    "7" -> "3" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Basis:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Basis" tooltip="Basis" fillcolor="#BFBFBF"]
    "4" [label="Component" tooltip="Component"]
    "6" [label="EL3" tooltip="EL3"]
    "5" [label="Orient" tooltip="Orient"]
    "2" [label="PotAccel" tooltip="PotAccel"]
    "7" [label="Timer" tooltip="Timer"]
    "3" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "4" -> "4" [dir=forward tooltip="usage"]
    "4" -> "2" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="usage"]
    "4" -> "7" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "2" -> "4" [dir=forward tooltip="usage"]
    "3" -> "2" [dir=forward tooltip="usage"]
}

Defines a basis-based potential and acceleration class.

Subclassed by AxisymmetricBasis, Cylinder

Utility functions

void legendre_R(int lmax, double x, Eigen::MatrixXd &p)

Compute Associated Legendre Polynomials, return MatrixXd type.

void dlegendre_R(int lmax, double x, Eigen::MatrixXd &p, Eigen::MatrixXd &dp)

Compute Associated Legendre Polynomials and derivitives, return Matrix type

void sinecosine_R(int mmax, double phi, Eigen::VectorXd &c, Eigen::VectorXd &s)

Compute vectors of sines and cosines by recursion.

Public Functions

Basis(Component *c0, const YAML::Node &conf)

Constructor.

virtual void determine_acceleration_and_potential(void) = 0

All derived classes must provide a method to compute the force.

virtual void determine_fields_at_point(double x, double y, double z, double *tdens0, double *tpotl0, double *tdens, double *tpotl, double *tpotx, double *tpoty, double *tpotz) = 0

Supply density, potential and derivatives at a point in Cartesian coordinates

virtual void determine_fields_at_point_cyl(double r, double z, double phi, double *tdens0, double *dpotl0, double *tdens, double *tpotl, double *tpotr, double *tpotz, double *tpotp) = 0

Supply density, potential and derivatives at a point in cylindrical coordinates

virtual void determine_fields_at_point_sph(double r, double theta, double phi, double *tdens0, double *dpotl0, double *tdens, double *tpotl, double *tpotr, double *tpott, double *tpotp) = 0

Supply density, potential and derivatives at a point in spherical coordinates

class Basis2d
#include <EmpCyl2d.H>

Two-d basis models.

Public Functions

virtual double dens(int M, int N, double r) = 0
virtual double dpot(int M, int N, double r) = 0
virtual double norm(int N, int M) = 0
virtual double potl(int M, int N, double r) = 0

Required basis-function members.

Public Static Functions

static std::shared_ptr<Basis2d> createBasis(int mmax, int nmaxfid, double rmax, const std::string &type)

Basis creation factory.

Public Static Attributes

static bool debug

Enable orthgonality check.

class Bess
#include <Bess.H>

Generate orthonormal Bessel functions of integral order.

Public Functions

inline Bess(double order, unsigned int nroots)

Constructor: set the order and number of radial functions.

inline double eval(double &x, unsigned &m)

Evaluate the Bessel for x in [0, 1] for radial order m.

inline double getNorm(int m)

Get the norm for radial order m.

inline double operator()(double &x, const unsigned &m)

Evaluate the Bessel for x in [0, 1] for radial order m.

Private Functions

std::tuple<double, double> bracket(std::function<double(double)> B, double zmin, double z0)
std::vector<double> zeros(double Nu, int Nz, double tol = 1.0e-18)

Private Members

std::vector<double> norm
unsigned int nroots
double order
std::vector<double> roots
class Bessel : public SphericalBasis
#include <Bessel.H>

Inheritence diagram for Bessel:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="AxisymmetricBasis" tooltip="AxisymmetricBasis"]
    "4" [label="Basis" tooltip="Basis"]
    "1" [label="Bessel" tooltip="Bessel" fillcolor="#BFBFBF"]
    "5" [label="PotAccel" tooltip="PotAccel"]
    "2" [label="SphericalBasis" tooltip="SphericalBasis"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "4" -> "5" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Bessel:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="AxisymmetricBasis" tooltip="AxisymmetricBasis"]
    "4" [label="Basis" tooltip="Basis"]
    "1" [label="Bessel" tooltip="Bessel" fillcolor="#BFBFBF"]
    "7" [label="Component" tooltip="Component"]
    "9" [label="EL3" tooltip="EL3"]
    "11" [label="MixtureBasis" tooltip="MixtureBasis"]
    "8" [label="Orient" tooltip="Orient"]
    "5" [label="PotAccel" tooltip="PotAccel"]
    "2" [label="SphericalBasis" tooltip="SphericalBasis"]
    "10" [label="Timer" tooltip="Timer"]
    "12" [label="TwoCenter" tooltip="TwoCenter"]
    "6" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "4" -> "5" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "7" -> "7" [dir=forward tooltip="usage"]
    "7" -> "5" [dir=forward tooltip="usage"]
    "7" -> "8" [dir=forward tooltip="usage"]
    "7" -> "10" [dir=forward tooltip="usage"]
    "11" -> "12" [dir=forward tooltip="usage"]
    "8" -> "9" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "7" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "11" [dir=forward tooltip="usage"]
    "12" -> "5" [dir=forward tooltip="public-inheritance"]
    "12" -> "4" [dir=forward tooltip="usage"]
    "12" -> "11" [dir=forward tooltip="usage"]
    "6" -> "5" [dir=forward tooltip="usage"]
}

Computes the potential, acceleration and density using eigenfunctions of the Spherical Laplacian: spherical Bessel functions

Public Functions

Bessel(Component *c0, const YAML::Node &conf, MixtureBasis *m = 0)

Constructor.

inline virtual ~Bessel()

Destructor.

Private Functions

double dens(double r, int n)

Density and potential members.

double get_dens(double r, int l, double *coef)
virtual void get_dens(int lmax, int nmax, double r, Eigen::MatrixXd &p, int tid)

Get derivative of potential

Parameters:
  • lmax – is the maximum harmonic order

  • nmax – is the maximum radial order

  • r – is the evaluation radius

  • d – will be returned array in harmonics l and radial order n for the density

  • tid – is the thread enumerator that allows the function to provide some thread safety

void get_dens_coefs(int l, double *coef, double *p)
virtual void get_dpotl(int lmax, int nmax, double r, Eigen::MatrixXd &p, Eigen::MatrixXd &dp, int tid)

Get derivative of potential

Parameters:
  • lmax – is the maximum harmonic order

  • nmax – is the maximum radial order

  • r – is the evaluation radius

  • p – will be returned array in harmonics l and radial order n for the potential

  • dp – will be returned array in harmonics l and radial order n for the derivative of the potential

  • tid – is the thread enumerator that allows the function to provide some thread safety

void get_pot_coefs(int l, double *coef, double *p, double *dp)

Required members for Spherical Basis.

void get_pot_coefs_safe(int l, double *coef, double *p, double *dp, double **potd1, double **dpot1)
virtual void get_potl(int lmax, int nmax, double r, Eigen::MatrixXd &p, int tid)

Get derivative of potential

Parameters:
  • lmax – is the maximum harmonic order

  • nmax – is the maximum radial order

  • r – is the evaluation radius

  • p – will be returned array in harmonics l and radial order n for the potential

  • tid – is the thread enumerator that allows the function to provide some thread safety

virtual void get_potl_dens(int lmax, int nmax, double r, Eigen::MatrixXd &p, Eigen::MatrixXd &d, int tid)

Get derivative of potential

Parameters:
  • lmax – is the maximum harmonic order

  • nmax – is the maximum radial order

  • r – is the evaluation radius

  • p – will be returned array in harmonics l and radial order n for the potential

  • d – will be returned array in harmonics l and radial order n for the density

  • tid – is the thread enumerator that allows the function to provide some thread safety

virtual void initialize()

Initialize parameters from YAML.

void make_grid(double rmin, double rmax, int lmax, int nmax)

Make the density and potential grid.

double potl(double r, int n)

Private Members

std::vector<RGrid> dens_grid

Grid storage and parameters.

bool firstime_accel
bool firstime_coef
std::shared_ptr<Roots> p

Root database isntance.

std::vector<RGrid> potl_grid
Eigen::VectorXd r_grid
double r_grid_del
int RNUM

Number of entries in the fixed table.

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class Biorth
#include <biorth.H>

Inheritence diagram for Biorth:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymBiorth" tooltip="AxiSymBiorth"]
    "3" [label="BSDisk" tooltip="BSDisk"]
    "4" [label="BSSphere" tooltip="BSSphere"]
    "1" [label="Biorth" tooltip="Biorth" fillcolor="#BFBFBF"]
    "5" [label="BiorthGrid" tooltip="BiorthGrid"]
    "6" [label="CBDisk" tooltip="CBDisk"]
    "7" [label="CBSphere" tooltip="CBSphere"]
    "8" [label="HQSphere" tooltip="HQSphere"]
    "10" [label="OneDBiorth" tooltip="OneDBiorth"]
    "11" [label="OneDTrig" tooltip="OneDTrig"]
    "9" [label="SphereSL" tooltip="SphereSL"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
    "3" -> "2" [dir=forward tooltip="public-inheritance"]
    "4" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "2" [dir=forward tooltip="public-inheritance"]
    "6" -> "2" [dir=forward tooltip="public-inheritance"]
    "7" -> "2" [dir=forward tooltip="public-inheritance"]
    "8" -> "2" [dir=forward tooltip="public-inheritance"]
    "10" -> "1" [dir=forward tooltip="public-inheritance"]
    "11" -> "10" [dir=forward tooltip="public-inheritance"]
    "9" -> "2" [dir=forward tooltip="public-inheritance"]
}

Subclassed by AxiSymBiorth, OneDBiorth

Public Functions

inline void bomb(const char *s)
virtual double dens(const int, const int, const double) = 0
inline const std::string &id(void)
virtual double krnl(const int, const int) = 0
virtual double norm(const int, const int) = 0
virtual double potl(const int, const int, const double) = 0
inline virtual ~Biorth()

Public Members

std::string BiorthID
class BiorthCube
#include <BiorthCube.H>

! BiorthCube grid class

Public Types

using coefType = Eigen::Tensor<std::complex<double>, 3>

Coefficient type.

Public Functions

BiorthCube(const YAML::Node &conf)

Constructor.

std::complex<double> dens(Eigen::Vector3d x, Eigen::Vector3i n)

Get density for dimensionless coord with harmonic order l and radial orer n

Eigen::Vector3cd force(Eigen::Vector3d x, Eigen::Vector3i n)

Get radial force for dimensionless coord with harmonic order l and radial orer n.

std::complex<double> get_dens(const coefType &c, Eigen::Vector3d x)

Get density for dimensionless coord with harmonic order l and radial orer n

Eigen::Vector3cd get_force(const coefType &c, Eigen::Vector3d x)

Get radial force for dimensionless coord with harmonic order l and radial orer n.

std::complex<double> get_pot(const coefType &c, Eigen::Vector3d x)

Get potential for dimensionless coord with harmonic order m and radial orer n.

Eigen::MatrixXcd orthoCheck()

For pyEXP.

std::complex<double> pot(Eigen::Vector3d x, Eigen::Vector3i n)

Get potential for dimensionless coord with harmonic order m and radial orer n.

inline virtual ~BiorthCube()

Destructor.

Public Static Attributes

static int mpi

Flag for MPI enabled (default: 0=off)

Protected Attributes

YAML::Node conf
std::string forceID
std::string geometry
int knots
Eigen::Vector3i nmax
Eigen::Vector3i nmin
bool verbose

Protected Static Attributes

static constexpr double dfac = 2.0 * M_PI
static constexpr std::complex<double> kfac = {0.0, dfac}
class BiorthCyl
#include <BiorthCyl.H>

Collaboration diagram for BiorthCyl:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="BiorthCyl" tooltip="BiorthCyl" fillcolor="#BFBFBF"]
    "2" [label="EmpCyl2d" tooltip="EmpCyl2d"]
    "3" [label="EmpCyl2d::Mapping" tooltip="EmpCyl2d::Mapping"]
    "1" -> "2" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="usage"]
}

! BiorthCyl grid class

Public Functions

BiorthCyl(const YAML::Node &conf)

Constructor.

double d_xi_to_r(double x)

Jacobian of nondimensional radial coordinate mapping.

double d_yi_to_z(double y)

Jacobian of nondimensional vertical coordinate mapping.

void dump_basis(const string &name)

Dump the basis for plotting.

inline double get_dens(double x, double y, int m, int n)

Get density for dimensionless coord with harmonic order l and radial orer n

inline void get_dens(Eigen::MatrixXd &d, double r, double z)

Get density for dimensionless coord with harmonic order l and radial orer n

inline double get_pot(double x, double y, int m, int n)

Get potential for dimensionless coord with harmonic order m and radial orer n.

inline void get_pot(Eigen::MatrixXd &p, double r, double z)

Get potential for dimensionless coord with harmonic order m and radial orer n.

void get_pot(Eigen::MatrixXd &Vc, Eigen::MatrixXd &Vs, double r, double z)

Evaluate all orders in matrices; for n-body.

inline double get_rforce(double x, double y, int m, int n)

Get radial force for dimensionless coord with harmonic order l and radial orer n.

inline void get_rforce(Eigen::MatrixXd &f, double r, double z)

Get radial force for dimensionless coord with harmonic order l and radial orer n.

inline double get_zforce(double x, double y, int m, int n)

Get radial force for dimensionless coord with harmonic order l and radial orer n.

inline void get_zforce(Eigen::MatrixXd &f, double r, double z)

Get radial force for dimensionless coord with harmonic order l and radial orer n.

inline const std::string getBiorthName()

Get biorthogonal function base name.

inline const std::string getModelName()

Get model name.

inline double getRtable()

Get the table bounds.

inline double getXmax()
inline double getXmin()

Get table range bounds.

inline double getYmax()
inline double getYmin()
std::vector<Eigen::MatrixXd> orthoCheck()

For pyEXP.

double r_to_xi(double r)

Map radial coordinate to nondimensional coordinate.

double xi_to_r(double x)

Map nondimensional coordinate to radial coordinate.

double yi_to_z(double y)

Map of nondimensional coordinate to vertical coordinate.

double z_to_yi(double z)

Map of vertical coordinate to nondimesional coordinate.

inline virtual ~BiorthCyl()

Destructor.

Public Static Functions

static std::map<std::string, std::string> cacheInfo(const std::string &cachefile, bool verbose = true)

Read and print the cache and return the header parameters as a map/dictionary

static YAML::Node getHeader(const std::string &cachefile)

Read the cache and report parameters.

Public Static Attributes

static int mpi

Flag for MPI enabled (default: 0=off)

Protected Functions

void create_tables()

Build basis tables.

void initialize()

Create storage arrays.

void interp(double R, double z, const std::vector<std::vector<Eigen::MatrixXd>> &mat, Eigen::MatrixXd &ret, bool anti_symmetric = false)

Matrix interpolation on grid for coefficient composition.

double interp(int m, int n, double R, double z, const std::vector<std::vector<Eigen::MatrixXd>> &mat, bool anti_symmetric = false)

Interpolate on grid.

virtual void ReadH5Arrays(HighFive::Group &arrays)

Read the basis arrays.

virtual bool ReadH5Cache()

Read the HDF5 cache.

virtual void WriteH5Arrays(HighFive::Group &arrays)

Write the basis arrays.

virtual void WriteH5Cache()

Write the HDF5 cache.

virtual void WriteH5Params(HighFive::File &file)

Write parameter attributes (needed for derived classes)

Protected Attributes

double acylcut
double acyltbl
std::string biorth
std::string cachename

Active cache file name.

int cmapR

Grid parameters.

int cmapZ
YAML::Node conf
std::vector<std::vector<Eigen::MatrixXd>> dens

Storage for basis arrays.

YAML::Node diskconf
std::string disktype

Density target name.

double dx
double dy
EmpCyl2d emp

The 2d basis instance.

bool EVEN_M
std::string forceID
std::string geometry
int knots
bool logr
int mlim
int mmax
int mmin
double Mouter
double Ninner
int nlim
int nmax
int nmaxfid
int nmin
int NQDHT
int numr
int numx
int numy
std::vector<std::vector<Eigen::MatrixXd>> pot
double rcylmax
double rcylmin
std::vector<std::vector<Eigen::MatrixXd>> rforce
double scale
bool use_mpi
bool verbose
double xmax
double xmin
double ymax
double ymin
std::vector<std::vector<Eigen::MatrixXd>> zforce

Protected Static Attributes

static std::string Version

Cache versioning.

class BiorthGrid : public AxiSymBiorth
#include <biorth.H>

Inheritence diagram for BiorthGrid:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymBiorth" tooltip="AxiSymBiorth"]
    "3" [label="Biorth" tooltip="Biorth"]
    "1" [label="BiorthGrid" tooltip="BiorthGrid" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for BiorthGrid:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymBiorth" tooltip="AxiSymBiorth"]
    "3" [label="Biorth" tooltip="Biorth"]
    "1" [label="BiorthGrid" tooltip="BiorthGrid" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

BiorthGrid(AxiSymBioPtr T, double RMIN = 0.0, double RMAX = 20, int NMAX = 10, int LMAX = 10, int RNUM = 400)
inline virtual double d_r_to_rb(double const r)
inline virtual void dens(const int nn, const int l, const double r, Eigen::VectorXd &a)
virtual double dens(const int nn, const int l, const double rb)
inline double densR(const int nn, const int l, const double r)
inline virtual double krnl(const int n, const int l)
inline virtual double norm(const int n, const int l)
inline virtual void potl(const int nn, const int l, const double r, Eigen::VectorXd &a)
virtual double potl(const int nn, const int l, const double rb)
inline virtual double potlR(const int nn, const int l, const double r)
inline virtual double potlRZ(const int nn, const int l, const double r, const double z)
inline virtual double r_to_rb(double const r)
inline virtual double rb_max(void)
inline virtual double rb_min(void)
inline virtual double rb_to_r(double const rb)
inline virtual ~BiorthGrid()

Private Members

std::vector<Eigen::MatrixXd> dens_grid
std::vector<Eigen::MatrixXd> dens_grid2
Eigen::MatrixXd krnl_grid
int lmax
int nmax
Eigen::MatrixXd norm_grid
std::vector<Eigen::MatrixXd> potl_grid
std::vector<Eigen::MatrixXd> potl_grid2
double rmax
double rmin
int rnum
AxiSymBioPtr t
Eigen::VectorXd x_grid
double xmax
double xmin
class BiorthWake
#include <biorth_wake.H>

Collaboration diagram for BiorthWake:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymBiorth" tooltip="AxiSymBiorth"]
    "3" [label="Biorth" tooltip="Biorth"]
    "1" [label="BiorthWake" tooltip="BiorthWake" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="usage"]
}

Public Functions

void accumulate(double x, double y, double z, double mass)
BiorthWake(AxiSymBiorth *BIO, int LMAX, int NMAX)
double energy(std::vector<double> &params)
inline int get_amoeba_iterations(void)
void orientation(int L, int M, Eigen::VectorXd &phi, Eigen::VectorXd &theta, Eigen::VectorXd &psi, Eigen::VectorXd &cost)
void reconstruct(double r, double costh, double phi, double &dens0, double &dens, double &potl0, double &potl, int L1 = 0, int L2 = 10000)
void reset_coefs(void)
inline void set_scale(const double scl)
~BiorthWake(void)

Private Functions

void accumulate_2d(double x, double y, double mass)
void accumulate_3d(double x, double y, double z, double mass)
void amoeba(void)
double amoeba_energy(std::vector<double> &params)
double amotry(int ihi, double fac)
void bomb(const char *s)
void check_orientation(double, double, double)
void get_transform(double &phi, double &theta, double &psi, double &cost)
void modulo_param(std::vector<double> &params)
void orientation_init(void)
void reconstruct_2d(double r, double phi, double &dens0, double &dens, double &potl0, double &potl, int L1 = 0, int L2 = 10000)
void reconstruct_3d(double r, double costh, double phi, double &dens0, double &dens, double &potl0, double &potl, int L1 = 0, int L2 = 10000)
std::complex<double> test_fct(double, double)
void test_transform(void)

Private Members

std::vector<std::vector<double>> ambp
std::vector<double> amby
AxiSymBiorth *bio
bool coefs_defined
Eigen::MatrixXd expcoef
Eigen::MatrixXd factorial
std::complex<double> I
bool init_orientation
int iter
int ll
int lmax
int mm
int nfunk
int nmax
Eigen::MatrixXd norm_grid
std::vector<double> param
std::vector<double> psum
std::vector<double> ptry
double rscl
double tol
int used
Eigen::VectorXcd ylm

Private Static Attributes

static int iterDef
static int ndim
static double tolDef
class BSDisk : public AxiSymBiorth
#include <biorth2d.H>

Inheritence diagram for BSDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymBiorth" tooltip="AxiSymBiorth"]
    "1" [label="BSDisk" tooltip="BSDisk" fillcolor="#BFBFBF"]
    "3" [label="Biorth" tooltip="Biorth"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for BSDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymBiorth" tooltip="AxiSymBiorth"]
    "1" [label="BSDisk" tooltip="BSDisk" fillcolor="#BFBFBF"]
    "3" [label="Biorth" tooltip="Biorth"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

BSDisk(double RMAX, int NMAX, int MMAX)
inline virtual double d_r_to_rb(double const r)
virtual double dens(const int n, const int m, const double r)
virtual void dens(const int n, const int m, const double r, Eigen::VectorXd &a)
inline double densR(const int n, const int m, const double r)
inline virtual double krnl(const int n, const int m)
virtual double norm(const int n, const int m)
virtual double potl(const int n, const int m, const double r)
virtual void potl(const int n, const int m, const double r, Eigen::VectorXd &a)
inline virtual double potlR(const int n, const int m, const double r)
virtual double potlRZ(const int n, const int m, const double r, const double z)
inline virtual double r_to_rb(double const r)
inline virtual double rb_max(void)
inline virtual double rb_min(void)
inline virtual double rb_to_r(double const r)
~BSDisk()

Private Functions

void setup_potl_table(void)

Private Members

std::vector<Eigen::VectorXd> a
int mmax
int nmax
int numz
double rmax
Eigen::VectorXd t_dr
Eigen::MatrixXd t_f
int t_n
Eigen::MatrixXd t_y
class BSSphere : public AxiSymBiorth
#include <biorth.H>

Inheritence diagram for BSSphere:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymBiorth" tooltip="AxiSymBiorth"]
    "1" [label="BSSphere" tooltip="BSSphere" fillcolor="#BFBFBF"]
    "3" [label="Biorth" tooltip="Biorth"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for BSSphere:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymBiorth" tooltip="AxiSymBiorth"]
    "1" [label="BSSphere" tooltip="BSSphere" fillcolor="#BFBFBF"]
    "3" [label="Biorth" tooltip="Biorth"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

BSSphere(double RMAX = 1.0, int NMAX = 10, int LMAX = 10)
inline virtual double d_r_to_rb(double const r)
virtual void dens(const int nn, const int l, const double r, Eigen::VectorXd &t)
virtual double dens(const int nn, const int l, const double rb)
inline double densR(const int nn, const int l, const double r)
inline virtual double krnl(const int nn, const int l)
inline virtual double norm(const int nn, const int l)
virtual void potl(const int nn, const int l, const double r, Eigen::VectorXd &t)
virtual double potl(const int nn, const int l, const double rb)
inline virtual double potlR(const int nn, const int l, const double r)
inline virtual double potlRZ(const int nn, const int l, const double r, const double z)
inline virtual double r_to_rb(double const r)
inline virtual double rb_max(void)
inline virtual double rb_min(void)
inline virtual double rb_to_r(double const r)
virtual ~BSSphere()

Private Functions

void setup_potl_table(void)

Private Members

std::vector<Eigen::VectorXd> a
int lmax
int nmax
double rmax
Eigen::VectorXd t_dr
Eigen::MatrixXd t_f
Eigen::MatrixXd t_g
int t_n
Eigen::MatrixXd t_y
template<bool isConst = false>
struct BufferIterator

Public Types

typedef std::conditional<isConst, constcircular_buffer<value_type>*, circular_buffer<value_type>*>::type cbuf_pointer
typedef ptrdiff_t difference_type
typedef std::random_access_iterator_tag iterator_category
typedef std::conditional<isConst, constvalue_type*, value_type*>::type pointer
typedef std::conditional<isConst, constvalue_type&, value_type&>::type reference
typedef T value_type

Public Functions

inline BufferIterator()
inline BufferIterator(const BufferIterator<false> &it)
inline bool operator!=(const BufferIterator &other) const
inline reference operator*()
inline BufferIterator &operator++()
inline BufferIterator operator++(int)
inline BufferIterator &operator+=(difference_type n)
inline BufferIterator &operator--()
inline BufferIterator operator--(int)
inline BufferIterator &operator-=(difference_type n)
inline pointer operator->()
inline bool operator<(const BufferIterator &other) const
inline bool operator<=(const BufferIterator &other) const
inline bool operator==(const BufferIterator &other) const
inline bool operator>(const BufferIterator &other) const
inline bool operator>=(const BufferIterator &other) const
inline reference operator[](size_type index)

Friends

friend class circular_buffer< T >
inline friend BufferIterator operator+(BufferIterator lhsiter, difference_type n)
inline friend BufferIterator operator+(difference_type n, BufferIterator rhsiter)
inline friend BufferIterator operator-(BufferIterator lhsiter, difference_type n)
inline friend difference_type operator-(const BufferIterator &lhsiter, const BufferIterator &rhsiter)
class bw_struct
#include <BWHelper.H>

Public Functions

inline bw_struct(int localid, int commsize)
inline bw_struct(int owner, time_t first)

Public Members

unsigned count
time_t expire
time_t first
std::vector<bool> nd
int owner

Public Static Attributes

static int dt1

Number of seconds before first alarm.

static int dt2

Number of seconds before all sebsequent alarms.

class BWData
#include <BarrierWrapper.H>

Public Functions

void Add(InfoPtr &p)

Register node in existing entry.

BWData(InfoPtr &p, int commsize)

Full constructor.

int Owner()

Return the valid node with the lowest rank.

Public Members

unsigned count

Number of entries registered.

time_t expire
time_t first

Times: initial and next expiration.

std::list<InfoPtr> info

Cache Info shared pointers; storage reclaimed on destruction.

std::vector<bool> nd

Array of received entries.

unsigned nexpiry

Number of alarm expirations.

Public Static Attributes

static int dt1

Number of seconds before first alarm.

static int dt2

Number of seconds before all subsequent alarms.

template<typename key_t, typename value_t>
class Cache : public std::map<key_t, value_t>
#include <KDtree.H>

Inheritence diagram for KDtree::Cache:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="KDtree::Cache< key_t, value_t >" tooltip="KDtree::Cache< key_t, value_t >" fillcolor="#BFBFBF"]
    "2" [label="std::map< key_t, value_t >" tooltip="std::map< key_t, value_t >"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for KDtree::Cache:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="KDtree::Cache< key_t, value_t >" tooltip="KDtree::Cache< key_t, value_t >" fillcolor="#BFBFBF"]
    "2" [label="std::map< key_t, value_t >" tooltip="std::map< key_t, value_t >"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Wrapper class for std::map to keep a finite size.

Public Functions

inline void add(key_t key, value_t value)
inline Cache(int N = 1)
inline void resize(int N)

Private Members

int max_size
class CBDisk : public AxiSymBiorth, public PolarBasis
#include <biorth2d.H>

Inheritence diagram for CBDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymBiorth" tooltip="AxiSymBiorth"]
    "5" [label="AxisymmetricBasis" tooltip="AxisymmetricBasis"]
    "6" [label="Basis" tooltip="Basis"]
    "3" [label="Biorth" tooltip="Biorth"]
    "1" [label="CBDisk" tooltip="CBDisk" fillcolor="#BFBFBF"]
    "4" [label="PolarBasis" tooltip="PolarBasis"]
    "7" [label="PotAccel" tooltip="PotAccel"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
    "6" -> "7" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "4" [dir=forward tooltip="public-inheritance"]
    "4" -> "5" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for CBDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymBiorth" tooltip="AxiSymBiorth"]
    "5" [label="AxisymmetricBasis" tooltip="AxisymmetricBasis"]
    "6" [label="Basis" tooltip="Basis"]
    "3" [label="Biorth" tooltip="Biorth"]
    "1" [label="CBDisk" tooltip="CBDisk" fillcolor="#BFBFBF"]
    "9" [label="Component" tooltip="Component"]
    "11" [label="EL3" tooltip="EL3"]
    "17" [label="MixtureBasis" tooltip="MixtureBasis"]
    "10" [label="Orient" tooltip="Orient"]
    "4" [label="PolarBasis" tooltip="PolarBasis"]
    "15" [label="PolarBasis::CoefMatrix" tooltip="PolarBasis::CoefMatrix"]
    "13" [label="PolarBasis::CoefVector" tooltip="PolarBasis::CoefVector"]
    "7" [label="PotAccel" tooltip="PotAccel"]
    "12" [label="Timer" tooltip="Timer"]
    "18" [label="TwoCenter" tooltip="TwoCenter"]
    "16" [label="std::vector< std::vector< MatrixM > >" tooltip="std::vector< std::vector< MatrixM > >"]
    "14" [label="std::vector< std::vector< VectorM > >" tooltip="std::vector< std::vector< VectorM > >"]
    "8" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
    "6" -> "7" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "4" [dir=forward tooltip="public-inheritance"]
    "9" -> "9" [dir=forward tooltip="usage"]
    "9" -> "7" [dir=forward tooltip="usage"]
    "9" -> "10" [dir=forward tooltip="usage"]
    "9" -> "12" [dir=forward tooltip="usage"]
    "17" -> "18" [dir=forward tooltip="usage"]
    "10" -> "11" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="public-inheritance"]
    "4" -> "13" [dir=forward tooltip="usage"]
    "4" -> "15" [dir=forward tooltip="usage"]
    "4" -> "17" [dir=forward tooltip="usage"]
    "15" -> "16" [dir=forward tooltip="public-inheritance"]
    "13" -> "14" [dir=forward tooltip="public-inheritance"]
    "7" -> "8" [dir=forward tooltip="usage"]
    "7" -> "9" [dir=forward tooltip="usage"]
    "18" -> "7" [dir=forward tooltip="public-inheritance"]
    "18" -> "6" [dir=forward tooltip="usage"]
    "18" -> "17" [dir=forward tooltip="usage"]
    "8" -> "7" [dir=forward tooltip="usage"]
}

Reference implemenation of the Clutton-Brock disk basis

Parameters

Param mmax:

is the maximum azimuthal order

Param Lmax:

alias for mmax

Param Mmax:

alias for mmax

Param scale:

radius for coordinate scaling. By default, the core radius of the Clutton-Brock density is 1.

Public Functions

CBDisk(Component *c0, const YAML::Node &conf, MixtureBasis *m = 0)

Constructor

Parameters:
  • c0 – is the instantiating caller (Component)

  • conf – passes any parameters to basis instance

  • scale – is the radius for coordinate scaling

CBDisk(void)
inline virtual double d_r_to_rb(double const r)
virtual double dens(const int n, const int m, const double r)
virtual void dens(const int n, const int m, const double r, Eigen::VectorXd &a)
inline double densR(const int n, const int m, const double r)
inline virtual double krnl(const int n, const int m)
virtual double norm(const int n, const int m)
virtual double potl(const int n, const int m, const double r)
virtual void potl(const int n, const int m, const double r, Eigen::VectorXd &a)
inline virtual double potlR(const int n, const int m, const double r)
virtual double potlRZ(const int n, const int m, const double r, const double z)
inline virtual double r_to_rb(double const r)
inline virtual double rb_max(void)
inline virtual double rb_min(void)
inline virtual double rb_to_r(double const r)
inline void set_numz(int n)
virtual ~CBDisk()

Destructor.

Protected Functions

inline virtual void get_pot(Eigen::MatrixXd &Vc, Eigen::MatrixXd &Vs, double r, double z)

Clutton-Brock potential.

Private Types

using Disk2d = std::shared_ptr<EmpCyl2d::ModelCyl>

Background instance.

Private Functions

inline virtual std::tuple<double, double, double> background(double r, double z)

Background evaluation.

void dens(const int m, const double r, Eigen::VectorXd &a)
virtual double dens(const int n, const int m, const double r)
double dphi(const int n, const int m, const double r)
double dpot(const int n, const int m, const double r)
virtual void get_dens(double r, double z, Eigen::MatrixXd &p, int tid)

Get derivative of potential

Parameters:
  • r – is the evaluation radius

  • z – is the evaluation height

  • d – will be returned array in harmonics l and radial order n for the density

  • tid – is the thread enumerator that allows the function to provide some thread safety

virtual void get_dpotl(double r, double z, Eigen::MatrixXd &p, Eigen::MatrixXd &dpr, Eigen::MatrixXd &dpz, int tid)

Get derivative of potential

Parameters:
  • r – is the evaluation radius

  • z – is the evaluation height

  • p – will be returned array in harmonics l and radial order n for the potential

  • dpr – will be returned array in harmonics l and radial order n for the derivative of the potential

  • dpz – will be returned array in harmonics l and radial order n for the derivative of the potential

  • tid – is the thread enumerator that allows the function to provide some thread safety

virtual void get_potl(double r, double z, Eigen::MatrixXd &p, int tid)

Get derivative of potential

Parameters:
  • r – is the evaluation radius

  • z – is the evaluation height

  • p – will be returned array in harmonics l and radial order n for the potential

  • tid – is the thread enumerator that allows the function to provide some thread safety

virtual void get_potl_dens(double r, double z, Eigen::MatrixXd &p, Eigen::MatrixXd &d, int tid)

Get the potential and density

Parameters:
  • r – is the evaluation radius

  • p – will be returned array in harmonics l and radial order n for the potential

  • d – will be returned array in harmonics l and radial order n for the density

  • tid – is the thread enumerator that allows the function to provide some thread safety

inline virtual double getRtable()

Required maximum table radious (no limit here)

virtual void initialize(void)

Initialize method.

virtual double norm(const int n, const int m)
void orthoCheck()

Sanity check.

double phif(const int n, const int m, const double r)
double phif(const int n, const int m, const double r)

2D Clutton-Brock basis

void potl(const int m, const double r, Eigen::VectorXd &a)
virtual double potl(const int n, const int m, const double r)
void setBackground()

Set background from YAML.

Private Members

Disk2d disk
double fac1

Potential, force, and density scale factors.

double fac2
int mmax
string model
int numz
double scale

Parameters.

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class CBSphere : public AxiSymBiorth
#include <biorth.H>

Inheritence diagram for CBSphere:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymBiorth" tooltip="AxiSymBiorth"]
    "3" [label="Biorth" tooltip="Biorth"]
    "1" [label="CBSphere" tooltip="CBSphere" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for CBSphere:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymBiorth" tooltip="AxiSymBiorth"]
    "3" [label="Biorth" tooltip="Biorth"]
    "1" [label="CBSphere" tooltip="CBSphere" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

CBSphere(void)
virtual double d_r_to_rb(double const)
virtual void dens(const int nn, const int l, const double r, Eigen::VectorXd &a)
virtual double dens(const int nn, const int l, const double rb)
inline double densR(const int nn, const int l, const double r)
virtual double krnl(const int nn, const int l)
virtual double norm(const int nn, const int l)
virtual void potl(const int nn, const int l, const double r, Eigen::VectorXd &a)
virtual double potl(const int nn, const int l, const double rb)
inline virtual double potlR(const int nn, const int l, const double r)
inline virtual double potlRZ(const int nn, const int l, const double r, const double z)
virtual double r_to_rb(double const)
inline virtual double rb_max(void)
inline virtual double rb_min(void)
virtual double rb_to_r(double const)
inline virtual ~CBSphere()

Private Members

double rbmax
double rbmin
class CenterFile
#include <CenterFile.H>

Read a file in @Orient format and provide the center interpolated in time. The YAML node needs two key word&#8212;value pairs:

file: file name of orient-style center info type: EJ or COM

This implementation will exit for safety if it is called beyond its range.

Public Functions

CenterFile(const YAML::Node &conf)

Read in the file and cache the data.

std::array<double, 3> operator()(double T)

Interpolate and provide the desired center.

Private Members

std::vector<std::array<double, 3>> data
std::vector<double> time
class Cheb1 : public OrthoPoly
#include <OrthoPoly.H>

Inheritence diagram for Cheb1:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Cheb1" tooltip="Cheb1" fillcolor="#BFBFBF"]
    "2" [label="OrthoPoly" tooltip="OrthoPoly"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Cheb1:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Cheb1" tooltip="Cheb1" fillcolor="#BFBFBF"]
    "2" [label="OrthoPoly" tooltip="OrthoPoly"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline Cheb1(void)
inline virtual double coef1(const int n)
inline virtual double coef2(const int n)
inline virtual double coef3(const int n)
inline virtual double coef4(const int n)
inline virtual double f0(const double x)
inline virtual double f1(const double x)
inline virtual double h(const int n)
inline virtual double w(const double x)
class Cheb2 : public OrthoPoly
#include <OrthoPoly.H>

Inheritence diagram for Cheb2:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Cheb2" tooltip="Cheb2" fillcolor="#BFBFBF"]
    "2" [label="OrthoPoly" tooltip="OrthoPoly"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Cheb2:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Cheb2" tooltip="Cheb2" fillcolor="#BFBFBF"]
    "2" [label="OrthoPoly" tooltip="OrthoPoly"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline Cheb2(void)
inline virtual double coef1(const int n)
inline virtual double coef2(const int n)
inline virtual double coef3(const int n)
inline virtual double coef4(const int n)
inline virtual double f0(const double x)
inline virtual double f1(const double x)
inline virtual double h(const int n)
inline virtual double w(const double x)
class Cheby1d : public Interp1d
#include <interp.H>

Inheritence diagram for Cheby1d:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Cheby1d" tooltip="Cheby1d" fillcolor="#BFBFBF"]
    "2" [label="Interp1d" tooltip="Interp1d"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Cheby1d:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Cheby1d" tooltip="Cheby1d" fillcolor="#BFBFBF"]
    "2" [label="Interp1d" tooltip="Interp1d"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

void bomb(const char*, ...)

Handle error.

Cheby1d()

Null constructor.

Cheby1d(const double A, const double B, const Eigen::VectorXd &x, const Eigen::VectorXd &y, int N)

Construct with Eigen input (N is Chebyshev order)

Cheby1d(const double A, const double B, std::vector<double> &x, std::vector<double> &y, int N)

Construct with std::vector input (N is Chebyshev order)

Cheby1d(const Eigen::VectorXd &x, const Eigen::VectorXd &y, int N)

Construct with Eigen input (N is Chebyshev order) using data limits.

Cheby1d(std::vector<double> &x, std::vector<double> &y, int N)

Construct with std::vector input (N is Chebyshev order) using data limits.

inline virtual double deriv(const double &x)

Evaluate first derivative.

inline double deriv2(const double &x)

Evaluate the second derivative.

inline virtual double eval(const double &x)

Evaluate the interpolant.

inline void eval(const double &x, double &val, double &deriv)

Evaluate the interpolant and its first derivative.

inline double integral(const double &x)

Evaluate integral of interpolant.

void new_data(std::vector<double> &X, std::vector<double> &Y, int N)

Update the data.

void new_func(std::function<double(double)> func, double A, double B, int N)

Generate interpolant from a function.

void new_limits(double A, double B)

Update the data limits.

Cheby1d &operator=(const Cheby1d&)

Copy constructor.

inline virtual double xhi()
inline virtual double xlo()

Data limits.

~Cheby1d()

Destructor.

Private Functions

void chder(std::vector<double> &cin, std::vector<double> &cder)
double chebev(double x, std::vector<double> &cin)
double chebint(double x)

Private Members

double a
double b
std::vector<double> c
std::vector<double> c1
std::vector<double> c2
bool defined
int n
double xmax = 0
double xmin = 0
class CheckpointTimer
#include <chkTimer.H>

This class keeps track of time between time steps and calls for a checkpoint and signals an exit if there will not be time to reach the next checkpoint

Public Functions

CheckpointTimer()

Constructor.

bool done()

Time to quit.

void mark()

Mark the current time.

Public Static Attributes

static time_t delta

Safety time interval [Default: 10 minute warning].

static time_t diag

Diagnostic output interval [Default: 2 hours].

Private Functions

string exec(string &cmd)

Execute a command and pipe the results to string.

double time_remaining()

Get the remaining execution time.

Private Members

time_t current
time_t final
bool firstime
time_t initial
time_t last
time_t last_diag
double mean
unsigned nsteps
time_t start_time
double var
template<typename T>
class circular_buffer
#include <circular_buffer.H>

Circular buffer implementation from https://github.com/vinitjames/circularbuffer to temporarily replace the boost::circular_buffer implementation. Hopefully, this can be replaced by STL eventually.

Public Types

typedef BufferIterator<true> const_iterator
typedef BufferIterator<false> iterator

Public Functions

inline reference at(size_type index)
inline const_reference at(size_type index) const
inline reference back()
inline const_reference back() const
inline iterator begin()
inline const_iterator begin() const
inline size_type buffer_size() const
inline size_type capacity() const
inline const_iterator cbegin() const noexcept
inline const_iterator cend() const noexcept
inline circular_buffer(circular_buffer &&other) noexcept
inline circular_buffer(const circular_buffer &other)

Copy constructor.

inline explicit circular_buffer(size_t size)

Constructor.

inline void clear()
inline const_pointer data() const
inline bool empty() const
inline iterator end()
inline const_iterator end() const
inline reference front()
inline const_reference front() const
inline bool full() const
inline circular_buffer &operator=(circular_buffer &&other) noexcept
inline circular_buffer &operator=(const circular_buffer &other)

Assignment operator.

inline reference operator[](size_type index)
inline const_reference operator[](size_type index) const
inline void pop_front()
inline void push_back(const value_type &data)
inline void push_back(value_type &&data) noexcept
inline const_iterator rbegin() const noexcept
inline iterator rbegin() noexcept
inline const_iterator rend() const noexcept
inline iterator rend() noexcept
inline size_type size() const

Private Types

typedef const T *const_pointer
typedef const T &const_reference
typedef ptrdiff_t difference_type
typedef T *pointer
typedef T &reference
typedef size_t size_type
typedef T value_type
class CLin : public Disk2dHalo::CMap

Inheritence diagram for Disk2dHalo::CLin:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Disk2dHalo::CLin" tooltip="Disk2dHalo::CLin" fillcolor="#BFBFBF"]
    "2" [label="Disk2dHalo::CMap" tooltip="Disk2dHalo::CMap"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Disk2dHalo::CLin:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Disk2dHalo::CLin" tooltip="Disk2dHalo::CLin" fillcolor="#BFBFBF"]
    "2" [label="Disk2dHalo::CMap" tooltip="Disk2dHalo::CMap"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline virtual double r_to_x(double r)
inline virtual double x_to_r(double x)
class CLin : public DiskHalo::CMap

Inheritence diagram for DiskHalo::CLin:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="DiskHalo::CLin" tooltip="DiskHalo::CLin" fillcolor="#BFBFBF"]
    "2" [label="DiskHalo::CMap" tooltip="DiskHalo::CMap"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for DiskHalo::CLin:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="DiskHalo::CLin" tooltip="DiskHalo::CLin" fillcolor="#BFBFBF"]
    "2" [label="DiskHalo::CMap" tooltip="DiskHalo::CMap"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline virtual double r_to_x(double r)
inline virtual double x_to_r(double x)
class CLog : public Disk2dHalo::CMap

Inheritence diagram for Disk2dHalo::CLog:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Disk2dHalo::CLog" tooltip="Disk2dHalo::CLog" fillcolor="#BFBFBF"]
    "2" [label="Disk2dHalo::CMap" tooltip="Disk2dHalo::CMap"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Disk2dHalo::CLog:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Disk2dHalo::CLog" tooltip="Disk2dHalo::CLog" fillcolor="#BFBFBF"]
    "2" [label="Disk2dHalo::CMap" tooltip="Disk2dHalo::CMap"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline virtual double r_to_x(double r)
inline virtual double x_to_r(double x)
class CLog : public DiskHalo::CMap

Inheritence diagram for DiskHalo::CLog:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="DiskHalo::CLog" tooltip="DiskHalo::CLog" fillcolor="#BFBFBF"]
    "2" [label="DiskHalo::CMap" tooltip="DiskHalo::CMap"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for DiskHalo::CLog:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="DiskHalo::CLog" tooltip="DiskHalo::CLog" fillcolor="#BFBFBF"]
    "2" [label="DiskHalo::CMap" tooltip="DiskHalo::CMap"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline virtual double r_to_x(double r)
inline virtual double x_to_r(double x)
class CMap

Inheritence diagram for Disk2dHalo::CMap:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="Disk2dHalo::CLin" tooltip="Disk2dHalo::CLin"]
    "3" [label="Disk2dHalo::CLog" tooltip="Disk2dHalo::CLog"]
    "1" [label="Disk2dHalo::CMap" tooltip="Disk2dHalo::CMap" fillcolor="#BFBFBF"]
    "4" [label="Disk2dHalo::CRat" tooltip="Disk2dHalo::CRat"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
}

Subclassed by Disk2dHalo::CLin, Disk2dHalo::CLog, Disk2dHalo::CRat

Public Functions

virtual double r_to_x(double r) = 0
virtual double x_to_r(double x) = 0
class CMap

Inheritence diagram for DiskHalo::CMap:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="DiskHalo::CLin" tooltip="DiskHalo::CLin"]
    "3" [label="DiskHalo::CLog" tooltip="DiskHalo::CLog"]
    "1" [label="DiskHalo::CMap" tooltip="DiskHalo::CMap" fillcolor="#BFBFBF"]
    "4" [label="DiskHalo::CRat" tooltip="DiskHalo::CRat"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
}

Subclassed by DiskHalo::CLin, DiskHalo::CLog, DiskHalo::CRat

Public Functions

virtual double r_to_x(double r) = 0
virtual double x_to_r(double x) = 0
struct CoefMatrix : public std::vector<std::vector<MatrixM>>
#include <EmpCylSL.H>

Inheritence diagram for EmpCylSL::CoefMatrix:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="EmpCylSL::CoefMatrix" tooltip="EmpCylSL::CoefMatrix" fillcolor="#BFBFBF"]
    "2" [label="std::vector< std::vector< MatrixM > >" tooltip="std::vector< std::vector< MatrixM > >"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for EmpCylSL::CoefMatrix:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="EmpCylSL::CoefMatrix" tooltip="EmpCylSL::CoefMatrix" fillcolor="#BFBFBF"]
    "2" [label="std::vector< std::vector< MatrixM > >" tooltip="std::vector< std::vector< MatrixM > >"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline Eigen::MatrixXd &operator()(int i, unsigned j, int m)
struct CoefMatrix : public std::vector<std::vector<MatrixM>>
#include <PolarBasis.H>

Inheritence diagram for PolarBasis::CoefMatrix:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="PolarBasis::CoefMatrix" tooltip="PolarBasis::CoefMatrix" fillcolor="#BFBFBF"]
    "2" [label="std::vector< std::vector< MatrixM > >" tooltip="std::vector< std::vector< MatrixM > >"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for PolarBasis::CoefMatrix:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="PolarBasis::CoefMatrix" tooltip="PolarBasis::CoefMatrix" fillcolor="#BFBFBF"]
    "2" [label="std::vector< std::vector< MatrixM > >" tooltip="std::vector< std::vector< MatrixM > >"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline Eigen::MatrixXd &operator()(int i, unsigned j, int m)
struct Coefs
#include <TwoDCoefs.H>

Public Functions

bool read(std::istream &in)

Public Members

Eigen::MatrixXd data
std::string id
int Lmax
int nmax
double rmax
double scale
double time
struct CoefVector : public std::vector<std::vector<VectorM>>
#include <EmpCylSL.H>

Inheritence diagram for EmpCylSL::CoefVector:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="EmpCylSL::CoefVector" tooltip="EmpCylSL::CoefVector" fillcolor="#BFBFBF"]
    "2" [label="std::vector< std::vector< VectorM > >" tooltip="std::vector< std::vector< VectorM > >"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for EmpCylSL::CoefVector:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="EmpCylSL::CoefVector" tooltip="EmpCylSL::CoefVector" fillcolor="#BFBFBF"]
    "2" [label="std::vector< std::vector< VectorM > >" tooltip="std::vector< std::vector< VectorM > >"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

More syntactic sugar for arrays of arrays: define an operator to the object of the main nested arrays. That is, for:

MatrixArray arr(N); for (auto & v : arr) v.resize(M);

One can use:

arr(n, m)[j][k] = …

instead of

(*arr[n][m])[j][k] = …

to access elements.

Public Functions

inline Eigen::VectorXd &operator()(int i, unsigned j, int m)
struct CoefVector : public std::vector<std::vector<VectorM>>
#include <PolarBasis.H>

Inheritence diagram for PolarBasis::CoefVector:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="PolarBasis::CoefVector" tooltip="PolarBasis::CoefVector" fillcolor="#BFBFBF"]
    "2" [label="std::vector< std::vector< VectorM > >" tooltip="std::vector< std::vector< VectorM > >"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for PolarBasis::CoefVector:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="PolarBasis::CoefVector" tooltip="PolarBasis::CoefVector" fillcolor="#BFBFBF"]
    "2" [label="std::vector< std::vector< VectorM > >" tooltip="std::vector< std::vector< VectorM > >"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

More syntactic sugar for arrays of arrays: define an operator to the object of the main nested arrays. That is, for:

MatrixArray arr(N); for (auto & v : arr) v.resize(M);

One can use:

arr(n, m)[j][k] = …

instead of

(*arr[n][m])[j][k] = …

to access elements.

Public Functions

inline Eigen::VectorXd &operator()(int i, unsigned j, int m)
class ColorGradient
#include <ColorGradient.H>

Internal class used to store colors at different points in the gradient.

Public Functions

inline void addColorPoint(float red, float green, float blue, float value)

Inserts a new color point into its correct position:

inline void clearGradient()

Inserts a new color point into its correct position:

inline ColorGradient()

Default constructor:

inline void createDefaultGradient()

Default gradient.

inline void createFiveColorHeatMapGradient()

5 color heapmap gradient into the “color” vector:

inline void createGrayGradient()

7 color heapmap gradient into the “color” vector:

inline void createSevenColorHeatMapGradient()

7 color heapmap gradient into the “color” vector:

inline png::rgb_pixel operator()(const float value)

Inputs a (value) between 0 and 1 and outputs the (red), (green) and (blue) values representing that position in the gradient.

Private Members

std::vector<ColorPoint> color

An array of color points in ascending value.

struct ColorPoint

Public Functions

inline ColorPoint(float red, float green, float blue, float value)

Public Members

float b
float g
float r

Red, green and blue values of our color.

float val

Position of our color along the gradient (between 0 and 1).

class Component
#include <Component.H>

Collaboration diagram for Component:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Component" tooltip="Component" fillcolor="#BFBFBF"]
    "5" [label="EL3" tooltip="EL3"]
    "4" [label="Orient" tooltip="Orient"]
    "2" [label="PotAccel" tooltip="PotAccel"]
    "6" [label="Timer" tooltip="Timer"]
    "3" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "1" -> "1" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="usage"]
    "1" -> "4" [dir=forward tooltip="usage"]
    "1" -> "6" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "2" -> "1" [dir=forward tooltip="usage"]
    "3" -> "2" [dir=forward tooltip="usage"]
}

Class associating the phase space with a biorthogonal basis.

The Component

provides “interactors” for specific particle fields

Each field in the

Component config file format contains four fields, each delimited by a colon (“:”), and new lines are not significant:
  1. name of the potential solver (force methods) for this phase space

  2. component-specific parameters [see Parameter section below]

  3. file name containing phase space to be read

  4. comma-delimited parameter list passed to the potential solver

Currently available force methods:

Reference frames:

  1. Inertial is the rest reference frame whose coordinate system is centered at (0, 0, 0)

  2. Local is the coordinate system of specific to the particles of an individual Component instance. If com_system is defined, this is defined to have its origin at the center of mass and the center of velocity of the component’s partcles at all times. If com_system is off, this is the same as Inertial

  3. Centered offsets the particles coordinates using the current centering scheme for the expansion. At this point, this is the EJ method selectable by the user. The SphereTwoCenter method indirectly manipulates this to achieve two separate expansion centers.

  4. keyPos is the value of the species key in the particle integer attribute vector

  5. pbufsiz is the number of particles in each particle buffer sent to disk when using MPI-IO with OutPSP

  6. blocking set to true chooses blocking writes when using MPI-IO with OutPSP

  7. buffered set to true chooses buffered writes when using POSIX binary

  8. ignore the PSP info stanza on restart (i.e. for specifying alternative parameters, using an old-style PSP file, or starting a new job with a previous output from another simulation)

bessel

Bessel function basis, see Bessel

sphereSL

Weinberg’s adaptive spherical basis derived by numerical solution to the Sturm-Liouville equation, see Sphere

cube

Trigonmetric basis with periodic boundaries, see Cube

slabSL

Trigonmetric basis with periodic boundaries the horizontal directions and vacuum boundary conditions in the vertical dirction, see Slab

slab

Trigonmetric basis with periodic boundaries the horizontal directions and vacuum boundary conditions in the vertical dirction based on a direct solution of the Sturm-Liouville equation perpendicular to the slab, see SlabSL

cylinder

Weinberg’s adaptive cylindrical basis derived by numerical solution to the Sturm-Liouville equation, see Cylinder

direct

The usual n2 force calculation, see Direct

noforce

No force (presumably, you are supplying your own force)

Param EJ:

enables energy weighed center-of-mass. The paramter value is a two-bit flag: AXIS=1 and CENTER=2.

Param nEJkeep:

is the number of time steps in running box car average for EJ-determined parameters

Param nEJwant:

is the target number of particles to keep in the ensemble used to determine the paramters. The energy cutoff is dynamically adjusted to achieve this target.

Param nEJwant:

is the size of the past states used to estimate the the acceleration of the expansion frame

Param EJx0:

is the initial EJ center x-coordinate (default: 0)

Param EJy0:

is the initial EJ center y-coordinate (default: 0)

Param EJz0:

is the initial EJ center z-coordinate (default: 0)

Param EJu0:

is the initial EJ center u-velocity (default: 0)

Param EJv0:

is the initial EJ center v-velocity (default: 0)

Param EJw0:

is the initial EJ center w-velocity (default: 0)

Param EJdT:

is the spacing in time between samples (default: 0)

Param EJkinE:

set true includes kinetic energy in the energy determination, otherwise potential energy alone is used

Param EJext:

set true includes the external potential energy in the energy computation

Param EJdiag:

turns on verbose EJ reporting

Param EJdryrun:

set to true does not apply EJ centering or rotation but computes the transformation

Param EJlinear:

set true moves center with constant velocity. For testing only!! (default: false)

Param EJdamp:

multiplies the least squares slope to prevent instability (default: 1.0, no damping)

Param rmax:

is the maximum radius particle. This is determined dynamically from the initial conditions but can be overridden as a parameter.

Param rtrunc:

is the radius from the center beyond which it does not contribute to the force expansion (but does continues to be affected by it). The default value is 1.0e20.

Param rcom:

is the radius beyond which a particle is not used to compute the center of mass coordinate system

Param ton:

is the midpoint of the adiabatic turn on for this component

Param twid:

is the width for the adiabatic turn on. Unless ton or toff is specified, the component begins and remains fully on.

Center of mass system coordinates

double mtot0

System mass, center of mass, center of velocity and acceleration.

double *com0
double *cov0
double *acc0
double rcom

Maximum radius for contribution to center-of-mass computation.

double mtot

Total mass.

int dim

Dimension of the phase space.

std::vector<vector<int>> levlist

Particle list per level This will be a sorted list for each level. We use a vector rather than (e.g.) a set for the random insertion

std::vector<vector<unsigned>> mdt_ctr

Multstep dt type counter.

PotAccel *force

Points to associated force instance.

int niattrib

Attribute array dimensions for integer parameters.

int ndattrib

Attribute array dimensions for float-valued parameters.

int EJ

Binding energy orientation flag.

int nEJkeep

Number to keep in orientation stack.

int nEJwant

Target number of particles for average.

int nEJaccel

Target number of states for pseudo-acceleration estimation.

double EJx0

Initial EJ center.

x-coord

double EJy0

y-coord

double EJz0

z-coord

double EJu0

Initial EJ velocity.

x-coord

double EJv0

y-coord

double EJw0

z-coord

double EJdT

Spacing between EJ samples.

bool EJdiag

Print verbose diagnostics.

bool EJdryrun

Do not apply transformation.

bool EJkinE

Use particle KE for energy computation.

bool EJext

Use external potential for energy computation.

bool EJlinear

Move center at constant velocity specified by (EJu0, EJv0, EJw0)

double EJdamp

Damping factor for center determination (< 1.0 for damping)

bool com_system

Use center of mass coordinate system.

bool com_log

Log the center of mass coordinate system at each step.

double rtrunc

Maximum radius from center for force evaluation.

bool timers

CUDA timing info.

bool buffered

Use buffered binary writes.

Orient *orient

Orientation cache.

Timer time_so_far

Running clock on the current potential/force evaluation.

Component(YAML::Node &conf)

The constructor.

Takes the id string id and phase space file name as arguments

Component(YAML::Node&, istream *in, bool SPL)

Initialize from file.

~Component()

Destructor.

PartPtr *get_particles(int *number)

Parallel gather.

inline int particle_count(int node)

Retrieve particle count on a particular node (one node at a time)

inline vector<unsigned int> particle_count()

Retrieve particle count on a particular node (all nodes at once)

void write_binary(ostream *out, bool real4 = false)

Write binary component phase-space structure.

void write_binary_header(ostream *out, bool real4, std::string prefix, int nth = 1)

Write header for per-node writes.

void write_binary_particles(std::ostream *out, bool real4)

Write particles for per-node writes.

void write_binary_particles(std::vector<std::shared_ptr<std::ofstream>> &out, bool real4)

Write particles for per-node writes (multithreaded version)

void write_binary_particles(std::ostream *out, int threads, bool real4)

Write particles for per-node writes with multithreading.

inline void write_binary_mpi(MPI_File &out, MPI_Offset &offset, bool real4 = false)

Write binary component phase-space structure using MPI.

void write_ascii(ostream *out, bool accel = false)

Write ascii component phase-space structure.

void redistribute_particles(void)

Redestribute this component.

void fix_positions_cpu(unsigned mlevel = 0)

Compute center of mass and center of velocity (CPU version)

inline void fix_positions(unsigned mlevel = 0)

Compute center of mass and center of velocity.

void redistributeByList(vector<int> &redist)

Redistribute particle by list (deprecated?)

Serialize redistribution list into an integer array of numprocs stanzas, each with the format n &#8212; current node M &#8212; number to redistribute (may be zero) index_1 tonode_1 index_2 tonode_2 . . index_M tonode_M

so each stanza has 2(M+1) integers

void update_accel(void)

Subtract mean acceleration from each particle accel.

void get_angmom(unsigned mlevel = 0)

Update angular momentum values.

double Adiabatic(void)

Adiabatic turn on factor, range in [0, 1].

bool freeze(unsigned indx)

Is particle out of bounds?

bool escape_com(const Particle&)

Is particle beyond COM system.

inline PartMap &Particles()

Access to particle vector.

inline Particle *Part(unsigned long i)

Access to particle as a pointer.

inline PartPtr partPtr(unsigned long i)

Access to particle via the shared pointer.

inline bool partExists(unsigned long i)

Check if particle index is in the component.

Particle *GetNewPart()

Generate new particle: this adds a new particle and returns a pointer to the same particle. It is the caller’s responsbility to populate the phase space and particle attributes with sane values.

void AddPart(PartPtr p)

Add a particle to the component.

void DestroyPart(PartPtr p)

Remove a particle from the component.

inline void ErasePart(PartPtr p)

Erase a particle with no level list check.

inline unsigned Number()

Particle vector size.

inline unsigned CurTotal()

Return the last particle total (no MPI)

inline unsigned NewTotal()

Update total number of particles in component. Should be called after adding or killing particles. Uses MPI.

inline double Mass(int i)

Access to mass.

inline double Pos(int i, int j, unsigned flags = Inertial)

Access to positions.

inline std::vector<double> getCenter(unsigned flags = Inertial)

Get rectified component center.

inline double Vel(int i, int j, unsigned flags = Inertial)

Access to velocities.

inline void Pos(double *pos, int i, unsigned flags = Inertial)

Get positions.

inline void Vel(double *vel, int i, unsigned flags = Inertial)

Get velocities.

inline void ConvertPos(double *pos, unsigned flags = Local | Centered)

Convert coordinates from inertial to local.

inline void ConvertVel(double *vel, unsigned flags = Local | Centered)

Convert velocities from inertial to local.

inline void PosConvert(double *pos, unsigned flags = Local | Centered)

Convert coordinates from local to inertial.

inline void VelConvert(double *vel, unsigned flags = Local | Centered)

Convert velocities from local inertial.

inline double Acc(int i, int j, unsigned flags = Inertial)

Access to acceleration.

inline void AddPos(int i, int j, double val)

Add to position (by component)

inline void AddPos(int i, double *val)

Add to position (by array)

inline void AddPos(int i, vector<double> &val)

Add to position (by vector)

inline void AddVel(int i, int j, double val)

Add to velocity (by component)

inline void AddVel(int i, double *val)

Add to velocity (by array)

inline void AddVel(int i, vector<double> &val)

Add to velocity (by vector)

inline void AddAcc(int i, int j, double val)

Add to accerlation (by component)

inline void AddAccExt(int i, int j, double val)

Add to accerlation (by component)

inline void AddAcc(int i, double *val)

Add to acceleration (by array)

inline void AddAccExt(int i, double *val)

Add to acceleration (by array)

inline void AddAcc(int i, vector<double> &val)

Add to accerlation (by vector)

inline void AddAccExt(int i, vector<double> &val)

Add to accerlation (by vector)

inline void AddPot(int i, double val)

Add to potential.

inline void AddPotExt(int i, double val)

Add to external potential.

void reset_level_lists()

Reset the level lists.

void print_level_lists(double T)

Print out the level lists to stdout for diagnostic purposes.

inline double get_time_sofar()

Time in potential/force computation so far.

inline bool Indexing()

Check for indexing.

inline bool NoSwitch()

Check for multistep restriction (this is still a test option)

inline bool FreezeLev()

Only compute new levels on first step.

inline bool DTreset()

Compute level from minimum requested time step from last master step.

Public Types

enum PSTYPE

Describe the phase space coordinates.

Values:

enumerator Inertial
enumerator Local
enumerator Centered

Public Functions

Eigen::Vector3d &getPseudoAccel(double *pos, double *vel)

Public Members

Eigen::Vector3d accel

Pseudo-accleration (set by Orient)

double *angmom

Angular momentum vector.

YAML::Node cconf

Parameters for component.

double *center

Center (e.g. set by Orient)

double *coa

Center of acceleration.

double *com

Center of mass.

These are pointers to the center of mass, center of velocity, angular momentum and the phase-space 6 vector.

YAML::Node conf

Configuration for this component.

double *cov

Center of velocity.

bool cube

Periodic cube.

bool disk

Cylindrical geometry.

Eigen::Vector3d domdt
YAML::Node fconf

Parameters for force.

std::string id

Force method.

int keyPos

Species key position in particle integer attribute vector.

std::string name

Identify this component.

Eigen::Vector3d omega
std::string pfile

Particle file.

bool point_mass

Point masses.

double *ps

Phase space vector.

Eigen::Vector3d pseudo
double rmax

Maximum initial particle radius.

bool slab

Slab geometry.

bool sphere

Spherical geometry.

Protected Functions

void configure(void)

Set configuration and force.

void find_ctr_component()

Locagte centering component.

void initialize(void)

Initialize parameters (called by ComponentContainer after component instantiation

void initialize_cuda(void)

Enumerate and initialize cuda devices.

void restart_com_system(void)

COM restart function.

void seq_new_particles()

Update sequence number of added particles.

void set_default_values()

Set default, unset parameters in config.

void setup_distribution(void)

Setup distribution vectors.

void write_binary_mpi_b(MPI_File &out, MPI_Offset &offset, bool real4 = false)

Write binary component phase-space structure using MPI (blocking)

void write_binary_mpi_i(MPI_File &out, MPI_Offset &offset, bool real4 = false)

Write binary component phase-space structure using MPI (non-blocking)

Protected Attributes

double azcm_slab

Slab parameters.

bool binary

Binary read flag.

Component *c0

Use center from this component.

std::shared_ptr<CenterFile> CF

Center file playback.

int com_restart

COM flag.

string comfile

COM log file.

std::string ctr_name

Name of the centering component.

bool dtreset

Select level from criteria over last time step.

bool freezeLev

Compute new levels on the first step only.

unsigned modified = 0

Particle number update is needed.

unsigned int nbodies

Bodies on this node.

vector<unsigned int> nbodies_index
vector<unsigned int> nbodies_table

Vector holding current particle partition.

unsigned int nbodies_tot

Bodies on all nodes.

std::list<PartPtr> new_particles

Particles waiting for a new index.

int nlevel

Level occupation output.

bool noswitch

No multistep switching.

vector<double> orates

Vectors for holding the rates per node for load balancing.

PartMap particles

Points to associated particles using sequence number.

MPI_Datatype Particletype

Used by gather and distribution routines to define a particle structure to MPI

unsigned long top_seq

Maximum sequence value so far.

vector<double> trates

Protected Static Attributes

static const std::set<std::string> valid_keys_force
static const std::set<std::string> valid_keys_parm
static const std::set<std::string> valid_keys_top

Valid keys for YAML configurations.

Private Functions

void add_particles(int from, int to, std::vector<PartPtr> &plist)
void initialize_com_system()
void load_balance(void)

Parallel distribute and particle io.

void openNextBlob(std::ifstream &in, std::list<std::string>::iterator &fit, int &N)

Helper for split-PSP-file particle consumer.

void read_bodies_and_distribute_ascii(void)
void read_bodies_and_distribute_binary_out(istream*)
void read_bodies_and_distribute_binary_spl(istream*)
int round_up(double dnumb)
void update_indices(void)

Private Members

bool adiabatic
bool aindex
vector<double> angmom_lev
bool blocking

Using blocking writes for MPI-IO.

vector<double> coa_lev
vector<double> com_lev
vector<double> com_mas
vector<double> comE_lev
vector<double> comE_mas
bool consp
vector<double> cov_lev
vector<double> covE_lev
bool indexing

Internal data for sequence checking.

vector<loadb_datum> loadb
std::vector<PartPtr> pbuf
int pBufSiz

Particle buffer count for MPI-IO writing.

ParticleFerryPtr pf
unsigned rsize
int seq_beg
int seq_cur
int seq_end
int tidal
double toff
double ton
double twid
bool umagic

Private Static Attributes

static const unsigned long magic = 0xadbfabc0

For magic number checking.

static const unsigned long mmask = 0xf
static const unsigned long nmask = ~mmask

Friends

friend class ComponentContainer
friend class OrbTrace
friend class ScatterMFP
class ComponentContainer

Collaboration diagram for ComponentContainer:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="ComponentContainer" tooltip="ComponentContainer" fillcolor="#BFBFBF"]
    "2" [label="Timer" tooltip="Timer"]
    "1" -> "2" [dir=forward tooltip="usage"]
}

A container for all phase-space components.

There are two parameters affecting ComponentContainter, which may be specified in the global stanza:

Restarting:

If the infile parameter contains a valid PSP file name, the simulation will resume using the file as an PSP body file. If the infile begins with or contains the string ‘SPL’, a split-PSP format will be assumed.

Param restart:

set to 1 instructs all the components and force methods to restart the simulation from phase space checkpoints and log files

Public Types

enum State

For timers in PotAcc to hook the type of acceleration.

Values:

enumerator NONE
enumerator SELF
enumerator INTERACTION
enumerator EXTERNAL

Public Functions

bool bad_values()

Debug for bad phase space values.

ComponentContainer()

Constructor.

void compute_expansion(unsigned mlevel = 0)

Compute the expansion for all components in the container Those without expansions, should return without working

void compute_potential(unsigned mlevel = 0)

Compute the acceleration for all components in the container.

void fix_acceleration()

Remove the center of mass accelration from the overall phase space.

void fix_positions()

Recompute the center of mass and centers of velocity for all components. These may be used (if flagged) to center the phase space on each grid either globally or per component

void initialize()

Read database and construct indvidual components.

void load_balance()

Compute duty for each processor and initiate load balancing.

void multistep_debug()

Print debug info.

void multistep_reset()

Reset data before a multistep step.

void print_level_list_header()

Print column explanation for level lists output.

void print_level_lists(double T)

Print out the level lists for all components to stdout for diagnostic purposes

void read_rates()

Read initial processor rates.

void report_numbers()

Diagnostic report of number from each component and process.

~ComponentContainer()

Destructor.

Public Members

std::list<Component*> components

List of components.

std::list<std::shared_ptr<Interaction>> interaction

List of interactions.

int ncomp

Number of components.

int ntot

Total number of bodies.

std::vector<double> rates

Processor rates.

enum ComponentContainer::State state
bool thread_timing
Timer timer_accel
Timer timer_angmom
Timer timer_clock
Timer timer_cuda
Timer timer_expand
Timer timer_extrn
Timer timer_fixp
Timer timer_force
Timer timer_gcom
Timer timer_inter
Timer timer_orient
Timer timer_posn

Performance timers (enabled with VERBOSE>3)

vector<pair<string, Timer>> timer_sext
vector<pair<string, Timer>> timer_sntr
Timer timer_thr_acc
Timer timer_thr_ext
Timer timer_thr_int
Timer timer_wait
Timer timer_zero
bool timing

Timing in use.

Public Static Attributes

static long tinterval

Seconds between timer dumps.

Private Members

bool binary
double *gcom1
double *gcov1
bool gottapot
int ifile
vector<unsigned> levcnt

Counts steps at each level for timing output.

double time0

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

Friends

friend class Component
class ComponentHeader
#include <header.H>

Describe a component in a phase space dump.

Public Functions

inline ComponentHeader()

Default constructor: uses defaultInfoSize by default.

inline ComponentHeader(int n)

Construct component with info field of length n.

inline int getSize()

Get header size.

bool read(istream *in)

Read binary header from input stream.

bool write(ostream *out)

Write binary header to output stream.

bool write_mpi(MPI_File &out, MPI_Offset &offset)

Write binary header to MPI.

Public Members

std::shared_ptr<char> info

Info string.

int nbod

Number of bodies in the component.

int ndatr

Number of real (double) attributes per particle.

int niatr

Number of integer attributes per particle.

int ninfochar

Size of info string.

Public Static Attributes

static int defaultInfoSize

Default size of info string (if not specified explicitly or read)

Friends

inline friend std::ostream &operator<<(std::ostream &os, const ComponentHeader &p)
class CoordMap

Inheritence diagram for SLGridSlab::CoordMap:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="SLGridSlab::CoordMap" tooltip="SLGridSlab::CoordMap" fillcolor="#BFBFBF"]
    "2" [label="SLGridSlab::LinearMap" tooltip="SLGridSlab::LinearMap"]
    "3" [label="SLGridSlab::SechMap" tooltip="SLGridSlab::SechMap"]
    "4" [label="SLGridSlab::TanhMap" tooltip="SLGridSlab::TanhMap"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
}

The base class for all coordinate maps.

Subclassed by SLGridSlab::LinearMap, SLGridSlab::SechMap, SLGridSlab::TanhMap

Public Functions

inline CoordMap(double H)

Constructor.

virtual double d_xi_to_z(double z) = 0

Jacobian of the transformation.

virtual double xi_to_z(double z) = 0

Convert from mapped coordinate back to vertical.

virtual double z_to_xi(double z) = 0

Convert from vertical to mapped coordinate.

inline virtual ~CoordMap()

Destructor.

Public Static Functions

static std::unique_ptr<CoordMap> factory(CoordMapTypes type, double H)

Coordinate map factory.

Protected Attributes

double H

Scale parameter.

class coulombSelect
#include <BN.H>

Cumulative angle scattering from Bobylev and Nanbu (2000)

Public Functions

inline coulombSelect()

Constructor.

inline double eval(double tau)

Evaluate A given tau.

inline double operator()(double tau, double U)

Select tau given random number U in [0,1)

Private Functions

inline double deriv(double x)
inline double f(double x)
inline double func(double tau, double x)

Private Members

std::vector<double> cA
std::vector<double> cT

Array grids.

const int numT = 2000

Tau evaluation grid.

const double tau_f = 4.0
const double tau_i = 0.0001

Limiting values for tau evaluation for asymptotic and extreme values

const double tau_m = 1.0e-8
const double tau_z = 40.0
class CPoly : public Eigen::VectorXcd
#include <cpoly.H>

Inheritence diagram for CPoly:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="CPoly" tooltip="CPoly" fillcolor="#BFBFBF"]
    "2" [label="Eigen::VectorXcd" tooltip="Eigen::VectorXcd"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for CPoly:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="CPoly" tooltip="CPoly" fillcolor="#BFBFBF"]
    "2" [label="Eigen::VectorXcd" tooltip="Eigen::VectorXcd"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

CPoly(const CPoly&)
CPoly(const Eigen::VectorXcd&)
CPoly(const int)
CPoly(const Poly&)
CPoly(int, double*)
CPoly(void)
std::complex<double> deriv(std::complex<double> z)
std::complex<double> eval(std::complex<double> z)
inline const int getorder(void)
CPoly &operator%=(const CPoly&)
CPoly &operator&=(const CPoly&)
inline CPoly operator+()
CPoly &operator+=(const CPoly&)
CPoly operator-()
CPoly &operator-=(const CPoly&)
CPoly &operator=(const CPoly&)
inline void Pop(int i)
void print(ostream&)

Private Functions

void reduce_order(void)

Private Members

int order

Friends

friend CPoly operator%(const CPoly&, const CPoly&)
friend CPoly operator&(const CPoly&, const CPoly&)
friend CPoly operator+(const CPoly&, const CPoly&)
friend CPoly operator-(const CPoly&, const CPoly&)
class CRat : public Disk2dHalo::CMap

Inheritence diagram for Disk2dHalo::CRat:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="Disk2dHalo::CMap" tooltip="Disk2dHalo::CMap"]
    "1" [label="Disk2dHalo::CRat" tooltip="Disk2dHalo::CRat" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Disk2dHalo::CRat:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="Disk2dHalo::CMap" tooltip="Disk2dHalo::CMap"]
    "1" [label="Disk2dHalo::CRat" tooltip="Disk2dHalo::CRat" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline CRat(const CRat &p)
inline CRat(double scale)
inline virtual double r_to_x(double r)
inline virtual double x_to_r(double x)

Public Members

double scale
class CRat : public DiskHalo::CMap

Inheritence diagram for DiskHalo::CRat:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="DiskHalo::CMap" tooltip="DiskHalo::CMap"]
    "1" [label="DiskHalo::CRat" tooltip="DiskHalo::CRat" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for DiskHalo::CRat:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="DiskHalo::CMap" tooltip="DiskHalo::CMap"]
    "1" [label="DiskHalo::CRat" tooltip="DiskHalo::CRat" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline CRat(const CRat &p)
inline CRat(double scale)
inline virtual double r_to_x(double r)
inline virtual double x_to_r(double x)

Public Members

double scale
template<typename X, typename Y>
class Cspline
#include <Cspline.H>

A cubic spline evaluator templated on data types X, Y. Types X and Y must have operator +, -, *, Y must have defined a constructor that takes a scalar.

Public Functions

inline Cspline()

Null constructor.

inline Cspline(const std::vector<X> &x, const std::vector<Y> &y)

Constructor for spline with x and y vectors.

inline std::vector<Y> interpolate(const std::vector<X> &xx) const

Evaluation function for vector input, assuming xx is sorted ascending.

inline Y interpolate(const X &x) const

Evaluation function.

inline std::vector<Y> operator()(const std::vector<X> &xx) const

Evaluation operator for vector input, assuming xx is sorted ascending.

inline Y operator()(const X &x) const

Evaluation opterator.

inline virtual ~Cspline()

Destructor.

Protected Types

typedef Element element_type

Protected Attributes

std::vector<element_type> elems
class Cube : public PotAccel
#include <Cube.H>

Inheritence diagram for Cube:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Cube" tooltip="Cube" fillcolor="#BFBFBF"]
    "2" [label="PotAccel" tooltip="PotAccel"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Cube:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="Component" tooltip="Component"]
    "1" [label="Cube" tooltip="Cube" fillcolor="#BFBFBF"]
    "6" [label="EL3" tooltip="EL3"]
    "5" [label="Orient" tooltip="Orient"]
    "2" [label="PotAccel" tooltip="PotAccel"]
    "7" [label="Timer" tooltip="Timer"]
    "3" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "4" -> "4" [dir=forward tooltip="usage"]
    "4" -> "2" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="usage"]
    "4" -> "7" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "2" -> "4" [dir=forward tooltip="usage"]
    "3" -> "2" [dir=forward tooltip="usage"]
}

Periodic cube basis.

YAML configuration

Param nminx:

is the minimum absoulte value of the wave number in the x direction (default: 0)

Param nminy:

is the minimum absoulte value of the wave number in the y direction (default: 0)

Param nminz:

is the minimum absoulte value of the wave number in the z direction (default: 0)

Param nmaxx:

is the maximum absoulte value of the wave number in the x direction (default: 16)

Param nmaxy:

is the maximum absoulte value of the wave number in the y direction (default: 16)

Param nmaxz:

is the maximum absoulte value of the wave number in the z direction (default: 16)

Param method:

string sets the evaluation method for the CUDA kernel. Available methods are: all, full, 3d which compute all dimensions at once and planes, axes, and 1d which compute wave vectors by plane. This may be extended to specific algorithms in the future. This does nothing for the CPU-only computation.

Public Functions

Cube(Component *c0, const YAML::Node &conf)

Constructor.

virtual void determine_coefficients(void)

Compute the coefficients.

virtual void dump_coefs_h5(const std::string &file)

Coefficient output.

virtual void get_acceleration_and_potential(Component*)

Compute the force.

virtual ~Cube()

Destructor.

Public Members

std::string id

Id string.

Private Types

using coefType = Eigen::Tensor<std::complex<double>, 3>

Coefficients are a 3-tensor.

using coefTypePtr = std::shared_ptr<coefType>

Interpolation arrays.

Private Functions

void compute_multistep_coefficients()

Extrapolate and sum coefficents per multistep level to get a complete set of coefficients for force evaluation at an intermediate time step

void determine_acceleration_and_potential()

Do the work.

virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreading implementation of the force computation.

virtual void *determine_coefficients_thread(void *arg)

Threading.

virtual void initialize(void)

Parameter and storage initialization.

virtual void multistep_update(int cur, int next, Component *c, int i, int id)

Implementation of level shifts.

virtual void multistep_update_begin()

Update the multi time step coefficient table when moving particle i from level cur to level next

virtual void multistep_update_finish()

Execute to finish level shifts for particles.

inline void swap_coefs(std::vector<coefType> &from, std::vector<coefType> &to)

Swap coefficients.

Private Members

bool byPlanes

Plane method (default: true)

CoefClasses::CubeCoefs cubeCoefs

Coefficient container instance for writing HDF5.

std::string cuMethod

Cuda batch method (string, default: planes.

double dfac
std::vector<std::vector<coefType>> differ1

For updating levels.

std::vector<coefType> expcoef

Current coefficient tensor.

std::vector<coefTypePtr> expcoefL
std::vector<coefTypePtr> expcoefN
std::vector<coefType> expcoefP
int imx

Variables.

int imy
int imz
std::complex<double> kfac
int nmaxx

Minimum wave numbers in each dimesion.

int nmaxy
int nmaxz
int nminx

Maximum wave numbers in each dimesion.

int nminy
int nminz
int osize
std::vector<std::complex<double>> pack
std::vector<std::complex<double>> unpack
int use0
int use1

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class Cubic_Table
#include <cubic.H>

Public Functions

void build(Eigen::VectorXd&, Eigen::VectorXd&, Eigen::VectorXd&)
inline Cubic_Table(Cubic_Table &c)
Cubic_Table(void)
inline Cubic_Table &operator*=(double x)
inline Cubic_Table &operator+=(Cubic_Table &c)
inline Cubic_Table &operator-=(Cubic_Table &c)
inline Cubic_Table &operator/=(double x)
inline Cubic_Table &operator=(Cubic_Table &c)
double value(double, double*)
~Cubic_Table(void)

Protected Attributes

Eigen::MatrixXd a
Eigen::VectorXd dx
Eigen::VectorXd xgrid

Friends

friend Cubic_Table operator*(Cubic_Table &c, double x)
friend Cubic_Table operator*(double x, Cubic_Table &c)
friend Cubic_Table operator+(Cubic_Table &c1, Cubic_Table &c2)
friend Cubic_Table operator-(Cubic_Table &c1, Cubic_Table &c2)
friend Cubic_Table operator/(Cubic_Table &c, double x)
template<typename T, typename Iterator>
class CyclicIterator
#include <Circular.H>

Collaboration diagram for CyclicIterator:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="CyclicIterator< T, Iterator >" tooltip="CyclicIterator< T, Iterator >" fillcolor="#BFBFBF"]
    "2" [label="Iterator< T >" tooltip="Iterator< T >"]
    "1" -> "2" [dir=forward tooltip="usage"]
}

Public Types

using difference_type = std::ptrdiff_t
using iterator_category = std::bidirectional_iterator_tag

Add typedefs for std::iterator_traits.

using pointer = T*
using reference = T&
using value_type = T

Public Functions

inline CyclicIterator(const Iterator &i, const Iterator &j)

Create using positions i through j.

inline bool operator!=(const CyclicIterator &x) const

Test for inequality.

inline T operator*() const

Return current data.

inline CyclicIterator &operator++()

Pre-increment operator.

inline CyclicIterator operator++(int)

Post-increment operator.

inline CyclicIterator &operator--()

Pre-decrement operator.

inline CyclicIterator operator--(int)

Post-decrement operator.

inline Iterator operator->() const

Return current iterator.

inline bool operator==(const CyclicIterator &x) const

Test for equality.

Private Members

Iterator begin
Iterator cursor
Iterator end
struct CylCoefHeader
#include <coef.H>

Header structure for cylindrical expansion.

Public Members

int mmax

Number of azimuthal orders kept.

int nmax

Number of functions per azimuthal order.

double time

Time for this dump.

struct CylCoefs
#include <Coefs.H>

Public Functions

bool read(std::istream &in, bool verbose = false)

Public Members

std::shared_ptr<char[]> buf
std::vector<std::vector<double>> cos_c
int mmax
int nmax
std::vector<std::vector<double>> sin_c
double time
class CylDisk : public AxiSymModel
#include <CylDisk.H>

Inheritence diagram for CylDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "1" [label="CylDisk" tooltip="CylDisk" fillcolor="#BFBFBF"]
    "3" [label="MassModel" tooltip="MassModel"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for CylDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "7" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "10" [label="CylCoefHeader" tooltip="CylCoefHeader"]
    "1" [label="CylDisk" tooltip="CylDisk" fillcolor="#BFBFBF"]
    "9" [label="EmpCylSL" tooltip="EmpCylSL"]
    "15" [label="EmpCylSL::CoefMatrix" tooltip="EmpCylSL::CoefMatrix"]
    "13" [label="EmpCylSL::CoefVector" tooltip="EmpCylSL::CoefVector"]
    "11" [label="EmpCylSL::MstepArray" tooltip="EmpCylSL::MstepArray"]
    "8" [label="GaussQuad" tooltip="GaussQuad"]
    "18" [label="Interp1d" tooltip="Interp1d"]
    "17" [label="Linear1d" tooltip="Linear1d"]
    "3" [label="MassModel" tooltip="MassModel"]
    "6" [label="RegularOrbit" tooltip="RegularOrbit"]
    "5" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "12" [label="std::vector< VectorD2ptr >" tooltip="std::vector< VectorD2ptr >"]
    "16" [label="std::vector< std::vector< MatrixM > >" tooltip="std::vector< std::vector< MatrixM > >"]
    "14" [label="std::vector< std::vector< VectorM > >" tooltip="std::vector< std::vector< VectorM > >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "9" [dir=forward tooltip="usage"]
    "9" -> "10" [dir=forward tooltip="usage"]
    "9" -> "11" [dir=forward tooltip="usage"]
    "9" -> "13" [dir=forward tooltip="usage"]
    "9" -> "15" [dir=forward tooltip="usage"]
    "9" -> "17" [dir=forward tooltip="usage"]
    "15" -> "16" [dir=forward tooltip="public-inheritance"]
    "13" -> "14" [dir=forward tooltip="public-inheritance"]
    "11" -> "12" [dir=forward tooltip="public-inheritance"]
    "17" -> "18" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
    "5" -> "7" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
}

Public Functions

inline CylDisk(EmpCylSL *D, double Rmin, double Rmax)
inline virtual double d2fde2(double E, double L)
inline virtual double dfde(double E, double L)
inline virtual double dfdl(double E, double L)
inline virtual double distf(double E, double L)
inline virtual double get_density(const double r)
inline virtual double get_dpot(const double r)
inline virtual double get_dpot2(const double r)
inline virtual double get_mass(const double r)

Access the profile.

inline virtual double get_max_radius(void)
inline virtual double get_min_radius(void)
inline virtual double get_pot(const double r)
inline virtual void get_pot_dpot(const double r, double &ur, double &dur)

Public Static Attributes

static int NUMR
static bool RLOG

Private Functions

void setup_model(double rmin, double rmax)

Private Members

EmpCylSL *d
vector<double> dd
double dr
vector<double> mm
vector<double> pp
bool rlog
double rmax
double rmin
vector<double> rr
class CylEXP : public EmpCylSL
#include <CylEXP.H>

Inheritence diagram for CylEXP:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="CylEXP" tooltip="CylEXP" fillcolor="#BFBFBF"]
    "2" [label="EmpCylSL" tooltip="EmpCylSL"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for CylEXP:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="CylCoefHeader" tooltip="CylCoefHeader"]
    "1" [label="CylEXP" tooltip="CylEXP" fillcolor="#BFBFBF"]
    "2" [label="EmpCylSL" tooltip="EmpCylSL"]
    "8" [label="EmpCylSL::CoefMatrix" tooltip="EmpCylSL::CoefMatrix"]
    "6" [label="EmpCylSL::CoefVector" tooltip="EmpCylSL::CoefVector"]
    "4" [label="EmpCylSL::MstepArray" tooltip="EmpCylSL::MstepArray"]
    "11" [label="Interp1d" tooltip="Interp1d"]
    "10" [label="Linear1d" tooltip="Linear1d"]
    "5" [label="std::vector< VectorD2ptr >" tooltip="std::vector< VectorD2ptr >"]
    "9" [label="std::vector< std::vector< MatrixM > >" tooltip="std::vector< std::vector< MatrixM > >"]
    "7" [label="std::vector< std::vector< VectorM > >" tooltip="std::vector< std::vector< VectorM > >"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "2" -> "4" [dir=forward tooltip="usage"]
    "2" -> "6" [dir=forward tooltip="usage"]
    "2" -> "8" [dir=forward tooltip="usage"]
    "2" -> "10" [dir=forward tooltip="usage"]
    "8" -> "9" [dir=forward tooltip="public-inheritance"]
    "6" -> "7" [dir=forward tooltip="public-inheritance"]
    "4" -> "5" [dir=forward tooltip="public-inheritance"]
    "10" -> "11" [dir=forward tooltip="public-inheritance"]
}

Encapsulatates a SLGridSph (Sturm-Liouville basis) for use as force method.

This provides the extra routines needed for n-body integration. See EmpCylSL in the exputils directory.

Public Functions

void compute_multistep_coefficients(unsigned mlevel)

Extrapolate and sum coefficents per multistep level to get a complete set of coefficients for force evaluation at an intermediate time step

inline CylEXP()
CylEXP(int numr, int lmax, int mmax, int nord, double ascale, double hscale, int Nodd = -1, std::string cachename = "")

Constructor with parameters

Parameters:

Parameters:
  • multistep – is the number of coefficient levels for n-body

  • numr – is the spherical radial order of the input basis

  • lmax – is the spherical angular order of the input basis

  • mmax – is the output aximuthal order for the EOF basis

  • nord – is the output radial order for the EOF basis

  • ascale – is the target disk scale LENGTH

  • hscale – is the target disk scale HEIGHT

  • nodd – is the number of vertically odd parity basis functions. If unspecified, you get eigenvalue order.

void multistep_debug()

Print debug info.

virtual void multistep_reset()
virtual void multistep_update(int from, int to, double r, double z, double phi, double mass, int id)
virtual void multistep_update_begin()

Update the multi time step coefficient table when moving particle i from level cur to level next

virtual void multistep_update_finish()

Protected Attributes

std::vector<std::vector<Eigen::MatrixXd>> differC1
std::vector<std::vector<Eigen::MatrixXd>> differS1

For updating levels.

std::vector<double> workC
std::vector<double> workC1
std::vector<double> workS
std::vector<double> workS1

Friends

friend class Cylinder
class Cylinder : public Basis
#include <Cylinder.H>

Inheritence diagram for Cylinder:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="Basis" tooltip="Basis"]
    "1" [label="Cylinder" tooltip="Cylinder" fillcolor="#BFBFBF"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Cylinder:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="Basis" tooltip="Basis"]
    "5" [label="Component" tooltip="Component"]
    "1" [label="Cylinder" tooltip="Cylinder" fillcolor="#BFBFBF"]
    "7" [label="EL3" tooltip="EL3"]
    "9" [label="MixtureBasis" tooltip="MixtureBasis"]
    "6" [label="Orient" tooltip="Orient"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "8" [label="Timer" tooltip="Timer"]
    "10" [label="TwoCenter" tooltip="TwoCenter"]
    "4" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "5" -> "5" [dir=forward tooltip="usage"]
    "5" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "9" [dir=forward tooltip="usage"]
    "9" -> "10" [dir=forward tooltip="usage"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "5" [dir=forward tooltip="usage"]
    "10" -> "3" [dir=forward tooltip="public-inheritance"]
    "10" -> "2" [dir=forward tooltip="usage"]
    "10" -> "9" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
}

This routine computes the potential, acceleration and density using the Cylindrical biorthogonal expansion.

YAML parameters

Param rcylmin:

is the minimum cylindrical grid radius in scale-length units

Param rcylmax:

is the maximum cylindrical grid radius in scale-length units

Param acyl:

is the scale length

Param hcyl:

is the scale height

Param lmaxfid:

is the maximum spherical harmonic index for EOF construction

Param nmaxfid:

is the maximum radial index for EOF construction

Param mmax:

is the maximum azimuthal order for the resulting basis

Param mlim:

applies a limit <= mmax without basis reconstruction

Param ncylnx:

is the grid size for the cylindrical radius axis

Param ncylny:

is the grid size for the vertical axis

Param ncylr:

radial grid size for basis computation (NUMR in EmpCylSL)

Param ncylorder:

is the maximum order in for each harmonic m for the new basis

Param ncylodd:

is the number of vertically antisymmetric basis functions out of the total ncylorder

Param ncylrecomp:

is the frequency of basis recompution during a running simulation

Param npca:

is the number steps between PCA variance/error analyses

Param npca0:

is the number steps to skip before the first PCA variance/error analysis

Param nvtk:

is the number steps between vtk visualization output for the PCA variance/error analyses

Param cachename:

is the name of the basis cache file

Param samplesz:

is the default particle number in PCA subsampling partitions (default is 1). The value 0 sets the sample size to sqrt(N).

Param rnum:

if the size of the radial quadrature grid for analytic EOF computation

Param pnum:

if the size of the azimuthal quadrature grid for analytic EOF computation (set to 1 if model is axisymmetric)

Param tnum:

is the size of the equitorial quadrature grid for analytic EOF computation

Param ashift:

offsets the center of the analytic model for basis function computation

Param precond:

boolean true turns on analytic basis function preconditioning (default: true)

Param logr:

boolean turns on logarithmic radial basis gridding in EmpCylSL

Param pcavar:

turns on variance analysis

Param pcaeof:

turns on basis conditioning based on variance analysis

Param pcadiag:

logs diagnostic output for variance analysis

Param pcavtk:

turns on VTK visualization diagnostic output for variance analysis

Param hexp:

is the Hall sharpness parameter

Param snr:

is the signal-to-noise prefactor for sharpness computation

Param evcut:

is the cumulative trim remainder on the covariance eigenvalues (default: -1, which implies no trimming). Set to small positive value for trimming.

Param try_cache:

false suppresses cache reading on restart (default: true)

Param EVEN_M:

true uses even harmonic orders only

Param cmap:

is the coordinate mapping type (deprecated but kept for backward consistency)

Param cmapr:

is the radial coordinate mapping type

Param cmapz:

is the vertical coordinate mapping type

Param self_consistent:

set to false turns off potential expansion; only performed the first time

Param playback:

file reads a coefficient file and uses it to compute the basis function output for resimiulation

Param pyname:

is the file name of Python module which supplies the ‘disk_density’ function for conditioning the cylindrical basis. A non-null string triggers the use of the Python interpreter to evaluate the target density function.

Param dumpbasis:

set to true dumps the basis to a file for diagnostic examination (default: false)

Public Functions

Cylinder(Component *c0, const YAML::Node &conf, MixtureBasis *m = 0)

Constructor

Parameters settable in the configuration line include:

Parameters:
  • c0 – is the instantiating caller (a Component)

  • conf – contains the parameters passed to the method

  • m – is the MixtureBasis for a multicenter expansion

  • acyl – is the disk scale length for the basis

  • hcyl – is the disk scale height for the basis

  • nmaxfid – is the radial order for the underlying spherical basis

  • lmaxfid – is the harmonic order for the underlying spherical basis

  • mmax – is the azimuthal harmonic order for final cylindrical expansion

  • mlim – restricts the azimuthal harmonic order for testing

  • ncylnx – is the radial grid in the basis function table

  • ncylny – is the vertical grid in the basis function table

  • ncylr – is the size of the spherical radial grid used to construct the cylindrical basis

  • nmax – is the order of the radial expansion

  • ncylodd – is the number of terms with vertically antisymmetric parity out of ncylorder. If unspecified, you will get the original variance order.

  • ncylrecomp – is the number of steps between basis recomputation (default: -1 which means NEVER)

  • npca – is the number of steps between Hall coefficient recomputaton

  • npca0 – is the first step for Hall coefficient computaton

  • nvtk – is the number of step VTK output

  • pcadiag – set to true enables PCA output diagnostics (default: false)

  • cachename – is the file for the EOF basis

  • vflag – sets verbosity (see EmpCylSL.cc)

  • rnum – is the number of Legendre radial knots for numerical basis computation

  • pnum – is the number of azimuthal knots for numerical basis computation

  • tnum – is the number of Legendre polar knots for numerical basis computation

  • ashift – is the shift applied in the x-axis relative to the original for basis conditioning

  • self_consistent – set to false for fixed potential

  • precond – set to true for analytic basis function conditioning (default: true)

  • logr – tabulate basis in logarithmic coordinates (default: false)

  • pcavar – set to true for real-time Hall analysis (default: false)

  • samplesz – is the default particle number in PCA subsampling partitions (default is 1). The value 0 sets the sample size to sqrt(N).

  • pcavtk – set to true dumps PCA functions in VTK format for diagnostics (default: false)

  • try_cache – set to true means try to read basis from cache (default: true)

  • dump_basis – set to true outputs basis into file

  • cmapR – selects the radial coordinate mapping (default: 2, power mapping)

  • cmapZ – selects the vertical coordinate mapping (default: 1, sinh mapping)

virtual void determine_fields_at_point(double x, double y, double z, double *tdens0, double *tpotl0, double *tdens, double *tpotl, double *tpotx, double *tpoty, double *tpotz)

Return the value for the fields in Cartesian coordinates.

virtual void determine_fields_at_point_cyl(double r, double z, double phi, double *tdens0, double *tpotl0, double *tdens, double *tpotl, double *tpotr, double *tpotz, double *tpotp)

Return the value for the fields in cylindrical coordinates.

inline void determine_fields_at_point_cyl(double r, double z, double phi, double *tdens0, double *tpotl0, double *tdens, double *tpotl, double *tpotr, double *tpotz, double *tpotp, int mmin, int mlim)

Return the value for the fields in cylindrical coordinates with limits.

virtual void determine_fields_at_point_sph(double r, double theta, double phi, double *tdens0, double *tpotl0, double *tdens, double *tpotl, double *tpotr, double *tpott, double *tpotp)

Return the value for the fields in spherical polar coordinates.

virtual void dump_coefs(ostream &out)

Save coefficients to file (need type marker to id dump, component id?)

virtual void dump_coefs_h5(const std::string &file)

Save coefficients to named HDF5 file.

void dump_mzero(const string &name, int step)

Sanity check on grid: dumps SM-style images of initial field.

virtual void get_acceleration_and_potential(Component*)

The main force call.

inline virtual void multistep_add_debug(const std::vector<std::vector<std::pair<unsigned, unsigned>>> &data)

Multistep accumulate debugging info.

virtual void multistep_debug()

Print debug info.

virtual void multistep_update(int cur, int next, Component *c, int i, int id)

Implementation of level shifts.

inline virtual void multistep_update_begin()

Update the multi time step coefficient table when moving particle i from level cur to level next.

inline virtual void multistep_update_finish()

Execute to finish level shifts for particles.

virtual ~Cylinder()

Destructor.

Public Static Attributes

static pthread_mutex_t cos_coef_lock
static pthread_mutex_t sin_coef_lock
static pthread_mutex_t used_lock

Mutexes for multithreading.

Protected Functions

inline void getCoefs(Eigen::MatrixXcd &C)

Store coefficients from EmpCylSL.

void occt_output()

Print deep debugging data.

inline void setCoefs(Eigen::MatrixXcd &C)

Installed stored coefficients in EmpCylSL.

Protected Attributes

bool coefMaster

Master node ships coefficients to hosts. True (default) implies that only the master node caches the coefficients for playback to save core memory. This is set in the config input using the ‘coefMaster: bool’ parameter. Once I am sure that there are no algorithmic issues, I will remove this as an option.

CoefClasses::CylCoefs cylCoefs

Coefficient container instance for writing HDF5.

int defSampT
double lastPlayTime

Last playback coefficient evaluation time.

std::vector<std::vector<unsigned>> occt

CUDA method for coefficient accumulation.

Test change level counts for deep debugging enabled by setting CYL_UPDATE_TABLE at the top of this header file or the command line

Eigen::MatrixXcd P

Save data pointers.

Eigen::MatrixXcd P1
std::shared_ptr<CoefClasses::CylCoefs> playback

Coefficient playback instance. Using shared_ptr to avoid constructing a simple pointer or null instance

int sampT

For variance subsampling.

Protected Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

Private Functions

void compute_grid_mass()

Manual computation of on-grid mass.

void compute_multistep_coefficients()

Extrapolate and sum coefficents per multistep level to get a complete set of coefficients for force evaluation at an intermediate time step

virtual void determine_acceleration_and_potential()

All derived classes must provide a method to compute the force.

virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreading implementation of the force computation.

virtual void determine_coefficients()

Used by get_acceleration_and_potential to request that the expansion be performed.

void determine_coefficients_eof()
void determine_coefficients_particles()
void determine_coefficients_playback()
virtual void *determine_coefficients_thread(void *arg)

Multithreading implementation of the expansion computation.

virtual void initialize(void)

Used by derived class to initialize any storage and parameters.

virtual void multistep_reset()

Reset used particle counter and mass registers.

Private Members

double acyl
double ashift
std::string cachename
int cmapR
int cmapZ
bool compute
double cylmass
std::vector<double> cylmass0
bool dump_basis
int eof
bool EVEN_M
bool firstime
bool firstime_coef
std::vector<Eigen::Vector3d> frc
double hcyl
double hexp
int lmaxfid
bool logarithmic
MixtureBasis *mix

For massive satellite simulations.

int mlim
int mmax
int ncompcyl
int ncylnx
int ncylny
int ncylodd
int ncylr
int ncylrecomp
int nmax
int nmaxfid
int npca
int npca0
int nvtk
std::vector<int> offgrid
std::shared_ptr<CylEXP> ortho
bool pcadiag
bool pcaeof
bool pcainit
bool pcavar
bool pcavtk
int pnum
std::vector<Eigen::Vector3d> pos
bool precond
std::string pyname
double rcylmax
double rcylmin
double rem
double resetT
int rnum
bool self_consistent
double snr
bool subsamp
int tnum
bool try_cache
unsigned int vflag
double zmax
struct dark_particle
#include <tipsydefs.h>

Tipsy particle structure for a dark particle.

Public Members

Real eps

Smoothing.

Real mass

Mass.

Real phi

Gravitational potential.

Real pos[MAXDIM]

Position vector.

Real vel[MAXDIM]

Velocity vector.

struct dark_particle
#include <tipsy.H>

Public Functions

inline int ID() const

Convert phi to index.

Public Members

Real eps
Real mass

Particle data.

Real phi
Real pos[MAXDIM]
Real vel[MAXDIM]
class DataGrid : public ThreeDGrid
#include <DataGrid.H>

Inheritence diagram for DataGrid:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="DataGrid" tooltip="DataGrid" fillcolor="#BFBFBF"]
    "2" [label="ThreeDGrid" tooltip="ThreeDGrid"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for DataGrid:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="DataGrid" tooltip="DataGrid" fillcolor="#BFBFBF"]
    "2" [label="ThreeDGrid" tooltip="ThreeDGrid"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

This implementation of ThreeDGrid instantiates at VtkGrid if VTK is available and TableGrid if not.

This is really syntactic glue that allows one call without checking for VTK in application codes.

Public Functions

inline virtual void Add(const std::vector<double> &data, const std::string &name)

Add data.

inline DataGrid(int nx, int ny, int nz, double xmin, double xmax, double ymin, double ymax, double zmin, double zmax, std::string type = "VTK")

Constructor.

inline virtual void Write(const std::string &name)

Write output file.

Private Members

ThreeDGridPtr ptr
class Direct : public PotAccel
#include <Direct.H>

Inheritence diagram for Direct:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Direct" tooltip="Direct" fillcolor="#BFBFBF"]
    "2" [label="PotAccel" tooltip="PotAccel"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Direct:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "14" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "9" [label="AxiSymModel" tooltip="AxiSymModel"]
    "19" [label="Cheby1d" tooltip="Cheby1d"]
    "4" [label="Component" tooltip="Component"]
    "1" [label="Direct" tooltip="Direct" fillcolor="#BFBFBF"]
    "6" [label="EL3" tooltip="EL3"]
    "17" [label="FDIST" tooltip="FDIST"]
    "18" [label="FDISTC" tooltip="FDISTC"]
    "15" [label="GaussQuad" tooltip="GaussQuad"]
    "20" [label="Interp1d" tooltip="Interp1d"]
    "10" [label="MassModel" tooltip="MassModel"]
    "5" [label="Orient" tooltip="Orient"]
    "2" [label="PotAccel" tooltip="PotAccel"]
    "16" [label="RUN" tooltip="RUN"]
    "13" [label="RegularOrbit" tooltip="RegularOrbit"]
    "8" [label="SphericalModelTable" tooltip="SphericalModelTable"]
    "12" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "7" [label="Timer" tooltip="Timer"]
    "11" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "3" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "9" -> "10" [dir=forward tooltip="public-inheritance"]
    "9" -> "11" [dir=forward tooltip="public-inheritance"]
    "9" -> "12" [dir=forward tooltip="usage"]
    "19" -> "20" [dir=forward tooltip="public-inheritance"]
    "4" -> "4" [dir=forward tooltip="usage"]
    "4" -> "2" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="usage"]
    "4" -> "7" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "8" [dir=forward tooltip="usage"]
    "18" -> "19" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "2" -> "4" [dir=forward tooltip="usage"]
    "8" -> "9" [dir=forward tooltip="public-inheritance"]
    "8" -> "16" [dir=forward tooltip="usage"]
    "8" -> "17" [dir=forward tooltip="usage"]
    "8" -> "18" [dir=forward tooltip="usage"]
    "12" -> "13" [dir=forward tooltip="public-inheritance"]
    "12" -> "14" [dir=forward tooltip="usage"]
    "12" -> "15" [dir=forward tooltip="usage"]
    "3" -> "2" [dir=forward tooltip="usage"]
}

Computes the potential, acceleration and density using the direct summation

Positions are passed from node to node on a ring. Accelerations computed on requested particles array due to particles in component associated with the Direct force.

Settable parameters:

Param soft_indx:

is the index in the particle double array for the softening value.

Param soft:

is a fixed softening value for all particles. This can be used even if a value is specified in the particle attribute array.

Param mn_model:

uses a Miyamoto-Nagi model for the distributed gravity. E.g. a disk model particle. Default: false.

Param a:

is the scale length of the Miyamoto-Nagai model for the distributed gravity. Default: 0.01

Param b:

is the scale height of the Miyamoto-Nagai model for the distributed gravity. Default: 0.002

Param pm_model:

uses a spherical model for the distributed gravity. E.g. a substructure halo profile. Default: false.

Param pmmodel_file:

is the file containing the substructure halo profile (default: SLGridSph.model)

Param type:

is the softening type. Current types: Plummer or Spline. Default type is Spline.

Public Functions

Direct(Component *c0, const YAML::Node &conf)

The constructor

Parameters:
  • c0 – is the instantiating caller (a Component)

  • conf – passes in any explicit parameters

virtual void get_acceleration_and_potential(Component*)

The main force call.

virtual ~Direct()

The constructor.

Private Functions

void determine_acceleration_and_potential(void)
virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreading implementation of the force computation.

virtual void determine_coefficients(void)

Used by get_acceleration_and_potential to request that the expansion be performed.

virtual void *determine_coefficients_thread(void *arg)

Multithreading implementation of the expansion computation.

virtual void initialize()

Used by derived class to initialize any storage and parameters.

Private Members

double a

MN disk scale length.

double b

MN disk scale height.

double *bod_buffer
int diverge
double diverge_rfac
bool fixed_soft
int from_proc
std::shared_ptr<SoftKernel> kernel

Smoothing kernel isntance.

int max_bodies
bool mn_model

Use Miyamoto-Nagai disk.

int ndim
int ninteract
bool pm_model

Use point-mass profile.

SphericalModelTable *pmmodel
string pmmodel_file
const double rtol = 1.0e-16

Separations smaller than this are assumed to be zero (same particle)

double soft
int soft_indx
double *tmp_buffer
int to_proc

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class Disk2d
#include <Disk2d.H>

Computes the potential, acceleration and density using an empirical function analysis for a flat Bessel basis and a target density

Param acyltbl:

is the scale length of target density (default is 0.6)

Param rcylmin:

is the minimum value in the table for the radial basis functions (default is 0.0)

Param rcylmax:

is the maximum value in the table for the radial basis functions in acyltbl units (default is 10.0)

Param numr:

is the number radial coordinate knots in the table (default is 1000)

Param knots:

is the number quadrature points for integrals in basis construction

Param logr:

scales the EmpCyl2d grid logarithmically

Param model:

name for EmpCyl2d (default: expon)

Param biorth:

set for EmpCyl2d (default: bess)

Param Mmax:

is the azimuthal order

Param nmaxfid:

is the radial order for the Bessel basis used to construct the EOF

Param nmax:

is the radial order

Param numx:

is the number of grid points in the scaled radial direction

Param numy:

is the number of grid points in the scaled vertical direction

Param NQDHT:

is the number of Bessel knots in the underlying Hankel transform used to get the vertical potential

Param cmapR:

is the scaling method for radius (0=none, 1=rational) in the grid mapping

Param cmapZ:

is the scaling method for vertical height (0=none, 1=sinh, 2=rational) in the grid mapping

Param scale:

is the expansion factor to get the physical scale from the internal scale (default is 0.01)

Param cachename:

is the file cache for the 2d EOF basis

Param verbose:

set to true turns on some additional diagnostic info in BiorthCyl

Param mmin:

changes the minimum harmonic order for evaluation to some value >=0

Param mlim:

changes the maximum harmonic order for evaluation to some value <=mmax

Param nmin:

changes the minimum radial order for evaluation to some value >=0

Param nlim:

changes the maximum radial order for evaluation to some value <=nmax

Param EVEN_M:

evaluates the expansion for even azimuthal harmonics only

Public Functions

void accumulate(double r, double phi, double mass)

Add single particle to coefficients.

void accumulate(std::vector<Particle> &part)

Accumulate coefficients from particle distribution.

std::tuple<double, double, double, double, double, double, double> accumulated_eval(double R, double z, double phi)

Evaluation of field. Returns: den0, den1, pot0, pot1, Fr, Fz, Fp.

Disk2d(const YAML::Node &conf)

Constructor.

inline Eigen::MatrixXd get_coefs()

Get coefficient matrix.

void inner_product(std::function<double(int, double)> dens, int numr, int nlim = std::numeric_limits<int>::max())

Compute the m=0 coefficients for the provided density profile.

void make_coefficients()

Finish making the coefficients after accumulation.

void setup_accumulation()

Set up for accumulations by zeroing counters, allocated storage, etc.

void write_coefficients(const std::string &outfile)

Write coefficients to a file for debugging.

virtual ~Disk2d()

Destructor.

Protected Functions

inline void get_pot(Eigen::MatrixXd &Vc, Eigen::MatrixXd &Vs, double r, double z)

Use BiorthCyl to evaluate the basis at r, z.

void setup_accum()

Setup accumulation arrays.

Protected Attributes

double cylmass
std::vector<double> cylmass1

Mass tally.

Eigen::MatrixXd dend

Field evaluation.

Eigen::MatrixXd expcoef

Final coefficiet set.

std::vector<Eigen::MatrixXd> expcoef0

Matrices per thread for obtaining expansion coefficients.

std::vector<Eigen::MatrixXd> potd

Potential coefficient computation.

Eigen::MatrixXd potl
Eigen::MatrixXd potr
Eigen::MatrixXd potz

Private Functions

void get_dens(double r, double z, Eigen::MatrixXd &p, int tid)
void get_dpotl(double r, double z, Eigen::MatrixXd &p, Eigen::MatrixXd &dpr, Eigen::MatrixXd &dpz, int tid)

Field evaluation members.

void get_potl(double r, double z, Eigen::MatrixXd &p, int tid)
void get_potl_dens(double r, double z, Eigen::MatrixXd &p, Eigen::MatrixXd &d, int tid)
inline virtual double getRtable()
void initialize(void)

Initialize parameters.

Private Members

bool accum_setup
double acyltbl

Parameters.

string biorth
bool coefs_made
YAML::Node conf

Config db.

int knots
bool logr
int mmax
string model
int nmax
int nthrds

Internal state variables.

int numr
CylPtr ortho

Basis instance.

double rcylmax
double rcylmin
double scale

Private Static Attributes

static std::set<std::string> valid_keys

Valid key set for parameter name checking.

class Disk2dHalo
#include <Disk2dHalo.H>

Public Types

enum DiskGenType

Values:

enumerator Jeans
enumerator Asymmetric
enumerator Epicyclic

Public Functions

double a_drift(double xp, double yp, double zp)
double deri_pot(double xp, double yp, double zp, int n)
double deri_pot_disk(double xp, double yp, double zp, int n)
double deri_pot_halo(double xp, double yp, double zp, int n)
Disk2dHalo()

Dummy Constructor.

Disk2dHalo(const Disk2dHalo&)

Copy constructor.

Disk2dHalo(SphericalSLptr expandh, std::shared_ptr<Disk2d> expandd, double A, double DMass, std::string maptype, string &filename, int DF = 0, int DIVERGE = 0, double DIVERGE_RFAC = 1.0, DiskGenType type = Asymmetric)

Constructor: equal mass.

Disk2dHalo(SphericalSLptr haloexp, std::shared_ptr<Disk2d> diskexp, double A, double DMass, std::string maptype, string &filename1, int DIVERGE, double DIVERGE_RFAC, string &filename2, int DIVERGE2, double DIVERGE_RFAC2, DiskGenType type = Asymmetric)

Constructor: multi mass.

void disk_eval(double R, double z, double phi, double &p, double &fr, double &fz, double &fp)
void disk_model(const std::string &modfile)
double epi(double xp, double yp, double zp)
double get_ddpot(double xp, double yp, double zp)
double get_disp(double xp, double yp, double zp)
double get_dpot(double xp, double yp, double zp)
double get_hdpot(double xp, double yp, double zp)
double get_hpot(double xp, double yp, double zp)
void profile(std::ostream &rotfile, vector<Particle> &dpart, double rmin, double rmax, int numr)
void set_disk_coordinates(vector<Particle> &pdisk, int ndisk, int npart)
void set_halo(vector<Particle> &phalo, int nhalo, int npart)
void set_halo_coordinates(vector<Particle> &phalo, int nhalo, int npart)
void set_halo_table_multi(vector<Particle> &phalo)
void set_halo_table_single(vector<Particle> &phalo)
inline void set_pos_origin(double &x, double &y, double &z)
void set_vel_disk(vector<Particle> &part)
void set_vel_halo(vector<Particle> &part)
inline void set_vel_origin(double &x, double &y, double &z)
void table_disk(vector<Particle> &part)
void table_halo(vector<Particle> &part)
double v_circ(double xp, double yp, double zp)
void virial_ratio(const char*, const char*)
void virial_ratio(vector<Particle> &hpart, vector<Particle> &dpart)
double vp_disp2(double xp, double yp, double zp)
double vr_disp2(double xp, double yp, double zp)
void write_file(ostream &fou, vector<Particle> &part)
inline void zero_com(bool val)
inline void zero_cov(bool val)
~Disk2dHalo()

Destructor.

Public Static Attributes

static bool ALLOW
static double AMPL
static bool CHEBY
static double COMPRESSION
static double DR_DF
static std::map<std::string, DiskGenType> getDiskGenType
static int ITMAX
static bool LOGR
static int MPERT
static unsigned NBUF
static int NCHEB
static int NDP
static int NDR
static int NDZ
static int NHR
static int NHT
static int NUMDF
static double Q
static double R_DF
static double RA
static double RDMAX
static double RDMIN
static double RHMAX
static double RHMIN
static int RNUM
static string RUNTAG
static int SEED
static double SHFACTOR
static double SIG0
static double TOLE
static bool use_mono
static unsigned VFLAG
static double XI

Private Functions

double disk_surface_density(double R)
void flush_buffer(ostream &out)
inline std::shared_ptr<CMap> make_cmap(std::string type, double scale)
void table_halo_disp()
inline void write_record(ostream &out, Particle &p)
void write_record(ostream &out, SParticle &p)

Private Members

Eigen::MatrixXd asytable
int bufcnt
std::ostringstream bufout
const int bunchcnt = 16384
double center_pos[3]
double center_vel[3]
std::shared_ptr<CMap> cmap
bool com
bool cov
double dc
bool DF
std::shared_ptr<ExponentialDisk> disk
double dmass
double dP
double dR
double dr
double dRh
Eigen::MatrixXd dv2table
double dZ
Eigen::MatrixXd epitable
std::shared_ptr<Disk2d> expandd
SphericalSLptr expandh
std::mt19937 gen
std::shared_ptr<SphericalModelTable> halo
std::shared_ptr<SphericalModelTable> halo2
std::shared_ptr<SphericalModelTable> halo3
Eigen::MatrixXd halotable
double hDmax
double hDmin
std::string mtype
std::shared_ptr<SphericalModelMulti> multi
bool MULTI
std::shared_ptr<AddDisk> newmod
vector<double> nhD
vector<double> nhM
vector<unsigned> nhN
int nzepi
int nzero
std::normal_distribution rndN
std::uniform_real_distribution rndU
double scalelength
double sigma0
DiskGenType type
double Xmax
double Xmin

Private Static Attributes

static const unsigned mh = 5
static const unsigned nh = 50
static const int use_spline = 0
class Disk2dHaloException : public std::runtime_error
#include <Disk2dHalo.H>

Inheritence diagram for Disk2dHaloException:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Disk2dHaloException" tooltip="Disk2dHaloException" fillcolor="#BFBFBF"]
    "2" [label="std::runtime_error" tooltip="std::runtime_error"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Disk2dHaloException:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Disk2dHaloException" tooltip="Disk2dHaloException" fillcolor="#BFBFBF"]
    "2" [label="std::runtime_error" tooltip="std::runtime_error"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline Disk2dHaloException(const string message, const string sourcefilename, const int sourcelinenumber)
class diskbulge : public EmpCylSL::AxiDisk
#include <DiskModels.H>

Inheritence diagram for diskbulge:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EmpCylSL::AxiDisk" tooltip="EmpCylSL::AxiDisk"]
    "1" [label="diskbulge" tooltip="diskbulge" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for diskbulge:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EmpCylSL::AxiDisk" tooltip="EmpCylSL::AxiDisk"]
    "1" [label="diskbulge" tooltip="diskbulge" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

The usual exponential disk + a Hernquist bulge.

Public Functions

inline diskbulge(double a, double h, double as, double Mfac, double M = 1)
inline virtual double operator()(double R, double z, double phi = 0.)

Density function.

Private Members

double a
double as
double d1
double d2
double h
double Mfac
class DiskEval
#include <DiskEval.H>

Compute the axisymmetric force of a three-dimensional disk density using the multipole expansion

Using the standard multipole formula

\[ \Phi(\mathbf{r}) = -4\pi G \sum_{lm} Y_{lm}(\mathbf{\Omega}) \left[ \frac{1}{r^{l+1}}\int_0^r da a^{l+2}\rho_{lm}(a) + r^l\int_r^{\infty} da \frac{\rho_{lm}(a)}{a^{l-1}} \right] \]
where
\[ \rho_{lm} = \int d\mathbf{\Omega}Y_{lm}(\mathbf{\Omega}) \rho(\mathbf{r}). \]

The forces follow by analytic differentiation. Specifically, the forces follows by differentiation of \(\Phi(\mathbf{r})\) with respect to \(r\) and \(\theta\) where:

\[ F_R = -\frac{\partial\Phi}{\partial r} \frac{R}{r} - \frac{\partial\Phi}{\partial\theta} \frac{z}{r^2} \]
and
\[ F_z = -\frac{\partial\Phi}{\partial r} \frac{z}{r} + \frac{\partial\Phi}{\partial\theta} \frac{R}{r^2} \]

Note

{Mathematics}

Param model:

is the target model for potential computation

Param rmin:

is the minimum radius for potential evaluation

Param rmax:

is the maximum radius for potential evaluation

Param ascl:

is the scale radius for maping r to the unit interval. This is only used if ascl>0, otherwise it is linear if rmin=0 or logarithmic if rmin>0.

Param lmax:

is the maximum order of the spherical harmonics

Param numr:

is the number of grid points in the radial table

Param nint:

is the number of quadrature knots for the x=cos(theta) integral @parm progress set to true prints a progress bar

Public Functions

DiskEval(EmpCylSL::AxiDiskPtr model, double rmin, double rmax, double ascl, int lmax, int numr, int nint, bool progress = true, int mmax = 1, int nump = 1, bool cache = true)

Constructor.

std::tuple<double, double, double, double> operator()(double R, double z, double phi = 0)

Evaluation where the return tuple is potential, dPhi/dR, dPhi/dz, dPhi/dphi.

inline void setPrenorm(bool b)

Set prenorm (true) standard (false) evaluation.

Private Functions

inline double dr_to_dx(double x)
inline double Nlm(int l, int m)

Ylm angular factors.

inline double r_to_x(double r)

Coordinate scaling: physical to scaled.

bool read_cache()
void write_cache()
inline double x_to_r(double x)

Coordinate scaling: scaled to physical.

inline double Ylm(int l, int m, double cosx)

Ylm evaluation.

inline double Ylm_prenorm(int L, int m, double x)

Prenormalized Ylm evaluation.

inline double Ylm_standard(int l, int m, double cosx)

Standard recursion CAUTION: this will fail at l>150 owing to double precision issues.

inline double Zlm(int l, int m, double cosx)

Ylm derivative.

inline double Zlm_prenorm(int L, int m, double x)

Derivative of Ylm prenormalized.

inline double Zlm_standard(int l, int m, double cosx)

Partial derivative of Ylm in theta Standard version

Private Members

double ascl
double dx
const unsigned hmagic = 0x57ee1ed
int lmax
bool logr
EmpCylSL::AxiDiskPtr model
int numr
bool prenorm = true
std::vector<std::vector<std::vector<double>>> rho

Rho(l, r), Term1(l, r), Term2(l, r)

Rho(l, m, r), Term1(l, m, r), Term2(l, m, r)

std::vector<std::vector<std::vector<double>>> T1
std::vector<std::vector<std::vector<double>>> T2
double xmax
double xmin
bool xscl

Private Static Attributes

static const std::string cachefile
class DiskHalo
#include <DiskHalo.H>

Public Types

enum DiskGenType

Values:

enumerator Jeans
enumerator Asymmetric
enumerator Epicyclic

Public Functions

double a_drift(double xp, double yp, double zp)
double deri_pot(double xp, double yp, double zp, int n)
double deri_pot_disk(double xp, double yp, double zp, int n)
double deri_pot_halo(double xp, double yp, double zp, int n)
void disk_eval(double R, double z, double phi, double &p, double &fr, double &fz, double &fp)
void disk_model(const std::string &modfile)
DiskHalo()

Dummy Constructor.

DiskHalo(const DiskHalo&)

Copy constructor.

DiskHalo(SphericalSLptr expandh, EmpCylSLptr expandd, double H, double A, double DMass, std::string maptype, string &filename, int DF = 0, int DIVERGE = 0, double DIVERGE_RFAC = 1.0, DiskGenType type = Asymmetric)

Constructor: equal mass.

DiskHalo(SphericalSLptr haloexp, EmpCylSLptr diskexp, double H, double A, double DMass, std::string maptype, string &filename1, int DIVERGE, double DIVERGE_RFAC, string &filename2, int DIVERGE2, double DIVERGE_RFAC2, DiskGenType type = Asymmetric)

Constructor: multi mass.

double epi(double xp, double yp, double zp)
double get_ddpot(double xp, double yp, double zp)
double get_disp(double xp, double yp, double zp)
double get_dpot(double xp, double yp, double zp)
double get_hdpot(double xp, double yp, double zp)
double get_hpot(double xp, double yp, double zp)
void profile(std::ostream &rotfile, vector<Particle> &dpart, double rmin, double rmax, int numr)
void set_disk_coordinates(vector<Particle> &pdisk, int ndisk, int npart)
void set_halo(vector<Particle> &phalo, int nhalo, int npart)
void set_halo_coordinates(vector<Particle> &phalo, int nhalo, int npart)
void set_halo_table_multi(vector<Particle> &phalo)
void set_halo_table_single(vector<Particle> &phalo)
inline void set_pos_origin(double &x, double &y, double &z)
void set_vel_disk(vector<Particle> &part)
void set_vel_halo(vector<Particle> &part)
inline void set_vel_origin(double &x, double &y, double &z)
void table_disk(vector<Particle> &part)
void table_halo(vector<Particle> &part)
double v_circ(double xp, double yp, double zp)
void virial_ratio(const char*, const char*)
void virial_ratio(vector<Particle> &hpart, vector<Particle> &dpart)
double vp_disp2(double xp, double yp, double zp)
double vr_disp2(double xp, double yp, double zp)
double vz_disp2(double xp, double yp, double zp)
void write_file(ostream &fou, vector<Particle> &part)
inline void zero_com(bool val)
inline void zero_cov(bool val)
~DiskHalo()

Destructor.

Public Static Attributes

static bool ALLOW
static bool CHEBY
static double COMPRESSION
static double DR_DF
static std::map<std::string, DiskGenType> getDiskGenType
static int ITMAX
static bool LOGR
static unsigned NBUF
static int NCHEB
static int NDP
static int NDR
static int NDZ
static int NHR
static int NHT
static int NUMDF
static double Q
static double R_DF
static double RA
static double RDMAX
static double RDMIN
static double RHMAX
static double RHMIN
static int RNUM
static string RUNTAG
static int SEED
static double SHFACTOR
static double SIG0
static double TOLE
static bool use_mono
static unsigned VFLAG
static double XI

Private Functions

double disk_density(double R, double z)
double disk_surface_density(double R)
void flush_buffer(ostream &out)
inline std::shared_ptr<CMap> make_cmap(std::string type, double scale)
void table_halo_disp()
inline void write_record(ostream &out, Particle &p)
void write_record(ostream &out, SParticle &p)

Private Members

Eigen::MatrixXd asytable
int bufcnt
std::ostringstream bufout
const int bunchcnt = 16384
double center_pos[3]
double center_vel[3]
std::shared_ptr<CMap> cmap
bool com
bool cov
double dc
bool DF
std::shared_ptr<ExponentialDisk> disk
std::vector<Eigen::MatrixXd> disktableN
std::vector<Eigen::MatrixXd> disktableP
double dmass
double dP
double dR
double dr
double dRh
Eigen::MatrixXd dv2table
double dZ
Eigen::MatrixXd epitable
EmpCylSLptr expandd
SphericalSLptr expandh
std::mt19937 gen
std::shared_ptr<SphericalModelTable> halo
std::shared_ptr<SphericalModelTable> halo2
std::shared_ptr<SphericalModelTable> halo3
Eigen::MatrixXd halotable
double hDmax
double hDmin
std::string mtype
std::shared_ptr<SphericalModelMulti> multi
bool MULTI
std::shared_ptr<AddDisk> newmod
vector<double> nhD
vector<double> nhM
vector<unsigned> nhN
int nzepi
int nzero
std::normal_distribution rndN
std::uniform_real_distribution rndU
double scaleheight
double scalelength
double sigma0
DiskGenType type
double Xmax
double Xmin

Private Static Attributes

static const unsigned mh = 5
static const unsigned nh = 50
static const int use_spline = 0
class DiskHaloException : public std::runtime_error
#include <DiskHalo.H>

Inheritence diagram for DiskHaloException:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="DiskHaloException" tooltip="DiskHaloException" fillcolor="#BFBFBF"]
    "2" [label="std::runtime_error" tooltip="std::runtime_error"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for DiskHaloException:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="DiskHaloException" tooltip="DiskHaloException" fillcolor="#BFBFBF"]
    "2" [label="std::runtime_error" tooltip="std::runtime_error"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline DiskHaloException(const string message, const string sourcefilename, const int sourcelinenumber)
class DiskWithHalo : public AxiSymModel
#include <DiskWithHalo.H>

Inheritence diagram for DiskWithHalo:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "1" [label="DiskWithHalo" tooltip="DiskWithHalo" fillcolor="#BFBFBF"]
    "3" [label="MassModel" tooltip="MassModel"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for DiskWithHalo:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "7" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "1" [label="DiskWithHalo" tooltip="DiskWithHalo" fillcolor="#BFBFBF"]
    "8" [label="GaussQuad" tooltip="GaussQuad"]
    "3" [label="MassModel" tooltip="MassModel"]
    "6" [label="RegularOrbit" tooltip="RegularOrbit"]
    "5" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
    "5" -> "7" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
}

Public Functions

inline virtual double d2fde2(double E, double L) override
inline virtual double dfde(double E, double L) override
inline virtual double dfdl(double E, double L) override
inline DiskWithHalo()
inline DiskWithHalo(const DiskWithHalo &t)
inline DiskWithHalo(std::shared_ptr<AxiSymModel> D, std::shared_ptr<AxiSymModel> H)
inline virtual double distf(double E, double L) override
inline virtual double get_density(const double r) override
inline virtual double get_density(const double x1, const double x2, const double x3) override

The density at (x, y, z)

inline virtual double get_dpot(const double r) override
inline virtual double get_dpot2(const double r) override
inline virtual double get_mass(const double r) override

Access the profile.

inline virtual double get_mass(const double x1, const double x2, const double x3) override

Get the mass inside of position (x, y, z) (this is ambiguous in general and will depend on the model)

inline virtual double get_max_radius(void) override
inline virtual double get_min_radius(void) override
inline virtual double get_pot(const double r) override
inline virtual double get_pot(const double x1, const double x2, const double x3) override

The potential at (x, y, z)

inline virtual void get_pot_dpot(const double r, double &ur, double &dur) override

Private Members

std::shared_ptr<AxiSymModel> d
std::shared_ptr<AxiSymModel> h
class DoubleExponential : public EmpCylSL::AxiDisk
#include <DiskModels.H>

Inheritence diagram for DoubleExponential:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="DoubleExponential" tooltip="DoubleExponential" fillcolor="#BFBFBF"]
    "2" [label="EmpCylSL::AxiDisk" tooltip="EmpCylSL::AxiDisk"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for DoubleExponential:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="DoubleExponential" tooltip="DoubleExponential" fillcolor="#BFBFBF"]
    "2" [label="EmpCylSL::AxiDisk" tooltip="EmpCylSL::AxiDisk"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

A mixture of two exponential disks.

Public Functions

inline DoubleExponential(double a, double h, double a2, double h2, double Mfac, double M = 1)
inline virtual double operator()(double R, double z, double phi = 0.)

Density function.

Private Members

double a
double a2
double d1
double d2
double h
double h2
double Mfac
struct dump
#include <tipsydefs.h>

Tipsy file header.

Public Members

int nbodies

Total number of bodies.

int ndark

Number of Dark particles.

int ndim

Dimensions.

int nsph

Number of Gas particles.

int nstar

Number of Star particles.

double time

Dump time.

template<typename T>
class Dynamic2dArray
#include <ThreeDGrid.H>

Make a two-d wrapper for nested std::vectors.

Public Functions

inline Dynamic2dArray()

Default constructor.

inline Dynamic2dArray(int rows, int cols)

Allocation constructor.

inline std::vector<T> &operator[](int i)

Get reference to second dimension.

inline const std::vector<T> &operator[](int i) const

Get reference to second dimension (const version)

inline void resize(int rows, int cols)

Resize the two dimentional array.

Private Members

std::vector<std::vector<T>> dArray
template<typename T>
class Dynamic3dArray
#include <ThreeDGrid.H>

Make a three-d wrapper for nested std::vectors.

Public Functions

inline Dynamic3dArray()

Default constructor.

inline Dynamic3dArray(int rows, int cols, int levs)

Allocation constructor.

inline Dynamic2dArray<T> &operator[](int i)

Return a Dynamic2DArray reference for first index.

inline const Dynamic2dArray<T> &operator[](int i) const

Return a Dynamic2DArray reference for first index (constant version)

inline void resize(int rows, int cols, int levs)

Resize the three dimentional array .

Private Members

std::vector<Dynamic2dArray<T>> tArray
class EJcom : public TwoCenter
#include <EJcom.H>

Inheritence diagram for EJcom:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="EJcom" tooltip="EJcom" fillcolor="#BFBFBF"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "2" [label="TwoCenter" tooltip="TwoCenter"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for EJcom:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "9" [label="Basis" tooltip="Basis"]
    "5" [label="Component" tooltip="Component"]
    "1" [label="EJcom" tooltip="EJcom" fillcolor="#BFBFBF"]
    "7" [label="EL3" tooltip="EL3"]
    "10" [label="MixtureBasis" tooltip="MixtureBasis"]
    "6" [label="Orient" tooltip="Orient"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "8" [label="Timer" tooltip="Timer"]
    "2" [label="TwoCenter" tooltip="TwoCenter"]
    "4" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "9" -> "3" [dir=forward tooltip="public-inheritance"]
    "5" -> "5" [dir=forward tooltip="usage"]
    "5" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "10" -> "2" [dir=forward tooltip="usage"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "5" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "9" [dir=forward tooltip="usage"]
    "2" -> "10" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
}

Computes the potential, acceleration and density using basis expansion solutions fitting to peak potential and COM. This implements a TwoCenter class by providing a mixture function.

The mixture function is:

\[ f({\bf r}) = \hbox{erf}\left(C\left[{|{\bf r} - {\bf r}_{peak}|\over |{\bf r}_{COM} - {\bf r}_{peak}|}\right]^\alpha\right) \]
On evaluation, the acceleration from the grid centered on \({\bf r}_{COM}\) is multiplied by \(f({\bf r})\) and the the acceleration from the grid centered on \({\bf r}_{peak}\) is multiplied by \(1-f({\bf r})\)

See SphereTwoCenter for other parameters controlling the spherical expansion.

Param cfac:

is a prefactor \(C\) for the erf ramp above

Param alpha:

is the exponent in the argument of the erf ( \(\alpha\))

Public Functions

EJcom(Component *c0, const YAML::Node &conf)

Constructor

Parameters:
  • c0 – is the instantiating caller (a Component)

  • line – passes any parameters (rsphSL, rmin and numr)

virtual double mixture(double *p)

Mixture function for the two expansions.

Private Functions

virtual void initialize()

Initialize the force.

Private Members

double alpha

exponent in the argument of the erf

double cfac

Prefactor for the erf ramp.

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class EL3
#include <Orient.H>

Class to hold energy and angular momentum for use in centering a component. Helper class for class Orient.

Public Functions

void debug() const

Debug output.

inline EL3()

Constructor.

inline bool operator<(const EL3 &x) const

Comparison member for ordering energy.

Public Members

double E

Binding energy.

Eigen::Vector3d L

Angular momentum.

double M

Mass.

Eigen::Vector3d R

Position.

double T

Time.

class Element
#include <Cspline.H>

A cubic spline fit for an interval.

Public Functions

inline Element(X _x)

Define the ordinate only.

inline Element(X _x, Y _a, Y _b, Y _c, Y _d)

The ordinate and the cubic coefficients.

inline Y eval(const X &xx) const

Evaluate the fit.

inline bool operator<(const Element &e) const

Sorting operators.

inline bool operator<(const X &xx) const

Public Members

Y a

Cubic coefficients.

Y b
Y c
Y d
X x

The ordinate.

class EllipForce
#include <EllipForce.H>

Public Functions

EllipForce(double a, double b, double c, double mass, int num = 100, int numr = 100)
double getMass(double x)
double getPot(double x)
void PrintModel(const string&)
void PrintTable()
void TestTable()
~EllipForce()

Public Static Attributes

static string cache_file

Private Functions

bool read_cache()
void write_cache()

Private Members

double a
double b
double c
std::shared_ptr<LegeQuad> lq
std::vector<double> m
double mass
int num
int numr
std::vector<double> p
std::vector<double> r
class EllipsoidForce
#include <EllipsoidForce.H>

Defines potential and force for ellipsoid models

Internal potential has the form (Chandra pg. 52, eqn. 93)

\[ V = \pi G a_1 a_2 a_3 \int^\infty_0\frac{du}{\Delta} \left[\Psi(1) - \Psi(m^2(u))\right] \]
where
\[ m^2(u) = \sum_{i=1}^3\frac{x_i^2}{a_i^2 + u} \]
and
\[ \Psi(m^2) = \int_1^{m^2} dm^2\,\rho(m^2). \]

The external potential has the form (Cha ndra pg. 51, eqn. 89)

\[ V = \pi G a_1 a_2 a_3 \int^\infty_\lambda\frac{du}{\Delta} \left[\Psi(1) - \Psi(m^2(u))\right]. \]

Note

{Mathematics}

Param a:

is the major axis

Param b:

is the submajor (middle) axis

Param c:

is the minor axis

Param mass:

is the total mass for the ellipsoid

Param num:

is the number of integration knots

Param numr:

is the number of grid points in the radial table

Public Types

enum BarType

Values:

enumerator powerlaw
enumerator ferrers
enumerator expon

Public Functions

EllipsoidForce(double a, double b, double c, double mass, double rmin, double rmax, BarType bartype, bool quad, double param = 0.0, int num = 100, int numr = 100)

Constructor.

double getDens(vector<double> x)

Returns the density at position x.

double getPotl(double r)

Returns the radial part of quadrupole potential.

double getPotl(vector<double> x)

Returns the potential at position x.

double getSurfDens(double r)

Compute the surface density along the major axis.

void MakeTable(int n1, int n2, int n3)

Tabulate the potential and force.

void MassInertia(double &M, vector<double> &I)

Returns the total mass and moment of inertia vector.

bool quadpot(double r, double &f, double &fr, double &M)

Get the quadrupole components at the radius r.

double RhoBar(double r)

Quadrupole bar density for radius r.

void TableEval(vector<double> x, vector<double> &forcepot)

Evaluate the force (indices 0,1,2) potential (index 3) on the table.

double U22(double r)

Quadrupole potential term for radius r.

~EllipsoidForce()

Destructor.

Public Static Attributes

static string cache_file

Interpolation grid cache name.

static double dfrac

Fraction of grid step for numerical derivatives.

static int n

Number of points for the monopole/quadrupole computation.

Private Functions

bool nindx(Eigen::Vector3d &x, Eigen::Vector3i &n)
bool read_cache()
double solve(vector<double> x, double m2)
void write_cache()

Private Members

vector<double> a
BarType bartype
vector<double> dX
std::shared_ptr<LegeQuad> gq
std::shared_ptr<LegeQuad> gt
std::shared_ptr<LegeQuad> gz
double ldr
double lrmax
double lrmin
double mass
vector<double> mm
int N
vector<int> ntab
int num
int numr
double param
vector<double> pp
bool quadr
double rho0
double rmax
double rmin
vector<double> rr
double rtmax
double rtmin
vector<double> table
bool tlog
bool tmade
vector<double> uu
class EmbeddedDiskModel : public AxiSymModel
#include <massmodel.H>

Inheritence diagram for EmbeddedDiskModel:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "1" [label="EmbeddedDiskModel" tooltip="EmbeddedDiskModel" fillcolor="#BFBFBF"]
    "3" [label="MassModel" tooltip="MassModel"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for EmbeddedDiskModel:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "7" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "1" [label="EmbeddedDiskModel" tooltip="EmbeddedDiskModel" fillcolor="#BFBFBF"]
    "8" [label="GaussQuad" tooltip="GaussQuad"]
    "3" [label="MassModel" tooltip="MassModel"]
    "6" [label="RegularOrbit" tooltip="RegularOrbit"]
    "5" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
    "5" -> "7" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
}

Public Functions

virtual double d2fde2(double E, double L)
virtual double dfde(double E, double L)
virtual double dfdl(double E, double L)
virtual double distf(double E, double L)
EmbeddedDiskModel(std::vector<std::shared_ptr<AxiSymModel>> &T, std::vector<double> &M_scale, std::vector<double> &R_scale, int NUMBER)
inline virtual double get_density(const double x1, const double x2, const double x3)

The density at (x, y, z)

virtual double get_density(const double)
virtual double get_dpot(const double)
virtual double get_dpot2(const double)
inline virtual double get_mass(const double x1, const double x2, const double x3)

Get the mass inside of position (x, y, z) (this is ambiguous in general and will depend on the model)

virtual double get_mass(const double)

Access the profile.

inline virtual double get_max_radius(void)
inline virtual double get_min_radius(void)
inline virtual double get_pot(const double x1, const double x2, const double x3)

The potential at (x, y, z)

virtual double get_pot(const double)
virtual void get_pot_dpot(const double, double&, double&)
void save_df(string &file)
void setup_df(int egrid = 10, int kgrid = 5, int mgrid = 20, double lambda = 0.0, double alpha = -6.0, double beta = 1.0, double gama = 1.0, double sigma = 2.0, double rmmax = -1, double roff = 0.05, double eoff = 0.5, double koff = 0.5, double kmin = 0.0, double kmax = 1.0, int nint = 20, int numt = 20)
void setup_df(string &file)
void verbose_df(void)
virtual ~EmbeddedDiskModel()

Private Members

std::shared_ptr<QPDistF> df
std::vector<double> m_scale
int number
std::vector<double> r_scale
double rmax
double rmin
std::vector<std::shared_ptr<AxiSymModel>> t
class EmpCyl2d
#include <EmpCyl2d.H>

Collaboration diagram for EmpCyl2d:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="EmpCyl2d" tooltip="EmpCyl2d" fillcolor="#BFBFBF"]
    "2" [label="EmpCyl2d::Mapping" tooltip="EmpCyl2d::Mapping"]
    "1" -> "2" [dir=forward tooltip="usage"]
}

A class that implements most of the members for an Exp force routine

Public Functions

inline void basisTest(bool which)

Use underlying basis for testing? Default: false.

void checkCoefs()

Check the coefficients of the EOF basis against the zeroth-order model

inline EmpCyl2d()

Null constructor (for copy construct)

EmpCyl2d(int mmax, int nmaxfid, int nmax, int knots, int numr, double rmin, double rmax, double scale, bool cmap, bool logr, const YAML::Node &P, const std::string biorth, const std::string cache = "")

Constructor.

EmpCyl2d(int mmax, int nmaxfid, int nmax, int knots, int numr, double rmin, double rmax, double scale, bool cmap, bool logr, std::shared_ptr<ModelCyl> disk, const std::string biorth, const std::string cache = "")

Constructor with user-supplied target model.

double get_dens(double r, int M, int N)

Linear interpolate on grid to get density value.

void get_dens(Eigen::MatrixXd &mat, double r)
double get_dpot(double r, int M, int N)

Linear interpolate on grid to get potential gradient (-force) value.

void get_force(Eigen::MatrixXd &mat, double r)
void get_pot(Eigen::MatrixXd &mat, double r)

Matrix evaluation members.

double get_potl(double r, int M, int N)

Linear interpolate on grid to get potential value.

inline const std::string getBiorthName()

Get biorthogonal function base name.

inline Mapping getMapping()

Get coordinate mapping object.

inline const std::string getModelName()

Get model name.

inline double getRmax()

Access the maximum radius.

inline double getRmin()

Access the minimum radius.

inline bool operator()()

Check for configuration.

std::vector<Eigen::MatrixXd> orthoCheck()

Return an array of inner-product matrices for the EOF basis.

void orthoCheck(int M, const std::string &file)

Write the inner-product matrix for the EOF basis for a particular azimuthal M value to a file

void writeBasis(int M, const std::string &file)

Write the basis for a partcular azimuthal M value to a file.

void writeTrans(int M, const std::string &file)

Write the eigenvector rotation matrix for a partcular azimuthal M value to a file

Protected Functions

void checkMN(int &M, int &N, const std::string &member)
void create_tables()
std::shared_ptr<ModelCyl> createModel()
std::tuple<int, int, double, double> linear_interp(double r)

Interpolation helpers.

bool ReadH5Cache()
void WriteH5Cache()

Protected Attributes

std::shared_ptr<Basis2d> basis
bool basis_test
std::string biorth
std::string cache_name_2d

The cache file name.

bool cmap
bool configured
std::vector<Eigen::MatrixXd> dens_array
std::shared_ptr<ModelCyl> disk
std::vector<Eigen::MatrixXd> dpot_array
double dxi
int knots
bool logr
Mapping map

Mapping instance.

int mmax
std::string model
int nmax
int nmaxfid
int numr
YAML::Node Params

Contains parameter database.

std::vector<Eigen::MatrixXd> potl_array
double rmax
double rmin
std::vector<Eigen::MatrixXd> rot_matrix
double scale
std::vector<double> xgrid
double xmax
double xmin

Protected Static Attributes

static const std::string default_cache_name

Default cache name.

static const unsigned int hmagic = 0xc0a57a1

Basis magic number.

static const std::string Version = "1.0"

Cache versioning.

class EmpCylSL
#include <EmpCylSL.H>

Inheritence diagram for EmpCylSL:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="CylEXP" tooltip="CylEXP"]
    "1" [label="EmpCylSL" tooltip="EmpCylSL" fillcolor="#BFBFBF"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for EmpCylSL:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="CylCoefHeader" tooltip="CylCoefHeader"]
    "1" [label="EmpCylSL" tooltip="EmpCylSL" fillcolor="#BFBFBF"]
    "7" [label="EmpCylSL::CoefMatrix" tooltip="EmpCylSL::CoefMatrix"]
    "5" [label="EmpCylSL::CoefVector" tooltip="EmpCylSL::CoefVector"]
    "3" [label="EmpCylSL::MstepArray" tooltip="EmpCylSL::MstepArray"]
    "10" [label="Interp1d" tooltip="Interp1d"]
    "9" [label="Linear1d" tooltip="Linear1d"]
    "4" [label="std::vector< VectorD2ptr >" tooltip="std::vector< VectorD2ptr >"]
    "8" [label="std::vector< std::vector< MatrixM > >" tooltip="std::vector< std::vector< MatrixM > >"]
    "6" [label="std::vector< std::vector< VectorM > >" tooltip="std::vector< std::vector< VectorM > >"]
    "1" -> "2" [dir=forward tooltip="usage"]
    "1" -> "3" [dir=forward tooltip="usage"]
    "1" -> "5" [dir=forward tooltip="usage"]
    "1" -> "7" [dir=forward tooltip="usage"]
    "1" -> "9" [dir=forward tooltip="usage"]
    "7" -> "8" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "9" -> "10" [dir=forward tooltip="public-inheritance"]
}

Encapsulatates a SLGridSph (Sturm-Liouville basis) for use as force method

This version breaks the spherical basis computation into even and odd subspaces if Nodd is selected. This gives the user more control over the vertical parity, is numerically more accurate, and more efficient.

Subclassed by CylEXP

Utility functions

using TableArray = std::vector<Eigen::MatrixXd>
TKType tk_type
void legendre_R(int lmax, double x, Eigen::MatrixXd &p)

Compute Associated Legendre Polynomials, return Matrix type.

void dlegendre_R(int lmax, double x, Eigen::MatrixXd &p, Eigen::MatrixXd &dp)

Compute Associated Legendre Polynomials and derivitives, return Matrix type

void sinecosine_R(int mmax, double phi, Eigen::VectorXd &c, Eigen::VectorXd &s)

Compute vectors of sines and cosines by recursion.

double xi_to_r(double)

Convert from non-dimensional to dimensional radial coordinate.

double r_to_xi(double)

Convert from dimension to non-dimension radial coordinate.

double d_xi_to_r(double)

Jacobian.

inline double get_ascale(void)

Return current value of disk scale length.

inline double get_hscale(void)

Return current value of disk scale height.

inline double get_rtable(void)

Return current table radius.

inline void setEven(bool even = true)

Set even modes only.

inline void setHall(std::string file, unsigned tot)

Set file name for EOF analysis and sample size for subsample computation

inline void AllowOldCache(bool allow = true)

Cache versioning override. Allow read of old cache files without triggering a cache recomputation.

void getPotSC(int m, int j, double R, double z, double &pC, double &pS)

Get potential grid interpolated entries.

void getDensSC(int m, int j, double R, double z, double &dC, double &dS)

Get density grid interpolated entries.

inline TableArray getDensC()

Return density and potential matrices Indexed (M, n) pair as id = M*NORDER + n

inline TableArray getDensS()
inline TableArray getPotlC()

Return density and potential matrices.

inline TableArray getPotlS()
void getPotParticle(double x, double y, double z, ContribArray &vc, ContribArray &vs)
void get_trimmed(double snr, std::vector<Eigen::VectorXd> &ac_cos, std::vector<Eigen::VectorXd> &ac_sin, std::vector<Eigen::VectorXd> *rt_cos = 0, std::vector<Eigen::VectorXd> *rt_sin = 0, std::vector<Eigen::VectorXd> *sn_rat = 0)

Get the coefficients trimmed by a SNR value using the defined algorithm.

void set_trimmed(double snr, double rem)

Set the coefficients trimmed by a SNR value using the defined algorithm.

inline void setTotal(unsigned tot)

Set number of bodies for subsample computation.

inline void setTK(const std::string &tk)
inline vector<double> sanity()
void ortho_check(std::ostream &out)

Check orthogonality for basis (debugging)

std::vector<Eigen::MatrixXd> orthoCheck()

Check orthogonality for basis (pyEXP style)

static std::map<std::string, std::string> cacheInfo(const std::string &cachefile, bool verbose = true)

Read and print the cache and return the header parameters as a map/dictionary

Public Types

typedef std::shared_ptr<AxiDisk> AxiDiskPtr
using ContribArray = std::vector<Eigen::VectorXd>
enum EmpModel

Type of density model to use.

Values:

enumerator Exponential
enumerator Gaussian
enumerator Plummer
enumerator Power
enumerator Deproject
using MatrixM = std::vector<Eigen::MatrixXd>
using SLGridSphPtr = std::shared_ptr<SLGridSph>
using SphModTblPtr = std::shared_ptr<SphericalModelTable>
enum TKType

Enum listing the possible selection algorithms for coefficient selection

Values:

enumerator Hall

Tapered signal-to-noise as defined by Hall

enumerator Truncate

Truncated signal-to-noise

enumerator None

Compute the S/N but do not modify coefficients

using VectorM = std::vector<Eigen::VectorXd>

Public Functions

void accumulate(double r, double z, double phi, double mass, unsigned long seq, int id, int mlev = 0, bool compute = false)

Add single particle to coefficients.

void accumulate(vector<Particle> &p, int mlev = 0, bool verbose = false, bool compute = false)

Accumulate coefficients from particle distribution.

void accumulate_eof(double r, double z, double phi, double mass, int id, int mlev = 0)

Add single particle to EOF coefficients.

void accumulate_eof(vector<Particle> &p, bool verbose = false)

Make EOF from particle distribution.

void accumulate_eof_thread(vector<Particle> &p, bool verbose = false)

Make EOF from particle distribution by thread. Used by external applications.

void accumulate_thread(vector<Particle> &p, int mlev = 0, bool verbose = false)

Accumulate coefficients from particle distribution by thread. Used by external applications.

double accumulated_dens_eval(double r, double z, double phi, double &d0)

Evaluate density field.

void accumulated_eval(double r, double z, double phi, double &p0, double &p, double &fr, double &fz, double &fp)

Evaluate potential and force field.

double accumulated_midplane_eval(double r, double zmin, double zmax, double phi, int num = 40)

Evaluate peak density height within two limits.

inline bool coefs_made_all()

True if coefficients are made at all levels.

void compare_basis(const EmpCylSL *p)

Compare current basis with another for debugging.

void create_deprojection(double H, double Rfactor, int numR, int numI, AxiDiskPtr func)

Compute deprojection of axisymmetric disk for and use this generate the EOF spherical basis. The scale length must be O(1) with scale height H in scale length units.

double d_y_to_z(double y)

For measure transformation.

inline void determine_acceleration_and_potential()

Necessary member function currently unused (change design?)

inline void determine_coefficients()

Necessary member function currently unused (change design?)

void dump_basis(const std::string &name, int step, double Rmax = -1.0)

Plot basis.

void dump_coefs(std::ostream &out)

Dump out coefficients to output stream.

void dump_coefs_binary(std::ostream &out, double time)

Dump out coefficients to stream in bianry format.

void dump_eof_file(const std::string &eof_file, const std::string &dump_file)

Dump the EOF basis in ascii format.

void dump_images(const std::string &OUTFILE, double XYOUT, double ZOUT, int OUTR, int OUTZ, bool logscale)

Plot full fields for debugging.

void dump_images_basis(const std::string &OUTFILE, double XYOUT, double ZOUT, int OUTR, int OUTZ, bool logscale, int M1, int M2, int N1, int N2)

Plot basis images for debugging.

void dump_images_basis_eof(const std::string &runtag, double XYOUT, double ZOUT, int OUTR, int OUTZ, int M, int N, int cnt, const Eigen::VectorXd &tp)

Plot EOF basis images for debugging.

void dump_images_basis_pca(const std::string &runtag, double XYOUT, double ZOUT, int OUTR, int OUTZ, int M, int N, int cnt)

Plot PCA basis images for debugging.

EmpCylSL()

Constructor (reset must called later)

EmpCylSL(int mlim, const std::string cache)

Construct from cache file.

EmpCylSL(int numr, int lmax, int mmax, int nord, double ascale, double hscale, int Nodd, std::string cachename)

Constructor with parameters

Parameters:

Parameters:
  • multistep – is the number of coefficient levels for n-body

  • numr – is the spherical radial order of the input basis

  • lmax – is the spherical angular order of the input basis

  • mmax – is the output aximuthal order for the EOF basis

  • nord – is the output radial order for the EOF basis

  • ascale – is the target disk scale LENGTH

  • hscale – is the target disk scale HEIGHT

  • nodd – is the number of vertically odd parity basis functions. If unspecified, you get eigenvalue order.

void generate_eof(int numr, int nump, int numt, std::function<double(double, double, double, int)> f)

Generate EOF by direct integration conditioned on a user supplied function

If func is axisymmetric, you may use nump=1 to save computation time.

Parameters:
  • numr – is the number of radial knots

  • nump – is the number of azimuthal knots

  • numt – is the number of inclination knots

  • func – is the user-supplied density target function

void get_all(int m, int n, double r, double z, double phi, double &p, double &d, double &fr, double &fz, double &fp)

Get a single basis function values for a phase-space point.

void get_coefs(int mm, Eigen::VectorXd &cos1, Eigen::VectorXd &sin1)

Get coefficients from Vectors.

void get_coefs(int mm, std::vector<double> &cos1, std::vector<double> &sin1)

Get coefficients from std::vectors.

inline int get_mlim()

Get limit to mmax for testing.

inline int get_mmax(void)

Parameter access: get mmax.

inline int get_mmin()

Get limit to mmax for testing.

inline int get_order(void)

Parameter access: get norder.

inline double getMaxSNR(void)

Maximum SNR coefficient value.

inline double getMinSNR(void)

Minimum SNR coefficient value.

void init_pca()

Initialize PCA work space.

void make_coefficients(bool compute = false)

Make coefficients from accumulated data.

All levels

void make_coefficients(unsigned mlevel, bool compute = false)

Single level.

void make_eof(void)

Make empirical orthgonal functions.

void pca_hall(bool compute, bool subsamp)

Compute PCA.

int read_cache(void)

Read basis from cache file.

int read_eof_file(const std::string &eof_file)

Read EOF basis from saved file.

int read_eof_header(const std::string &eof_file)

Read EOF basis header from saved file.

void reset(int numr, int lmax, int mmax, int nord, double ascale, double hscale, int Nodd, std::string cachename)

Reconstruct basis with new parameters.

void reset_mass(void)

Clear mass counter.

void restrict_order(int n)

Restrict order.

void set_coefs(int mm, const Eigen::VectorXd &cos1, const Eigen::VectorXd &sin1, bool zero = true)

Set coefficients from Vectors.

Extrapolate and sum coefficents per multistep level to get a complete set of coefficients for force evaluation at an intermediate time step

void set_coefs(int mm, const std::vector<double> &cos1, const std::vector<double> &sin1, bool zero = true)

Set coefficients from std::vectors.

inline void set_mass(double mass)

Set cylmass manually.

inline void set_mlim(int mlim)

Set limit to mmax for testing.

inline void set_mmin(int mmin)

Set limit to mmax for testing.

inline void set_mrange(int mmin, int mmax)

Set azimuthal order range for evaluation.

inline void set_nrange(int nmin, int nmax)

Set radial order range for evaluation.

inline void setSampT(int N)

For PCAVAR: set subsample size.

void setup_accumulation(int toplev = 0)

Setup for accumulated coefficients.

void setup_eof(void)

For EOF computation.

void setup_table(void)

For EOF.

double y_to_z(double y)

Compute Z from non-dbimensional vertical coordinate.

double z_to_y(double z)

Compute non-dimensional vertical coordinate from Z.

~EmpCylSL(void)

Destructor.

Public Static Attributes

static int CMAPR

TRUE if we are using coordinate mapping (0=no, 1 rational-function mapping (default)

static int CMAPZ

TRUE if we are using coordinate mapping (0=no, 1 for vertical hyberbolic mapping (default), 2 for power mampping)

static std::map<EmpModel, std::string> EmpModelLabs

Convert EmpModel to ascii label.

static bool enforce_limits

No extrapolating beyond grid (default: false)

static int HALLFREQ

Selector output freq (this only affects diagnostic output). Current default is to perform Hall on every step when selected

static double HEXP

Hall smoothing exponent (default: 1.0)

static double HFAC

Fraction of table range for basis images (for debug)

static bool logarithmic

TRUE if mapping is logarithmic (default: false)

static EmpModel mtype

Density model type.

static bool NewCoefs

Use YAML header in coefficient file.

static int NOUT

Number of bases to print (for debug)

static int NUMR

Number of entries in radial basis table.

static int NUMX

Radial basis grid in radial direction.

static int NUMY

Radial basis grid in vertical direction.

static bool PCADRY

Compute taper but to not apply to coefficients (default: true)

static bool PCAEOF

TRUE if EOF diagnostics are on (default: false)

static bool PCAVAR

TRUE if signal-to-noise methods are on (default: false)

static bool PCAVTK

TRUE if VTK diagnostics are on (default: false)

static double PPOW

Power exponent for EOF conditioning density function.

static double RMAX

Maximum radial value for basis.

static double RMIN

Minimum radial value for basis.

static unsigned VFLAG

Verbose level flags bit Action

0 = quiet 1 = SL model output 2 = EOF diagnostics 4 = Accumulation, PCA Hall, and all other diagnostics 8 = Debug-level communication details 16 = Timing info

static unsigned VTKFRQ

VTK diagnostic frequency (default: false)

Protected Types

typedef std::shared_ptr<PCAbasis> PCAbasisPtr
typedef std::shared_ptr<PCAelement> PCAelemPtr
using VarMat = std::vector<std::vector<std::vector<std::vector<double>>>>

EOF variance computation.

typedef std::vector<std::vector<Eigen::VectorXd>> VectorD2
typedef std::shared_ptr<VectorD2> VectorD2ptr

Protected Functions

void accumulate_eof_thread_call(int id, std::vector<Particle> *p, bool verbose)

Thread body for eof accumulation.

void accumulate_thread_call(int id, std::vector<Particle> *p, int mlevel, bool verbose)

Thread body for coef accumulation.

int cache_grid(int, std::string file)
void compute_eof_grid(int request_id, int m)
void compute_even_odd(int request_id, int m)
double densR(double R)
void eigen_problem(int request_id, int M, Timer &timer)
void get_pot(Eigen::MatrixXd&, Eigen::MatrixXd&, double, double)
double integral(int, int, int, int)
void make_grid()
SphModTblPtr make_sl()
double massR(double R)
void parityCheck(const std::string &prefix)
bool ReadH5Cache()

Read HDF5 cache.

void receive_eof(int request_id, int m)
void send_eof_grid()
void setup_eof_grid(void)
void WriteH5Cache()

Write HDF5 cache.

Protected Attributes

std::vector<Eigen::VectorXd> accum_cos
std::vector<Eigen::VectorXd> accum_sin
bool allow_old_cache = false

Allow older cache files with the Eigen3 row-major bug to be read with the new Eigen3 API

double ASCALE
std::string cachefile

The cache file name.

struct CylCoefHeader coefheadercyl
std::vector<short> coefs_made
MstepArray cosL
std::vector<Eigen::VectorXd> cosm
MstepArray cosN
CoefMatrix covM
CoefVector covV
double cylmass
std::vector<double> cylmass1
bool cylmass_made
std::vector<double> d
unsigned defSampT
Eigen::MatrixXd dend
std::vector<std::vector<Eigen::MatrixXd>> densC
Linear1d densRg
std::vector<std::vector<Eigen::MatrixXd>> densS
double dfac
std::vector<Eigen::MatrixXd> dlegs
Eigen::MatrixXd dpot
double dX
double dY
Eigen::MatrixXd ef
Eigen::MatrixXd efE
Eigen::MatrixXd efO
bool eof_made
Eigen::VectorXd ev
Eigen::VectorXd evE
bool EVEN_M

Suppress odd modes.

bool EvenOdd

Use EvenOdd partition.

Eigen::VectorXd evO
std::vector<Eigen::MatrixXd> facC
std::vector<Eigen::MatrixXd> facS
double ffac
std::string hallfile
std::vector<unsigned> howmany
std::vector<std::vector<unsigned>> howmany1
double HSCALE
std::vector<std::vector<int>> lE
std::vector<Eigen::MatrixXd> legs
int LMAX
std::vector<std::vector<int>> lO
int M
std::vector<double> m
Linear1d massRg
std::vector<double> massT
std::vector<std::vector<double>> massT1
double maxSNR
double minSNR
int MLIM
int MMAX
int MMIN
std::vector<double> mpi_double_buf2
std::vector<double> mpi_double_buf3
int MPIbufsz
std::vector<double> MPIin

Storage buffers for MPI.

std::vector<double> MPIin2
std::vector<double> MPIin_eof
std::vector<double> MPIout
std::vector<double> MPIout2
std::vector<double> MPIout_eof
int MPItable
unsigned nbodstot
int Neven

Number of even and odd terms per subspace.

int NKEEP
int NLIM
int NMAX
int NMIN
int Nodd
int NORDER
std::vector<unsigned> numbT
std::vector<std::vector<unsigned>> numbT1
SLGridSphPtr ortho
std::vector<double> p
PCAbasisPtr pb

Cache PCA information between calls.

double pfac
std::vector<std::vector<Eigen::MatrixXd>> potC
Eigen::MatrixXd potd
std::vector<std::vector<Eigen::MatrixXd>> potS
std::vector<double> r
int rank2
int rank3
std::vector<std::vector<Eigen::MatrixXd>> rforceC
std::vector<std::vector<Eigen::MatrixXd>> rforceS
double Rtable
unsigned sampT
VarMat SC
VarMat SCe
VarMat SCo
MstepArray sinL
std::vector<Eigen::VectorXd> sinm
MstepArray sinN
VarMat SS
VarMat SSe
VarMat SSo
MPI_Status status
Eigen::MatrixXd tabd
Eigen::MatrixXd tabf
std::vector<Eigen::MatrixXd> table
Eigen::MatrixXd tabp
std::vector<Eigen::MatrixXd> tdens
std::vector<Eigen::MatrixXd> tpot
std::vector<Eigen::MatrixXd> trforce
std::vector<std::vector<Eigen::MatrixXd>> tvar
std::vector<Eigen::MatrixXd> tzforce
bool use_mpi

MPI is active.

pthread_mutex_t used_lock
std::vector<Eigen::MatrixXd> var
std::vector<Eigen::MatrixXd> varE
std::vector<Eigen::MatrixXd> varO
std::vector<Eigen::MatrixXd> vc
std::vector<Eigen::MatrixXd> vs
double XMAX
double XMIN
double YMAX
double YMIN
std::vector<std::vector<Eigen::MatrixXd>> zforceC
std::vector<std::vector<Eigen::MatrixXd>> zforceS

Protected Static Functions

static YAML::Node getHeader(const std::string &cachefile)

Read the cache and return YAML db.

static YAML::Node getHeader_binary(const std::string &cachefile)
static YAML::Node getHeader_hdf5(const std::string &cachefile)

Protected Static Attributes

static const unsigned int cmagic = 0xc0a57a3

Coefficient magic number.

static const unsigned int hmagic = 0xc0a57a1

Basis magic number.

static const std::string Version = "1.0"

Cache versioning.

class Ensemble
#include <phase.H>

Public Functions

void binread(std::istream &fp)
void binwrite(std::ostream &fp)
Eigen::Vector3d CM_Position(void)
Eigen::Vector3d CM_Velocity(void)
Ensemble(Ensemble&)
Ensemble(int)
Ensemble(void)
inline int get_Nstars(void)
Eigen::Matrix3d Inertia_Tensor(double)
Ensemble integrate_to(double)
Ensemble integrate_to(double, freezing_function)
Eigen::Matrix3d Moment_Tensor(double)
Ensemble &operator=(Ensemble&)
Phase &operator[](int)
Eigen::Vector3d Principal_Axes(double, Eigen::Matrix3d&)
void read_orbits(std::istream&)
void read_snapshot(std::istream&)
void read_tidesfile(std::istream&)
void rotate_frame(double)
void rotate_view(double)
void scale_masses(double)
void scale_positions(double)
void scale_speeds(double)
void set_masses(double)
void setsize(int)
void settime(double)
Eigen::Vector3d Solid_Body_Frequency(double)
Ensemble Step_Positions(double)
Ensemble Step_Velocities(double, Eigen::Vector3d*)
Eigen::Vector3d total_Angular_Momentum(void)
double total_Energy(void)
double total_Kinetic(void)
double total_Potential(void)
void translate(Eigen::Vector3d&)
double Virial(void)
void write_log(std::ostream&)
void write_orbits(std::ostream&)
void write_snapshot(std::ostream&)
~Ensemble(void)

Protected Attributes

int Nstars
std::vector<Phase> stars
double t
template<typename T>
class EnumBitset
#include <EnumBitset.H>

Wrap the bitset according to the provided EnumTraits class. The class allows fields in a bit set to be accessed by members of the enum.

Public Functions

inline EnumBitset()

Constructor.

inline EnumBitset &flip(T pos)

Flip the flag.

inline bool operator[](size_t i) const

operator version of the test

inline bool operator[](T pos) const

operator version of the test

inline void reset()

Reset all flags.

inline EnumBitset &reset(T pos)

Reset the flag.

inline EnumBitset &set(T pos)

Set the flag.

inline size_t size()

Return size of bitset.

inline bool test(T pos) const

Test the flag.

Private Functions

inline std::underlying_type<T>::type get_value(T v) const

Private Members

std::bitset<static_cast<typename std::underlying_type<T>::type>(EnumTraits<T>::max)> s

The underlying bitset.

template<typename T>
struct EnumTraits

EnumTraits must define a max data member to set the bitset size and wraps an enum class

class exeTimer

Collaboration diagram for Cube::exeTimer:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="Component" tooltip="Component"]
    "2" [label="Cube" tooltip="Cube"]
    "1" [label="Cube::exeTimer" tooltip="Cube::exeTimer" fillcolor="#BFBFBF"]
    "7" [label="EL3" tooltip="EL3"]
    "6" [label="Orient" tooltip="Orient"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "8" [label="Timer" tooltip="Timer"]
    "4" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "5" -> "5" [dir=forward tooltip="usage"]
    "5" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="usage"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "5" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
}

Time routines.

Public Functions

inline exeTimer(Cube *c, const std::string &name)
inline void Start1()
inline void Stop1()
inline ~exeTimer()

Private Members

Cube *c
std::chrono::high_resolution_clock::time_point finish0
std::chrono::high_resolution_clock::time_point finish1
std::string routine
std::chrono::high_resolution_clock::time_point start0
std::chrono::high_resolution_clock::time_point start1
class EXPException : public std::exception
#include <EXPException.H>

Inheritence diagram for EXPException:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="BadIndexException" tooltip="BadIndexException"]
    "1" [label="EXPException" tooltip="EXPException" fillcolor="#BFBFBF"]
    "4" [label="FileCreateError" tooltip="FileCreateError"]
    "5" [label="FileOpenError" tooltip="FileOpenError"]
    "6" [label="GenericError" tooltip="GenericError"]
    "7" [label="InternalError" tooltip="InternalError"]
    "8" [label="YamlConfigError" tooltip="YamlConfigError"]
    "2" [label="std::exception" tooltip="std::exception"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
    "5" -> "1" [dir=forward tooltip="public-inheritance"]
    "6" -> "1" [dir=forward tooltip="public-inheritance"]
    "7" -> "1" [dir=forward tooltip="public-inheritance"]
    "8" -> "1" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for EXPException:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="EXPException" tooltip="EXPException" fillcolor="#BFBFBF"]
    "2" [label="std::exception" tooltip="std::exception"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Defines an error handler base class EXPException to handle exceptions

Subclassed by BadIndexException, FileCreateError, FileOpenError, GenericError, InternalError, YamlConfigError

Public Functions

inline EXPException(const std::string exceptionname, const std::string message, const std::string sourcefilename, int sourcelinenumber, int errorcode = -1, bool deadlock = false)

Constructor for base

Parameters:
  • exceptionname – Human-readable identifier for the error

  • message – Error details for the user

  • sourcefilename – File where the thrower resides

  • sourcelinenumber – Line number in the source for the thrower

  • errorcode – Error code to report at top-level catch

  • deadlock – Exception may break MPI synchronization

inline bool getDeadlock()

Get deadlock status.

inline int getErrorcode()

Get errorcode.

inline std::string getErrorMessage()

Returns an error message suitable for printing to the user. Also called by derived classes to assemble the error message for std::exception::what()

inline virtual const char *what() const

std::exception member returns a pointer to the error message

The std::string “buffer” used for assembling and passing the message to std::exception will be deleted when the exception is deleted.

Returns:

A pointer to a const char*.

inline virtual ~EXPException()

Destructor for base. Virtual to permit derived classes.

Protected Functions

inline EXPException(const std::string sourcefile, int linenumber, int errorcode = -1, bool deadlock = false)

Protected so it is only called by properly implemented classes.

Protected Attributes

bool deadlock

Possible deadlock?

int errorcode

Return code.

std::string errormessage

Error message describing the error in more detail.

std::string exceptionname

Friendly name of the exception.

std::string msg_

Message buffer.

Private Members

std::string sourcefilename

Source file where throw occured.

int sourcelinenumber

Line number of throw.

class ExponCyl : public EmpCyl2d::ModelCyl
#include <EmpCyl2d.H>

Inheritence diagram for EmpCyl2d::ExponCyl:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="EmpCyl2d::ExponCyl" tooltip="EmpCyl2d::ExponCyl" fillcolor="#BFBFBF"]
    "2" [label="EmpCyl2d::ModelCyl" tooltip="EmpCyl2d::ModelCyl"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for EmpCyl2d::ExponCyl:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="EmpCyl2d::ExponCyl" tooltip="EmpCyl2d::ExponCyl" fillcolor="#BFBFBF"]
    "2" [label="EmpCyl2d::ModelCyl" tooltip="EmpCyl2d::ModelCyl"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline virtual double dens(double r)
inline virtual double dpot(double r)
inline ExponCyl(const YAML::Node &par)
inline virtual double pot(double r)

Private Functions

inline virtual void parse(const YAML::Node &conf)

Private Members

double acyl
double sigma0
class Exponential : public EmpCylSL::AxiDisk
#include <DiskModels.H>

Inheritence diagram for Exponential:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EmpCylSL::AxiDisk" tooltip="EmpCylSL::AxiDisk"]
    "1" [label="Exponential" tooltip="Exponential" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Exponential:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EmpCylSL::AxiDisk" tooltip="EmpCylSL::AxiDisk"]
    "1" [label="Exponential" tooltip="Exponential" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

The usual exponential disk.

Public Functions

inline Exponential(double a, double h, double M = 1)
inline virtual double operator()(double R, double z, double phi = 0.)

Density function.

Private Members

double a
double h
class ExponentialDisk : public AxiSymModel
#include <exponential.H>

Inheritence diagram for ExponentialDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "1" [label="ExponentialDisk" tooltip="ExponentialDisk" fillcolor="#BFBFBF"]
    "3" [label="MassModel" tooltip="MassModel"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for ExponentialDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "7" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "1" [label="ExponentialDisk" tooltip="ExponentialDisk" fillcolor="#BFBFBF"]
    "8" [label="GaussQuad" tooltip="GaussQuad"]
    "3" [label="MassModel" tooltip="MassModel"]
    "6" [label="RegularOrbit" tooltip="RegularOrbit"]
    "5" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
    "5" -> "7" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
}

Public Functions

inline virtual double d2fde2(double E, double L)
inline virtual double dfde(double E, double L)
inline virtual double dfdl(double E, double L)
inline virtual double distf(double E, double L)
inline ExponentialDisk(double RSCALE = 1.0, double RMAX = 20.0, double DMASS = 1.0)
inline virtual double get_density(const double r)
virtual double get_dpot(const double r)
virtual double get_dpot2(const double r)
inline virtual double get_mass(const double r)

Access the profile.

inline virtual double get_max_radius(void)
inline virtual double get_min_radius(void)
virtual double get_pot(const double r)
virtual void get_pot_dpot(const double r, double &ur, double &dur)

Private Members

double a
double den0
double m
double rmax
double rmin
class ExternalCollection

Container class for external force types.

These are supplied as a file with one type to a line. The constructor does “hand coded” reflection to make a chain of these. Therefore, the external forces will be applied in order of their listing (in case this matters).

Format: single line per force, parameters separated from name by “:”

Public Functions

ExternalCollection()

Constructor.

void finish()

Call the finish member for all external forces.

void get_acceleration_and_potential(vector<Particle>*)

Provides the same interface to compute acceleration as ExternalForce.

void initialize()

Reads configuration database and initializes requested external forces.

~ExternalCollection()

Destructor.

Public Members

list<ExternalForce*> force_list

List of forces we create.

Private Functions

void dynamicload(void)
vector<string> getlibs(void)

Private Members

list<void*> dl_list
list<void*>::iterator itr
list<ExternalForce*>::iterator sitr
class ExternalForce : public PotAccel
#include <ExternalForce.H>

Inheritence diagram for ExternalForce:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="ExternalForce" tooltip="ExternalForce" fillcolor="#BFBFBF"]
    "3" [label="HaloBulge" tooltip="HaloBulge"]
    "4" [label="PeriodicBC" tooltip="PeriodicBC"]
    "2" [label="PotAccel" tooltip="PotAccel"]
    "5" [label="ScatterMFP" tooltip="ScatterMFP"]
    "6" [label="UserBar" tooltip="UserBar"]
    "7" [label="UserDisk" tooltip="UserDisk"]
    "8" [label="UserHalo" tooltip="UserHalo"]
    "9" [label="UserLogPot" tooltip="UserLogPot"]
    "10" [label="UserMNdisk" tooltip="UserMNdisk"]
    "11" [label="UserMW" tooltip="UserMW"]
    "12" [label="UserTest" tooltip="UserTest"]
    "13" [label="UserTestCuda" tooltip="UserTestCuda"]
    "14" [label="externalShock" tooltip="externalShock"]
    "15" [label="generateRelaxation" tooltip="generateRelaxation"]
    "16" [label="tidalField" tooltip="tidalField"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
    "5" -> "1" [dir=forward tooltip="public-inheritance"]
    "6" -> "1" [dir=forward tooltip="public-inheritance"]
    "7" -> "1" [dir=forward tooltip="public-inheritance"]
    "8" -> "1" [dir=forward tooltip="public-inheritance"]
    "9" -> "1" [dir=forward tooltip="public-inheritance"]
    "10" -> "1" [dir=forward tooltip="public-inheritance"]
    "11" -> "1" [dir=forward tooltip="public-inheritance"]
    "12" -> "1" [dir=forward tooltip="public-inheritance"]
    "13" -> "1" [dir=forward tooltip="public-inheritance"]
    "14" -> "1" [dir=forward tooltip="public-inheritance"]
    "15" -> "1" [dir=forward tooltip="public-inheritance"]
    "16" -> "1" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for ExternalForce:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="Component" tooltip="Component"]
    "6" [label="EL3" tooltip="EL3"]
    "1" [label="ExternalForce" tooltip="ExternalForce" fillcolor="#BFBFBF"]
    "5" [label="Orient" tooltip="Orient"]
    "2" [label="PotAccel" tooltip="PotAccel"]
    "7" [label="Timer" tooltip="Timer"]
    "3" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "4" -> "4" [dir=forward tooltip="usage"]
    "4" -> "2" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="usage"]
    "4" -> "7" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "2" -> "4" [dir=forward tooltip="usage"]
    "3" -> "2" [dir=forward tooltip="usage"]
}

External force PotAccel members.

This does little but make sure that user is not loading a class that is not designed to be an external force.

Subclassed by HaloBulge, PeriodicBC, ScatterMFP, UserBar, UserDisk, UserHalo, UserLogPot, UserMNdisk, UserMW, UserTest, UserTestCuda, externalShock, generateRelaxation, tidalField

Public Functions

virtual void *determine_acceleration_and_potential_thread(void *arg) = 0

Multithreaded method (must be thread safe) for force computation that must be provided by all derived classes (hence pure virtual)

ExternalForce(const YAML::Node &config)

Constructor.

Parameters:

line – passes any parameters to the method

inline virtual void finish()

Finish and clean-up (caching data necessary for restart)

virtual void get_acceleration_and_potential(Component *compIn)

Will be called by clients to evaluate force.

inline virtual ~ExternalForce()

Destructor.

Public Members

string id

Name of external force (mnemonic)

Protected Functions

virtual void determine_acceleration_and_potential(void)

Called to evaluate acceleration Default version calls the provided thread function. Can be overloaded to provide additional non-threaded tasks.

void print_divider(void)

User info divider Make demarcation in output log

Private Functions

virtual void determine_coefficients(void)

Used by get_acceleration_and_potential to request that the expansion be performed.

virtual void *determine_coefficients_thread(void *arg)

Multithreading implementation of the expansion computation.

class externalShock : public ExternalForce
#include <externalShock.H>

Inheritence diagram for externalShock:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="externalShock" tooltip="externalShock" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for externalShock:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="Component" tooltip="Component"]
    "7" [label="EL3" tooltip="EL3"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "6" [label="Orient" tooltip="Orient"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "8" [label="Timer" tooltip="Timer"]
    "1" [label="externalShock" tooltip="externalShock" fillcolor="#BFBFBF"]
    "4" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "5" -> "5" [dir=forward tooltip="usage"]
    "5" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "4" -> "3" [dir=forward tooltip="usage"]
}

Compute shock perturbation.

Public Functions

externalShock(const YAML::Node &conf)

Constructor.

~externalShock()

Destructor.

Private Functions

virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreaded method (must be thread safe) for force computation that must be provided by all derived classes (hence pure virtual)

double get_tidal_shock(double T)
virtual void initialize()

Used by derived class to initialize any storage and parameters.

Private Members

double AMPL
double E
string INFILE
double K
std::shared_ptr<SphericalModelTable> model
double PER
std::shared_ptr<SphericalOrbit> t
class FDIST
#include <massmodel.H>

A one-dimensional Merritt-Osipkov distribution.

Public Functions

inline FDIST()

Simple constructor. Use value of num to check for initialization.

Public Members

Eigen::VectorXd ffQ
Eigen::VectorXd ffQ2
Eigen::VectorXd fQ
Eigen::VectorXd fQ2
int num
double off
Eigen::VectorXd Q
double ra2
class FDISTC
#include <massmodel.H>

Collaboration diagram for FDISTC:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="Cheby1d" tooltip="Cheby1d"]
    "1" [label="FDISTC" tooltip="FDISTC" fillcolor="#BFBFBF"]
    "3" [label="Interp1d" tooltip="Interp1d"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="usage"]
}

Chebyshev version.

Public Functions

inline FDISTC()

Simple constructor. Use value of num to check for initialization.

Public Members

Cheby1d FF
Eigen::VectorXd ffQ
Eigen::VectorXd fQ
Cheby1d GG
int num
double off
Eigen::VectorXd Q
double ra2
class FEED : public EmpCylSL::AxiDisk
#include <DiskModels.H>

Inheritence diagram for FEED:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EmpCylSL::AxiDisk" tooltip="EmpCylSL::AxiDisk"]
    "1" [label="FEED" tooltip="FEED" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for FEED:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EmpCylSL::AxiDisk" tooltip="EmpCylSL::AxiDisk"]
    "1" [label="FEED" tooltip="FEED" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

A Ferrers Ellipsoid + Evacuated Exponential Disc (semi-realistic bar+disk model)

Public Functions

inline FEED(double a, double b, double c, double r0, double z0, double fbar, double M = 1)
inline virtual double operator()(double R, double z, double phi = 0.)

Density function.

Private Members

double a
double b
double c
double fbar
double r0
double z0
class Ferrers : public EmpCylSL::AxiDisk
#include <DiskModels.H>

Inheritence diagram for Ferrers:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EmpCylSL::AxiDisk" tooltip="EmpCylSL::AxiDisk"]
    "1" [label="Ferrers" tooltip="Ferrers" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Ferrers:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EmpCylSL::AxiDisk" tooltip="EmpCylSL::AxiDisk"]
    "1" [label="Ferrers" tooltip="Ferrers" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

An n=2 Ferrers Ellipsoid.

Public Functions

inline Ferrers(double a, double b, double c, double M = 1)
inline virtual double operator()(double R, double z, double phi = 0.)

Density function.

Private Members

double a
double b
double c
class FileCreateError : public EXPException
#include <EXPException.H>

Inheritence diagram for FileCreateError:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EXPException" tooltip="EXPException"]
    "1" [label="FileCreateError" tooltip="FileCreateError" fillcolor="#BFBFBF"]
    "3" [label="std::exception" tooltip="std::exception"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for FileCreateError:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EXPException" tooltip="EXPException"]
    "1" [label="FileCreateError" tooltip="FileCreateError" fillcolor="#BFBFBF"]
    "3" [label="std::exception" tooltip="std::exception"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

File creation error.

Public Functions

inline FileCreateError(const std::string filename, const std::string method, const std::string sourcefilename, int sourcelinenumber, int errorcode = -1, bool deadlock = false)

Constructor with method string.

inline FileCreateError(const std::string filename, std::string sourcefilename, int sourcelinenumber, int errorcode = -1, bool deadlock = false)

Constructor.

class FileOpenError : public EXPException
#include <EXPException.H>

Inheritence diagram for FileOpenError:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EXPException" tooltip="EXPException"]
    "1" [label="FileOpenError" tooltip="FileOpenError" fillcolor="#BFBFBF"]
    "3" [label="std::exception" tooltip="std::exception"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for FileOpenError:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EXPException" tooltip="EXPException"]
    "1" [label="FileOpenError" tooltip="FileOpenError" fillcolor="#BFBFBF"]
    "3" [label="std::exception" tooltip="std::exception"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

File open error.

Public Functions

inline FileOpenError(const std::string filename, const std::string method, const std::string sourcefilename, int sourcelinenumber, int errorcode = -1, bool deadlock = false)

Constructor with method string.

inline FileOpenError(const std::string filename, const std::string sourcefilename, int sourcelinenumber, int errorcode = -1, bool deadlock = false)

Constructor.

class FindOrb : public std::function<double(std::vector<double>&)>
#include <FindOrb.H>

Inheritence diagram for FindOrb:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="FindOrb" tooltip="FindOrb" fillcolor="#BFBFBF"]
    "2" [label="std::function< double(std::vector< double > &)>" tooltip="std::function< double(std::vector< double > &)>"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for FindOrb:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="FindOrb" tooltip="FindOrb" fillcolor="#BFBFBF"]
    "2" [label="std::function< double(std::vector< double > &)>" tooltip="std::function< double(std::vector< double > &)>"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

OrbValues Anneal()

Do the work!

FindOrb(std::shared_ptr<AxiSymModel> mod, double PERI, double APO)

Constructor.

inline SphericalOrbit &Orb()

Return the orbit instance (presumably now at minimum)

~FindOrb()

Destructor.

Public Static Attributes

static double EFAC
static double KMAX
static double KMIN

Defaults.

static int MAXIT
static bool MELT
static double RATE
static double T0

Private Functions

void mapvars(std::vector<double>&, double &ee, double &kk)
double operator()(std::vector<double> &ek)

Private Members

double apo
double Emax
double Emin
std::shared_ptr<AxiSymModel> halo_model
double Kmax
double Kmin
int maxit
double melt
std::shared_ptr<SphericalOrbit> orb
double peri
double rate
class FlatDisk : public PolarBasis
#include <FlatDisk.H>

Inheritence diagram for FlatDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="AxisymmetricBasis" tooltip="AxisymmetricBasis"]
    "4" [label="Basis" tooltip="Basis"]
    "1" [label="FlatDisk" tooltip="FlatDisk" fillcolor="#BFBFBF"]
    "2" [label="PolarBasis" tooltip="PolarBasis"]
    "5" [label="PotAccel" tooltip="PotAccel"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "4" -> "5" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for FlatDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="AxisymmetricBasis" tooltip="AxisymmetricBasis"]
    "4" [label="Basis" tooltip="Basis"]
    "7" [label="Component" tooltip="Component"]
    "9" [label="EL3" tooltip="EL3"]
    "1" [label="FlatDisk" tooltip="FlatDisk" fillcolor="#BFBFBF"]
    "15" [label="MixtureBasis" tooltip="MixtureBasis"]
    "8" [label="Orient" tooltip="Orient"]
    "2" [label="PolarBasis" tooltip="PolarBasis"]
    "13" [label="PolarBasis::CoefMatrix" tooltip="PolarBasis::CoefMatrix"]
    "11" [label="PolarBasis::CoefVector" tooltip="PolarBasis::CoefVector"]
    "5" [label="PotAccel" tooltip="PotAccel"]
    "10" [label="Timer" tooltip="Timer"]
    "16" [label="TwoCenter" tooltip="TwoCenter"]
    "14" [label="std::vector< std::vector< MatrixM > >" tooltip="std::vector< std::vector< MatrixM > >"]
    "12" [label="std::vector< std::vector< VectorM > >" tooltip="std::vector< std::vector< VectorM > >"]
    "6" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "4" -> "5" [dir=forward tooltip="public-inheritance"]
    "7" -> "7" [dir=forward tooltip="usage"]
    "7" -> "5" [dir=forward tooltip="usage"]
    "7" -> "8" [dir=forward tooltip="usage"]
    "7" -> "10" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "15" -> "16" [dir=forward tooltip="usage"]
    "8" -> "9" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "11" [dir=forward tooltip="usage"]
    "2" -> "13" [dir=forward tooltip="usage"]
    "2" -> "15" [dir=forward tooltip="usage"]
    "13" -> "14" [dir=forward tooltip="public-inheritance"]
    "11" -> "12" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "7" [dir=forward tooltip="usage"]
    "16" -> "5" [dir=forward tooltip="public-inheritance"]
    "16" -> "4" [dir=forward tooltip="usage"]
    "16" -> "15" [dir=forward tooltip="usage"]
    "6" -> "5" [dir=forward tooltip="usage"]
}

Computes the potential, acceleration and density using an empirical function analysis for a flat Bessel basis and a target density.

YAML configuration

Param rcylmin:

is the minimum value in the table for the radial basis functions (default is 0.0)

Param rcylmax:

is the maximum value in the table for the radial basis functions in acyltbl units (default is 10.0)

Param scale:

is the expansion factor to get the physical scale from the internal scale (default is 0.01)

Param mmax:

is the maximum azimuthal order

Param numx:

is the number of grid points in the scaled radial direction

Param numy:

is the number of grid points in the scaled vertical direction

Param knots:

is the number of quadrature points for EmpCyl2d

Param logr:

scales the EmpCyl2d grid logarithmically

Param model:

name for conditioning the new basis using EmpCyl2d (default: expon)

Param biorth:

is the biorthogonal basis set used by EmpCyl2d for conditioning (default: bess)

Param background:

sets a fixed monopole potential and force for the model. Used for stability analysis of disks with active and inactive tapers, following Zang

Param nmaxfid:

is the maximum radial order for the basis used by EmpCyl2d for conditioning

Param numr:

is the number of grid points in the radial direction for the numerical basis in EmpCyl2d

Param NQDHT:

is the number of grid points for the numerical Hankel transform

Param diskconf:

is a YAML configuration for the target disk model in EmpCyl2d

Param cachename:

is the name of the cache file for the newly constructed basis

Param dumpbasis:

provides the user with a ascii table of the basis potential-density pairs

Public Functions

FlatDisk(Component *c0, const YAML::Node &conf, MixtureBasis *m = 0)

Constructor

Input line parameters include:

Parameters:
  • c0 – is the instantiating caller (Component)

  • conf – passes any parameters to basis instance (rsphSL, rmin and numr

  • m – allows the spherical basis to be used for multiple center expansions

  • rs – is the radius for coordinate scaling

  • numr – is the number of radial grid points

  • cmap – set to true for scaling coordinates from the semi-infinite to finite segment

  • diverge – set to true means assume a cuspy profile

  • dfac – is the power of the “divergent” cusp

  • modelname – is the file containing the input background model profile

  • dtime – is the interval between basis recomputations (<=0 for never)

virtual ~FlatDisk()

Destructor.

Protected Functions

inline virtual void get_pot(Eigen::MatrixXd &Vc, Eigen::MatrixXd &Vs, double r, double z)

Use BiorthCyl to evaluate the basis at r, z.

Private Types

using Disk2d = std::shared_ptr<EmpCyl2d::ModelCyl>

Background instance.

Private Functions

inline virtual std::tuple<double, double, double> background(double r, double z)

Background evaluation.

virtual void get_dens(double r, double z, Eigen::MatrixXd &p, int tid)

Get derivative of potential

Parameters:
  • r – is the evaluation radius

  • z – is the evaluation height

  • d – will be returned array in harmonics l and radial order n for the density

  • tid – is the thread enumerator that allows the function to provide some thread safety

virtual void get_dpotl(double r, double z, Eigen::MatrixXd &p, Eigen::MatrixXd &dpr, Eigen::MatrixXd &dpz, int tid)

Get derivative of potential

Parameters:
  • r – is the evaluation radius

  • z – is the evaluation height

  • p – will be returned array in harmonics l and radial order n for the potential

  • dpr – will be returned array in harmonics l and radial order n for the derivative of the potential

  • dpz – will be returned array in harmonics l and radial order n for the derivative of the potential

  • tid – is the thread enumerator that allows the function to provide some thread safety

virtual void get_potl(double r, double z, Eigen::MatrixXd &p, int tid)

Get derivative of potential

Parameters:
  • r – is the evaluation radius

  • z – is the evaluation height

  • p – will be returned array in harmonics l and radial order n for the potential

  • tid – is the thread enumerator that allows the function to provide some thread safety

virtual void get_potl_dens(double r, double z, Eigen::MatrixXd &p, Eigen::MatrixXd &d, int tid)

Get the potential and density

Parameters:
  • r – is the evaluation radius

  • p – will be returned array in harmonics l and radial order n for the potential

  • d – will be returned array in harmonics l and radial order n for the density

  • tid – is the thread enumerator that allows the function to provide some thread safety

inline virtual double getRtable()

Get table scale.

virtual void initialize(void)

Initialize method.

void setBackground()

Set background from YAML.

Private Members

double acyltbl
string biorth
Disk2d disk
bool dump_basis
int knots
bool logr
int mmax
string model
int numr
CylPtr ortho
double rcylmax
double rcylmin
double scale

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class foarray
#include <foarray.H>

Public Functions

inline foarray(vector<string> &names, bool append = false)
inline ofstream &operator[](int n)
inline ~foarray()

Private Members

unsigned fnum
vector<ofstream*> fo
class Frame_Rotation
#include <phase.H>

Public Functions

inline void set_corotation(double rc)
inline void set_omega(double w)

Public Members

double omega
double omega2
double omegasq
class Func1d
#include <Func1d.H>

Public Functions

virtual double CostFunction(double*) = 0
inline virtual ~Func1d()
struct gadget_header
#include <gadget.H>

Public Members

double BoxSize

box-size of simulation in case periodic boundaries were used

char fill[64]
int flag_cooling

flags whether cooling was included

int flag_feedback

flags whether feedback was included (obsolete)

int flag_metals

flags whether the file contains metallicity values for gas and star particles

int flag_sfr

flags whether the simulation was including star formation */

int flag_stellarage

flags whether the file contains formation times of star particles

double HubbleParam

Hubble parameter in units of 100 km/sec/Mpc.

double mass[6]

mass of particles of each type. If 0, then the masses are explicitly stored in the mass-block of the snapshot file, otherwise they are omitted

int npart[6]

number of particles of each type in this file

unsigned int npartTotal[6]

total number of particles of each type in this snapshot. This can be different from npart if one is dealing with a multi-file snapshot.

unsigned int npartTotalHighWord[6]

High word of the total number of particles of each type.

int num_files

number of files in multi-file snapshot

double Omega0

matter density in units of critical density

double OmegaLambda

cosmological constant parameter

double redshift

redshift of snapshot file */

double time

time of snapshot file

class GadgetHDF5 : public PR::ParticleReader
#include <ParticleReader.H>

Inheritence diagram for PR::GadgetHDF5:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="PR::GadgetHDF5" tooltip="PR::GadgetHDF5" fillcolor="#BFBFBF"]
    "2" [label="PR::ParticleReader" tooltip="PR::ParticleReader"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for PR::GadgetHDF5:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="PR::GadgetHDF5" tooltip="PR::GadgetHDF5" fillcolor="#BFBFBF"]
    "2" [label="PR::ParticleReader" tooltip="PR::ParticleReader"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline virtual unsigned long CurrentNumber()

Number of particles in the chosen type.

inline virtual double CurrentTime()

Get current time.

virtual const Particle *firstParticle()

Reset to beginning of particles for this component.

GadgetHDF5(const std::vector<std::string> &file, bool verbose = false)

Constructor.

inline virtual std::vector<std::string> GetTypes()

Return list of particle types.

virtual const Particle *nextParticle()

Get the next particle.

inline virtual void SelectType(const std::string &type)

Select a particular particle type and reset the iterator.

Protected Functions

void getNumbers()
bool nextFile()
void packParticle()
void read_and_load()

Protected Attributes

std::vector<std::string>::iterator curfile

Current file.

double mass[6]
int npart[6]
int nptot[6]
std::vector<Particle> particles
unsigned pcount
std::vector<std::string> Pfound
int ptype
double time
unsigned long totalCount

Protected Static Attributes

static std::unordered_map<std::string, int> findP
static std::vector<std::string> Ptypes
class GadgetNative : public PR::ParticleReader
#include <ParticleReader.H>

Inheritence diagram for PR::GadgetNative:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="PR::GadgetNative" tooltip="PR::GadgetNative" fillcolor="#BFBFBF"]
    "2" [label="PR::ParticleReader" tooltip="PR::ParticleReader"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for PR::GadgetNative:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="PR::GadgetNative" tooltip="PR::GadgetNative" fillcolor="#BFBFBF"]
    "2" [label="PR::ParticleReader" tooltip="PR::ParticleReader"]
    "3" [label="gadget_header" tooltip="gadget_header"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "3" [dir=forward tooltip="usage"]
}

Public Functions

inline virtual unsigned long CurrentNumber()

Number of particles in the chosen type.

inline virtual double CurrentTime()

Get current time.

virtual const Particle *firstParticle()

Reset to beginning of particles for this component.

GadgetNative(const std::vector<std::string> &file, bool verbose = false)

Constructor.

inline virtual std::vector<std::string> GetTypes()

Return list of particle types.

virtual const Particle *nextParticle()

Get the next particle.

inline virtual void SelectType(const std::string &type)

Select a particular particle type and reset the iterator.

Private Functions

void getNumbers()
bool nextFile()
void packParticle()
void read_and_load()

Private Members

std::vector<std::string>::iterator curfile

Current file.

gadget_header header
double mass[6]
int npart[6]
int nptot[6]
std::vector<Particle> particles
unsigned pcount
std::vector<std::string> Pfound
int ptype
double time
unsigned long totalCount

Private Static Attributes

static std::unordered_map<std::string, int> findP
static std::vector<std::string> Ptypes
struct gas_particle
#include <tipsydefs.h>

Tipsy particle structure for a gas particle.

Public Members

Real hsmooth

Smoothing scale.

Real mass

particle mass

Real metals

Metal value.

Real phi

Gravitational potential.

Real pos[MAXDIM]

particle position vector

Real rho

Density.

Real temp

Temperature.

Real vel[MAXDIM]

particle velociy vector

struct gas_particle
#include <tipsy.H>

Public Functions

inline int ID() const

Convert phi to index.

Public Members

Real hsmooth
Real mass

Particle data.

Real metals
Real phi
Real pos[MAXDIM]
Real rho
Real temp
Real vel[MAXDIM]
struct GAUSS
#include <gknots.h>

Public Members

int n
double *w
double *x
class GaussQuad
#include <gaussQ.H>

Inheritence diagram for GaussQuad:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="GaussQuad" tooltip="GaussQuad" fillcolor="#BFBFBF"]
    "2" [label="HermQuad" tooltip="HermQuad"]
    "3" [label="JacoQuad" tooltip="JacoQuad"]
    "5" [label="LaguQuad" tooltip="LaguQuad"]
    "4" [label="LegeQuad" tooltip="LegeQuad"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "5" -> "1" [dir=forward tooltip="public-inheritance"]
    "4" -> "3" [dir=forward tooltip="public-inheritance"]
}

Subclassed by HermQuad, JacoQuad, LaguQuad

Public Functions

inline int bomb(const char *s)
inline GaussQuad()
inline double get_alpha(void)
inline double get_beta(void)
inline int get_n(void)
inline double knot(const int i)
inline std::vector<double> &kV(void)
inline double weight(const int i)
inline std::vector<double> &wV(void)

Public Members

double alpha
double beta
std::string FunctionID
int n
std::vector<double> r
std::vector<double> w
class GeneralizedPolytrope : public AxiSymModel
#include <GenPoly.H>

Inheritence diagram for GeneralizedPolytrope:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "1" [label="GeneralizedPolytrope" tooltip="GeneralizedPolytrope" fillcolor="#BFBFBF"]
    "3" [label="MassModel" tooltip="MassModel"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for GeneralizedPolytrope:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "7" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "8" [label="GaussQuad" tooltip="GaussQuad"]
    "1" [label="GeneralizedPolytrope" tooltip="GeneralizedPolytrope" fillcolor="#BFBFBF"]
    "3" [label="MassModel" tooltip="MassModel"]
    "9" [label="RUN" tooltip="RUN"]
    "6" [label="RegularOrbit" tooltip="RegularOrbit"]
    "5" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "9" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
    "5" -> "7" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
}

Public Functions

virtual double d2fde2(double E, double L)
virtual double dfde(double E, double L)
virtual double dfdl(double E, double L)
virtual double distf(double E, double L)
void dump_model(ostream *out)
GeneralizedPolytrope(int num, double n, double m, double eps0 = 1.0e-5, double step = 1.0e-5)
GeneralizedPolytrope(void)
virtual double get_density(const double)
virtual double get_dpot(const double)
virtual double get_dpot2(const double)
virtual double get_mass(const double)

Access the profile.

inline virtual double get_max_radius(void)
inline virtual double get_min_radius(void)
virtual double get_pot(const double)
virtual void get_pot_dpot(const double, double&, double&)

Private Members

RUN dens
double KF
double m
RUN mass
double n
RUN pot
class generateRelaxation : public ExternalForce

Inheritence diagram for generateRelaxation:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="generateRelaxation" tooltip="generateRelaxation" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for generateRelaxation:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="Component" tooltip="Component"]
    "7" [label="EL3" tooltip="EL3"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "6" [label="Orient" tooltip="Orient"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "8" [label="Timer" tooltip="Timer"]
    "1" [label="generateRelaxation" tooltip="generateRelaxation" fillcolor="#BFBFBF"]
    "4" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "5" -> "5" [dir=forward tooltip="usage"]
    "5" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "4" -> "3" [dir=forward tooltip="usage"]
}

Compute relaxation diagnoistics.

Public Functions

generateRelaxation(const YAML::Node &conf)

Constructor.

Private Functions

virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreaded method (must be thread safe) for force computation that must be provided by all derived classes (hence pure virtual)

virtual void initialize()

Used by derived class to initialize any storage and parameters.

Private Members

int done
int epos
class GenericError : public EXPException
#include <EXPException.H>

Inheritence diagram for GenericError:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EXPException" tooltip="EXPException"]
    "1" [label="GenericError" tooltip="GenericError" fillcolor="#BFBFBF"]
    "3" [label="std::exception" tooltip="std::exception"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for GenericError:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EXPException" tooltip="EXPException"]
    "1" [label="GenericError" tooltip="GenericError" fillcolor="#BFBFBF"]
    "3" [label="std::exception" tooltip="std::exception"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Used for explicit detailed messages.

Public Functions

inline GenericError(const std::string msg, const std::string sourcefilename, int sourcelinenumber, int errorcode = -1, bool deadlock = false)

Use this for reporting an error with a specific message.

class GenLagu : public OrthoPoly
#include <OrthoPoly.H>

Inheritence diagram for GenLagu:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="GenLagu" tooltip="GenLagu" fillcolor="#BFBFBF"]
    "2" [label="OrthoPoly" tooltip="OrthoPoly"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for GenLagu:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="GenLagu" tooltip="GenLagu" fillcolor="#BFBFBF"]
    "2" [label="OrthoPoly" tooltip="OrthoPoly"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline virtual double coef1(const int n)
inline virtual double coef2(const int n)
inline virtual double coef3(const int n)
inline virtual double coef4(const int n)
inline virtual double f0(const double x)
inline virtual double f1(const double x)
inline GenLagu(double A)
inline virtual double h(const int n)
inline virtual double w(const double x)

Private Members

double alpha
class GenPhi

Public Functions

inline double Angle(double r)
inline GenPhi(double scale, double amp, int m)
inline std::tuple<unsigned, unsigned, std::vector<unsigned>> getStats()

Private Members

double baramp
std::vector<unsigned> counts
std::random_device dev
std::uniform_real_distribution dist
int m
unsigned numbar
unsigned numtot
std::mt19937 rng
double scale

Private Static Attributes

static constexpr int numcnt = 32
class Grid2D
#include <Grid2D.H>

Create, store, and restore a two-dimensional binned grid

Public Functions

inline void addPoint(double mass, double x, double y)

Add.

inline Grid2D(double Rmax, int num, double t)

Constructor.

inline Grid2D(std::istream &in)

Constructor from istream (restore from cache file)

inline double operator()(double x, double y)

Get density.

inline void read(std::istream &in)

Read from file.

inline void sync()

Synchonize arrays.

inline double Time()

Get time.

inline void write(std::ostream &out)

Write to file.

Private Members

std::vector<double> dens

Data store (flattened into a single vector)

double dr
int N
double R

Parameters.

double T
class HaloBulge : public ExternalForce
#include <HaloBulge.H>

Inheritence diagram for HaloBulge:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "1" [label="HaloBulge" tooltip="HaloBulge" fillcolor="#BFBFBF"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for HaloBulge:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="Component" tooltip="Component"]
    "7" [label="EL3" tooltip="EL3"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "1" [label="HaloBulge" tooltip="HaloBulge" fillcolor="#BFBFBF"]
    "6" [label="Orient" tooltip="Orient"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "8" [label="Timer" tooltip="Timer"]
    "4" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "5" -> "5" [dir=forward tooltip="usage"]
    "5" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "5" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
}

Compute halo + bulge external force.

Public Functions

HaloBulge(const YAML::Node &conf)

Constructor.

Private Functions

virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreaded method (must be thread safe) for force computation that must be provided by all derived classes (hence pure virtual)

virtual void initialize()

Used by derived class to initialize any storage and parameters.

Private Members

AxiSymModPtr bmodel
int HMODEL

Halo model type (default: file)

string INFILE

Halo model file (default: w05)

double MBULGE

Bulge mass scale factor (default: 1.0)

double MHALO

Halo mass scale factor (default: 1.0)

AxiSymModPtr model
double RBCORE

Bulge core/scale size (default: 1.0)

double RBMOD

Bulge maximum model radius (default: 20.0)

double RBMODMIN

Bulge miniimum model radius (default: 1.0e-3)

double RBULGE

Bulge radius scale factor (default: 1.0)

double RHALO

Halo radius scale factor (default: 1.0)

double RMOD

Halo maximum model radius (default: 20.0)

double RMODMIN

Halo minimum model radius (default: 1.0e-3)

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class HankelTransform
#include <Hankel.H>

Hankel transform based on the Ogata quadrature formulae from:

Ogata, H, 2005, “A Numerical Integration Formula Based on the

Bessel Functions”, Publ. Res. Inst. Math. Sci. 41 (4) (2005) 949–970.

Public Functions

inline HankelTransform()

Null constructor.

HankelTransform(double h, double nu, int N = 20)

Constructor.

double operator()(std::function<double(double)> f, double q)

Perform the transform F(q)=int(f(x)*Jn(x*q))

inline void setLinear()

Set to unmapped Ogata formula.

inline ~HankelTransform()

Destructor.

Private Functions

inline double fk_trans(double x, std::function<double(double)> f, double q)

Variable change.

double get_psi(double t)

Ogata mapping formula.

double get_psip(double t)

Derivative of the Ogata mapping formula.

double ogata_linear(std::function<double(double)> f, double q, double h)

The unmapped algorithm.

double ogata_transformed(std::function<double(double)> f, double q, double h)

The mapping transformation algorithm (default)

Private Members

double h

the h scaling value for the Ogata mapping

bool mapped

True for mapping transformation algorithm (default)

int N

N is number of function calls.

double nu

nu is Bessel function order

std::vector<double> w

Ogata weights; Bessel functions of the second kind divided by the first kind for nu+1 evaluated at the zeros

std::vector<double> xi

Zeros divided by 2*pi for Ogata.

std::vector<double> zeros

Will contain the zeros of the Bessel function of order nu.

struct Header
#include <tipsy.H>

Public Members

int nbodies
int ndark
int ndim
int nsph
int nstar
double time
struct HelpGroupDetails
#include <cxxopts.H>

Public Members

std::string description = {}
std::string name = {}
std::vector<HelpOptionDetails> options = {}
struct HelpOptionDetails
#include <cxxopts.H>

Public Members

std::string arg_help
std::string default_value
String desc
bool has_default
bool has_implicit
std::string implicit_value
bool is_boolean
bool is_container
std::string l
std::string s
class Hermite : public OrthoPoly
#include <OrthoPoly.H>

Inheritence diagram for Hermite:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Hermite" tooltip="Hermite" fillcolor="#BFBFBF"]
    "2" [label="OrthoPoly" tooltip="OrthoPoly"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Hermite:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Hermite" tooltip="Hermite" fillcolor="#BFBFBF"]
    "2" [label="OrthoPoly" tooltip="OrthoPoly"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline virtual double coef1(const int n)
inline virtual double coef2(const int n)
inline virtual double coef3(const int n)
inline virtual double coef4(const int n)
inline virtual double f0(const double x)
inline virtual double f1(const double x)
inline virtual double h(const int n)
inline Hermite(void)
inline virtual double w(const double x)
class HermQuad : public GaussQuad
#include <gaussQ.H>

Inheritence diagram for HermQuad:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="GaussQuad" tooltip="GaussQuad"]
    "1" [label="HermQuad" tooltip="HermQuad" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for HermQuad:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="GaussQuad" tooltip="GaussQuad"]
    "1" [label="HermQuad" tooltip="HermQuad" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

HermQuad(int N = 10, double ALPHA = 0.0)
class Hernquist
#include <models.H>

Public Functions

Eigen::Vector3d force(Eigen::Vector3d&)
double potential(Eigen::Vector3d&)
inline void set_Hernquist(double r0init, double Ginit, double Minit)

Protected Attributes

double G
double GM
double M
double r0
class HernquistSphere : public AxiSymModel
#include <hernquist_model.H>

Inheritence diagram for HernquistSphere:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "1" [label="HernquistSphere" tooltip="HernquistSphere" fillcolor="#BFBFBF"]
    "3" [label="MassModel" tooltip="MassModel"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for HernquistSphere:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "7" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "8" [label="GaussQuad" tooltip="GaussQuad"]
    "1" [label="HernquistSphere" tooltip="HernquistSphere" fillcolor="#BFBFBF"]
    "3" [label="MassModel" tooltip="MassModel"]
    "6" [label="RegularOrbit" tooltip="RegularOrbit"]
    "5" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
    "5" -> "7" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
}

Public Functions

inline virtual double d2fde2(double E, double L)
inline virtual double dfde(double E, double L)
inline virtual double dfdl(double E, double L)
inline virtual double distf(double E, double L)
inline virtual double get_density(const double r)
inline virtual double get_dpot(const double r)
inline virtual double get_dpot2(const double r)
inline virtual double get_mass(const double r)

Access the profile.

inline virtual double get_max_radius(void)
inline virtual double get_min_radius(void)
inline virtual double get_pot(const double r)
inline virtual void get_pot_dpot(const double r, double &ur, double &dur)
inline HernquistSphere(double RSCL = 1.0, double RMIN = 1.0e-6, double RMAX = 1.0e6, double TOLE = 1.0e-5)

Private Members

double rmax
double rmin
double rot
double rscl
double tolE
class HQSphere : public AxiSymBiorth
#include <biorth.H>

Inheritence diagram for HQSphere:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymBiorth" tooltip="AxiSymBiorth"]
    "3" [label="Biorth" tooltip="Biorth"]
    "1" [label="HQSphere" tooltip="HQSphere" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for HQSphere:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymBiorth" tooltip="AxiSymBiorth"]
    "3" [label="Biorth" tooltip="Biorth"]
    "1" [label="HQSphere" tooltip="HQSphere" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

virtual double d_r_to_rb(double const)
virtual void dens(const int nn, const int l, const double r, Eigen::VectorXd &a)
virtual double dens(const int nn, const int l, const double rb)
inline double densR(const int nn, const int l, const double r)
HQSphere(void)
virtual double krnl(const int nn, const int l)
virtual double norm(const int nn, const int l)
virtual void potl(const int nn, const int l, const double r, Eigen::VectorXd &a)
virtual double potl(const int nn, const int l, const double rb)
inline virtual double potlR(const int nn, const int l, const double r)
inline virtual double potlRZ(const int nn, const int l, const double r, const double z)
virtual double r_to_rb(double const)
inline virtual double rb_max(void)
inline virtual double rb_min(void)
virtual double rb_to_r(double const)
inline virtual ~HQSphere()

Private Members

double rbmax
double rbmin
class HunterDisk : public AxiSymModel
#include <hunter.H>

Inheritence diagram for HunterDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "1" [label="HunterDisk" tooltip="HunterDisk" fillcolor="#BFBFBF"]
    "3" [label="MassModel" tooltip="MassModel"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for HunterDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "7" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "8" [label="GaussQuad" tooltip="GaussQuad"]
    "1" [label="HunterDisk" tooltip="HunterDisk" fillcolor="#BFBFBF"]
    "3" [label="MassModel" tooltip="MassModel"]
    "6" [label="RegularOrbit" tooltip="RegularOrbit"]
    "5" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
    "5" -> "7" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
}

Public Functions

inline virtual double d2fde2(double E, double L)
inline virtual double dfde(double E, double L)
inline virtual double dfdl(double E, double L)
inline virtual double distf(double E, double L)
virtual double get_density(const double r)
virtual double get_dpot(const double r)
double get_dpot(const double r, const double z)
virtual double get_dpot2(const double r)
double get_dpot2(const double r, const double z)
virtual double get_mass(const double r)

Access the profile.

inline virtual double get_max_radius(void)
inline virtual double get_min_radius(void)
virtual double get_pot(const double r)
double get_pot(const double r, const double z)
void get_pot_dpot(const double r, const double z, double &ur, double &dur)
virtual void get_pot_dpot(const double r, double &ur, double &dur)
HunterDisk(int N, double RMAX = 1.0, double MASS = 1.0)
void set_params(const double KMAX = 20.0, const double RCUT = 8.0, const int NINT = 200, const int MGRID = 200, const int NHANK = 400)

Private Functions

Vector d2vplgndr(double)
Vector dvplgndr(double)
void setup_mass(void)
void setup_model(void)
void tabulate_hankel(void)
Vector vplgndr(double)

Private Members

Vector cvec
Vector gam
Logic hankel_setup
Vector K
double kfac
double kmax
Vector m_mass
double mass
Logic mass_setup
int mgrid
Logic model_setup
int n
int nhank
int nint
double offset_dp
double offset_dp2
double offset_p
double omfac
double pfac
Vector r_mass
double rcut
double rmax
Vector S_K
double sfac

Private Static Attributes

static const double defKMAX = 20.0
static const int defMGRID = 200
static const int defNHANK = 400
static const int defNINT = 200
static const double defRCUT = 8.0
class HunterDiskX : public AxiSymModel
#include <HunterX.H>

Inheritence diagram for HunterDiskX:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "1" [label="HunterDiskX" tooltip="HunterDiskX" fillcolor="#BFBFBF"]
    "3" [label="MassModel" tooltip="MassModel"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for HunterDiskX:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "7" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "8" [label="GaussQuad" tooltip="GaussQuad"]
    "9" [label="HunterDisk" tooltip="HunterDisk"]
    "1" [label="HunterDiskX" tooltip="HunterDiskX" fillcolor="#BFBFBF"]
    "3" [label="MassModel" tooltip="MassModel"]
    "6" [label="RegularOrbit" tooltip="RegularOrbit"]
    "5" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "9" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "9" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
    "5" -> "7" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
}

Public Functions

inline virtual double d2fde2(double E, double L)
inline virtual double dfde(double E, double L)
inline virtual double dfdl(double E, double L)
inline virtual double distf(double E, double L)
virtual double get_density(const double r)
virtual double get_dpot(const double r)
double get_dpot(const double r, const double z)
virtual double get_dpot2(const double r)
double get_dpot2(const double r, const double z)
virtual double get_mass(const double r)

Access the profile.

inline virtual double get_max_radius(void)
inline virtual double get_min_radius(void)
virtual double get_pot(const double r)
double get_pot(const double r, const double z)
void get_pot_dpot(const double r, const double z, double &ur, double &dur)
virtual void get_pot_dpot(const double r, double &ur, double &dur)
HunterDiskX(int N, double RMAX = 1.0, double MASS = 1.0)
void set_params(const double KMAX = 20.0, const double RCUT = 8.0, const int NINT = 200, const int MGRID = 200, const int NHANK = 400)
~HunterDiskX()

Private Members

HunterDisk *disk1
HunterDisk *diskN
double factor
double rmax
template<template<class, class, class...> class C, typename K, typename V, typename ...Args>
class Icont : public C<K, V, Args...>
#include <InitContainer.H>

Inheritence diagram for Icont:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="C< K, V, Args... >" tooltip="C< K, V, Args... >"]
    "1" [label="Icont< C, K, V, Args >" tooltip="Icont< C, K, V, Args >" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Icont:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="C< K, V, Args... >" tooltip="C< K, V, Args... >"]
    "1" [label="Icont< C, K, V, Args >" tooltip="Icont< C, K, V, Args >" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

This does the same thing as the non-invasive templates above using inheritance to wrap the container

Public Functions

inline virtual V Default()

Default value is zero for simple arithmetic types, but may be specialized as necessary. If it fails to compile, it probably needs to be specialized.

inline V &operator[](const K &key)

Initializer.

class Info
#include <BarrierWrapper.H>

Public Functions

inline Info()

Null constructor for assignment.

Info(CharPtr p)

Construct from MPI-passed char buffer.

Info(int own, time_t ctm, const std::string &s)

Full constructor.

void sendInfo(int myid, MPI_Comm comm, int commsize)

Send the Info to all processes in the communicator.

Public Members

CharPtr c

Character buffer for string.

time_t ctm

Creation time.

int own

Owning process.

std::string s

Label.

unsigned siz

Label size.

Public Static Attributes

static const size_t bufsz = 512

Buffer size (1 block)

static const int tag = 232395

Tag.

Private Functions

void pack()

Helper to translate buffer.

Private Members

CharPtr blob

MPI buffer.

size_t charsz

Space for character string.

std::list<ReqPtr> req

Request handle.

class Input
Input class to adaptively handle various EXP output formats.

inputs
---------------
filename : str
    the input filename to be read
comp     : str, optional
    the name of the component for which to extract data. If None, will read primary header and exit.
legacy   : bool, default=True
    if True, return attributes rather than a dictionary of particle data
verbose  : int, default 0
    verbosity flag.

returns
---------------
self        : Input instance
  .header   : dict, all header values pulled from the file
    the .keys() are the names of each component
    each component has a dictionary of values, including 'parameters'
    the details of the force calculation are in 'force'
  .filename : str, the filename that was read
  .comp     : str, name of the component
  .time     : float, the time in the output file
  .data     : dictionary, with keys:
    x       : float, the x position
    y       : float, the y position
    z       : float, the z position
    vx      : float, the x velocity
    vy      : float, the y velocity
    vz      : float, the z velocity
    mass    : float, the mass of the particle
    index   : int, the integer index of the particle
    potE    : float, the potential energy value

  ---or, if legacy=True---
  
  .xpos     : float, the x position
  .ypos     : float, the y position
  .zpos     : float, the z position
  .xvel     : float, the x velocity
  .yvel     : float, the y velocity
  .zvel     : float, the z velocity
  .mass     : float, the mass of the particle
  .indx     : int, the integer index of the particle
  .pote     : float, the potential energy value

Public Members

comp
data
filename
header
indx
mass
pote
style
time
xpos
xvel
ypos
yvel
zpos
zvel
struct IntegerDesc
#include <cxxopts.H>

Public Members

std::string base = ""
std::string negative = ""
std::string value = ""
class Interaction

Collaboration diagram for Interaction:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="Component" tooltip="Component"]
    "6" [label="EL3" tooltip="EL3"]
    "1" [label="Interaction" tooltip="Interaction" fillcolor="#BFBFBF"]
    "5" [label="Orient" tooltip="Orient"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "7" [label="Timer" tooltip="Timer"]
    "4" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "2" -> "2" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "2" -> "7" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "2" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
}

Class to keep track of the interactions between components.

Maintains a list of component that feel the force from the given component. Every pair of interactions must be explicitly be listed in the [interaction] stanza of the input file. Example: halo : disk will tell the code to apply the force from halo particles on the disk particles. The fully self-consistent simulation with a disk and halo component would have the lines: halo : disk disk : halo

Public Functions

inline Interaction(Component *c)

Constructor.

Public Members

Component *c

Fiducial component with whom force interactions are desired.

std::list<Component*> l

List of components whose particles will feel the force from *c.

class InternalError : public EXPException
#include <EXPException.H>

Inheritence diagram for InternalError:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EXPException" tooltip="EXPException"]
    "1" [label="InternalError" tooltip="InternalError" fillcolor="#BFBFBF"]
    "3" [label="std::exception" tooltip="std::exception"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for InternalError:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EXPException" tooltip="EXPException"]
    "1" [label="InternalError" tooltip="InternalError" fillcolor="#BFBFBF"]
    "3" [label="std::exception" tooltip="std::exception"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Used when execution reaches a point it should not reach.

Public Functions

inline InternalError(const std::string msg, const std::string sourcefilename, int sourcelinenumber, int errorcode = -1, bool deadlock = true)
inline InternalError(const std::string sourcefilename, int sourcelinenumber, int errorcode = -1, bool deadlock = true)

Use this when you reach an unexpected state.

class Interp1d
#include <interp.H>

Inheritence diagram for Interp1d:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="Cheby1d" tooltip="Cheby1d"]
    "1" [label="Interp1d" tooltip="Interp1d" fillcolor="#BFBFBF"]
    "3" [label="Linear1d" tooltip="Linear1d"]
    "4" [label="Spline1d" tooltip="Spline1d"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
}

Subclassed by Cheby1d, Linear1d, Spline1d

Public Functions

virtual double deriv(const double &x) = 0

Evaluate first derivative.

virtual double eval(const double &x) = 0

Evaluate the interpolant.

virtual double xhi() = 0
virtual double xlo() = 0

Data limits.

virtual ~Interp1d() = 0

Destructor.

class invalid_option_format_error : public cxxopts::OptionSpecException
#include <cxxopts.H>

Inheritence diagram for cxxopts::invalid_option_format_error:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "2" [label="cxxopts::OptionSpecException" tooltip="cxxopts::OptionSpecException"]
    "1" [label="cxxopts::invalid_option_format_error" tooltip="cxxopts::invalid_option_format_error" fillcolor="#BFBFBF"]
    "4" [label="std::exception" tooltip="std::exception"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for cxxopts::invalid_option_format_error:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "2" [label="cxxopts::OptionSpecException" tooltip="cxxopts::OptionSpecException"]
    "1" [label="cxxopts::invalid_option_format_error" tooltip="cxxopts::invalid_option_format_error" fillcolor="#BFBFBF"]
    "4" [label="std::exception" tooltip="std::exception"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline explicit invalid_option_format_error(const std::string &format)
class Isothermal
#include <models.H>

Public Functions

Eigen::Vector3d force(Eigen::Vector3d&)
double potential(Eigen::Vector3d&)
inline void set_Isothermal(double r0init, double vcinit)

Protected Attributes

double r0
double vc
double vcsq
class IsothermalSphere : public AxiSymModel
#include <isothermal.H>

Inheritence diagram for IsothermalSphere:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "1" [label="IsothermalSphere" tooltip="IsothermalSphere" fillcolor="#BFBFBF"]
    "3" [label="MassModel" tooltip="MassModel"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for IsothermalSphere:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "7" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "8" [label="GaussQuad" tooltip="GaussQuad"]
    "1" [label="IsothermalSphere" tooltip="IsothermalSphere" fillcolor="#BFBFBF"]
    "3" [label="MassModel" tooltip="MassModel"]
    "6" [label="RegularOrbit" tooltip="RegularOrbit"]
    "5" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
    "5" -> "7" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
}

Public Functions

inline virtual double d2fde2(double E, double L)
inline virtual double dfde(double E, double L)
inline virtual double dfdl(double E, double L)
inline virtual double distf(double E, double L)
inline virtual double get_density(const double R)
inline virtual double get_dpot(const double R)
inline virtual double get_dpot2(const double R)
inline virtual double get_mass(const double R)

Access the profile.

inline virtual double get_max_radius(void)
inline virtual double get_min_radius(void)
inline virtual double get_pot(const double R)
inline virtual void get_pot_dpot(const double R, double &ur, double &dur)
IsothermalSphere(double RCORE = 1.0, double RMAX = 20.0, double VROT = 1.0, int NUM = 2000, int dN = 20)

Private Members

Eigen::VectorXd d
Eigen::VectorXd d2
double F
Eigen::VectorXd m
Eigen::VectorXd m2
int num
Eigen::VectorXd p
Eigen::VectorXd p2
Eigen::VectorXd r
double ret1
double ret2
double rmax
double rscale
double sigma
double vrot
template<typename T>
class Iterable : public Iterator<T>
#include <Iterable.H>

Inheritence diagram for Iterable:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Iterable< T >" tooltip="Iterable< T >" fillcolor="#BFBFBF"]
    "2" [label="Iterator< T >" tooltip="Iterator< T >"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Iterable:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Iterable< T >" tooltip="Iterable< T >" fillcolor="#BFBFBF"]
    "2" [label="Iterator< T >" tooltip="Iterator< T >"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline explicit Iterable(T *_ptr)
inline bool operator!=(Iterable other) const
inline T *operator*() const
inline Iterable &operator++()
inline Iterable operator++(int)
inline bool operator==(Iterable other) const

Private Members

T *ptr
class Iterator
#include <cxxopts.H>

Collaboration diagram for cxxopts::ParseResult::Iterator:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="cxxopts::ParseResult" tooltip="cxxopts::ParseResult"]
    "1" [label="cxxopts::ParseResult::Iterator" tooltip="cxxopts::ParseResult::Iterator" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="usage"]
}

Public Types

using difference_type = void
using iterator_category = std::forward_iterator_tag
using pointer = const KeyValue*
using reference = const KeyValue&
using value_type = KeyValue

Public Functions

Iterator() = default
Iterator(const Iterator&) = default
inline Iterator(const ParseResult *pr, bool end = false)
inline bool operator!=(const Iterator &other) const
inline const KeyValue &operator*()
inline Iterator &operator++()
inline Iterator operator++(int)
inline const KeyValue *operator->()
inline bool operator==(const Iterator &other) const

Private Members

std::vector<KeyValue>::const_iterator m_iter
const ParseResult *m_pr
template<typename T>
struct Iterator
#include <Iterable.H>

Inheritence diagram for Iterator:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="Iterable< T >" tooltip="Iterable< T >"]
    "1" [label="Iterator< T >" tooltip="Iterator< T >" fillcolor="#BFBFBF"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
}

Subclassed by Iterable< T >

Public Types

using difference_type = std::ptrdiff_t
using iterator_category = std::forward_iterator_tag
using pointer = T*
using reference = T&
using value_type = T
class JacoQuad : public GaussQuad
#include <gaussQ.H>

Inheritence diagram for JacoQuad:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="GaussQuad" tooltip="GaussQuad"]
    "1" [label="JacoQuad" tooltip="JacoQuad" fillcolor="#BFBFBF"]
    "3" [label="LegeQuad" tooltip="LegeQuad"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for JacoQuad:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="GaussQuad" tooltip="GaussQuad"]
    "1" [label="JacoQuad" tooltip="JacoQuad" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Subclassed by LegeQuad

Public Functions

JacoQuad(int N = 10, double ALPHA = 0.0, double BETA = 0.0)
class KalnajsDisk : public AxiSymModel
#include <kalnajs.H>

Inheritence diagram for KalnajsDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "1" [label="KalnajsDisk" tooltip="KalnajsDisk" fillcolor="#BFBFBF"]
    "3" [label="MassModel" tooltip="MassModel"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for KalnajsDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "7" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "8" [label="GaussQuad" tooltip="GaussQuad"]
    "1" [label="KalnajsDisk" tooltip="KalnajsDisk" fillcolor="#BFBFBF"]
    "3" [label="MassModel" tooltip="MassModel"]
    "6" [label="RegularOrbit" tooltip="RegularOrbit"]
    "5" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
    "5" -> "7" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
}

Public Functions

inline virtual double d2fde2(double E, double L)
inline virtual double dfde(double E, double L)
inline virtual double dfdl(double E, double L)
inline virtual double distf(double E, double L)
inline virtual double get_density(const double r)
inline virtual double get_dpot(const double r)
inline virtual double get_dpot2(const double r)
inline virtual double get_mass(const double r)

Access the profile.

inline virtual double get_max_radius(void)
inline virtual double get_min_radius(void)
inline virtual double get_pot(const double r)
inline virtual void get_pot_dpot(const double r, double &ur, double &dur)
inline KalnajsDisk(double RMOD = 1.0, double MASS = 1.0)
inline void setup_df(double frac)

Private Members

double F
double fac0
double mmax
double omega
double omega0
double potfac1
double potfac2
double rhofac
double rmax
class KDE2d
#include <KDE2d.H>

Class for 2D kernel density estimation

Public Functions

inline KDE2d(int numx, int numy, double xmin, double xmax, double ymin, double ymax, double sigmax, double sigmay)

Constructor.

inline const Eigen::MatrixXd &operator()(const Eigen::MatrixXd &GRID)

Get the smoothed density from an input grid.

inline const Eigen::MatrixXd &operator()(const std::vector<double> &x, const std::vector<double> &y)

Get the smoothed density from an input data arrays.

inline const Eigen::MatrixXd &operator()(const std::vector<std::pair<double, double>> &data)

Get the smoothed density from an input data pairs.

inline void setDebug()

Set debug mode.

Protected Functions

std::vector<double> gaussian_kernel_2d(int xsize, int ysize)

Create a smooth 2D gaussian kernel.

void grid_array(const std::vector<double> &x, const std::vector<double> &y)
void grid_pairs(const std::vector<std::pair<double, double>> &data)

Make 2D grid.

void kde_fft_2d()

Do the FFT convolution.

Protected Attributes

bool debug = false

Parameters.

double delx
double dely
Eigen::MatrixXd grid

Eigen matrices.

const int minKsize = 7
int numx
int numy
double sigmax
double sigmay
Eigen::MatrixXd smooth
double xmax
double xmin
double ymax
double ymin
template<typename coordinate_type, size_t dimensions>
class kdtree
#include <KDtree.H>

Collaboration diagram for KDtree::kdtree:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="KDtree::kdtree< coordinate_type, dimensions >::node" tooltip="KDtree::kdtree< coordinate_type, dimensions >::node"]
    "1" [label="KDtree::kdtree< coordinate_type, dimensions >" tooltip="KDtree::kdtree< coordinate_type, dimensions >" fillcolor="#BFBFBF"]
    "2" -> "2" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="usage"]
}

k-d tree implementation

Public Types

using cache = Cache<double, node*>
using point_type = point<coordinate_type, dimensions>

Public Functions

inline double distance(cache &best_) const

Returns the distance between the input point and return value from the last call to nearest().

inline bool empty() const

Returns true if the tree is empty, false otherwise.

inline std::vector<double> getDist(cache &best_)
inline std::vector<std::vector<unsigned long>> getPartition(unsigned level)
kdtree(const kdtree&) = delete

Copy constructor2.

template<typename func>
inline kdtree(func &&f, size_t n)

Constructor taking a function object that generates points. The function object will be called n times to populate the tree.

Parameters:
  • f – function that returns a point

  • n – number of points to add

template<typename iterator>
inline kdtree(iterator begin, iterator end)

Constructor taking a pair of iterators. Adds each point in the range [begin, end) to the tree.

Parameters:
  • begin – start of range

  • end – end of range

inline std::tuple<std::vector<point_type>, double, cache> nearestList(const point_type &pt, int N)

Finds the nearest N points in the tree to the given point. It is not valid to call this function if the tree is empty.

Returns: tuple of the nearest point list and the radius of the Nth point

Parameters:
  • pt – a point

  • N – is the number of nearest points

inline std::tuple<point_type, double, double, cache> nearestN(const point_type &pt, int N)

Finds the nearest N points in the tree to the given point. It is not valid to call this function if the tree is empty.

Returns: tuple of the first points, summed weight, and the radius of the Nth point

Parameters:
  • pt – a point

  • N – is the number of nearest points

kdtree &operator=(const kdtree&) = delete
inline size_t visited() const

Returns the number of nodes visited by the last call to nearest().

Private Functions

inline void accum(node *root, std::vector<std::vector<unsigned long>> &ret, unsigned cur)
inline node *make_tree(size_t begin, size_t end, size_t index)
inline void nearestN(node *root, const point_type &point, size_t index, int N, cache &best_)
inline void walk(node *root, std::vector<std::vector<unsigned long>> &ret, unsigned int cur, unsigned int lev, unsigned int level)

Private Members

std::vector<node> nodes_
node *root_
size_t visited_
class KeyConvert
#include <Species.H>

Wrap a union for converting a speciesKey to an int

Public Functions

inline unsigned short C()

Get C.

inline int getInt()

Get the converted int.

inline speciesKey getKey()

Get the converter speciesKey.

inline KeyConvert()

Null constructor.

inline KeyConvert(const int i)

Constructor taking a converted int (enter value into the union)

inline KeyConvert(const KeyConvert &p)

Copy constructor.

inline KeyConvert(const speciesKey &k)

Constructor taking a speciesKey (enter values into the union)

inline int updateC(short unsigned C)

Update C and return int.

inline unsigned short Z()

Get Z.

Public Members

int i
unsigned short us[2]

Private Members

union KeyConvert c
class KeyValue
#include <cxxopts.H>

Public Functions

template<typename T>
inline T as() const
inline CXXOPTS_NODISCARD const std::string & key () const
inline KeyValue(std::string key_, std::string value_)
inline CXXOPTS_NODISCARD const std::string & value () const

Private Members

std::string m_key
std::string m_value
class KingSphere : public SphericalModelTable
#include <king.H>

Inheritence diagram for KingSphere:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="AxiSymModel" tooltip="AxiSymModel"]
    "1" [label="KingSphere" tooltip="KingSphere" fillcolor="#BFBFBF"]
    "4" [label="MassModel" tooltip="MassModel"]
    "2" [label="SphericalModelTable" tooltip="SphericalModelTable"]
    "5" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "3" -> "5" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for KingSphere:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "8" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "3" [label="AxiSymModel" tooltip="AxiSymModel"]
    "13" [label="Cheby1d" tooltip="Cheby1d"]
    "11" [label="FDIST" tooltip="FDIST"]
    "12" [label="FDISTC" tooltip="FDISTC"]
    "9" [label="GaussQuad" tooltip="GaussQuad"]
    "14" [label="Interp1d" tooltip="Interp1d"]
    "1" [label="KingSphere" tooltip="KingSphere" fillcolor="#BFBFBF"]
    "4" [label="MassModel" tooltip="MassModel"]
    "10" [label="RUN" tooltip="RUN"]
    "7" [label="RegularOrbit" tooltip="RegularOrbit"]
    "2" [label="SphericalModelTable" tooltip="SphericalModelTable"]
    "6" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "5" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "3" -> "5" [dir=forward tooltip="public-inheritance"]
    "3" -> "6" [dir=forward tooltip="usage"]
    "13" -> "14" [dir=forward tooltip="public-inheritance"]
    "12" -> "13" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "10" [dir=forward tooltip="usage"]
    "2" -> "11" [dir=forward tooltip="usage"]
    "2" -> "12" [dir=forward tooltip="usage"]
    "6" -> "7" [dir=forward tooltip="public-inheritance"]
    "6" -> "8" [dir=forward tooltip="usage"]
    "6" -> "9" [dir=forward tooltip="usage"]
}

Public Functions

inline double d2fde2(double E)
inline double dfde(double E)
inline double distf(double E)
inline KingSphere(string filename)
inline void setup_df(void)

Private Members

double betaK
double E0K
double kingK
class KuzminCyl : public EmpCyl2d::ModelCyl
#include <EmpCyl2d.H>

Inheritence diagram for EmpCyl2d::KuzminCyl:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="EmpCyl2d::KuzminCyl" tooltip="EmpCyl2d::KuzminCyl" fillcolor="#BFBFBF"]
    "2" [label="EmpCyl2d::ModelCyl" tooltip="EmpCyl2d::ModelCyl"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for EmpCyl2d::KuzminCyl:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="EmpCyl2d::KuzminCyl" tooltip="EmpCyl2d::KuzminCyl" fillcolor="#BFBFBF"]
    "2" [label="EmpCyl2d::ModelCyl" tooltip="EmpCyl2d::ModelCyl"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline virtual double dens(double R)
inline virtual double dpot(double R)
inline KuzminCyl(const YAML::Node &par)
inline virtual double pot(double R)

Private Functions

inline virtual void parse(const YAML::Node &conf)

Private Members

double acyl
class LaguQuad : public GaussQuad
#include <gaussQ.H>

Inheritence diagram for LaguQuad:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="GaussQuad" tooltip="GaussQuad"]
    "1" [label="LaguQuad" tooltip="LaguQuad" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for LaguQuad:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="GaussQuad" tooltip="GaussQuad"]
    "1" [label="LaguQuad" tooltip="LaguQuad" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

LaguQuad(int N = 10, double ALPHA = 0.0)
template<class U>
class largestValues
#include <largest.H>

Public Functions

inline void clear()

Empty the queue.

inline std::vector<U> getValues()

Get the current list of values.

inline largestValues(int size)

Construtor: size is the desired size of the heap.

inline void operator()(U data)

Add a new value set.

Private Members

int maxSize
std::priority_queue<U, std::vector<U>, std::greater<U>> pq
class Legendre : public OrthoPoly
#include <OrthoPoly.H>

Inheritence diagram for Legendre:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Legendre" tooltip="Legendre" fillcolor="#BFBFBF"]
    "2" [label="OrthoPoly" tooltip="OrthoPoly"]
    "3" [label="PVQuad" tooltip="PVQuad"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Legendre:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Legendre" tooltip="Legendre" fillcolor="#BFBFBF"]
    "2" [label="OrthoPoly" tooltip="OrthoPoly"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Subclassed by PVQuad

Public Functions

inline virtual double coef1(const int n)
inline virtual double coef2(const int n)
inline virtual double coef3(const int n)
inline virtual double coef4(const int n)
inline virtual double f0(const double x)
inline virtual double f1(const double x)
inline virtual double h(const int n)
inline Legendre(void)
inline virtual double w(const double x)
class LegeQuad : public JacoQuad
#include <gaussQ.H>

Inheritence diagram for LegeQuad:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="GaussQuad" tooltip="GaussQuad"]
    "2" [label="JacoQuad" tooltip="JacoQuad"]
    "1" [label="LegeQuad" tooltip="LegeQuad" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for LegeQuad:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="GaussQuad" tooltip="GaussQuad"]
    "2" [label="JacoQuad" tooltip="JacoQuad"]
    "1" [label="LegeQuad" tooltip="LegeQuad" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline LegeQuad(int N = 10)
class Linear1d : public Interp1d
#include <interp.H>

Inheritence diagram for Linear1d:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="Interp1d" tooltip="Interp1d"]
    "1" [label="Linear1d" tooltip="Linear1d" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Linear1d:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="Interp1d" tooltip="Interp1d"]
    "1" [label="Linear1d" tooltip="Linear1d" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

virtual double deriv(const double &x)

Evaluate first derivative.

virtual double eval(const double &x)

Evaluate the interpolant.

Linear1d()

Null constructor.

Linear1d(const Eigen::VectorXd &x, const Eigen::VectorXd &y)

Construct from Eigen input.

Linear1d(const std::vector<double> &x, const std::vector<double> &y)

Construct from std::vector input.

Linear1d &operator=(const Linear1d&)

Copy constructor.

inline virtual double xhi()
inline virtual double xlo()

Data limits.

~Linear1d()

Destructor.

Private Members

Eigen::VectorXd x
Eigen::VectorXd y
class LinearMap : public SLGridSlab::CoordMap

Inheritence diagram for SLGridSlab::LinearMap:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="SLGridSlab::CoordMap" tooltip="SLGridSlab::CoordMap"]
    "1" [label="SLGridSlab::LinearMap" tooltip="SLGridSlab::LinearMap" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for SLGridSlab::LinearMap:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="SLGridSlab::CoordMap" tooltip="SLGridSlab::CoordMap"]
    "1" [label="SLGridSlab::LinearMap" tooltip="SLGridSlab::LinearMap" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

x = z

Public Functions

virtual double d_xi_to_z(double z)

Jacobian of the transformation.

inline LinearMap(double H)
virtual double xi_to_z(double z)

Convert from mapped coordinate back to vertical.

virtual double z_to_xi(double z)

Convert from vertical to mapped coordinate.

struct loadb_datum
#include <Component.H>

Structure used to sort old & new indices for load balancing.

Public Members

int indx

Process ID.

unsigned short s

0–>Old partiion, 1–>New partiion

int top

Top particle index for this process.

class Logarithmic
#include <models.H>

Public Functions

Eigen::Vector3d force(Eigen::Vector3d&)
inline double get_r0(void)
inline double get_vc(void)
double potential(Eigen::Vector3d&)
inline void set_Logarithmic(double r0init, double vcinit, double qyinit, double qzinit)
inline void set_r0(double r)
inline void set_vc(double v)

Protected Attributes

double qy
double qz
double r0
double vc
double vcsq
class LowIso : public OneDModelTable
#include <massmodel1d.H>

Inheritence diagram for LowIso:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="LowIso" tooltip="LowIso" fillcolor="#BFBFBF"]
    "4" [label="MassModel" tooltip="MassModel"]
    "3" [label="OneDModel" tooltip="OneDModel"]
    "2" [label="OneDModelTable" tooltip="OneDModelTable"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for LowIso:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "6" [label="Interp1d" tooltip="Interp1d"]
    "1" [label="LowIso" tooltip="LowIso" fillcolor="#BFBFBF"]
    "4" [label="MassModel" tooltip="MassModel"]
    "3" [label="OneDModel" tooltip="OneDModel"]
    "2" [label="OneDModelTable" tooltip="OneDModelTable"]
    "5" [label="Spline1d" tooltip="Spline1d"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
}

Public Functions

virtual double dfde(const double E, const double V = 0.0)
virtual double dfdv(const double E, const double V = 0.0)
virtual double distf(const double E, const double V = 0.0)
virtual double get_dpot(const double)
virtual double get_dpot2(const double)
virtual double get_pot(const double)
virtual tuple<double, double> get_pot_dpot(const double)
inline LowIso(string filename, double DISPX = 0.159154943091895335768)

Private Functions

void setup_model(void)

Private Members

double betak
double Bfac
double dispx
double gammak
double normx
double w0
class LowSingIsothermalSphere : public AxiSymModel
#include <isothermal.H>

Inheritence diagram for LowSingIsothermalSphere:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "1" [label="LowSingIsothermalSphere" tooltip="LowSingIsothermalSphere" fillcolor="#BFBFBF"]
    "3" [label="MassModel" tooltip="MassModel"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for LowSingIsothermalSphere:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "7" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "8" [label="GaussQuad" tooltip="GaussQuad"]
    "1" [label="LowSingIsothermalSphere" tooltip="LowSingIsothermalSphere" fillcolor="#BFBFBF"]
    "3" [label="MassModel" tooltip="MassModel"]
    "6" [label="RegularOrbit" tooltip="RegularOrbit"]
    "5" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
    "5" -> "7" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
}

Public Functions

inline virtual double d2fde2(double E, double L)
inline virtual double dfde(double E, double L)
inline virtual double dfdl(double E, double L)
inline virtual double distf(double E, double L)
inline virtual double get_density(const double R)
inline virtual double get_dpot(const double R)
inline virtual double get_dpot2(const double R)
inline virtual double get_mass(const double R)

Access the profile.

inline virtual double get_max_radius(void)
inline virtual double get_min_radius(void)
inline virtual double get_pot(const double R)
inline virtual void get_pot_dpot(const double R, double &ur, double &dur)
LowSingIsothermalSphere(double RMIN = 1.0e-3, double RMAX = 20.0, int NUM = 2000, int dN = 20)

Private Members

Eigen::VectorXd d
Eigen::VectorXd d2
double F
double Fconst
Eigen::VectorXd m
Eigen::VectorXd m2
int num
Eigen::VectorXd p
Eigen::VectorXd p2
double ret1
double ret2
double rmax
double rmin
double sigma
Eigen::VectorXd u
struct ltEL3
#include <Orient.H>

Comparsion function for set<>

Public Functions

inline bool operator()(const EL3 &s1, const EL3 &s2) const
class MakeModel
#include <MakeModel.H>

Public Functions

void AddPoint(double r, double mass)
std::shared_ptr<SphericalModelTable> Compute()
MakeModel(int N, double Rmin, double Rmax, bool logr = true)
void WriteModel(string &filename)

Private Members

Eigen::VectorXd d
std::vector<Eigen::VectorXd> dm
double dr
bool logr
Eigen::VectorXd m
int num
Eigen::VectorXd p
Eigen::VectorXd p1
Eigen::VectorXd r
double rmax
double rmin
class Mapping
#include <EmpCyl2d.H>

Map the radius.

Public Functions

double d_xi_to_r(double xi)

Jacobian.

inline Mapping()

Null constructor (for copy construct)

inline Mapping(double scale, bool cmap)

Main constructor.

double r_to_xi(double r)

From semi-infinite radius to [-1, 1].

double xi_to_r(double xi)

From [-1, 1] to semi-infinite radius.

Protected Attributes

bool cmap
double scale
class MassModel
#include <massmodel.H>

Inheritence diagram for MassModel:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "3" [label="CylDisk" tooltip="CylDisk"]
    "4" [label="DiskWithHalo" tooltip="DiskWithHalo"]
    "5" [label="EmbeddedDiskModel" tooltip="EmbeddedDiskModel"]
    "6" [label="ExponentialDisk" tooltip="ExponentialDisk"]
    "7" [label="GeneralizedPolytrope" tooltip="GeneralizedPolytrope"]
    "8" [label="HernquistSphere" tooltip="HernquistSphere"]
    "9" [label="HunterDisk" tooltip="HunterDisk"]
    "10" [label="HunterDiskX" tooltip="HunterDiskX"]
    "11" [label="IsothermalSphere" tooltip="IsothermalSphere"]
    "12" [label="KalnajsDisk" tooltip="KalnajsDisk"]
    "20" [label="KingSphere" tooltip="KingSphere"]
    "24" [label="LowIso" tooltip="LowIso"]
    "13" [label="LowSingIsothermalSphere" tooltip="LowSingIsothermalSphere"]
    "1" [label="MassModel" tooltip="MassModel" fillcolor="#BFBFBF"]
    "14" [label="MestelDisk" tooltip="MestelDisk"]
    "22" [label="OneDModel" tooltip="OneDModel"]
    "23" [label="OneDModelTable" tooltip="OneDModelTable"]
    "16" [label="PlummerSphere" tooltip="PlummerSphere"]
    "26" [label="Sech2" tooltip="Sech2"]
    "25" [label="Sech2Halo" tooltip="Sech2Halo"]
    "27" [label="Sech2mu" tooltip="Sech2mu"]
    "17" [label="SingIsothermalSphere" tooltip="SingIsothermalSphere"]
    "18" [label="SphericalModelMulti" tooltip="SphericalModelMulti"]
    "19" [label="SphericalModelTable" tooltip="SphericalModelTable"]
    "15" [label="TaperedMestelDisk" tooltip="TaperedMestelDisk"]
    "21" [label="ToomreDisk" tooltip="ToomreDisk"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
    "3" -> "2" [dir=forward tooltip="public-inheritance"]
    "4" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "2" [dir=forward tooltip="public-inheritance"]
    "6" -> "2" [dir=forward tooltip="public-inheritance"]
    "7" -> "2" [dir=forward tooltip="public-inheritance"]
    "8" -> "2" [dir=forward tooltip="public-inheritance"]
    "9" -> "2" [dir=forward tooltip="public-inheritance"]
    "10" -> "2" [dir=forward tooltip="public-inheritance"]
    "11" -> "2" [dir=forward tooltip="public-inheritance"]
    "12" -> "2" [dir=forward tooltip="public-inheritance"]
    "20" -> "19" [dir=forward tooltip="public-inheritance"]
    "24" -> "23" [dir=forward tooltip="public-inheritance"]
    "13" -> "2" [dir=forward tooltip="public-inheritance"]
    "14" -> "2" [dir=forward tooltip="public-inheritance"]
    "22" -> "1" [dir=forward tooltip="public-inheritance"]
    "23" -> "22" [dir=forward tooltip="public-inheritance"]
    "16" -> "2" [dir=forward tooltip="public-inheritance"]
    "26" -> "22" [dir=forward tooltip="public-inheritance"]
    "25" -> "23" [dir=forward tooltip="public-inheritance"]
    "27" -> "22" [dir=forward tooltip="public-inheritance"]
    "17" -> "2" [dir=forward tooltip="public-inheritance"]
    "18" -> "2" [dir=forward tooltip="public-inheritance"]
    "19" -> "2" [dir=forward tooltip="public-inheritance"]
    "15" -> "14" [dir=forward tooltip="public-inheritance"]
    "21" -> "2" [dir=forward tooltip="public-inheritance"]
}

A three-dimensional density-potential model.

Subclassed by AxiSymModel, OneDModel

Public Functions

inline void bomb(const char *s)

Exception handling using std::exception.

inline int dof()

Return the number of dimensions (degrees of freedom)

virtual double get_density(const double, const double, const double) = 0

The density at (x, y, z)

virtual double get_mass(const double, const double, const double) = 0

Get the mass inside of position (x, y, z) (this is ambiguous in general and will depend on the model)

virtual double get_pot(const double, const double, const double) = 0

The potential at (x, y, z)

inline virtual ~MassModel()

Destructor.

Public Members

bool defined

True if model is assigned.

int dim

The number of dimensions (degrees of freedom)

string ModelID

Model identifier.

class MasterHeader
#include <header.H>

Describe the phase space dump.

Public Members

int ncomp

Number of individual components.

int ntot

Number of particles in entire phase space.

double time

Current time for phase space.

Friends

inline friend std::ostream &operator<<(std::ostream &os, const MasterHeader &p)
class MestelCyl : public EmpCyl2d::ModelCyl
#include <EmpCyl2d.H>

Inheritence diagram for EmpCyl2d::MestelCyl:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="EmpCyl2d::MestelCyl" tooltip="EmpCyl2d::MestelCyl" fillcolor="#BFBFBF"]
    "2" [label="EmpCyl2d::ModelCyl" tooltip="EmpCyl2d::ModelCyl"]
    "3" [label="EmpCyl2d::ZangCyl" tooltip="EmpCyl2d::ZangCyl"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for EmpCyl2d::MestelCyl:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="EmpCyl2d::MestelCyl" tooltip="EmpCyl2d::MestelCyl" fillcolor="#BFBFBF"]
    "2" [label="EmpCyl2d::ModelCyl" tooltip="EmpCyl2d::ModelCyl"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Subclassed by EmpCyl2d::ZangCyl

Public Functions

inline virtual double dens(double R)
inline virtual double dpot(double R)
inline MestelCyl(const YAML::Node &par)
inline virtual double pot(double R)

Protected Functions

inline virtual void parse(const YAML::Node &conf)

Protected Attributes

double rot
double vrot
class MestelDisk : public AxiSymModel
#include <mestel.H>

Inheritence diagram for MestelDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "3" [label="MassModel" tooltip="MassModel"]
    "1" [label="MestelDisk" tooltip="MestelDisk" fillcolor="#BFBFBF"]
    "5" [label="TaperedMestelDisk" tooltip="TaperedMestelDisk"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "1" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for MestelDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "7" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "8" [label="GaussQuad" tooltip="GaussQuad"]
    "3" [label="MassModel" tooltip="MassModel"]
    "1" [label="MestelDisk" tooltip="MestelDisk" fillcolor="#BFBFBF"]
    "6" [label="RegularOrbit" tooltip="RegularOrbit"]
    "5" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
    "5" -> "7" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
}

Infiinte Mestel Disk.

Subclassed by TaperedMestelDisk

Public Functions

virtual double d2fde2(double E, double L)
virtual double dfde(double E, double L)
virtual double dfdl(double E, double L)
virtual double distf(double E, double L)
virtual double get_density(const double R)
virtual double get_dpot(const double R)
virtual double get_dpot2(const double R)
virtual double get_mass(const double R)

Required member functions.

inline virtual double get_max_radius(void)
inline virtual double get_min_radius(void)

Addiional member functions.

virtual double get_pot(const double R)
virtual void get_pot_dpot(const double R, double &ur, double &dur)
MestelDisk(double VROT = 1.0, double RMIN = 1.0e-6, double RMAX = 1.0e6)

Constructor.

virtual void setup_df(double sigma)

Protected Attributes

double F
double q
double rmax
double rmin
double rot
double sig2
double vrot
class missing_argument_exception : public cxxopts::OptionParseException
#include <cxxopts.H>

Inheritence diagram for cxxopts::missing_argument_exception:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "2" [label="cxxopts::OptionParseException" tooltip="cxxopts::OptionParseException"]
    "1" [label="cxxopts::missing_argument_exception" tooltip="cxxopts::missing_argument_exception" fillcolor="#BFBFBF"]
    "4" [label="std::exception" tooltip="std::exception"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for cxxopts::missing_argument_exception:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "2" [label="cxxopts::OptionParseException" tooltip="cxxopts::OptionParseException"]
    "1" [label="cxxopts::missing_argument_exception" tooltip="cxxopts::missing_argument_exception" fillcolor="#BFBFBF"]
    "4" [label="std::exception" tooltip="std::exception"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline explicit missing_argument_exception(const std::string &option)
class MixtureBasis
#include <MixtureBasis.H>

Collaboration diagram for MixtureBasis:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "9" [label="Basis" tooltip="Basis"]
    "5" [label="Component" tooltip="Component"]
    "7" [label="EL3" tooltip="EL3"]
    "1" [label="MixtureBasis" tooltip="MixtureBasis" fillcolor="#BFBFBF"]
    "6" [label="Orient" tooltip="Orient"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "8" [label="Timer" tooltip="Timer"]
    "2" [label="TwoCenter" tooltip="TwoCenter"]
    "4" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "9" -> "3" [dir=forward tooltip="public-inheritance"]
    "5" -> "5" [dir=forward tooltip="usage"]
    "5" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="usage"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "5" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "9" [dir=forward tooltip="usage"]
    "2" -> "1" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
}

Public Functions

inline void getCenter(vector<double> &c)
inline double Mixture(double *pos)
inline MixtureBasis(TwoCenter &instance, vector<double> *c, string ID, mixFunc func)

Private Types

typedef double (TwoCenter::* mixFunc)(double *p)

Private Members

vector<double> *ctr
mixFunc f
string id
TwoCenter *p
class Miyamoto
#include <models.H>

Public Functions

Eigen::Vector3d force(Eigen::Vector3d&)
inline double get_a(void)
inline double get_b(void)
inline double get_M(void)
double potential(Eigen::Vector3d&)
inline void set_a(double aa)
inline void set_b(double bb)
inline void set_M(double m)
inline void set_Miyamoto(double ainit, double binit, double Ginit, double Minit)

Protected Attributes

double a
double b
double G
double GM
double M
class Miyamoto_Needle
#include <models.H>

Public Functions

double density(Eigen::Vector3d&)
Eigen::Vector3d force(Eigen::Vector3d&)
Vector force(Vector&)
inline double get_a(void)
inline double get_b(void)
inline double get_c(void)
inline double get_M(void)
double potential(Eigen::Vector3d&)
double potential(Vector&)
inline void set_a(double aa)
inline void set_b(double bb)
inline void set_c(double cc)
inline void set_M(double m)
inline void set_Miyamoto_Needle(double aa, double bb, double cc, double gg, double mm)
inline void set_Miyamoto_Needle(double aa, double bb, double cc, double gg, double mm)

Protected Attributes

double a
double b
double c
double G
double k
double kf
double M
class MNdisk : public EmpCylSL::AxiDisk
#include <DiskModels.H>

Inheritence diagram for MNdisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EmpCylSL::AxiDisk" tooltip="EmpCylSL::AxiDisk"]
    "1" [label="MNdisk" tooltip="MNdisk" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for MNdisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EmpCylSL::AxiDisk" tooltip="EmpCylSL::AxiDisk"]
    "1" [label="MNdisk" tooltip="MNdisk" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Miyamoto-Nagai disk.

Public Functions

inline MNdisk(double a, double h, double M = 1)
inline virtual double operator()(double R, double z, double phi = 0.)

Density function.

Private Members

double a
double h
class ModelCyl
#include <EmpCyl2d.H>

Inheritence diagram for EmpCyl2d::ModelCyl:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EmpCyl2d::ExponCyl" tooltip="EmpCyl2d::ExponCyl"]
    "3" [label="EmpCyl2d::KuzminCyl" tooltip="EmpCyl2d::KuzminCyl"]
    "4" [label="EmpCyl2d::MestelCyl" tooltip="EmpCyl2d::MestelCyl"]
    "1" [label="EmpCyl2d::ModelCyl" tooltip="EmpCyl2d::ModelCyl" fillcolor="#BFBFBF"]
    "5" [label="EmpCyl2d::ZangCyl" tooltip="EmpCyl2d::ZangCyl"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
    "5" -> "4" [dir=forward tooltip="public-inheritance"]
}

A two-dimensional disk model for computing the EOF.

Subclassed by EmpCyl2d::ExponCyl, EmpCyl2d::KuzminCyl, EmpCyl2d::MestelCyl

Public Functions

virtual double dens(double r) = 0
virtual double dpot(double r) = 0
inline virtual std::string ID()
virtual double pot(double r) = 0

Protected Functions

virtual void parse(const YAML::Node&) = 0

Protected Attributes

std::string id
class Modified_Hubble
#include <models.H>

Public Functions

Eigen::Vector3d force(Eigen::Vector3d&)
inline double get_Gravity(void)
inline double get_Ms(void)
inline double get_rs(void)
double potential(Eigen::Vector3d&)
inline void set_Gravity(double g)
inline void set_Modified_Hubble(double r, double m, double G)
inline void set_Ms(double m)
inline void set_rs(double r)

Protected Attributes

double Gravity
double Ms
double rs
class MonotCubicInterpolator

Represents one dimensional function f with single valued argument x that can be interpolated using monotone cubic interpolation.

Class to represent a one-dimensional function f with single-valued argument x. The function is represented by a table of function values. Interpolation between table values is cubic and monotonicity preserving if input values are monotonous.

Outside x_min and x_max, the class will extrapolate using the constant f(x_min) or f(x_max).

Extra functionality:

  • Can return (x_1+x_2)/2 where x_1 and x_2 are such that abs(f(x_1) - f(x_2)) is maximized. This is used to determine where one should calculate a new value for increased accuracy in the current function

Monotonicity preserving cubic interpolation algorithm is taken from Fritsch and Carlson, “Monotone piecewise cubic interpolation”, SIAM J. Numer. Anal. 17, 238&#8212;246, no. 2,

$Id$

Algorithm also described here: http://en.wikipedia.org/wiki/Monotone_cubic_interpolation

Author

Håvard Berland <havb (at) statoil.com>, December 2006, Updated for >=C++ 11 by M. Weinberg

Public Functions

void addPair(double newx, double newf)

Adds a new datapoint to the function.

This causes all the derivatives at all points of the functions to be recomputed and then adjusted for monotone cubic interpolation. If this function ever enters a critical part of any code, the locality of the algorithm for monotone adjustment must be exploited.

Parameters:
  • newx – New x point

  • newf – New f(x) point

inline void chopFlatEndpoints()

Wrapper function for chopFlatEndpoints(const double) providing a default epsilon parameter

void chopFlatEndpoints(const double)

Checks if the function curve is flat at the endpoints, chop off endpoint data points if that is the case.

The notion of “flat” is determined by the input parameter “epsilon” Values whose difference are less than epsilon are regarded as equal.

This is implemented to be able to obtain a strictly monotone curve from a data set that is strictly monotone except at the endpoints.

Example: The data points (1,3), (2,3), (3,4), (4,5), (5,5), (6,5) will become (2,3), (3,4), (4,5)

Assumes at least 3 datapoints. If less than three, this function is a noop.

double evaluate(double x) const

Returns f(x) for given x (input). Interpolates (monotone cubic or linearly) if necessary.

Extrapolates using the constants f(x_min) or f(x_max) if input x is outside (x_min, x_max)

Parameters:

x – x value

Returns:

f(x) for a given x

double evaluate(double x, double &errorestimate_output) const

Returns f(x) and an error estimate for given x (input).

Interpolates (linearly) if necessary.

Throws an exception if extrapolation would be necessary for evaluation. We do not want to do extrapolation (yet).

The error estimate for x1 < x < x2 is (x2 - x1)^2/8 * f’’(x) where f’’(x) is evaluated using the stencil (1 -2 1) using either (x0, x1, x2) or (x1, x2, x3);

Throws an exception if the table contains only two x-values.

NOT IMPLEMENTED YET!

Parameters:
  • x – x value

  • errorestimate_output

std::vector<double> get_fVector() const

Provide a copy of tghe function data as a vector

Unspecified order, but corresponds to get_xVector

Returns:

f values as a vector

std::vector<double> get_xVector() const

Provide a copy of the x-data as a vector

Unspecified order, but corresponds to get_fVector.

Returns:

x values as a vector

std::pair<double, double> getMaximumF() const

Maximum f-value, returns both x and f in a pair.

Returns:

x value corresponding to maximum f value

Returns:

maximum f value

inline std::pair<double, double> getMaximumX() const

Maximum x-value, returns both x and f in a pair.

Returns:

maximum x value

Returns:

f(maximum x value)

std::pair<double, double> getMinimumF() const

Minimum f-value, returns both x and f in a pair

Returns:

x value corresponding to minimal f value

Returns:

minimum f value

inline std::pair<double, double> getMinimumX() const

Minimum x-value, returns both x and f in a pair.

Returns:

minimum x value

Returns:

f(minimum x value)

std::pair<double, double> getMissingX() const

Returns an x-value that is believed to yield the best improvement in global accuracy for the interpolation if computed.

Searches for the largest jump in f-values, and returns a x value being the average of the two x-values representing the f-value-jump.

Returns:

New x value beleived to yield the best improvement in global accuracy

Returns:

Maximal difference

inline int getSize() const
Returns:

Number of datapoint pairs in this object

inline bool isMonotone() const

Determines if the current function-value-data is monotone.

Returns:

True if f(x) is monotone, else False

inline bool isMonotoneDecreasing() const

Determines if the current function-value-data is monotone and decreasing

Returns:

True if f(x) is monotone and decreasing, else False

inline bool isMonotoneIncreasing() const

Determines if the current function-value-data is monotone and increasing.

Returns:

True if f(x) is monotone and increasing, else False

inline bool isStrictlyDecreasing()

Determines if the current function-value-data is strictly decreasing. This is a utility function for outsiders if they want to invert the data for example.

Returns:

True if f(x) is strictly decreasing, else False

inline bool isStrictlyIncreasing()

Determines if the current function-value-data is strictly increasing. This is a utility function for outsiders if they want to invert the data for example.

Returns:

True if f(x) is strictly increasing, else False

inline bool isStrictlyMonotone()

Determines if the current function-value-data is strictly monotone. This is a utility function for outsiders if they want to invert the data for example.

Returns:

True if f(x) is strictly monotone, else False

inline MonotCubicInterpolator()

No input, an empty function object is created.

This object must be treated with care until populated.

inline MonotCubicInterpolator(const char *datafilename)

Accepts a filename as input and parses this file for two-column floating point data, interpreting the data as representing function values x and f(x).

Ignores all lines not conforming to <whitespace><float><whitespace><float><whatever><newline>

All commas in the file will be treated as spaces when parsing.

Parameters:

datafilename – A datafile with the x values and the corresponding f(x) values

inline MonotCubicInterpolator(const char *datafilename, int xColumn, int fColumn)

Accepts a filename as input, and parses the chosen columns in that file.

Parameters:
  • datafilename – data file

  • XColumn – x values

  • fColumn – f values

inline MonotCubicInterpolator(const std::string &datafilename)

Accepts a filename as input and parses this file for two-column floating point data, interpreting the data as representing function values x and f(x).

Ignores all lines not conforming to <whitespace><float><whitespace><float><whatever><newline>

Parameters:

datafilename – A datafile with the x values and the corresponding f(x) values

inline MonotCubicInterpolator(const std::string &datafilename, int xColumn, int fColumn)

Accepts a filename as input, and parses the chosen columns in that file.

Parameters:
  • datafilename – data file

  • XColumn – x values

  • fColumn – f values

MonotCubicInterpolator(const std::vector<double> &x, const std::vector<double> &f)

Accepts two equal-length vectors as input for constructing the interpolation object. First vector is the x-values, the second vector is the function values

Parameters:
  • x – vector of x values

  • f – vector of corresponding f values

inline double operator()(double x) const

Returns f(x) for given x (input). Interpolates (monotone cubic or linearly) if necessary.

Extrapolates using the constants f(x_min) or f(x_max) if input x is outside (x_min, x_max)

Parameters:

x – x value

Returns:

f(x) for a given x

inline bool read(const std::string &datafilename)

Accepts a filename as input and parses this file for two-column floating point data, interpreting the data as representing function values x and f(x).

returns true on success

All commas in file will be treated as spaces when parsing

Ignores all lines not conforming to <whitespace><float><whitespace><float><whatever><newline>

Parameters:

datafilename – A datafile with the x values and the corresponding f(x) values

bool read(const std::string &datafilename, int xColumn, int fColumn)

Accepts a filename as input, and parses the chosen columns in that file.

Parameters:
  • datafilename – data file

  • XColumn – x values

  • fColumn – f values

void scaleData(double factor)

Scale all the function value data by a constant

Parameters:

factor – Scaling constant

inline void shrinkFlatAreas()

Wrapper function for shrinkFlatAreas(const double) providing a default epsilon parameter

void shrinkFlatAreas(const double)

If function is monotone, but not strictly monotone, this function will remove datapoints from intervals with zero derivative so that the curve become strictly monotone.

Example The data points (1,2), (2,3), (3,4), (4,4), (5,5), (6,6) will become (1,2), (2,3), (3,4), (5,5), (6,6)

Assumes at least two datapoints, if one or zero datapoint, this is a noop.

std::string toString() const

Constructs a string containing the data in a table

Returns:

a string containing the data in a table

Private Functions

void adjustDerivativesForMonotoneness() const

Adjusts the derivative values (ddata) so that we can guarantee that the resulting piecewise Hermite polymial is monotone. This is done according to the algorithm of Fritsch and Carlsson 1980, see Section 4, especially the two last lines.

void computeInternalFunctionData() const
void computeSimpleDerivatives() const

Computes initial derivative values using centered (second order) difference for internal datapoints, and one-sided derivative for endpoints

The internal datastructure map<double,double> ddata is populated by this method.

inline double H00(double t) const
inline double H01(double t) const
inline double H10(double t) const
inline double H11(double t) const
inline bool isMonotoneCoeff(double alpha, double beta) const

Checks if the coefficient alpha and beta is in the region that guarantees monotoneness of the derivative values they represent

See Fritsch and Carlson 1980, Lemma 2, alternatively Step 5 in Wikipedia’s article on Monotone cubic interpolation.

Private Members

std::map<double, double> data
mutable std::map<double, double> ddata
mutable bool decreasing
mutable bool increasing
mutable bool monotone
mutable bool monotoneCached
mutable bool strictlyDecreasing
mutable bool strictlyIncreasing
mutable bool strictlyMonotone
mutable bool strictlyMonotoneCached
struct MstepArray : public std::vector<VectorD2ptr>
#include <EmpCylSL.H>

Inheritence diagram for EmpCylSL::MstepArray:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="EmpCylSL::MstepArray" tooltip="EmpCylSL::MstepArray" fillcolor="#BFBFBF"]
    "2" [label="std::vector< VectorD2ptr >" tooltip="std::vector< VectorD2ptr >"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for EmpCylSL::MstepArray:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="EmpCylSL::MstepArray" tooltip="EmpCylSL::MstepArray" fillcolor="#BFBFBF"]
    "2" [label="std::vector< VectorD2ptr >" tooltip="std::vector< VectorD2ptr >"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Some syntactic sugar for array of shared pointers: define an operator to the object of the shared pointer. That is, for:

MstepArray step(N);

One can use:

step(n)[j][k] = …

instead of

(*step[n])[j][k] = …

to access elements.

Public Functions

inline VectorD2 &operator()(int M)
struct NData
#include <PotAccel.H>

For timing data.

Public Members

string name
int node
int tid
class Needle
#include <models.H>

Public Functions

Eigen::Vector3d force(Eigen::Vector3d&)
Vector force(Vector&)
inline double get_a(void)
inline double get_b(void)
inline double get_M(void)
double potential(Eigen::Vector3d&)
double potential(Vector&)
inline void set_a(double aa)
inline void set_b(double bb)
inline void set_M(double m)
inline void set_Needle(double aa, double bb, double gg, double mm)
inline void set_Needle(double aa, double bb, double gg, double mm)

Protected Attributes

double a
double b
double G
double k
double kf
double M
struct node
#include <KDtree.H>

Collaboration diagram for KDtree::kdtree::node:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="KDtree::kdtree< coordinate_type, dimensions >::node" tooltip="KDtree::kdtree< coordinate_type, dimensions >::node"]
    "1" [label="KDtree::kdtree< coordinate_type, dimensions >::node" tooltip="KDtree::kdtree< coordinate_type, dimensions >::node" fillcolor="#BFBFBF"]
    "2" -> "2" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="usage"]
}

Public Functions

inline double distance(const point_type &pt) const
inline coordinate_type get(size_t index) const
inline node(const point_type &pt)

Public Members

node *left_
point_type point_
node *right_
struct node_cmp

Public Functions

inline node_cmp(size_t index)
inline bool operator()(const node &n1, const node &n2) const

Public Members

size_t index_
class NoForce : public PotAccel
#include <NoForce.H>

Inheritence diagram for NoForce:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="NoForce" tooltip="NoForce" fillcolor="#BFBFBF"]
    "2" [label="PotAccel" tooltip="PotAccel"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for NoForce:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="Component" tooltip="Component"]
    "6" [label="EL3" tooltip="EL3"]
    "1" [label="NoForce" tooltip="NoForce" fillcolor="#BFBFBF"]
    "5" [label="Orient" tooltip="Orient"]
    "2" [label="PotAccel" tooltip="PotAccel"]
    "7" [label="Timer" tooltip="Timer"]
    "3" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "4" -> "4" [dir=forward tooltip="usage"]
    "4" -> "2" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="usage"]
    "4" -> "7" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "2" -> "4" [dir=forward tooltip="usage"]
    "3" -> "2" [dir=forward tooltip="usage"]
}

A NULL force method

Applies no acceleration to the particles whatsoever. This allows the user to supply an alternative as an external force.

Public Functions

inline virtual void get_acceleration_and_potential(Component*)

The main force call.

NoForce(Component *c0, const YAML::Node &conf)

The constructor

Parameters:
  • c0 – is the instantiating caller (a Component)

  • conf – is ignored here

virtual ~NoForce()

The constructor.

Private Functions

inline void determine_acceleration_and_potential(void)
inline virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreading implementation of the force computation.

inline virtual void determine_coefficients(void)

Used by get_acceleration_and_potential to request that the expansion be performed.

inline virtual void *determine_coefficients_thread(void *arg)

Multithreading implementation of the expansion computation.

inline virtual void initialize()

Used by derived class to initialize any storage and parameters.

class nvTracer
#include <NVTX.H>

Public Functions

inline nvTracer(const char *name)
inline ~nvTracer()
class OneDBiorth : public Biorth
#include <biorth1d.H>

Inheritence diagram for OneDBiorth:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="Biorth" tooltip="Biorth"]
    "1" [label="OneDBiorth" tooltip="OneDBiorth" fillcolor="#BFBFBF"]
    "3" [label="OneDTrig" tooltip="OneDTrig"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OneDBiorth:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="Biorth" tooltip="Biorth"]
    "1" [label="OneDBiorth" tooltip="OneDBiorth" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

One-dimensional biorthgonal basis.

Subclassed by OneDTrig

Public Functions

virtual double d_r_to_rb(double const) = 0

Jacobian of mapping.

virtual double dens(const int, const int, const double) = 0

Get density basis value.

virtual void dens(const int, const int, const double, Eigen::VectorXd&) = 0

Write density basis into a vetor.

virtual double get_dens(double r, int l, Eigen::VectorXd &coef) = 0

Return value of density for given coefficient vector.

inline int get_dof(void)

Number of degrees of freedom.

virtual double get_potl(double r, int l, Eigen::VectorXd &coef) = 0

Return value of poential for given coefficient vector.

inline OneDBiorth(void)

Constructor.

virtual double potl(const int, const int, const double) = 0

Get potential basis value.

virtual void potl(const int, const int, const double, Eigen::VectorXd&) = 0

Write potential basis into a vetor.

virtual double r_to_rb(double const) = 0

Dimensional to non-dimensional coordinate map.

virtual double rb_max(void) = 0

Maximum value in non-dimensional mapping.

virtual double rb_min(void) = 0

Minimum value in non-dimensional mapping.

virtual double rb_to_r(double const) = 0

Non-dimensional to dimensional coordinate map.

inline void reset_kx(double KX)

Reset vertical wave number.

Public Members

double kx

Vertical wave number.

Private Members

int dof
class OneDModel : public MassModel
#include <massmodel1d.H>

Inheritence diagram for OneDModel:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="LowIso" tooltip="LowIso"]
    "2" [label="MassModel" tooltip="MassModel"]
    "1" [label="OneDModel" tooltip="OneDModel" fillcolor="#BFBFBF"]
    "3" [label="OneDModelTable" tooltip="OneDModelTable"]
    "6" [label="Sech2" tooltip="Sech2"]
    "5" [label="Sech2Halo" tooltip="Sech2Halo"]
    "7" [label="Sech2mu" tooltip="Sech2mu"]
    "4" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "6" -> "1" [dir=forward tooltip="public-inheritance"]
    "5" -> "3" [dir=forward tooltip="public-inheritance"]
    "7" -> "1" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OneDModel:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="MassModel" tooltip="MassModel"]
    "1" [label="OneDModel" tooltip="OneDModel" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Subclassed by OneDModelTable, Sech2, Sech2mu

Public Functions

virtual double dfde(const double, const double V = 0.0) = 0
virtual double dfdv(const double, const double V = 0.0) = 0
virtual double distf(const double, const double V = 0.0) = 0
inline virtual double get_density(const double x, const double y, const double z)

The density at (x, y, z)

virtual double get_density(const double) = 0
virtual double get_dpot(const double) = 0
virtual double get_dpot2(const double) = 0
inline virtual double get_mass(const double x, const double y, const double z)

Get the mass inside of position (x, y, z) (this is ambiguous in general and will depend on the model)

virtual double get_mass(const double) = 0
virtual double get_max_radius(void) = 0
virtual double get_min_radius(void) = 0
inline virtual double get_pot(const double x, const double y, const double z)

The potential at (x, y, z)

virtual double get_pot(const double) = 0
virtual tuple<double, double> get_pot_dpot(const double) = 0
virtual double get_scale_height(void) = 0

Public Members

bool dist_defined
class OneDModelTable : public OneDModel
#include <massmodel1d.H>

Inheritence diagram for OneDModelTable:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="LowIso" tooltip="LowIso"]
    "3" [label="MassModel" tooltip="MassModel"]
    "2" [label="OneDModel" tooltip="OneDModel"]
    "1" [label="OneDModelTable" tooltip="OneDModelTable" fillcolor="#BFBFBF"]
    "5" [label="Sech2Halo" tooltip="Sech2Halo"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "1" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OneDModelTable:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="Interp1d" tooltip="Interp1d"]
    "3" [label="MassModel" tooltip="MassModel"]
    "2" [label="OneDModel" tooltip="OneDModel"]
    "1" [label="OneDModelTable" tooltip="OneDModelTable" fillcolor="#BFBFBF"]
    "4" [label="Spline1d" tooltip="Spline1d"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "4" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="public-inheritance"]
}

Subclassed by LowIso, Sech2Halo

Public Functions

virtual double get_density(const double)
virtual double get_dpot(const double)
virtual double get_dpot2(const double)
virtual double get_mass(const double)
inline virtual double get_max_radius(void)
inline virtual double get_min_radius(void)
inline const int get_num_param(void)
inline const double get_param(int i)
virtual double get_pot(const double)
virtual tuple<double, double> get_pot_dpot(const double)
inline virtual double get_scale_height(void)
inline int grid_size(void)
inline OneDModelTable()
OneDModelTable(int num, double *r, double *d, double *m, double *p, string ID = "")
OneDModelTable(string filename, int PARM = 0)

Protected Attributes

Spline1d dens
int even
double half_height
Spline1d mass
int num
int numdf
std::vector<double> params
Spline1d pot
class OneDTrig : public OneDBiorth
#include <biorth1d.H>

Inheritence diagram for OneDTrig:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="Biorth" tooltip="Biorth"]
    "2" [label="OneDBiorth" tooltip="OneDBiorth"]
    "1" [label="OneDTrig" tooltip="OneDTrig" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OneDTrig:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="Biorth" tooltip="Biorth"]
    "2" [label="OneDBiorth" tooltip="OneDBiorth"]
    "1" [label="OneDTrig" tooltip="OneDTrig" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Basis based on trigonometric functions in vertical direction.

Public Functions

inline virtual double d_r_to_rb(double const x)

Jacobian for non-dimensional mapping.

virtual double dens(const int n, const int tmp, const double z)

Get density value for basis.

virtual void dens(const int n, const int tmp, const double z, Eigen::VectorXd &vec)

Return density basis in a vector.

double force(const int n, const int tmp, const double z)

Get force value for basis.

void force(const int n, const int tmp, const double z, Eigen::VectorXd &vec)

Return force basis in a vector.

virtual double get_dens(double r, int l, Eigen::VectorXd &coef)

Return density field for given coefficient vector.

double get_force(double r, int l, Eigen::VectorXd &coef)

Return force field for given coefficient vector.

virtual double get_potl(double r, int l, Eigen::VectorXd &coef)

Return potential field for given coefficient vector.

inline virtual double krnl(int n, int k = 0)

Kernel value.

inline virtual double norm(int n, int k = 0)

Norm value.

OneDTrig(double kx)

Constructor.

OneDTrig(double kx, double ZMAX)

Constructor.

OneDTrig(void)

Constructor.

virtual double potl(const int n, const int tmp, const double z)

Get potential value for basis.

virtual void potl(const int n, const int tmp, const double z, Eigen::VectorXd &vec)

Return potential basis in a vector.

inline virtual double r_to_rb(double const x)

Dimensional to non-dimensional mapping.

inline virtual double rb_max(void)

Maximum value in non-dimensional mapping.

inline virtual double rb_min(void)

Minimum value in non-dimensional mapping.

inline virtual double rb_to_r(double const x)

Non-dimensional to dimensional mapping.

void reset(double KX, double ZMAX)

Reset grid with new parameters.

Public Static Attributes

static double KSTOL

Enpoint offset for root finding (small)

static double KSZTOL

Root finding tolerance (small)

Private Functions

void compute_kstar(int n)
void compute_norm(void)

Private Members

Eigen::VectorXd cnorm
Eigen::VectorXd kbstar
Eigen::VectorXd kstar
int nrmax
double zmax
struct Option
#include <cxxopts.H>

Public Functions

inline Option(std::string opts, std::string desc, std::shared_ptr<const Value> value = ::cxxopts::value<bool>(), std::string arg_help = "")

Public Members

std::string arg_help_
std::string desc_
std::string opts_
std::shared_ptr<const Value> value_
class option_exists_error : public cxxopts::OptionSpecException
#include <cxxopts.H>

Inheritence diagram for cxxopts::option_exists_error:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "2" [label="cxxopts::OptionSpecException" tooltip="cxxopts::OptionSpecException"]
    "1" [label="cxxopts::option_exists_error" tooltip="cxxopts::option_exists_error" fillcolor="#BFBFBF"]
    "4" [label="std::exception" tooltip="std::exception"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for cxxopts::option_exists_error:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "2" [label="cxxopts::OptionSpecException" tooltip="cxxopts::OptionSpecException"]
    "1" [label="cxxopts::option_exists_error" tooltip="cxxopts::option_exists_error" fillcolor="#BFBFBF"]
    "4" [label="std::exception" tooltip="std::exception"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline explicit option_exists_error(const std::string &option)
class option_has_no_value_exception : public cxxopts::OptionException
#include <cxxopts.H>

Inheritence diagram for cxxopts::option_has_no_value_exception:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "1" [label="cxxopts::option_has_no_value_exception" tooltip="cxxopts::option_has_no_value_exception" fillcolor="#BFBFBF"]
    "3" [label="std::exception" tooltip="std::exception"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for cxxopts::option_has_no_value_exception:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "1" [label="cxxopts::option_has_no_value_exception" tooltip="cxxopts::option_has_no_value_exception" fillcolor="#BFBFBF"]
    "3" [label="std::exception" tooltip="std::exception"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline explicit option_has_no_value_exception(const std::string &option)
class option_not_exists_exception : public cxxopts::OptionParseException
#include <cxxopts.H>

Inheritence diagram for cxxopts::option_not_exists_exception:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "2" [label="cxxopts::OptionParseException" tooltip="cxxopts::OptionParseException"]
    "1" [label="cxxopts::option_not_exists_exception" tooltip="cxxopts::option_not_exists_exception" fillcolor="#BFBFBF"]
    "4" [label="std::exception" tooltip="std::exception"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for cxxopts::option_not_exists_exception:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "2" [label="cxxopts::OptionParseException" tooltip="cxxopts::OptionParseException"]
    "1" [label="cxxopts::option_not_exists_exception" tooltip="cxxopts::option_not_exists_exception" fillcolor="#BFBFBF"]
    "4" [label="std::exception" tooltip="std::exception"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline explicit option_not_exists_exception(const std::string &option)
class option_not_has_argument_exception : public cxxopts::OptionParseException
#include <cxxopts.H>

Inheritence diagram for cxxopts::option_not_has_argument_exception:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "2" [label="cxxopts::OptionParseException" tooltip="cxxopts::OptionParseException"]
    "1" [label="cxxopts::option_not_has_argument_exception" tooltip="cxxopts::option_not_has_argument_exception" fillcolor="#BFBFBF"]
    "4" [label="std::exception" tooltip="std::exception"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for cxxopts::option_not_has_argument_exception:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "2" [label="cxxopts::OptionParseException" tooltip="cxxopts::OptionParseException"]
    "1" [label="cxxopts::option_not_has_argument_exception" tooltip="cxxopts::option_not_has_argument_exception" fillcolor="#BFBFBF"]
    "4" [label="std::exception" tooltip="std::exception"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline option_not_has_argument_exception(const std::string &option, const std::string &arg)
class option_not_present_exception : public cxxopts::OptionParseException
#include <cxxopts.H>

Inheritence diagram for cxxopts::option_not_present_exception:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "2" [label="cxxopts::OptionParseException" tooltip="cxxopts::OptionParseException"]
    "1" [label="cxxopts::option_not_present_exception" tooltip="cxxopts::option_not_present_exception" fillcolor="#BFBFBF"]
    "4" [label="std::exception" tooltip="std::exception"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for cxxopts::option_not_present_exception:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "2" [label="cxxopts::OptionParseException" tooltip="cxxopts::OptionParseException"]
    "1" [label="cxxopts::option_not_present_exception" tooltip="cxxopts::option_not_present_exception" fillcolor="#BFBFBF"]
    "4" [label="std::exception" tooltip="std::exception"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline explicit option_not_present_exception(const std::string &option)
class option_required_exception : public cxxopts::OptionParseException
#include <cxxopts.H>

Inheritence diagram for cxxopts::option_required_exception:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "2" [label="cxxopts::OptionParseException" tooltip="cxxopts::OptionParseException"]
    "1" [label="cxxopts::option_required_exception" tooltip="cxxopts::option_required_exception" fillcolor="#BFBFBF"]
    "4" [label="std::exception" tooltip="std::exception"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for cxxopts::option_required_exception:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "2" [label="cxxopts::OptionParseException" tooltip="cxxopts::OptionParseException"]
    "1" [label="cxxopts::option_required_exception" tooltip="cxxopts::option_required_exception" fillcolor="#BFBFBF"]
    "4" [label="std::exception" tooltip="std::exception"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline explicit option_required_exception(const std::string &option)
class option_requires_argument_exception : public cxxopts::OptionParseException
#include <cxxopts.H>

Inheritence diagram for cxxopts::option_requires_argument_exception:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "2" [label="cxxopts::OptionParseException" tooltip="cxxopts::OptionParseException"]
    "1" [label="cxxopts::option_requires_argument_exception" tooltip="cxxopts::option_requires_argument_exception" fillcolor="#BFBFBF"]
    "4" [label="std::exception" tooltip="std::exception"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for cxxopts::option_requires_argument_exception:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "2" [label="cxxopts::OptionParseException" tooltip="cxxopts::OptionParseException"]
    "1" [label="cxxopts::option_requires_argument_exception" tooltip="cxxopts::option_requires_argument_exception" fillcolor="#BFBFBF"]
    "4" [label="std::exception" tooltip="std::exception"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline explicit option_requires_argument_exception(const std::string &option)
class option_syntax_exception : public cxxopts::OptionParseException
#include <cxxopts.H>

Inheritence diagram for cxxopts::option_syntax_exception:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "2" [label="cxxopts::OptionParseException" tooltip="cxxopts::OptionParseException"]
    "1" [label="cxxopts::option_syntax_exception" tooltip="cxxopts::option_syntax_exception" fillcolor="#BFBFBF"]
    "4" [label="std::exception" tooltip="std::exception"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for cxxopts::option_syntax_exception:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "2" [label="cxxopts::OptionParseException" tooltip="cxxopts::OptionParseException"]
    "1" [label="cxxopts::option_syntax_exception" tooltip="cxxopts::option_syntax_exception" fillcolor="#BFBFBF"]
    "4" [label="std::exception" tooltip="std::exception"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline explicit option_syntax_exception(const std::string &text)
class OptionAdder
#include <cxxopts.H>

Collaboration diagram for cxxopts::OptionAdder:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="cxxopts::OptionAdder" tooltip="cxxopts::OptionAdder" fillcolor="#BFBFBF"]
    "2" [label="cxxopts::Options" tooltip="cxxopts::Options"]
    "1" -> "2" [dir=forward tooltip="usage"]
}

Public Functions

inline OptionAdder &operator()(const std::string &opts, const std::string &desc, const std::shared_ptr<const Value> &value = ::cxxopts::value<bool>(), std::string arg_help = "")
inline OptionAdder(Options &options, std::string group)

Private Members

std::string m_group
Options &m_options
class OptionDetails
#include <cxxopts.H>

Public Functions

inline CXXOPTS_NODISCARD const String & description () const
inline size_t hash() const
inline CXXOPTS_NODISCARD const std::string & long_name () const
inline CXXOPTS_NODISCARD std::shared_ptr< Value > make_storage () const
inline OptionDetails(const OptionDetails &rhs)
OptionDetails(OptionDetails &&rhs) = default
inline OptionDetails(std::string short_, std::string long_, String desc, std::shared_ptr<const Value> val)
inline CXXOPTS_NODISCARD const std::string & short_name () const
inline CXXOPTS_NODISCARD const Value & value () const

Private Members

int m_count
String m_desc = {}
size_t m_hash = {}
std::string m_long = {}
std::string m_short = {}
std::shared_ptr<const Value> m_value = {}
class OptionException : public std::exception
#include <cxxopts.H>

Inheritence diagram for cxxopts::OptionException:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException" fillcolor="#BFBFBF"]
    "3" [label="cxxopts::OptionParseException" tooltip="cxxopts::OptionParseException"]
    "12" [label="cxxopts::OptionSpecException" tooltip="cxxopts::OptionSpecException"]
    "4" [label="cxxopts::argument_incorrect_type" tooltip="cxxopts::argument_incorrect_type"]
    "13" [label="cxxopts::invalid_option_format_error" tooltip="cxxopts::invalid_option_format_error"]
    "5" [label="cxxopts::missing_argument_exception" tooltip="cxxopts::missing_argument_exception"]
    "14" [label="cxxopts::option_exists_error" tooltip="cxxopts::option_exists_error"]
    "15" [label="cxxopts::option_has_no_value_exception" tooltip="cxxopts::option_has_no_value_exception"]
    "6" [label="cxxopts::option_not_exists_exception" tooltip="cxxopts::option_not_exists_exception"]
    "7" [label="cxxopts::option_not_has_argument_exception" tooltip="cxxopts::option_not_has_argument_exception"]
    "8" [label="cxxopts::option_not_present_exception" tooltip="cxxopts::option_not_present_exception"]
    "9" [label="cxxopts::option_required_exception" tooltip="cxxopts::option_required_exception"]
    "10" [label="cxxopts::option_requires_argument_exception" tooltip="cxxopts::option_requires_argument_exception"]
    "11" [label="cxxopts::option_syntax_exception" tooltip="cxxopts::option_syntax_exception"]
    "2" [label="std::exception" tooltip="std::exception"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "12" -> "1" [dir=forward tooltip="public-inheritance"]
    "4" -> "3" [dir=forward tooltip="public-inheritance"]
    "13" -> "12" [dir=forward tooltip="public-inheritance"]
    "5" -> "3" [dir=forward tooltip="public-inheritance"]
    "14" -> "12" [dir=forward tooltip="public-inheritance"]
    "15" -> "1" [dir=forward tooltip="public-inheritance"]
    "6" -> "3" [dir=forward tooltip="public-inheritance"]
    "7" -> "3" [dir=forward tooltip="public-inheritance"]
    "8" -> "3" [dir=forward tooltip="public-inheritance"]
    "9" -> "3" [dir=forward tooltip="public-inheritance"]
    "10" -> "3" [dir=forward tooltip="public-inheritance"]
    "11" -> "3" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for cxxopts::OptionException:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException" fillcolor="#BFBFBF"]
    "2" [label="std::exception" tooltip="std::exception"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Subclassed by cxxopts::OptionParseException, cxxopts::OptionSpecException, cxxopts::option_has_no_value_exception

Public Functions

inline explicit OptionException(std::string message)
inline CXXOPTS_NODISCARD const char * what () const noexcept override

Private Members

std::string m_message
class OptionParseException : public cxxopts::OptionException
#include <cxxopts.H>

Inheritence diagram for cxxopts::OptionParseException:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "1" [label="cxxopts::OptionParseException" tooltip="cxxopts::OptionParseException" fillcolor="#BFBFBF"]
    "4" [label="cxxopts::argument_incorrect_type" tooltip="cxxopts::argument_incorrect_type"]
    "5" [label="cxxopts::missing_argument_exception" tooltip="cxxopts::missing_argument_exception"]
    "6" [label="cxxopts::option_not_exists_exception" tooltip="cxxopts::option_not_exists_exception"]
    "7" [label="cxxopts::option_not_has_argument_exception" tooltip="cxxopts::option_not_has_argument_exception"]
    "8" [label="cxxopts::option_not_present_exception" tooltip="cxxopts::option_not_present_exception"]
    "9" [label="cxxopts::option_required_exception" tooltip="cxxopts::option_required_exception"]
    "10" [label="cxxopts::option_requires_argument_exception" tooltip="cxxopts::option_requires_argument_exception"]
    "11" [label="cxxopts::option_syntax_exception" tooltip="cxxopts::option_syntax_exception"]
    "3" [label="std::exception" tooltip="std::exception"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
    "5" -> "1" [dir=forward tooltip="public-inheritance"]
    "6" -> "1" [dir=forward tooltip="public-inheritance"]
    "7" -> "1" [dir=forward tooltip="public-inheritance"]
    "8" -> "1" [dir=forward tooltip="public-inheritance"]
    "9" -> "1" [dir=forward tooltip="public-inheritance"]
    "10" -> "1" [dir=forward tooltip="public-inheritance"]
    "11" -> "1" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for cxxopts::OptionParseException:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "1" [label="cxxopts::OptionParseException" tooltip="cxxopts::OptionParseException" fillcolor="#BFBFBF"]
    "3" [label="std::exception" tooltip="std::exception"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Subclassed by cxxopts::argument_incorrect_type, cxxopts::missing_argument_exception, cxxopts::option_not_exists_exception, cxxopts::option_not_has_argument_exception, cxxopts::option_not_present_exception, cxxopts::option_required_exception, cxxopts::option_requires_argument_exception, cxxopts::option_syntax_exception

Public Functions

inline explicit OptionParseException(const std::string &message)
class OptionParser
#include <cxxopts.H>

Public Functions

inline void add_to_option(OptionMap::const_iterator iter, const std::string &option, const std::string &arg)
inline void checked_parse_arg(int argc, const char *const *argv, int &current, const std::shared_ptr<OptionDetails> &value, const std::string &name)
inline bool consume_positional(const std::string &a, PositionalListIterator &next)
inline OptionParser(const OptionMap &options, const PositionalList &positional, bool allow_unrecognised)
inline ParseResult parse(int argc, const char *const *argv)
inline void parse_default(const std::shared_ptr<OptionDetails> &details)
inline void parse_no_value(const std::shared_ptr<OptionDetails> &details)
inline void parse_option(const std::shared_ptr<OptionDetails> &value, const std::string &name, const std::string &arg = "")

Private Functions

inline void finalise_aliases()

Private Members

bool m_allow_unrecognised
std::vector<KeyValue> m_defaults = {}
NameHashMap m_keys = {}
const OptionMap &m_options
ParsedHashMap m_parsed = {}
const PositionalList &m_positional
std::vector<KeyValue> m_sequential = {}
class Options
#include <cxxopts.H>

Public Functions

inline void add_option(const std::string &group, const Option &option)
inline void add_option(const std::string &group, const std::string &s, const std::string &l, std::string desc, const std::shared_ptr<const Value> &value, std::string arg_help)
inline void add_options(const std::string &group, std::initializer_list<Option> options)
inline OptionAdder add_options(std::string group = "")
inline Options &allow_unrecognised_options()
inline Options &custom_help(std::string help_text)
inline const HelpGroupDetails &group_help(const std::string &group) const
inline std::vector<std::string> groups() const
inline std::string help(const std::vector<std::string> &groups = {}) const
inline explicit Options(std::string program, std::string help_string = "")
inline ParseResult parse(int argc, const char *const *argv)
template<typename Iterator>
inline void parse_positional(Iterator begin, Iterator end)
inline void parse_positional(std::initializer_list<std::string> options)
inline void parse_positional(std::string option)
inline void parse_positional(std::vector<std::string> options)
inline Options &positional_help(std::string help_text)
inline Options &set_tab_expansion(bool expansion = true)
inline Options &set_width(size_t width)
inline Options &show_positional_help()

Private Functions

inline void add_one_option(const std::string &option, const std::shared_ptr<OptionDetails> &details)
inline void generate_all_groups_help(String &result) const
inline void generate_group_help(String &result, const std::vector<std::string> &groups) const
inline String help_one_group(const std::string &group) const

Private Members

bool m_allow_unrecognised
std::string m_custom_help = {}
std::map<std::string, HelpGroupDetails> m_help = {}
String m_help_string = {}
std::list<OptionDetails> m_option_list = {}
std::unordered_map< std::string, decltype(m_option_list)::iterator > m_option_map   = {}
std::shared_ptr<OptionMap> m_options
std::vector<std::string> m_positional = {}
std::string m_positional_help = {}
std::unordered_set<std::string> m_positional_set = {}
std::string m_program = {}
bool m_show_positional
bool m_tab_expansion
size_t m_width
class OptionSpecException : public cxxopts::OptionException
#include <cxxopts.H>

Inheritence diagram for cxxopts::OptionSpecException:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "1" [label="cxxopts::OptionSpecException" tooltip="cxxopts::OptionSpecException" fillcolor="#BFBFBF"]
    "4" [label="cxxopts::invalid_option_format_error" tooltip="cxxopts::invalid_option_format_error"]
    "5" [label="cxxopts::option_exists_error" tooltip="cxxopts::option_exists_error"]
    "3" [label="std::exception" tooltip="std::exception"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
    "5" -> "1" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for cxxopts::OptionSpecException:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="cxxopts::OptionException" tooltip="cxxopts::OptionException"]
    "1" [label="cxxopts::OptionSpecException" tooltip="cxxopts::OptionSpecException" fillcolor="#BFBFBF"]
    "3" [label="std::exception" tooltip="std::exception"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Subclassed by cxxopts::invalid_option_format_error, cxxopts::option_exists_error

Public Functions

inline explicit OptionSpecException(const std::string &message)
class OptionValue
#include <cxxopts.H>

Public Functions

template<typename T>
inline const T &as() const
inline CXXOPTS_NODISCARD size_t count () const noexcept
inline CXXOPTS_NODISCARD bool has_default () const noexcept
inline void parse(const std::shared_ptr<const OptionDetails> &details, const std::string &text)
inline void parse_default(const std::shared_ptr<const OptionDetails> &details)
inline void parse_no_value(const std::shared_ptr<const OptionDetails> &details)

Private Functions

inline void ensure_value(const std::shared_ptr<const OptionDetails> &details)

Private Members

size_t m_count = 0
bool m_default = false
const std::string *m_long_name = nullptr
std::shared_ptr<Value> m_value = {}
class OrbTrace : public Output
#include <OrbTrace.H>

Inheritence diagram for OrbTrace:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OrbTrace" tooltip="OrbTrace" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OrbTrace:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="Component" tooltip="Component"]
    "8" [label="EL3" tooltip="EL3"]
    "1" [label="OrbTrace" tooltip="OrbTrace" fillcolor="#BFBFBF"]
    "7" [label="Orient" tooltip="Orient"]
    "2" [label="Output" tooltip="Output"]
    "5" [label="PotAccel" tooltip="PotAccel"]
    "3" [label="Timer" tooltip="Timer"]
    "6" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "4" -> "4" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="usage"]
    "4" -> "7" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "4" [dir=forward tooltip="usage"]
    "7" -> "8" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "4" [dir=forward tooltip="usage"]
    "6" -> "5" [dir=forward tooltip="usage"]
}

Log norb orbits at each interval

For best efficiency, particles to be traced should be on the root process.

Param norb:

is the number of orbits per node to follow

Param nbeg:

is the offset in the bodies list for the first particle to trace.

Param nskip:

is the interval between orbits beginning with nskip. If nskip is unspecified, nskip=nbodies/norb.

Param nint:

is the frequency between file updates

Param use_acc:

to output the acceleration

Param use_pot:

to output the potential

Param use_lev:

to output the multistep level

Param orbitlist:

is the list of particle numbers to trace

Param name:

of the component to trace

Public Functions

OrbTrace(const YAML::Node &conf)

Constructor.

virtual void Run(int nstep, int mstep, bool last)

Generate the output.

Parameters:
  • nstep – is the current time step used to decide whether or not to dump

  • mstep – is the current multistep level to decide whether or not to dump multisteps

  • last – should be true on final step to force phase space dump indepentently of whether or not the frequency criterion is met

Private Functions

virtual void initialize(void)

Used to assign additional specific parameters, create storage, etc.

Private Members

std::string filename
int flags
bool local
int nbeg
int nbuf
int norb
int nskip
std::string orbitlist
std::vector<int> orblist
std::vector<double> pbuf
double prev = -std::numeric_limits<double>::max()

Last output time.

Component *tcomp
bool use_acc
bool use_lev
bool use_pot

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

struct OrbValues
#include <FindOrb.H>

Public Members

double apo
double azimuthal_period
double Boltzmann
double energy
double kappa
double peri
double radial_period
double rate
double t0
double tf
double value
class Orient
#include <Orient.H>

Collaboration diagram for Orient:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EL3" tooltip="EL3"]
    "1" [label="Orient" tooltip="Orient" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="usage"]
}

Class to keep track of orientation

Log file contents:

  1. Time

  2. Energy

  3. Particles used

  4. Current Axis(x) from regression

  5. Current Axis(y)

  6. Current Axis(z)

  7. Last Axis(x) from particles

  8. Last Axis(y)

  9. Last Axis(z)

  10. Current Center(x) from regression

  11. Current Center(y)

  12. Current Center(z)

  13. Current Center(x) from analytic approx

  14. Current Center(y)

  15. Current Center(z)

  16. Last Center(x) from particles

  17. Last Center(y)

  18. Last Center(z)

  19. COM(x)

  20. COM(y)

  21. COM(z)

  22. System COM(x)

  23. System COM(y)

  24. System COM(z)

Public Types

enum ControlFlags

Mask flags for Orient behavior.

Values:

enumerator DIAG
enumerator KE
enumerator EXTERNAL
enum OrientFlags

Mask flags for Orient type.

Values:

enumerator AXIS
enumerator CENTER

Public Functions

void accumulate(double time, Component *c)

Register phase space of num particles and store angular momentum vector for the lowest many binding energies.

inline const std::tuple<Eigen::Vector3d&, Eigen::Vector3d&, Eigen::Vector3d&> currentAccel(void)

Return current pseudo force, angular velocity, and angular velocity derivative

inline Eigen::Vector3d &currentAxis(void)

Return current axis.

inline double currentAxisVar(void)

Return variance of axis determination (linear least squares solution)

inline Eigen::Vector3d &currentCenter(void)

Return current center.

inline double currentCenterVar(void)

Return variance for center determination (linear least squares solution)

inline double currentCenterVarZ(void)

Return variance for center determination for z component alone.

inline double currentE(void)

Return energy for disk ang mom.

inline int currentUsed(void)

Return number of particles used.

void logEntry(double time, Component *c)

Write log entry.

Orient(int number_to_keep, int target, int Naccel, unsigned orient_flags, unsigned control_flags, string logfile, double dt = 0.0, double damping = 1.0)

Constructor.

inline void set_center(double x, double y, double z)

Set initial center (zero by default)

inline void set_cenvel(double u, double v, double w)

Set initial center velocity (zero by default)

inline void set_linear()

Set center to move at constant velocity.

inline Eigen::Matrix3d &transformBody(void)

Return transformation to new body axes.

inline Eigen::Matrix3d &transformOrig(void)

Return transformation to original coordinates.

~Orient()

Destructor.

Private Types

typedef pair<double, Eigen::VectorXd> DV

Private Functions

void accumulate_cpu(double time, Component *c)

Private Members

std::shared_ptr<PseudoAccel> accel
set<EL3, ltEL3> angm
Eigen::Vector3d axis
Eigen::Vector3d axis1
Eigen::Matrix3d body
Eigen::Vector3d center
Eigen::Vector3d center0
Eigen::Vector3d center1
Eigen::Vector3d cenvel0
unsigned int cflags
int current
double damp
double deltaT
Eigen::Vector3d domdt = Eigen::Vector3d::Zero()
double Ecurr
double Elast
Eigen::Vector3d intercept
int keep
double lasttime
bool linear
string logfile
int many
int Nlast
unsigned int oflags
Eigen::Vector3d omega = Eigen::Vector3d::Zero()
Eigen::Matrix3d orig
std::vector<double> pos
std::vector<double> psa
Eigen::Vector3d pseudo = Eigen::Vector3d::Zero()
double sigA
double sigC
double sigCz
Eigen::Vector3d slope
deque<DV> sumsA
deque<DV> sumsC
double sumX
double sumX2
Eigen::Vector3d sumXY
Eigen::Vector3d sumY
Eigen::Vector3d sumY2
EL3 t
int used
std::vector<double> vel
class OrthoFunction
#include <OrthoFunction.H>

Compute orthogonal functions whose lowest-order member is the background density using the Stieltjes procedure for generating 3-term recursion

Public Types

using DensFunc = std::function<double(double)>

Public Functions

void dumpOrtho(const std::string &filename)

Dump the orthogonal function table

Parameters:

filename – Filename for output

Eigen::VectorXd operator()(double r)

Evaluate orthogonal functions at r

Parameters:

r – Radial coordinate

Returns:

A vector of the orthogonal functions

OrthoFunction(int norder, DensFunc W, double rmin, double rmax, double scale, int dof)

Constructor

Parameters:
  • norder – Order of the orthogonal polynomial

  • W – Density weight function

  • rmin – Inner radial bound

  • rmax – Outer radial bound

  • scale – Mapping scale

  • dof – Degrees of freedom (2 or 3)

inline void setKnots(int N)

Reset Legendre knots and weights for inner product

Parameters:

N – Number of Legendre knots

Eigen::MatrixXd testOrtho()

Test orthogonality.

inline virtual ~OrthoFunction()

Destructor.

Private Functions

inline double d_r_to_x(double x)
void generate()

Generate the recursion for the orthogonal polynomials.

Eigen::VectorXd poly_eval(double t, int n)

Polynomial evaluation at t for orders j=0,…,n.

inline double r_to_x(double r)

Coordinate scaling.

double scalar_prod(int n, int m)

Inner product polynomial of order n with moment m.

inline double x_to_r(double x)

Private Members

Eigen::VectorXd alph

Recursion coefficients and norm.

Eigen::VectorXd beta
int dof

Degrees of freedom.

double dx
int knots = 400

Legendre knots.

std::shared_ptr<LegeQuad> lq

Gaussian quadrature.

int nmax

Polynomial order.

Eigen::VectorXd norm
double rmax
double rmin

Radial boundaries.

double scale

Mapping scale.

DensFunc W

Sqrt root weight function.

double xmax
double xmin

Mapped radial boundaries and range.

class OrthoPoly
#include <OrthoPoly.H>

Inheritence diagram for OrthoPoly:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="Cheb1" tooltip="Cheb1"]
    "3" [label="Cheb2" tooltip="Cheb2"]
    "4" [label="GenLagu" tooltip="GenLagu"]
    "5" [label="Hermite" tooltip="Hermite"]
    "6" [label="Legendre" tooltip="Legendre"]
    "1" [label="OrthoPoly" tooltip="OrthoPoly" fillcolor="#BFBFBF"]
    "7" [label="PVQuad" tooltip="PVQuad"]
    "8" [label="Ultra" tooltip="Ultra"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
    "5" -> "1" [dir=forward tooltip="public-inheritance"]
    "6" -> "1" [dir=forward tooltip="public-inheritance"]
    "7" -> "6" [dir=forward tooltip="public-inheritance"]
    "8" -> "1" [dir=forward tooltip="public-inheritance"]
}

Subclassed by Cheb1, Cheb2, GenLagu, Hermite, Legendre, Ultra

Public Functions

virtual double coef1(const int n) = 0
virtual double coef2(const int n) = 0
virtual double coef3(const int n) = 0
virtual double coef4(const int n) = 0
double f(const double x, const int n)
virtual double f0(const double x) = 0
virtual double f1(const double x) = 0
Eigen::VectorXd fv(const double x, const int n)
inline double get_a(void)
inline double get_b(void)
virtual double h(const int n) = 0
virtual double w(const double x) = 0

Protected Attributes

double a
double b
double *param

Private Members

double coefs[4]
class OutAscii : public Output
#include <OutAscii.H>

Inheritence diagram for OutAscii:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutAscii" tooltip="OutAscii" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OutAscii:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="Component" tooltip="Component"]
    "8" [label="EL3" tooltip="EL3"]
    "7" [label="Orient" tooltip="Orient"]
    "1" [label="OutAscii" tooltip="OutAscii" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "5" [label="PotAccel" tooltip="PotAccel"]
    "3" [label="Timer" tooltip="Timer"]
    "6" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "4" -> "4" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="usage"]
    "4" -> "7" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
    "7" -> "8" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "4" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "4" [dir=forward tooltip="usage"]
    "6" -> "5" [dir=forward tooltip="usage"]
}

Write phase-space dumps for a single component at regular intervals in ascii format. Each line contains: mass, pos[3], vel[3], acc[3], pot, potext, ival[niattr], dval[ndattr]

Each dump is written into a new file label as filename.n where is begins at nbeg and incremented by 1 after each file is written.

Param filename:

is the name of the output file

Param nint:

is the number of steps between dumps

Param nintsub:

is the substep number to perform outputs

Param nbeg:

is suffix of the first phase space dump

Param name:

of the desired component

Param accel:

set to 1 means print out accelerations

Public Functions

OutAscii(const YAML::Node &conf)

Constructor.

virtual void Run(int nstep, int mstep, bool last)

Provided by derived class to generate some output.

Parameters:
  • nstep – is the current time step used to decide whether or not to dump

  • last – should be true on final step to force phase space dump indepentently of whether or not the frequency criterion is met

Private Functions

virtual void initialize(void)

Used to assign additional specific parameters, create storage, etc.

Private Members

bool accel
Component *c0
std::string filename
std::string name
int nbeg
double prev = -std::numeric_limits<double>::max()

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class OutCalbr : public Output
#include <OutCalbr.H>

Inheritence diagram for OutCalbr:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutCalbr" tooltip="OutCalbr" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OutCalbr:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="Component" tooltip="Component"]
    "8" [label="EL3" tooltip="EL3"]
    "7" [label="Orient" tooltip="Orient"]
    "1" [label="OutCalbr" tooltip="OutCalbr" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "5" [label="PotAccel" tooltip="PotAccel"]
    "3" [label="Timer" tooltip="Timer"]
    "6" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "4" -> "4" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="usage"]
    "4" -> "7" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
    "7" -> "8" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "4" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "4" [dir=forward tooltip="usage"]
    "6" -> "5" [dir=forward tooltip="usage"]
}

Compute changes in energy and angular momentum per orbit and provide rms changes as a function of energy

The routine assumes that the input file is defined with four double attributes to hold the energy and angular momentum vector.

Param filename:

of the output file

Param name:

of the component to dump

Param nint:

is the frequency between file updates

Param N:

are the number of energy bins

Public Functions

OutCalbr(const YAML::Node &conf)

Constructor.

virtual void Run(int nstep, int mstep, bool last)

Generate the output.

Parameters:
  • nstep – is the current time step used to decide whether or not to dump

  • last – should be true on final step to force phase space dump indepentently of whether or not the frequency criterion is met

Private Functions

virtual void initialize(void)

Used to assign additional specific parameters, create storage, etc.

void set_energies(void)

Private Members

double dE
std::vector<double> deltaE
std::vector<double> deltaE1
std::vector<double> deltaLx
std::vector<double> deltaLx1
std::vector<double> deltaLy
std::vector<double> deltaLy1
std::vector<double> deltaLz
std::vector<double> deltaLz1
std::vector<double> Ec
double Emax
double Emin
std::string filename
std::vector<unsigned> ncnt
std::vector<unsigned> ncnt1
int num
double prev = -std::numeric_limits<double>::max()
Component *tcomp

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class OutCHKPT : public Output
#include <OutCHKPT.H>

Inheritence diagram for OutCHKPT:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutCHKPT" tooltip="OutCHKPT" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OutCHKPT:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutCHKPT" tooltip="OutCHKPT" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "3" [label="Timer" tooltip="Timer"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="usage"]
}

Writes a checkpoint file at regular intervals

Previously written checkpoint file will be rename to <filename>.bak

Sending the root process a SIGHUP will cause the first of OutPS, OutPSP, OutPSN, OutPSQ, or OutCHKPT in the Output list to execute. This may not always be possible to signal for batch scheduled jobs.

Param filename:

is the name of the output file

Param nint:

is the number of steps between dumps

Param mpio:

set to true uses MPI-IO output with arbitrarily sequenced particles

Param nagg:

is the number of MPI-IO aggregators

Public Functions

OutCHKPT(const YAML::Node &conf)

Constructor.

virtual void Run(int nstep, int mstep, bool last)

Provided by derived class to generate some output.

Parameters:
  • nstep – is the current time step used to decide whether or not to dump

  • last – should be true on final step to force phase space dump indepentently of whether or not the frequency criterion is met

Private Functions

virtual void initialize(void)

Used to assign additional specific parameters, create storage, etc.

Private Members

std::string filename
bool mpio
std::string nagg
bool timer

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class OutCHKPTQ : public Output
#include <OutCHKPTQ.H>

Inheritence diagram for OutCHKPTQ:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutCHKPTQ" tooltip="OutCHKPTQ" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OutCHKPTQ:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutCHKPTQ" tooltip="OutCHKPTQ" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "3" [label="Timer" tooltip="Timer"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="usage"]
}

Writes a checkpoint file at regular intervals from each node in component pieces. These pieces may be reassembled from the info in an “instruction” file.

Previously written checkpoint file will be rename to <filename>.bak

Sending the root process a SIGHUP will cause the first of OutPS, OutPSP, OutPSN, OutPSQ, OutCHKPT, or OutCHKPTQ in the Output list to execute. This may not always be possible to signal for batch scheduled jobs.

Param filename:

is the name of the output file

Param nint:

is the number of steps between dumps

Param mpio:

set to true uses MPI-IO output with arbitrarily sequenced particles

Param nagg:

is the number of MPI-IO aggregators

Public Functions

OutCHKPTQ(const YAML::Node &conf)

Constructor.

virtual void Run(int nstep, int mstep, bool last)

Provided by derived class to generate some output.

Parameters:
  • nstep – is the current time step used to decide whether or not to dump

  • last – should be true on final step to force phase space dump indepentently of whether or not the frequency criterion is met

Private Functions

virtual void initialize(void)

Used to assign additional specific parameters, create storage, etc.

Private Members

std::string filename
bool mpio
std::string nagg
bool timer

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class OutCoef : public Output
#include <OutCoef.H>

Inheritence diagram for OutCoef:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutCoef" tooltip="OutCoef" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OutCoef:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="Component" tooltip="Component"]
    "8" [label="EL3" tooltip="EL3"]
    "7" [label="Orient" tooltip="Orient"]
    "1" [label="OutCoef" tooltip="OutCoef" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "5" [label="PotAccel" tooltip="PotAccel"]
    "3" [label="Timer" tooltip="Timer"]
    "6" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "4" -> "4" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="usage"]
    "4" -> "7" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
    "7" -> "8" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "4" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "4" [dir=forward tooltip="usage"]
    "6" -> "5" [dir=forward tooltip="usage"]
}

Dump coefficients at each interval

Param filename:

of the coefficient file

Param name:

of the component to dump

Param nint:

is the frequency between file updates

Param native:

set to true uses old-style native coefficient format

Public Functions

OutCoef(const YAML::Node &conf)

Constructor.

virtual void Run(int nstep, int mstep, bool last)

Generate the output.

Parameters:
  • nstep – is the current time step used to decide whether or not to dump

  • last – should be true on final step to force phase space dump indepentently of whether or not the frequency criterion is met

Private Functions

virtual void initialize(void)

Used to assign additional specific parameters, create storage, etc.

Private Members

std::string filename
bool native
double prev = -std::numeric_limits<double>::max()
Component *tcomp

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class OutDiag : public Output
#include <OutDiag.H>

Inheritence diagram for OutDiag:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutDiag" tooltip="OutDiag" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OutDiag:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutDiag" tooltip="OutDiag" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "3" [label="Timer" tooltip="Timer"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="usage"]
}

Print field quantities for spherical and cylindrical bases.

Public Functions

OutDiag(const YAML::Node &conf)

Constructor.

virtual void Run(int nstep, int mstep, bool last)

Generate the output.

Parameters:
  • nstep – is the current time step used to decide whether or not to dump

  • last – should be true on final step to force phase space dump indepentently of whether or not the frequency criterion is met

Private Functions

void header(ostream &out)
virtual void initialize(void)

Used to assign additional specific parameters, create storage, etc.

Private Members

std::string filename
std::list<Component*> lcomp
std::vector<std::string> names
int NUM
double PHI
double prev = -std::numeric_limits<double>::max()
double RMAX
double RMIN
double THETA

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class OutFrac : public Output
#include <OutFrac.H>

Inheritence diagram for OutFrac:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutFrac" tooltip="OutFrac" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OutFrac:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="Component" tooltip="Component"]
    "8" [label="EL3" tooltip="EL3"]
    "7" [label="Orient" tooltip="Orient"]
    "1" [label="OutFrac" tooltip="OutFrac" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "5" [label="PotAccel" tooltip="PotAccel"]
    "3" [label="Timer" tooltip="Timer"]
    "6" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "4" -> "4" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="usage"]
    "4" -> "7" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
    "7" -> "8" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "4" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "4" [dir=forward tooltip="usage"]
    "6" -> "5" [dir=forward tooltip="usage"]
}

Dump mass fractions at each interval

Param filename:

of the fraction file

Param name:

of the component to dump

Param nint:

is the frequency between file updates

Param frac(n):

are the quantiles

Public Functions

OutFrac(const YAML::Node &conf)

Constructor.

virtual void Run(int nstep, int mstep, bool last)

Generate the output.

Parameters:
  • nstep – is the current time step used to decide whether or not to dump

  • last – should be true on final step to force phase space dump indepentently of whether or not the frequency criterion is met

Private Functions

virtual void initialize(void)

Used to assign additional specific parameters, create storage, etc.

Private Members

std::string filename
int numQuant
double prev = -std::numeric_limits<double>::max()
vector<double> Quant
Component *tcomp

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class OUTInput
Input class to adaptively handle OUT. format specifically

inputs
---------------
filename : str
    the input filename to be read
comp     : str, optional
    the name of the component for which to extract data. If None, will read primary header and exit.
verbose  : int, default 0
    verbosity flag.

returns
---------------
self        : Input instance
  .header   : dict, all header values pulled from the file
    the .keys() are the names of each component
    each component has a dictionary of values, including 'parameters'
    the details of the force calculation are in 'force'
  .filename : str, the filename that was read
  .comp     : str, name of the component
  .time     : float, the time in the output file
  .data     : dictionary, with keys:
    x       : float, the x position
    y       : float, the y position
    z       : float, the z position
    vx      : float, the x velocity
    vy      : float, the y velocity
    vz      : float, the z velocity
    mass    : float, the mass of the particle
    index   : int, the integer index of the particle
    potE    : float, the potential energy value

Public Members

comp
comp_map
data
f
filename
header
indexing
primary_header
time
verbose
class OutLog : public Output
#include <OutLog.H>

Inheritence diagram for OutLog:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutLog" tooltip="OutLog" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OutLog:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutLog" tooltip="OutLog" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "3" [label="Timer" tooltip="Timer"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="usage"]
}

Log vital statistics every n steps.

New version of log file puts all entries on a single line. This makes for difficult human reading but great for machines.

Centers of mass, Centers of velocity, Virial of Clausius and 2T/VC will be computed for each component

NB: the “Virial of Clausius” is a better indicatator of the true potential energy for multiple components or external forces

Current ordering (will be labeled in the file):

  • Global statistics

    1. Current time

Total mass

  1. Number of bodies

  2. COM (x, y, z)

  3. COV (x, y, z)

  4. Ang mom (x, y, z)

  5. Total KE

  6. Total PE

  7. Total E

  8. Virial of Clausius (VC)

  9. 2T/VC

  10. Time per step

  11. Total particles used

For each component in succession

  1. Total mass

Number of bodies

  1. COM (x, y, z)

  2. COV (x, y, z)

  3. Ang mom (x, y, z)

  4. Total KE

  5. Total PE

  6. Total E

  7. Virial of Clausius (VC)

  8. 2T/VC

  9. Particles used

Public Functions

OutLog(const YAML::Node &conf)

Constructor.

Parameters:

line – token list of specific parameters

virtual void Run(int nstep, int mstep, bool last)

Generate output.

Parameters:
  • nstep – the current step number (used e.g. to decide whether or not to write output

  • mstep – is the current multistep level to decide whether or not to dump multisteps

  • last – if true, output is generated independent of the step number

Public Static Attributes

static char lab_component[][20]

Per-component column labels.

static char lab_global[][19]

Global column labels.

static const int num_component = 20

Number of per-component entries.

static const int num_global = 19

Number of global entries.

Private Types

typedef vector<double> dvector

Private Functions

virtual void initialize(void)

Used to assign additional specific parameters, create storage, etc.

Private Members

vector<dvector> angm
vector<double> angm0
vector<dvector> angm1
vector<double> angmG
vector<double> clausius
vector<double> clausius1
vector<dvector> com
vector<double> com0
vector<dvector> com1
vector<double> comG
vector<double> comL
vector<dvector> cov
vector<double> cov0
vector<dvector> cov1
vector<double> covG
vector<double> covL
vector<dvector> ctr
double curwtime
vector<double> ektot
vector<double> ektot1
double ektotxy
vector<double> eptot
vector<double> eptot1
vector<double> eptotx
vector<double> eptotx1
std::string filename
bool firstime
int laststep
double lastwtime
vector<double> mtot
vector<double> mtot1
vector<int> nbodies
vector<int> nbodies1
int nfreq
vector<double> pos0
vector<double> posL
int precision
vector<int> used
vector<int> used1
vector<double> vel0
vector<double> velL

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class OutMulti : public Output
#include <OutMulti.H>

Inheritence diagram for OutMulti:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutMulti" tooltip="OutMulti" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OutMulti:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutMulti" tooltip="OutMulti" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "3" [label="Timer" tooltip="Timer"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="usage"]
}

Dump histogram of multistep levels to file in GNUPLOT format

Param filename:

is the name of the output file

Param nint:

is the number of steps between dumps

Public Functions

OutMulti(const YAML::Node &conf)

Constructor.

virtual void Run(int nstep, int mstep, bool last)

Provided by derived class to generate some output.

Parameters:
  • nstep – is the current time step used to decide whether or not to dump

  • mstep – is the current multistep level to decide whether or not to dump multisteps

  • last – should be true on final step to force phase space dump indepentently of whether or not the frequency criterion is met

Private Functions

virtual void initialize(void)

Used to assign additional specific parameters, create storage, etc.

Private Members

std::string filename
double prev = -std::numeric_limits<double>::max()

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class OutPS : public Output
#include <OutPS.H>

Inheritence diagram for OutPS:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutPS" tooltip="OutPS" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OutPS:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutPS" tooltip="OutPS" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "3" [label="Timer" tooltip="Timer"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="usage"]
}

Append phase space dumps to specified file at regular intervals

Sending the root process a SIGHUP will cause the first of OutPS, OutPSP, OutPSN, OutPSQ, OutCHKPT, or OutCHKPTQ in the Output list to execute. This may not always be possible to signal for batch scheduled jobs.

Param filename:

is the name of the output file

Param nint:

is the number of steps between dumps

Param timer:

set to true turns on wall-clock timer for PS output

Public Functions

OutPS(const YAML::Node &conf)

Constructor.

virtual void Run(int nstep, int mstep, bool last)

Provided by derived class to generate some output.

Parameters:
  • nstep – is the current time step used to decide whether or not to dump

  • mstep – is the current multistep level to decide whether or not to dump multisteps

  • last – should be true on final step to force phase space dump indepentently of whether or not the frequency criterion is met

  • timer – set to true turns on wall-clock timer for PS output

Private Functions

virtual void initialize(void)

Used to assign additional specific parameters, create storage, etc.

Private Members

std::string filename
bool timer

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class OutPSN : public Output
#include <OutPSN.H>

Inheritence diagram for OutPSN:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutPSN" tooltip="OutPSN" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OutPSN:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutPSN" tooltip="OutPSN" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "3" [label="Timer" tooltip="Timer"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="usage"]
}

Write phase-space dumps at regular intervals. Each dump is written into a new file label as filename.n where is begins at nbeg and incremented by 1 after each file is written.

Sending the root process a SIGHUP will cause the first of OutPS, OutPSP, OutPSN, OutPSQ, OutCHKPT, or OutCHKPTQ in the Output list to execute. This may not always be possible to signal for batch scheduled jobs.

Param filename:

is the name of the output file

Param nint:

is the number of steps between dumps

Param nbeg:

is suffix of the first phase space dump

Param real4:

indicates floats for real PS quantities

Param timer:

set to true turns on wall-clock timer for PS output

Public Functions

OutPSN(const YAML::Node &conf)

Constructor.

virtual void Run(int nstep, int mstep, bool last)

Provided by derived class to generate some output.

Parameters:
  • nstep – is the current time step used to decide whether or not to dump

  • mstep – is the current multistep level to decide whether or not to dump multisteps

  • last – should be true on final step to force phase space dump indepentently of whether or not the frequency criterion is met

  • timer – set to true turns on wall-clock timer for PS output

Private Functions

virtual void initialize(void)

Used to assign additional specific parameters, create storage, etc.

Private Members

std::string filename
int nbeg
bool real4
bool timer

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class OutPSP : public Output
#include <OutPSP.H>

Inheritence diagram for OutPSP:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutPSP" tooltip="OutPSP" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OutPSP:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutPSP" tooltip="OutPSP" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "3" [label="Timer" tooltip="Timer"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="usage"]
}

Write phase-space dumps at regular intervals using MPI-IO

Each dump is written into a new file label as filename.n where is begins at nbeg and incremented by 1 after each file is written. This implementation bunches particles into memory and uses a collective MPI_File write to push the bunch to disk at the appropriate offset. The MPI-IO implementation does not maintain the particle sequence so indexing=1 needs to be added as a Component option if the particle index is needed for post processing. This version is much faster than OutPSN and OutCHKPT which uses MPI gather to the root node before writing. This is the newest version for PSP output and has not be extensively tested as of 10/2018.

Sending the root process a SIGHUP will cause the first of OutPS, OutPSP, OutPSN, OutPSQ, OutCHKPT, or OutCHKPTQ in the output list to execute. This may not always be possible to signal for batch scheduled jobs.

Param filename:

is the name of the output file

Param nint:

is the number of steps between dumps

Param nbeg:

is suffix of the first phase space dump

Param real4:

indicates floats for real PS quantities

Param nagg:

is the number of MPI-IO aggregators

Public Functions

OutPSP(const YAML::Node &conf)

Constructor.

virtual void Run(int nstep, int mstep, bool last)

Provided by derived class to generate some output.

Parameters:
  • nstep – is the current time step used to decide whether or not to dump

  • mstep – is the current multistep level to decide whether or not to dump multisteps

  • last – should be true on final step to force phase space dump indepentently of whether or not the frequency criterion is met

Private Functions

virtual void initialize(void)

Used to assign additional specific parameters, create storage, etc.

Private Members

std::string filename
std::string nagg
int nbeg
bool real4
bool timer

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class OutPSQ : public Output
#include <OutPSQ.H>

Inheritence diagram for OutPSQ:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutPSQ" tooltip="OutPSQ" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OutPSQ:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutPSQ" tooltip="OutPSQ" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "3" [label="Timer" tooltip="Timer"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="usage"]
}

Write phase-space dumps at regular intervals from each node in component pieces. These pieces may be reassembled from the info in an “instruction” file.

The assembly instructions for each dump is written into a new file label as filename.n where is begins at nbeg and incremented by 1 after each file is written.

The component pieces are indexed from 0 onward.

Sending the root process a SIGHUP will cause the first of OutPS, OutPSP, OutPSN, OutPSQ, OutCHKPT, or OutCHKPTQ in the Output list to execute. This may not always be possible to signal for batch scheduled jobs.

Param filename:

is the name of the output file

Param nint:

is the number of steps between dumps

Param nbeg:

is suffix of the first phase space dump

Param timer:

set to true turns on wall-clock timer for PS output

Param threads:

number of threads for binary writes

Public Functions

OutPSQ(const YAML::Node &conf)

Constructor.

virtual void Run(int nstep, int mstep, bool last)

Provided by derived class to generate some output.

Parameters:
  • nstep – is the current time step used to decide whether or not to dump

  • mstep – is the current multistep level to decide whether or not to dump multisteps

  • last – should be true on final step to force phase space dump indepentently of whether or not the frequency criterion is met

  • timer – set to true turns on wall-clock timer for PS output

  • threads – is the thread count for binary writes

Private Functions

virtual void initialize(void)

Used to assign additional specific parameters, create storage, etc.

Private Members

std::string filename
int nbeg
bool real4
int threads
bool timer

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class OutPSR : public Output
#include <OutPSR.H>

Inheritence diagram for OutPSR:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutPSR" tooltip="OutPSR" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OutPSR:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutPSR" tooltip="OutPSR" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "3" [label="Timer" tooltip="Timer"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="usage"]
}

Write phase-space dumps at regular intervals from each node in component pieces. These pieces may be reassembled from the info in an “instruction” file.

The assembly instructions for each dump is written into a new file label as filename.n where is begins at nbeg and incremented by 1 after each file is written.

The component pieces are indexed from 0 onward.

Sending the root process a SIGHUP will cause the first of OutPS, OutPSP, OutPSN, OutPSR, OutCHKPT, or OutCHKPTQ in the Output list to execute. This may not always be possible to signal for batch scheduled jobs.

Param filename:

is the name of the output file

Param nint:

is the number of steps between dumps

Param nbeg:

is suffix of the first phase space dump

Param timer:

set to true turns on wall-clock timer for PS output

Param threads:

number of threads for binary writes

Public Functions

OutPSR(const YAML::Node &conf)

Constructor.

virtual void Run(int nstep, int mstep, bool last)

Provided by derived class to generate some output.

Parameters:
  • nstep – is the current time step used to decide whether or not to dump

  • mstep – is the current multistep level to decide whether or not to dump multisteps

  • last – should be true on final step to force phase space dump indepentently of whether or not the frequency criterion is met

  • timer – set to true turns on wall-clock timer for PS output

  • threads – is the thread count for binary writes

Private Functions

virtual void initialize(void)

Used to assign additional specific parameters, create storage, etc.

void write_thread(void)

Private Members

std::string filename
std::string fname
int nbeg
bool real4
int threads
bool timer

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class Output
#include <Output.H>

Inheritence diagram for Output:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="OrbTrace" tooltip="OrbTrace"]
    "3" [label="OutAscii" tooltip="OutAscii"]
    "4" [label="OutCHKPT" tooltip="OutCHKPT"]
    "5" [label="OutCHKPTQ" tooltip="OutCHKPTQ"]
    "6" [label="OutCalbr" tooltip="OutCalbr"]
    "7" [label="OutCoef" tooltip="OutCoef"]
    "8" [label="OutDiag" tooltip="OutDiag"]
    "9" [label="OutFrac" tooltip="OutFrac"]
    "10" [label="OutLog" tooltip="OutLog"]
    "11" [label="OutMulti" tooltip="OutMulti"]
    "12" [label="OutPS" tooltip="OutPS"]
    "13" [label="OutPSN" tooltip="OutPSN"]
    "14" [label="OutPSP" tooltip="OutPSP"]
    "15" [label="OutPSQ" tooltip="OutPSQ"]
    "16" [label="OutPSR" tooltip="OutPSR"]
    "17" [label="OutRelaxation" tooltip="OutRelaxation"]
    "18" [label="OutVel" tooltip="OutVel"]
    "1" [label="Output" tooltip="Output" fillcolor="#BFBFBF"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
    "5" -> "1" [dir=forward tooltip="public-inheritance"]
    "6" -> "1" [dir=forward tooltip="public-inheritance"]
    "7" -> "1" [dir=forward tooltip="public-inheritance"]
    "8" -> "1" [dir=forward tooltip="public-inheritance"]
    "9" -> "1" [dir=forward tooltip="public-inheritance"]
    "10" -> "1" [dir=forward tooltip="public-inheritance"]
    "11" -> "1" [dir=forward tooltip="public-inheritance"]
    "12" -> "1" [dir=forward tooltip="public-inheritance"]
    "13" -> "1" [dir=forward tooltip="public-inheritance"]
    "14" -> "1" [dir=forward tooltip="public-inheritance"]
    "15" -> "1" [dir=forward tooltip="public-inheritance"]
    "16" -> "1" [dir=forward tooltip="public-inheritance"]
    "17" -> "1" [dir=forward tooltip="public-inheritance"]
    "18" -> "1" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Output:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="Output" tooltip="Output" fillcolor="#BFBFBF"]
    "2" [label="Timer" tooltip="Timer"]
    "1" -> "2" [dir=forward tooltip="usage"]
}

Output routines.

These are designed to be run in a chain at each step. Each Output class is responsible for determining when to run. Initialization parameters are parsed on construction and available to the contructor for initializing control variables.

The class is also responsible for cycling through the component list and operating on each phase space accordingly. NB: the alternative would be to allow each component to define an output method. However, this can easily result in a chaos of specialized output streams and so I rejected this approach.

The stopWatch Timer is implemented in the base class but can be used by any derived class to time the output event. See OutPS for an example.

Subclassed by OrbTrace, OutAscii, OutCHKPT, OutCHKPTQ, OutCalbr, OutCoef, OutDiag, OutFrac, OutLog, OutMulti, OutPS, OutPSN, OutPSP, OutPSQ, OutPSR, OutRelaxation, OutVel

Public Functions

Output(const YAML::Node &conf)

Constructor.

virtual void Run(int nstep, int mstep, bool final) = 0

Provided by derived class to generate some output.

inline std::set<std::string> unmatched()

Return unmatched parameters.

inline virtual ~Output()

Destructor.

Public Members

string id

Id string.

Protected Functions

virtual void initialize(void) = 0

Used to assign additional specific parameters, create storage, etc.

inline void nintsub_warning(const std::string &name)

nintsub warning message

Protected Attributes

const YAML::Node &conf

Configuration.

std::set<std::string> current_keys

Current YAML keys to check configuration.

int nint

Output frequency (should be used by derived classes)

int nintsub

Multistep output frequency (also used by derived classes)

Timer stopWatch

Output timer.

bool timer

Use output timer.

class OutputContainer
#include <OutputContainer.H>

Container class to hold the output chain of container methods.

Public Functions

void initialize()

Will read configuration stanza and initialize requested output methods.

OutputContainer()

Constructor.

void Run(int nstep, int mstep = std::numeric_limits<int>::max(), bool final = false)

Execute the all methods in the container.

~OutputContainer()

Destructor.

Public Members

std::list<std::shared_ptr<std::thread>> cproc

A list of concurrent threads for asychronous processing.

std::list<Output*> out

List of output methods currently active.

Private Members

double last

Last run time.

class OutRelaxation : public Output
#include <OutRelaxation.H>

Inheritence diagram for OutRelaxation:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutRelaxation" tooltip="OutRelaxation" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OutRelaxation:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutRelaxation" tooltip="OutRelaxation" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "3" [label="Timer" tooltip="Timer"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="usage"]
}

Output routine for generateRelaxation (“external force”) module.

Public Functions

OutRelaxation(const YAML::Node &conf)

Constructor.

virtual void Run(int nstep, int mstep, bool final = false)

Do some output.

Parameters:
  • nstep – is the current time step index

  • mstep – is the current multistep level to decide whether or not to dump multisteps

  • final – should be true on last step to force output

inline virtual ~OutRelaxation()

Destructor.

Private Functions

virtual void initialize(void)

Used to assign additional specific parameters, create storage, etc.

Private Members

int epos
std::string fname
std::string suffix

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class OutVel : public Output
#include <OutVel.H>

Inheritence diagram for OutVel:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="OutVel" tooltip="OutVel" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for OutVel:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="Component" tooltip="Component"]
    "8" [label="EL3" tooltip="EL3"]
    "7" [label="Orient" tooltip="Orient"]
    "1" [label="OutVel" tooltip="OutVel" fillcolor="#BFBFBF"]
    "2" [label="Output" tooltip="Output"]
    "5" [label="PotAccel" tooltip="PotAccel"]
    "3" [label="Timer" tooltip="Timer"]
    "6" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "4" -> "4" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="usage"]
    "4" -> "7" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
    "7" -> "8" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "4" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "4" [dir=forward tooltip="usage"]
    "6" -> "5" [dir=forward tooltip="usage"]
}

Dump velocity flow coefficients at each interval

Param modelname:

is the file specifying the density model

Param name:

of the component to dump

Param nint:

is the frequency between file updates

Param dof:

is the number of degrees of freedom. 2=polar, 3 =spherical

Param lmax:

is the maximum harmonic order

Param nmax:

is the maximum radial order

Param rmapping:

is the coordinate mapping parameter for the expansion

Param rmin:

is the minimum radius for the density field

Param rmax:

is the maximum radius for the density field

Param ascl:

is the exponential scale length used for the “expon” density

Param delta:

is the cutoff radius used for the “expon” density

Param model:

defines the density for the orthogonal functions

Public Functions

OutVel(const YAML::Node &conf)

Constructor.

virtual void Run(int nstep, int mstep, bool last)

Generate the output.

Parameters:
  • nstep – is the current time step used to decide whether or not to dump

  • last – should be true on final step to force phase space dump indepentently of whether or not the frequency criterion is met

Private Types

using CoefType = Eigen::TensorMap<Eigen::Tensor<std::complex<double>, 3>>

Private Functions

void ExtendH5Coefs()

Extend the HDF5 file.

virtual void initialize(void)

Used to assign additional specific parameters, create storage, etc.

void WriteH5Coefs()

Initialize and write the HDF5 file.

void WriteH5Params(HighFive::File &file)

Write the parameters to the HDF5 file.

unsigned WriteH5Times(HighFive::Group &snaps, unsigned count)

Write the coefficient data to the HDF5 file.

Private Members

std::shared_ptr<BasisClasses::VelocityBasis> basis

The basis isntance.

CoefClasses::CoefsPtr coefs
int dof
std::string model
std::string modelname
std::string outfile
double prev = -std::numeric_limits<double>::max()
Component *tcomp

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class P2Quantile
#include <P2Quantile.H>

Implementation of the quantile estimator from:

Jain, Raj, and Imrich Chlamtac. “The P² algorithm for dynamic calculation of quantiles and histograms without storing observations.” Communications of the ACM 28, no. 10 (1985): 1076-1085.

Public Functions

inline void addValue(double x)

Add a new value.

inline double getQuantile()

Get the current quantile value.

inline P2Quantile(double prob = 0.5)

Quantile constructor where.

Parameters:

prob – is the quantile

inline void reset(double prob)

Change the probability value and reset.

Private Functions

inline double Linear(int i, int d)
inline double Parabolic(int i, double d)

Private Members

size_t count

Update count so far.

std::array<double, 5> dns

Marker updates.

std::array<int, 5> n

Marker indices.

std::array<double, 5> ns

Desired marker positions.

double p

Probability.

std::array<double, 5> q

Marker heights.

class ParseResult
#include <cxxopts.H>

Public Functions

inline const std::vector<KeyValue> &arguments() const
inline const std::string arguments_string() const
inline Iterator begin() const
inline size_t count(const std::string &o) const
inline const std::vector<KeyValue> &defaults() const
inline Iterator end() const
ParseResult &operator=(const ParseResult&) = default
ParseResult &operator=(ParseResult&&) = default
inline const OptionValue &operator[](const std::string &option) const
ParseResult() = default
ParseResult(const ParseResult&) = default
inline ParseResult(NameHashMap &&keys, ParsedHashMap &&values, std::vector<KeyValue> sequential, std::vector<KeyValue> default_opts, std::vector<std::string> &&unmatched_args)
inline const std::vector<std::string> &unmatched() const

Private Members

std::vector<KeyValue> m_defaults = {}
NameHashMap m_keys = {}
std::vector<KeyValue> m_sequential = {}
std::vector<std::string> m_unmatched = {}
ParsedHashMap m_values = {}
class Particle
#include <Particle.H>

Inheritence diagram for Particle:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="PR::PParticle< double >" tooltip="PR::PParticle< double >"]
    "2" [label="PR::PParticle< float >" tooltip="PR::PParticle< float >"]
    "4" [label="PR::PParticle< real >" tooltip="PR::PParticle< real >"]
    "1" [label="Particle" tooltip="Particle" fillcolor="#BFBFBF"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
}

Keeps track of all info for one particle.

The iattrib and dattrib vectors are used by individual components to carry additional parameters specific to different particle types.

Subclassed by PR::PParticle< float >, PR::PParticle< double >, PR::PParticle< real >

Public Types

typedef std::pair<unsigned short, unsigned short> speciesKey

Public Functions

inline unsigned getMPIBufSize(unsigned rsize, bool indexing)

Particle buffer size.

Particle()

Constructor.

Particle()
Particle(const Particle&)

Copy constructor.

Particle(const Particle &p)
Particle(unsigned niatr, unsigned ndatr)

Constructor with presized attribute lists.

void readAscii(bool indexing, int seq, std::istream *fin)

Read particles from file.

void readBinary(unsigned rsize, bool indexing, int seq, std::istream *in)

Read particles from file.

void writeAscii(bool indexing, bool accel, std::ostream *out)

Write a particle in ascii format.

void writeBinary(unsigned rsize, bool indexing, std::ostream *out) const

Write a particle in binary format (PSP)

void writeBinaryBuffered(unsigned rsize, bool indexing, std::ostream *out, ParticleBuffer &buf) const

Write a particle in binary format (PSP)

int writeBinaryMPI(char *buf, unsigned rsize, bool indexing)

Write a particle in binary format (PSP) to buffer for MPI.

void writeBinaryThreaded(unsigned rsize, bool indexing, ParticleBuffer &buf, int count) const

Write a particle in binary format (PSP), threaded version.

Public Members

double acc[3]

Acceleration vector.

vector<double> dattrib

Real (double) attributes.

float dtreq

Internal process time step (<0 means ignore)

float effort

Scale factor for partitioning work.

vector<int> iattrib

Integer attributes.

unsigned long indx

Index for ordering.

unsigned long key

Hash key.

unsigned level

Multistep level.

double mass

Mass of particle.

double pos[3]

Position vector.

double pot

Gravitational potential due to particles

double potext

Gravitational potential from external forces.

float scale

Internal size scale (<0 means ignore)

speciesKey skey

Species key (this is a cache value to prevent endless on-the-fly reconstruction of the species key)

unsigned tree

Tree key.

double vel[3]

Velocity vector.

Public Static Attributes

static const speciesKey defaultKey
static float effort_default

Default effort value.

Private Members

std::vector<char> buffer

MPI buffer.

class ParticleBuffer
#include <Particle.H>

Helper class for writing a buffer of particles.

Public Functions

inline char *operator()()

Raw access to particle buffer.

inline void operator++(int)

Increment the particle counter.

ParticleBuffer(unsigned rsize, bool indexing, const Particle *p)

Constructor.

inline unsigned pMemSize()

Get memory per particle.

inline void setLocation(int n)

Set location to the nth particle.

void writeBuffer(std::ostream *out, bool finish = false)

Write buffer.

Public Members

char *Loc

Buffer location.

const unsigned maxBufCount = 1048576

Buffer maximum particle count.

Protected Attributes

unsigned bufCount

Buffer particle count.

unsigned bufSize

Buffer size.

std::vector<char> charBuffer

Write buffer.

unsigned parSize

Particle size.

class ParticleFerry
#include <ParticleFerry.H>

For interprocess communication, need static structure for MPI mapping

Public Functions

inline size_t getBufsize()

Size needed for a single particle.

ParticleFerry(int nimax, int ndmax)

Constructor.

void particlePack(PartPtr in, char *buffer)

Pack particle into buffer. Caller provides buffer.

void particleUnpack(PartPtr out, char *buffer)

Unpack buffer into particle. Caller provides buffer.

PartPtr RecvParticle()
void SendParticle(PartPtr part)

Send and receive particles. Uses ParticleFerry internally maintained buffer

void ShipParticles(unsigned to, unsigned from, unsigned &total)

Send message to receiver: get ready for bulk shipment of particles.

~ParticleFerry()

Destructor.

Private Functions

void BufferRecv()
void BufferSend()
void particleBufInit()

Determine size of buffer needed.

Private Members

std::vector<char> buf
unsigned bufpos
size_t bufsiz
unsigned ibufcount
int idxpos
unsigned itotcount
int keypos
int ndmax
int nimax
int treepos
class ParticleReader
#include <ParticleReader.H>

Inheritence diagram for PR::ParticleReader:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="PR::GadgetHDF5" tooltip="PR::GadgetHDF5"]
    "3" [label="PR::GadgetNative" tooltip="PR::GadgetNative"]
    "4" [label="PR::PSP" tooltip="PR::PSP"]
    "5" [label="PR::PSPout" tooltip="PR::PSPout"]
    "6" [label="PR::PSPspl" tooltip="PR::PSPspl"]
    "1" [label="PR::ParticleReader" tooltip="PR::ParticleReader" fillcolor="#BFBFBF"]
    "7" [label="PR::Tipsy" tooltip="PR::Tipsy"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
    "5" -> "4" [dir=forward tooltip="public-inheritance"]
    "6" -> "4" [dir=forward tooltip="public-inheritance"]
    "7" -> "1" [dir=forward tooltip="public-inheritance"]
}

Base class for reading particle phase space from any simulation.

Subclassed by PR::GadgetHDF5, PR::GadgetNative, PR::PSP, PR::Tipsy

Public Functions

virtual unsigned long CurrentNumber() = 0

Number of particles in the chosen type.

virtual double CurrentTime() = 0

Get current time.

virtual const Particle *firstParticle() = 0

Reset to beginning of particles for this component.

virtual std::vector<std::string> GetTypes() = 0

Return list of particle types.

virtual const Particle *nextParticle() = 0

Get the next particle.

inline ParticleReader()

Constructor: check for and set up MPI.

virtual void PrintSummary(std::ostream &out, bool stats = false, bool timeonly = false)

Print summary phase-space info.

virtual void SelectType(const std::string &type) = 0

Select a particular particle type and reset the iterator.

inline virtual ~ParticleReader()

Destructor.

Public Static Functions

static std::shared_ptr<ParticleReader> createReader(const std::string &type, const std::vector<std::string> &file, int myid = 0, bool verbose = false)

Create a shared pointer to derived instance of the desired type and return it.

static std::vector<std::vector<std::string>> parseFileList(const std::string &file, const std::string &delimit)

Order file list into batches at single times from file.

static std::vector<std::vector<std::string>> parseStringList(const std::vector<std::string> &file, const std::string &delimit)

Order file list into batches at single times from vector of strings.

Protected Attributes

int myid
int numprocs
bool use_mpi

Protected Static Attributes

static std::vector<std::string> readerTypes
class PCAbasis : public std::map<int, PCAelemPtr>
#include <EmpCylSL.H>

Inheritence diagram for EmpCylSL::PCAbasis:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="EmpCylSL::PCAbasis" tooltip="EmpCylSL::PCAbasis" fillcolor="#BFBFBF"]
    "2" [label="std::map< int, PCAelemPtr >" tooltip="std::map< int, PCAelemPtr >"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for EmpCylSL::PCAbasis:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="EmpCylSL::PCAbasis" tooltip="EmpCylSL::PCAbasis" fillcolor="#BFBFBF"]
    "2" [label="std::map< int, PCAelemPtr >" tooltip="std::map< int, PCAelemPtr >"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

PCA basis structure for caching and diagnostics.

Public Functions

inline PCAbasis(int M, int n)

Constructor.

inline void reset()

Reset all variables to zero for accumulation.

Public Members

double Tmass

Mass in the accumulation.

unsigned Tnumb

Total number in accumulation.

class PCAelement
#include <EmpCylSL.H>

Data for each harmonic subspace.

Public Functions

inline PCAelement(int n)

Constructor.

inline void reset()

Zero all data.

Public Members

Eigen::MatrixXd covrJK
Eigen::VectorXd evalJK

All the public data.

Eigen::MatrixXd evecJK
Eigen::VectorXd meanJK
Eigen::VectorXd ratio
class Perfect
#include <staeckel.H>

Public Functions

double dFlambda(double)
double dFmu(double)
double Feff_lambda(double, double)
double Feff_mu(double, double)
double Flambda(double)
double Fmu(double)
Eigen::Vector3d force(Eigen::Vector3d&)
void Integrals(Phase&, double*, double*, double*)
void meridional_force(double, double, double*, double*)
double potential(Eigen::Vector3d&)
double second_integral(double, double, double, double, double)
inline void set_Perfect(double aa, double bb, double g, double m)
void to_ellipsoidal(double, double, double*, double*)

Protected Attributes

double a
double alpha
double b
double beta
double G
double M
double rho0
double W0
class PeriodicBC : public ExternalForce
#include <PeriodicBC.H>

Inheritence diagram for PeriodicBC:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "1" [label="PeriodicBC" tooltip="PeriodicBC" fillcolor="#BFBFBF"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for PeriodicBC:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="Component" tooltip="Component"]
    "7" [label="EL3" tooltip="EL3"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "6" [label="Orient" tooltip="Orient"]
    "1" [label="PeriodicBC" tooltip="PeriodicBC" fillcolor="#BFBFBF"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "8" [label="Timer" tooltip="Timer"]
    "4" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "5" -> "5" [dir=forward tooltip="usage"]
    "5" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "5" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "5" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
}

Enforce periodic boundary conditions in a rectangular prism (box)

Param ctrname:

is the name of the component whose particles will be subject to the boundary condition

Param sx:

is the edge size in the x-direction

Param sy:

is the edge size in the y-direction

Param sz:

is the edge size in the z-direction

Param cx:

is the center offset in the x-direction

Param cy:

is the center offset in the y-direction

Param cz:

is the center offset in the z-direction

Param btype:

is a string of length that defines the type of boundary condition for each dimension (‘r’ for reflection bc, ‘p’ for periodic bc, ‘v’ is vacuum)

Public Functions

PeriodicBC(const YAML::Node &conf)

Constructor.

~PeriodicBC()

Destructor.

Private Functions

virtual void determine_acceleration_and_potential(void)

Called to evaluate acceleration Default version calls the provided thread function. Can be overloaded to provide additional non-threaded tasks.

virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreaded method (must be thread safe) for force computation that must be provided by all derived classes (hence pure virtual)

virtual void initialize()

Used by derived class to initialize any storage and parameters.

void userinfo()

Private Members

std::vector<double> atomic_weights
std::string bc
Component *c0
std::string comp_name
std::vector<double> L
double munit
std::normal_distribution norm

Pseudorandom generation.

std::vector<double> offset
double temp
double vunit

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class permutation
#include <permutation.H>

Make a permutation index. Share will MPI nodes if MPI is active.

This implementation should fall back politely to single processor use.

Public Functions

inline size_t operator[](size_t n) const

The permutation operator.

inline permutation(unsigned n, bool full = false)

Initialize and generate the identity permutation

Parameters:

Parameters:
  • n – is the vecctor rank

  • full – set to true will seed every value in the mt19937 state. This will produce better randomness at higher startup cost.

inline void shuffle()

Create and share the random permutation.

Private Functions

inline void seed19937()

Seed the Mersenne Twister from the random device.

Private Members

std::mt19937 g
std::vector<size_t> perm
class Phase
#include <phase.H>

Public Functions

double Accuracy(Phase&)
Phase advance(double&)
Phase advance_symplectic(double&)
inline Eigen::Vector3d Angular_Momentum(void)
void binread(std::istream &fp)
void binwrite(std::ostream &fp)
inline double Energy(void)
char *get_Integrator(void)
inline double get_Tolerance(void)
inline double get_Vscale(void)
inline double get_Xscale(void)
Phase integrate_to(double)
Phase integrate_to_symplectic(double, double)
double Jacobi(void)
inline double &Mass(void)
Phase &operator=(const Phase&)
Phase PC_advance(double)
Phase(const Phase&)
Phase(void)
inline double &Position(int i)
inline Eigen::Vector3d &Position(void)
void print(std::ostream &out)
Phase rotate_frame(double)
Phase rotate_view(double)
void set_Integrator(char*)
void set_PC(double, int)
inline void set_Tolerance(double tol)
inline void set_Vscale(double vv)
inline void set_Xscale(double xx)
inline double Speed(void)
inline double &Time(void)
inline double &Velocity(int i)
inline Eigen::Vector3d &Velocity(void)
inline double &Work(void)
Phase x_return_map(void)

Public Static Functions

static Eigen::Vector3d Default_Force(double, Eigen::Vector3d&, Eigen::Vector3d&)
static double Default_Potential(double, Eigen::Vector3d&)
static inline void Register_Potential(pot_func_ptr p, force_func_ptr f)

Public Static Attributes

static force_func_ptr Force
static pot_func_ptr Potential

Protected Attributes

double m
double t
Eigen::Vector3d v
double work
Eigen::Vector3d x

Protected Static Attributes

static ode_integrator integrator
static char integrator_name[8]
static symp_integrator mapping
static int potential_defined
static char symp_integrator_name[8]
static double tolerance
static double vscale
static double xscale

Friends

friend class Ensemble
class Plummer
#include <models.H>

Public Functions

Eigen::Vector3d force(Eigen::Vector3d&)
inline double get_M(void)
inline double get_r0(void)
double potential(Eigen::Vector3d&)
inline void set_M(double m)
inline void set_Plummer(double r, double g, double m)
inline void set_r0(double r)

Protected Attributes

double G
double GM
double M
double r0
double r2
double r3
class PlummerSoft : public SoftKernel
#include <GravKernel.H>

Inheritence diagram for PlummerSoft:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="PlummerSoft" tooltip="PlummerSoft" fillcolor="#BFBFBF"]
    "2" [label="SoftKernel" tooltip="SoftKernel"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for PlummerSoft:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="PlummerSoft" tooltip="PlummerSoft" fillcolor="#BFBFBF"]
    "2" [label="SoftKernel" tooltip="SoftKernel"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Plummer softened gravity (infinite support)

Public Functions

virtual std::pair<double, double> operator()(double r, double eps)

Main operator returning enclosed mass and gravitational potential

class PlummerSphere : public AxiSymModel
#include <plummer.H>

Inheritence diagram for PlummerSphere:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "3" [label="MassModel" tooltip="MassModel"]
    "1" [label="PlummerSphere" tooltip="PlummerSphere" fillcolor="#BFBFBF"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for PlummerSphere:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "7" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "8" [label="GaussQuad" tooltip="GaussQuad"]
    "3" [label="MassModel" tooltip="MassModel"]
    "1" [label="PlummerSphere" tooltip="PlummerSphere" fillcolor="#BFBFBF"]
    "6" [label="RegularOrbit" tooltip="RegularOrbit"]
    "5" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
    "5" -> "7" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
}

Public Functions

inline virtual double d2fde2(double E, double L)
inline virtual double dfde(double E, double L)
inline virtual double dfdl(double E, double L)
inline virtual double distf(double E, double L)
inline virtual double get_density(const double r)
inline virtual double get_dpot(const double r)
inline virtual double get_dpot2(const double r)
inline virtual double get_mass(const double r)

Access the profile.

inline virtual double get_max_radius(void)
inline virtual double get_min_radius(void)
inline virtual double get_pot(const double r)
inline virtual void get_pot_dpot(const double r, double &ur, double &dur)
inline PlummerSphere(double RSCL = 1.0, double RMIN = 1.0e-6, double RMAX = 1.0e6, double MASS = 1.0)

Private Members

double dfac
double ffac
double mass
double rmax
double rmin
double rscl
template<typename coordinate_type, size_t dimensions>
class point
#include <KDtree.H>

Class for representing a point Coordinate_type must be a numeric type Field (weight) is a double

Public Functions

inline double distance(const point &pt) const

Returns the distance squared from this point to another point.

Parameters:

pt – another point

Returns:

distance squared from this point to the other point

inline coordinate_type get(size_t index) const

Returns the coordinate in the given dimension.

Parameters:

index – dimension index (zero based)

Returns:

coordinate in the given dimension

inline unsigned long indx() const
inline double mass() const
inline point()

Null initializer.

inline point(const point &p)

Copy constructor.

inline point(std::array<coordinate_type, dimensions> c, double m = 1, unsigned long indx = 0)

Constructor.

inline point(std::array<coordinate_type, dimensions> c, std::array<coordinate_type, dimensions> v, double m = 1, unsigned long indx = 0)
inline point(std::initializer_list<coordinate_type> list, double m = 1, unsigned long indx = 0)

List constructor.

inline point(std::initializer_list<coordinate_type> list, std::initializer_list<coordinate_type> vlst, double m = 1, unsigned long indx = 0)
inline double speed(const point &pt) const

Returns the squared velocity between this point to another point.

Parameters:

pt – another point

Returns:

squared speed between this point and the other point

inline coordinate_type vel(size_t index) const

Private Members

std::array<coordinate_type, dimensions> coords_
unsigned long indx_
double mass_
std::array<coordinate_type, dimensions> vels_
class Point_Quadrupole
#include <models.H>

Public Functions

Eigen::Vector3d force(Eigen::Vector3d&)
double potential(Eigen::Vector3d&)
inline void set_Point_Quadrupole(double q)

Protected Attributes

double Q
class PolarBasis : public AxisymmetricBasis
#include <PolarBasis.H>

Inheritence diagram for PolarBasis:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxisymmetricBasis" tooltip="AxisymmetricBasis"]
    "3" [label="Basis" tooltip="Basis"]
    "5" [label="CBDisk" tooltip="CBDisk"]
    "6" [label="FlatDisk" tooltip="FlatDisk"]
    "1" [label="PolarBasis" tooltip="PolarBasis" fillcolor="#BFBFBF"]
    "4" [label="PotAccel" tooltip="PotAccel"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "5" -> "1" [dir=forward tooltip="public-inheritance"]
    "6" -> "1" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for PolarBasis:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxisymmetricBasis" tooltip="AxisymmetricBasis"]
    "3" [label="Basis" tooltip="Basis"]
    "6" [label="Component" tooltip="Component"]
    "8" [label="EL3" tooltip="EL3"]
    "14" [label="MixtureBasis" tooltip="MixtureBasis"]
    "7" [label="Orient" tooltip="Orient"]
    "1" [label="PolarBasis" tooltip="PolarBasis" fillcolor="#BFBFBF"]
    "12" [label="PolarBasis::CoefMatrix" tooltip="PolarBasis::CoefMatrix"]
    "10" [label="PolarBasis::CoefVector" tooltip="PolarBasis::CoefVector"]
    "4" [label="PotAccel" tooltip="PotAccel"]
    "9" [label="Timer" tooltip="Timer"]
    "15" [label="TwoCenter" tooltip="TwoCenter"]
    "13" [label="std::vector< std::vector< MatrixM > >" tooltip="std::vector< std::vector< MatrixM > >"]
    "11" [label="std::vector< std::vector< VectorM > >" tooltip="std::vector< std::vector< VectorM > >"]
    "5" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "6" -> "6" [dir=forward tooltip="usage"]
    "6" -> "4" [dir=forward tooltip="usage"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "6" -> "9" [dir=forward tooltip="usage"]
    "14" -> "15" [dir=forward tooltip="usage"]
    "7" -> "8" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "10" [dir=forward tooltip="usage"]
    "1" -> "12" [dir=forward tooltip="usage"]
    "1" -> "14" [dir=forward tooltip="usage"]
    "12" -> "13" [dir=forward tooltip="public-inheritance"]
    "10" -> "11" [dir=forward tooltip="public-inheritance"]
    "4" -> "5" [dir=forward tooltip="usage"]
    "4" -> "6" [dir=forward tooltip="usage"]
    "15" -> "4" [dir=forward tooltip="public-inheritance"]
    "15" -> "3" [dir=forward tooltip="usage"]
    "15" -> "14" [dir=forward tooltip="usage"]
    "5" -> "4" [dir=forward tooltip="usage"]
}

Defines a cylindrical basis with members specific to polar symmetry

Configurable parameters:

Other parameters may be defined and passed to any derived classes in addition to these.

Param scale:

is the characterisic scale of the basis

Param rmin:

is the minimum radius of the basis

Param rmax:

is the maximum radius of the basis

Param self_consistent:

true for updating the the coefficients at time steps

Param NO_M0:

true to omit the m=0 harmonic (default: false)

Param NO_M1:

true to omit the m=1 harmonic (default: false)

Param NO_MONO:

true to omit the monopole off-grid force algorithm (default: false)

Param EVEN_M:

true to include only even m harmonics (default: false)

Param M0_ONLY:

true to include only the m=0 harmonic (default: false)

Param M0_BACK:

true includes fixed m=0 harmonic (default: false)

Param ssfrac:

set > 0.0 to compute a fraction of particles only

Param playback:

true to replay from a coefficient file

Param coefMaster:

true to have only the root node read and distribute the coefficients

Subclassed by CBDisk, FlatDisk

Public Types

using ContribArray = std::vector<Eigen::VectorXd>
using MatrixM = std::vector<Eigen::MatrixXd>
using VectorM = std::vector<Eigen::VectorXd>

Public Functions

virtual void determine_acceleration_and_potential(void)

Required member to compute accleration and potential with threading.

The thread member must be supplied by the derived class

inline virtual void determine_coefficients(Component *c)

Compute coefficients with threading using the provided component.

virtual void determine_coefficients(void)

Required member to compute coeifficients with threading.

The thread member must be supplied by the derived class

virtual void determine_fields_at_point(double x, double y, double z, double *tdens0, double *tpotl0, double *tdens, double *tpotl, double *tpotx, double *tpoty, double *tpotz)

Return the value for the fields in Cartesian coordinates.

virtual void determine_fields_at_point_cyl(double r, double z, double phi, double *tdens0, double *tpotl0, double *tdens, double *tpotl, double *tpotr, double *tpotz, double *tpotp)

Returns the potential, its derivatives & density in cylindrical coords.

virtual void determine_fields_at_point_sph(double r, double theta, double phi, double *tdens0, double *tpotl0, double *tdens, double *tpotl, double *tpotr, double *tpott, double *tpotp)

Returns the potential, its derivatives & density in spherical coords.

virtual void dump_coefs(ostream&)

Dump current coefficients.

virtual void dump_coefs_h5(const std::string &file)

Dump current coefficients into named HDF5 file.

virtual void get_acceleration_and_potential(Component *cC)

Required member to compute accelration and potential.

This implemenation should be fine for most cases

virtual void get_dens(double r, double z, Eigen::MatrixXd &d, int tid) = 0

Get derivative of potential

Parameters:
  • r – is the evaluation radius

  • z – is the evaluation height

  • d – will be returned array in harmonics l and radial order n for the density

  • tid – is the thread enumerator that allows the function to provide some thread safety

virtual void get_dpotl(double r, double z, Eigen::MatrixXd &p, Eigen::MatrixXd &dpr, Eigen::MatrixXd &dpz, int tid) = 0

Get derivative of potential

Parameters:
  • r – is the evaluation radius

  • z – is the evaluation height

  • p – will be returned array in harmonics l and radial order n for the potential

  • dpr – will be returned array in harmonics l and radial order n for the derivative of the potential

  • dpz – will be returned array in harmonics l and radial order n for the derivative of the potential

  • tid – is the thread enumerator that allows the function to provide some thread safety

virtual void get_potl(double r, double z, Eigen::MatrixXd &p, int tid) = 0

Get derivative of potential

Parameters:
  • r – is the evaluation radius

  • z – is the evaluation height

  • p – will be returned array in harmonics l and radial order n for the potential

  • tid – is the thread enumerator that allows the function to provide some thread safety

virtual void get_potl_dens(double r, double z, Eigen::MatrixXd &p, Eigen::MatrixXd &d, int tid) = 0

Get the potential and density

Parameters:
  • r – is the evaluation radius

  • p – will be returned array in harmonics l and radial order n for the potential

  • d – will be returned array in harmonics l and radial order n for the density

  • tid – is the thread enumerator that allows the function to provide some thread safety

inline virtual double knl(int, int)

Kernel value for recursion relation basis.

virtual void multistep_reset()

Update the multi time step coefficient table when moving particle i from level cur to level next

virtual void multistep_update(int cur, int next, Component *c, int i, int id)

Implementation of level shifts.

virtual void multistep_update_begin()

Execute to begin level shifts for particles.

Update the multi time step force algorithm when moving particle i from level cur to level next

virtual void multistep_update_finish()

Execute to finish level shifts for particles.

PolarBasis(Component *c0, const YAML::Node &conf, MixtureBasis *m = 0)

Constructor (line contains the paramter list)

PolarBasis(const PolarBasis &p)

Copy constructor.

virtual ~PolarBasis()

Destructor.

Public Static Attributes

static bool NewCoefs

Use YAML header in coefficient file.

Protected Types

typedef std::shared_ptr<Eigen::VectorXd> VectorXdP

Matrices per thread for obtaining expansion coefficients.

Protected Functions

inline virtual std::tuple<double, double, double> background(double r, double z)

CUDA method for coefficient accumulation.

Background evaluation

virtual void check_range()

Provided by derived classes to check consistency.

void compute_multistep_coefficients()

Extrapolate and sum coefficents per multistep level to get a complete set of coefficients for force evaluation at an intermediate time step

virtual void *determine_acceleration_and_potential_thread(void *arg)

Thread method for accerlation compuation.

virtual void determine_coefficients_particles(void)

Compute the coefficients from particles.

virtual void determine_coefficients_playback(void)

Compute the coefficients from an table.

virtual void *determine_coefficients_thread(void *arg)

Thread method for coefficient accumulation.

void dump_coefs_all(ostream&)

Dump current coefficients (all multistep levels) For debugging …

void get_dens_coefs(int m, Eigen::VectorXd &coef, double &p)

Get density from coefficient vector.

virtual void get_pot(Eigen::MatrixXd &Vc, Eigen::MatrixXd &Vs, double r, double z) = 0
void get_pot_coefs(int m, const Eigen::VectorXd &coef, double &p, double &dpr, double &dprz)

Get potential and accel field values from coefficients.

void get_pot_coefs_safe(int m, const Eigen::VectorXd &coef, double &p, double &dpr, double &dprz, Eigen::MatrixXd &potd1, Eigen::MatrixXd &dpotr1, Eigen::MatrixXd &dpotz1)

Get potential and field values from coefficients (provide workspace for thread safety)

virtual double getRtable() = 0

Get table scale.

void init_pca()

Initialize for PCA variance computation.

virtual void initialize()

Initialize method.

inline void setup()

Should be called by derived classes after initialization (does nothing here)

void setup_accumulation(int mlevel)

Clear arrays for accumulation.

Protected Attributes

const unsigned int cmagic = 0xc0a57a2

Coefficient magic number.

bool coefMaster

Master node ships coefficients to hosts. True (default) implies that only the master node caches the coefficients for playback to save core memory. This is set in the config input using the ‘coefMaster: bool’ parameter. Once I am sure that there are no algorithmic issues, I will remove this as an option.

std::vector<Eigen::VectorXd> cosm

Work vectors for cosines for all values m

CoefMatrix covM
CoefVector covV
CoefClasses::CylCoefs cylCoefs

Coefficient container instance for writing HDF5.

double cylmass
std::vector<double> cylmass1
unsigned defSampT
Eigen::MatrixXd dend

Work matrix.

vector<vector<Eigen::MatrixXd>> differ1

For updating levels.

std::vector<std::vector<Eigen::MatrixXd>> differC1
std::vector<std::vector<Eigen::MatrixXd>> differS1

For updating levels.

std::vector<Eigen::MatrixXd> dpotR

Matrices per thread for obtaining derivative of potential field.

std::vector<Eigen::MatrixXd> dpotZ
bool EVEN_M

Flag use of even m harmonics only.

std::vector<std::vector<VectorXdP>> expcoef0
bool firstime_accel

Flag whether or not work space has been initialized for acceleration.

bool firstime_coef

Flag whether or not work space has been initialized for coefficients.

std::vector<unsigned> howmany
std::vector<std::vector<unsigned>> howmany1
bool is_flat

Model is flat.

double lastPlayTime

Last playback coefficient evaluation time.

bool M0_back

Flag fixed monopole.

bool M0_only

Use axisymmetric terms.

std::vector<double> massT
std::vector<std::vector<double>> massT1
double maxSNR
Eigen::VectorXd meanC

Expected coefficient values for RMS noise computation.

double minSNR
MixtureBasis *mix

For massive satellite simulations.

int mlim

Maximum harmonic order restriction.

double muse0
vector<double> muse1

Mass accumulation for PCA.

bool NO_M0

Omit monopole.

bool NO_M1

Flag drop m=1 term.

bool NO_MONO

Omit off-grid force algorithm.

std::normal_distribution nrand
std::vector<unsigned> numbT
std::vector<std::vector<unsigned>> numbT1
vector<double> pack
std::shared_ptr<CoefClasses::CylCoefs> playback

Coefficient playback instance. Using shared_ptr to avoid constructing a simple pointer or null instance

std::vector<Eigen::MatrixXd> potd

Matrices per thread for obtaining potential field.

double resetT

Time at last multistep reset.

std::mt19937 rgen
double rmax

The maximum radius.

double rmin

The minimum radius.

Eigen::MatrixXd rmsC

Expected squared coefficient values for RMS noise computation.

unsigned sampT
double scale

Basis linear scale for mapping.

unsigned int seedN

Pseudorandom generation.

bool self_consistent

Flag self_consitency.

std::vector<Eigen::VectorXd> sinm

Work vectors for sines for all values m

double ssfrac

Subsample fraction of particles.

bool subset

Flag to use subset.

std::vector<std::vector<Eigen::MatrixXd>> tvar
std::vector<Eigen::VectorXd> u

Work vectors to make recursion evaluations thread safe.

vector<double> unpack
std::vector<Eigen::MatrixXd> vc
std::vector<Eigen::MatrixXd> vs
std::vector<double> workC
std::vector<double> workC1
std::vector<double> workS
std::vector<double> workS1

Protected Static Attributes

static pthread_mutex_t cos_coef_lock
static pthread_mutex_t sin_coef_lock
static pthread_mutex_t used_lock

Mutexes for multithreading.

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class Poly : public Eigen::VectorXd
#include <poly.H>

Inheritence diagram for Poly:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="Eigen::VectorXd" tooltip="Eigen::VectorXd"]
    "1" [label="Poly" tooltip="Poly" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Poly:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="Eigen::VectorXd" tooltip="Eigen::VectorXd"]
    "1" [label="Poly" tooltip="Poly" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

double deriv(double z)
double eval(double z)
inline int getorder(void) const
Poly &operator%=(Poly&)
Poly &operator&=(Poly&)
inline Poly operator+()
Poly &operator+=(Poly&)
Poly operator-()
Poly &operator-=(Poly&)
Poly &operator=(Poly&)
Poly(const Eigen::VectorXd&)
Poly(const Poly&)
Poly(int)
Poly(int, double*)
Poly(void)
void print(ostream&)
~Poly(void)

Private Functions

void reduce_order(void)

Private Members

int order

Friends

friend Poly operator%(Poly&, Poly&)
friend Poly operator&(Poly&, Poly&)
friend Poly operator+(Poly&, Poly&)
friend Poly operator-(Poly&, Poly&)
class PotAccel
#include <PotAccel.H>

Inheritence diagram for PotAccel:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="AxisymmetricBasis" tooltip="AxisymmetricBasis"]
    "2" [label="Basis" tooltip="Basis"]
    "8" [label="Bessel" tooltip="Bessel"]
    "5" [label="CBDisk" tooltip="CBDisk"]
    "11" [label="Cube" tooltip="Cube"]
    "10" [label="Cylinder" tooltip="Cylinder"]
    "12" [label="Direct" tooltip="Direct"]
    "32" [label="EJcom" tooltip="EJcom"]
    "13" [label="ExternalForce" tooltip="ExternalForce"]
    "6" [label="FlatDisk" tooltip="FlatDisk"]
    "14" [label="HaloBulge" tooltip="HaloBulge"]
    "28" [label="NoForce" tooltip="NoForce"]
    "15" [label="PeriodicBC" tooltip="PeriodicBC"]
    "4" [label="PolarBasis" tooltip="PolarBasis"]
    "1" [label="PotAccel" tooltip="PotAccel" fillcolor="#BFBFBF"]
    "16" [label="ScatterMFP" tooltip="ScatterMFP"]
    "29" [label="Shells" tooltip="Shells"]
    "30" [label="SlabSL" tooltip="SlabSL"]
    "9" [label="Sphere" tooltip="Sphere"]
    "7" [label="SphericalBasis" tooltip="SphericalBasis"]
    "31" [label="TwoCenter" tooltip="TwoCenter"]
    "17" [label="UserBar" tooltip="UserBar"]
    "18" [label="UserDisk" tooltip="UserDisk"]
    "19" [label="UserHalo" tooltip="UserHalo"]
    "20" [label="UserLogPot" tooltip="UserLogPot"]
    "21" [label="UserMNdisk" tooltip="UserMNdisk"]
    "22" [label="UserMW" tooltip="UserMW"]
    "23" [label="UserTest" tooltip="UserTest"]
    "24" [label="UserTestCuda" tooltip="UserTestCuda"]
    "25" [label="externalShock" tooltip="externalShock"]
    "26" [label="generateRelaxation" tooltip="generateRelaxation"]
    "27" [label="tidalField" tooltip="tidalField"]
    "3" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
    "8" -> "7" [dir=forward tooltip="public-inheritance"]
    "5" -> "4" [dir=forward tooltip="public-inheritance"]
    "11" -> "1" [dir=forward tooltip="public-inheritance"]
    "10" -> "2" [dir=forward tooltip="public-inheritance"]
    "12" -> "1" [dir=forward tooltip="public-inheritance"]
    "32" -> "31" [dir=forward tooltip="public-inheritance"]
    "13" -> "1" [dir=forward tooltip="public-inheritance"]
    "6" -> "4" [dir=forward tooltip="public-inheritance"]
    "14" -> "13" [dir=forward tooltip="public-inheritance"]
    "28" -> "1" [dir=forward tooltip="public-inheritance"]
    "15" -> "13" [dir=forward tooltip="public-inheritance"]
    "4" -> "3" [dir=forward tooltip="public-inheritance"]
    "16" -> "13" [dir=forward tooltip="public-inheritance"]
    "29" -> "1" [dir=forward tooltip="public-inheritance"]
    "30" -> "1" [dir=forward tooltip="public-inheritance"]
    "9" -> "7" [dir=forward tooltip="public-inheritance"]
    "7" -> "3" [dir=forward tooltip="public-inheritance"]
    "31" -> "1" [dir=forward tooltip="public-inheritance"]
    "17" -> "13" [dir=forward tooltip="public-inheritance"]
    "18" -> "13" [dir=forward tooltip="public-inheritance"]
    "19" -> "13" [dir=forward tooltip="public-inheritance"]
    "20" -> "13" [dir=forward tooltip="public-inheritance"]
    "21" -> "13" [dir=forward tooltip="public-inheritance"]
    "22" -> "13" [dir=forward tooltip="public-inheritance"]
    "23" -> "13" [dir=forward tooltip="public-inheritance"]
    "24" -> "13" [dir=forward tooltip="public-inheritance"]
    "25" -> "13" [dir=forward tooltip="public-inheritance"]
    "26" -> "13" [dir=forward tooltip="public-inheritance"]
    "27" -> "13" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for PotAccel:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="Component" tooltip="Component"]
    "5" [label="EL3" tooltip="EL3"]
    "4" [label="Orient" tooltip="Orient"]
    "1" [label="PotAccel" tooltip="PotAccel" fillcolor="#BFBFBF"]
    "6" [label="Timer" tooltip="Timer"]
    "2" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "3" -> "3" [dir=forward tooltip="usage"]
    "3" -> "1" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "6" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="usage"]
    "1" -> "3" [dir=forward tooltip="usage"]
    "2" -> "1" [dir=forward tooltip="usage"]
}

Defines the basic components of the Force class.

This class provides the threading members. Derived classes must provide the per thread members for evaluating coeffients (if any) and acceleration.

Subclassed by Basis, Cube, Direct, ExternalForce, NoForce, Shells, SlabSL, TwoCenter

Public Types

enum Geometry

Possible geometries.

Values:

enumerator sphere
enumerator cylinder
enumerator cube
enumerator slab
enumerator table
enumerator other
typedef std::vector<std::time_t> TList

For timing.

Public Functions

inline bool atol(string &val)

For parameter parsing.

inline void ClearExternal()

Clear external flag.

inline bool cudaAware()

Cuda aware.

virtual void *determine_acceleration_and_potential_thread(void *arg) = 0

Multithreading implementation of the force computation.

inline virtual void determine_coefficients(Component *c)
virtual void determine_coefficients(void) = 0

Used by get_acceleration_and_potential to request that the expansion be performed.

virtual void *determine_coefficients_thread(void *arg) = 0

Multithreading implementation of the expansion computation.

inline virtual void dump_coefs(ostream &out)

Dump current coefficients.

inline virtual void dump_coefs_h5(const std::string &file)
void exp_thread_fork(bool coef)

Make some threads.

virtual void get_acceleration_and_potential(Component *c) = 0

The main force evaluation routine to be called by clients.

inline virtual double getScale()

Get current length scale.

inline bool HaveCoefDump()

Dump coefficients for this force?

void kill_mutex(pthread_mutex_t *m, const char *caller, const char *name)

Kill a mutex.

void make_mutex(pthread_mutex_t *m, const char *caller, const char *name)

Make a mutex.

inline virtual void multistep_debug()

Print debug info.

inline virtual void multistep_reset()

Reset data for multistep.

inline virtual void multistep_update(int cur, int next, Component *c, int i, int id)

Implementation of level shifts.

inline virtual void multistep_update_begin()

Execute to begin level shifts for particles.

Update the multi time step force algorithm when moving particle i from level cur to level next

inline virtual void multistep_update_finish()

Execute to finish level shifts for particles.

inline bool NoCoefs()

Check whether coeffcients are not available.

PotAccel(Component *c0, const YAML::Node &conf)

Constructor

Parameters:
  • c0 – is the instantiating caller (a Component)

  • line – is parsed and info is made available to derived classes on request

void print_timings(const string&, TList &tlist)

For timing the fraction spent in threaded force methods.

void print_timings(const string &label)
inline virtual void RegisterComponent(Component *c)

For access to parent component.

inline virtual void set_multistep_level(unsigned n)

Set the level for evaluating acceleration at level n.

inline void SetExternal()

Set external flag for current force call.

inline virtual void setScale(double s)

Set new length scale (default: 1.0)

void thread_timing_beg(int id)
void thread_timing_end(int id)
inline std::set<std::string> unmatched()

Get unaccounted keys.

inline int Used()

Return umber of particles used on last coefficient evaluation.

virtual ~PotAccel()

Destructor.

Public Members

bool compute

Flag to indicate that PCA variance matrix should be recomputed.

int dof

Dimension of the force vector (degrees of freedom)

Geometry geometry

sphere, cylinder, cube, slab, other

string id

Id string.

std::vector<int> use

Thread particle counter.

Public Static Attributes

static pthread_mutex_t cc_lock

Mutex used to be used in the threading implementations to lock PCA variance matrix for updating

static std::map<Geometry, std::string> geoname

Map from enum to string.

Protected Functions

virtual void initialize(void) = 0

Used by derived class to initialize any storage and parameters.

Protected Attributes

Component *cC

Current component pointer.

bool coef_dump

Coefficient dump flag (true if a useful dump_coefs member is defined)

Component *component

“Back” pointer to component that instantiated this force

const YAML::Node &conf

Contains parameter database.

bool cuda_aware

Cuda implementation is available for this source method. Otherwise, particle structures will be copied between the GPU and CPU at significant expanse

std::set<std::string> current_keys

Current YAML keys to check configuration.

unsigned mlevel

Current level for multistepping.

int nbodies

Number of bodies.

Call to return value for requested parameter name

bool play_back

Coefficient play back flag (true cached coefficients in use)

bool play_cnew

Compute new coefficients during play back (false by default)

double scale

Length scaling (not used for all methods)

TList timer_list

For thread timing.

int use_external

Set flag to add to external potential field.

int used

Number of particles used on last coefficient evaluation.

Private Members

pthread_t *t
thrd_pass_PotAccel *td
class PotRZ
#include <PotRZ.H>

Collaboration diagram for PotRZ:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="PotRZ" tooltip="PotRZ" fillcolor="#BFBFBF"]
    "3" [label="PotRZ::Sk" tooltip="PotRZ::Sk"]
    "2" [label="QDHT" tooltip="QDHT"]
    "1" -> "2" [dir=forward tooltip="usage"]
    "1" -> "3" [dir=forward tooltip="usage"]
    "3" -> "2" [dir=forward tooltip="usage"]
}

Compute the inverse Hankel transform using the quasi-discrete Hankel transform to get the potential based on Gauss’ Law applied to the cylindrical Laplacian. The user supplies a functor containing the surface density. E.g. B&T equations 2.184-2.185.

Public Types

enum class Field

Which field.

Values:

enumerator potential
enumerator rforce
enumerator zforce

Public Functions

inline std::tuple<Eigen::VectorXd, Eigen::VectorXd> getKT(std::function<double(double)> func)

Evalute the forward transform: Sk.

inline double operator()(double r, double z, std::function<double(double)> dens, Field f = Field::potential)

Perform the evaluation at a particular r.

inline std::tuple<Eigen::VectorXd, Eigen::VectorXd> operator()(double z, std::function<double(double)> dens, Field f = Field::potential)

Perform the evaluation.

inline PotRZ(double R, int N, int M)

The gravitational potential by Hankel transform

Constructor

Protected Attributes

std::function<double(double)> mass

Sigma(R) functor instance stored by the constructor.

Private Members

int M
Sk u
QDHT v
QDHT vm
QDHT vp
template<typename real>
class PParticle
#include <PSP2.H>

Public Functions

inline void read(std::istream &in, int pcount, list<PSPstanza>::iterator spos)
inline void read(std::istream &in, int pcount, std::list<PSPstanza>::iterator spos)

Public Members

vector<real> datr
std::vector<real> datr
vector<int> iatr
std::vector<int> iatr
unsigned long indx
real mass
real phi
real pos[3]
real vel[3]
template<typename real>
class PParticle : public Particle
#include <ParticleReader.H>

Inheritence diagram for PR::PParticle:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="PR::PParticle< real >" tooltip="PR::PParticle< real >" fillcolor="#BFBFBF"]
    "2" [label="Particle" tooltip="Particle"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for PR::PParticle:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="PR::PParticle< real >" tooltip="PR::PParticle< real >" fillcolor="#BFBFBF"]
    "2" [label="Particle" tooltip="Particle"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline void read(std::istream &in, int pcount, list<PSPstanza>::iterator spos)
inline void skip(std::istream &in, int pcount, list<PSPstanza>::iterator spos)
class progress_display
#include <Progress.H>

Public Functions

inline unsigned long count() const
inline unsigned long expected_count() const
inline unsigned long operator++()
inline unsigned long operator+=(unsigned long increment)
inline explicit progress_display(unsigned long expected_count_, std::ostream &os = std::cout, const std::string &s1 = "\n", const std::string &s2 = "", const std::string &s3 = "")
inline void restart(unsigned long expected_count_)

Private Functions

inline void display_tic()

Private Members

std::ostream &m_os
const std::string m_s1
const std::string m_s2
const std::string m_s3
class PseudoAccel
#include <PseudoAccel.H>

Public Functions

inline void add(double t, const Eigen::Vector3d &c, const Eigen::Vector3d &a)

Add a center element to the pseudo accelration estimator.

inline std::tuple<Eigen::Vector3d&, Eigen::Vector3d&, Eigen::Vector3d&> operator()()
inline PseudoAccel(unsigned int Nsize, bool center, bool axis)

Construct a pseudo acceleration estimator.

Private Types

using Elem = std::array<double, 7>

Queue of elements.

Private Members

Eigen::Vector3d accel = Eigen::Vector3d::Zero()

Storage.

bool AXIS = false
bool CENTER = false

Type flags.

Eigen::Vector3d domdt = Eigen::Vector3d::Zero()
unsigned int Nsize

Maximum number of time points.

Eigen::Vector3d omega = Eigen::Vector3d::Zero()
std::deque<Elem> queue
class PSP : public PR::ParticleReader
#include <ParticleReader.H>

Inheritence diagram for PR::PSP:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="PR::PSP" tooltip="PR::PSP" fillcolor="#BFBFBF"]
    "3" [label="PR::PSPout" tooltip="PR::PSPout"]
    "4" [label="PR::PSPspl" tooltip="PR::PSPspl"]
    "2" [label="PR::ParticleReader" tooltip="PR::ParticleReader"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for PR::PSP:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="ComponentHeader" tooltip="ComponentHeader"]
    "3" [label="MasterHeader" tooltip="MasterHeader"]
    "8" [label="PR::PParticle< double >" tooltip="PR::PParticle< double >"]
    "6" [label="PR::PParticle< float >" tooltip="PR::PParticle< float >"]
    "1" [label="PR::PSP" tooltip="PR::PSP" fillcolor="#BFBFBF"]
    "4" [label="PR::PSPstanza" tooltip="PR::PSPstanza"]
    "2" [label="PR::ParticleReader" tooltip="PR::ParticleReader"]
    "7" [label="Particle" tooltip="Particle"]
    "8" -> "7" [dir=forward tooltip="public-inheritance"]
    "6" -> "7" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "3" [dir=forward tooltip="usage"]
    "1" -> "4" [dir=forward tooltip="usage"]
    "1" -> "6" [dir=forward tooltip="usage"]
    "1" -> "8" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="usage"]
}

Subclassed by PR::PSPout, PR::PSPspl

Public Functions

inline virtual unsigned long CurrentNumber()

Number of particles in current type.

inline virtual double CurrentTime()

Get snapshot time.

virtual const Particle *firstParticle() = 0

Particle access.

inline virtual PSPstanza *GetNamed(const std::string &name)

Set stanza to name.

virtual PSPstanza *GetStanza()

Reset to beginning of stanza list and return null if no stanzas.

inline virtual std::vector<std::string> GetTypes()

Return list of particle types.

virtual const Particle *nextParticle() = 0

Get the next particle.

virtual PSPstanza *NextStanza()

Get next stanza in list and return null at end;.

void PrintSummary(ostream &out, bool stats = false, bool timeonly = false)

Print summary phase-space info.

inline PSP(bool verbose)

Default constructor.

inline virtual void SelectType(const std::string &name)

Set to type.

void writePSP(std::ostream &out, bool real4)

Write a new PSP file.

inline virtual ~PSP()

Destructor.

Protected Functions

void ComputeStats()
inline void init()

Stream init.

void write_binary(std::ostream &out, list<PSPstanza>::iterator its, bool real4)

Protected Attributes

PSPstanza *cur
PParticle<double> dpart
PParticle<float> fpart
MasterHeader header
std::ifstream in
float mtot

Temporaries for stanza statistics.

int pcount
std::vector<double> pmax
std::vector<double> pmed
std::vector<double> pmin
std::list<PSPstanza>::iterator spos
std::list<PSPstanza> stanzas
bool VERBOSE
std::vector<double> vmax
std::vector<double> vmed
std::vector<double> vmin

Protected Static Attributes

static const unsigned long magic = 0xadbfabc0
static const unsigned long mmask = 0xf
static const unsigned long nmask = ~mmask
class PSP
#include <PSP2.H>

Inheritence diagram for PSP:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="PSP" tooltip="PSP" fillcolor="#BFBFBF"]
    "2" [label="PSPout" tooltip="PSPout"]
    "3" [label="PSPspl" tooltip="PSPspl"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for PSP:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="ComponentHeader" tooltip="ComponentHeader"]
    "2" [label="MasterHeader" tooltip="MasterHeader"]
    "1" [label="PSP" tooltip="PSP" fillcolor="#BFBFBF"]
    "3" [label="PSPstanza" tooltip="PSPstanza"]
    "5" [label="SParticle" tooltip="SParticle"]
    "1" -> "2" [dir=forward tooltip="usage"]
    "1" -> "3" [dir=forward tooltip="usage"]
    "1" -> "5" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
}

Subclassed by PSPout, PSPout, PSPspl, PSPspl

Public Functions

inline virtual SParticle *begin()

Define necessary member functions to be a valid container iterator

inline double CurrentTime()

Get snapshot time.

inline double CurrentTime()

Get snapshot time.

inline virtual SParticle *end()
inline virtual PSPstanza *GetNamed(const std::string &name)

Set stanza to name.

inline virtual PSPstanza *GetNamed(const std::string &name)

Set stanza to name.

virtual SParticle *GetParticle() = 0

Reset to beginning of particles for this component.

virtual SParticle *GetParticle() = 0

Reset to beginning of particles for this component.

virtual PSPstanza *GetStanza()

Reset to beginning of stanza list and return null if no stanzas.

virtual PSPstanza *GetStanza()

Reset to beginning of stanza list and return null if no stanzas.

virtual SParticle *NextParticle() = 0

Get next particle and return null at end.

virtual SParticle *NextParticle() = 0

Get next particle and return null at end.

virtual PSPstanza *NextStanza()

Get next stanza in list and return null at end;.

virtual PSPstanza *NextStanza()

Get next stanza in list and return null at end;.

inline virtual bool operator!=(SParticle *const &other)
inline virtual SParticle *operator++()
inline virtual bool operator==(SParticle *const &other)
void PrintSummary(ostream &out, bool stats = false, bool timeonly = false)

Print summary phase-space info.

void PrintSummary(std::ostream &out, bool stats = false, bool timeonly = false)

Print summary phase-space info.

inline PSP(bool verbose)

Default constructor.

inline PSP(bool verbose)

Default constructor.

inline PSP(bool verbose, std::string new_dir)

Constructor specifying current working data directory.

inline PSP(bool verbose, std::string new_dir)

Constructor specifying current working data directory.

void writePSP(std::ostream &out, bool real4)

Write a new PSP file.

void writePSP(std::ostream &out, bool real4)

Write a new PSP file.

inline virtual ~PSP()

Destructor.

inline virtual ~PSP()

Destructor.

Public Static Functions

static std::shared_ptr<PSP> getPSP(const std::string &file, const std::string dir = "", bool verbose = false)

PSP factory: choose type based on file name.

Protected Functions

void check_dirname()

Append ‘/’ if necessary.

void check_dirname()

Append ‘/’ if necessary.

void ComputeStats()
void ComputeStats()
inline void init()

Stream init.

inline void init()

Stream init.

void write_binary(std::ostream &out, list<PSPstanza>::iterator its, bool real4)
void write_binary(std::ostream &out, std::list<PSPstanza>::iterator its, bool real4)

Protected Attributes

PSPstanza *cur
MasterHeader header
std::ifstream in
float mtot

Temporaries for stanza statistics.

std::string new_dir
SParticle part
int pcount
std::vector<float> pmax
std::vector<float> pmed
std::vector<float> pmin
list<PSPstanza>::iterator spos
std::list<PSPstanza>::iterator spos
list<PSPstanza> stanzas
std::list<PSPstanza> stanzas
bool VERBOSE
std::vector<float> vmax
std::vector<float> vmed
std::vector<float> vmin

Protected Static Attributes

static const unsigned long magic = 0xadbfabc0
static const unsigned long mmask = 0xf
static const unsigned long nmask = ~mmask
class PSPout : public PR::PSP
#include <ParticleReader.H>

Inheritence diagram for PR::PSPout:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="PR::PSP" tooltip="PR::PSP"]
    "1" [label="PR::PSPout" tooltip="PR::PSPout" fillcolor="#BFBFBF"]
    "3" [label="PR::ParticleReader" tooltip="PR::ParticleReader"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for PR::PSPout:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "6" [label="ComponentHeader" tooltip="ComponentHeader"]
    "4" [label="MasterHeader" tooltip="MasterHeader"]
    "9" [label="PR::PParticle< double >" tooltip="PR::PParticle< double >"]
    "7" [label="PR::PParticle< float >" tooltip="PR::PParticle< float >"]
    "2" [label="PR::PSP" tooltip="PR::PSP"]
    "1" [label="PR::PSPout" tooltip="PR::PSPout" fillcolor="#BFBFBF"]
    "5" [label="PR::PSPstanza" tooltip="PR::PSPstanza"]
    "3" [label="PR::ParticleReader" tooltip="PR::ParticleReader"]
    "8" [label="Particle" tooltip="Particle"]
    "9" -> "8" [dir=forward tooltip="public-inheritance"]
    "7" -> "8" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="usage"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "2" -> "7" [dir=forward tooltip="usage"]
    "2" -> "9" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="usage"]
}

Class to access a full PSP file (OUT)

Public Functions

virtual const Particle *firstParticle()

Particle access.

virtual const Particle *nextParticle()

Get the next particle.

PSPout(const std::vector<std::string> &file, bool verbose = false)

Constructor.

inline virtual ~PSPout()

Destructor.

Private Members

streampos pos
class PSPout : public PSP, public PSP
#include <PSP2.H>

Inheritence diagram for PSPout:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="PSP" tooltip="PSP"]
    "1" [label="PSPout" tooltip="PSPout" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for PSPout:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="ComponentHeader" tooltip="ComponentHeader"]
    "3" [label="MasterHeader" tooltip="MasterHeader"]
    "2" [label="PSP" tooltip="PSP"]
    "1" [label="PSPout" tooltip="PSPout" fillcolor="#BFBFBF"]
    "4" [label="PSPstanza" tooltip="PSPstanza"]
    "6" [label="SParticle" tooltip="SParticle"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "2" -> "4" [dir=forward tooltip="usage"]
    "2" -> "6" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "4" -> "5" [dir=forward tooltip="usage"]
}

Class to access a full PSP file (OUT)

Public Functions

virtual SParticle *GetParticle()

Reset to beginning of particles for this component.

virtual SParticle *GetParticle()

Iterators.

virtual SParticle *NextParticle()

Get next particle and return null at end.

virtual SParticle *NextParticle()

Get next particle and return null at end.

PSPout(const std::string &file, bool verbose = false)
PSPout(const std::string &file, bool verbose = false)
inline virtual ~PSPout()

Destructor.

inline virtual ~PSPout()

Destructor.

Private Members

streampos pos
std::streampos pos
class PSPspl : public PR::PSP
#include <ParticleReader.H>

Inheritence diagram for PR::PSPspl:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="PR::PSP" tooltip="PR::PSP"]
    "1" [label="PR::PSPspl" tooltip="PR::PSPspl" fillcolor="#BFBFBF"]
    "3" [label="PR::ParticleReader" tooltip="PR::ParticleReader"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for PR::PSPspl:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "6" [label="ComponentHeader" tooltip="ComponentHeader"]
    "4" [label="MasterHeader" tooltip="MasterHeader"]
    "9" [label="PR::PParticle< double >" tooltip="PR::PParticle< double >"]
    "7" [label="PR::PParticle< float >" tooltip="PR::PParticle< float >"]
    "2" [label="PR::PSP" tooltip="PR::PSP"]
    "1" [label="PR::PSPspl" tooltip="PR::PSPspl" fillcolor="#BFBFBF"]
    "5" [label="PR::PSPstanza" tooltip="PR::PSPstanza"]
    "3" [label="PR::ParticleReader" tooltip="PR::ParticleReader"]
    "8" [label="Particle" tooltip="Particle"]
    "9" -> "8" [dir=forward tooltip="public-inheritance"]
    "7" -> "8" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="usage"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "2" -> "7" [dir=forward tooltip="usage"]
    "2" -> "9" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="usage"]
}

Class to access a SPLIT PSP file (SPL)

Public Functions

virtual const Particle *firstParticle()

Particle access.

virtual const Particle *nextParticle()

Get the next particle.

PSPspl(const std::vector<std::string> &file, bool verbose = false)

Constuctors.

inline virtual ~PSPspl()

Destructor.

Private Functions

void openNextBlob()

Open next file part.

Private Members

unsigned int fcount
std::vector<std::string>::iterator fit
unsigned int N
class PSPspl : public PSP, public PSP
#include <PSP2.H>

Inheritence diagram for PSPspl:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="PSP" tooltip="PSP"]
    "1" [label="PSPspl" tooltip="PSPspl" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for PSPspl:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="ComponentHeader" tooltip="ComponentHeader"]
    "3" [label="MasterHeader" tooltip="MasterHeader"]
    "2" [label="PSP" tooltip="PSP"]
    "1" [label="PSPspl" tooltip="PSPspl" fillcolor="#BFBFBF"]
    "4" [label="PSPstanza" tooltip="PSPstanza"]
    "6" [label="SParticle" tooltip="SParticle"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "2" -> "4" [dir=forward tooltip="usage"]
    "2" -> "6" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "4" -> "5" [dir=forward tooltip="usage"]
}

Class to access a SPLIT PSP file (SPL)

Public Functions

virtual SParticle *GetParticle()

Reset to beginning of particles for this component.

virtual SParticle *GetParticle()

Reset to beginning of particles for this component.

virtual SParticle *NextParticle()

Get next particle and return null at end.

virtual SParticle *NextParticle()

Get next particle and return null at end.

PSPspl(const std::string &file, const std::string dir = "", bool verbose = false)

Constuctors.

PSPspl(const std::string &file, const std::string dir = "", bool verbose = false)

Constuctors.

inline virtual ~PSPspl()

Destructor.

inline virtual ~PSPspl()

Destructor.

Private Functions

void openNextBlob()

Open next file part.

void openNextBlob()

Open next file part.

Private Members

unsigned int fcount
std::vector<std::string>::iterator fit
unsigned int N
class PSPstanza
#include <ParticleReader.H>

Collaboration diagram for PR::PSPstanza:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="ComponentHeader" tooltip="ComponentHeader"]
    "1" [label="PR::PSPstanza" tooltip="PR::PSPstanza" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="usage"]
}

Public Functions

inline bool operator==(const PSPstanza &x) const

Public Members

ComponentHeader comp
std::string cparam
std::string fparam
std::string id
size_t index_size
std::string name
std::vector<std::string> nparts
streampos pos
streampos pspos
size_t r_size
class PSPstanza
#include <PSP2.H>

Collaboration diagram for PSPstanza:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="ComponentHeader" tooltip="ComponentHeader"]
    "1" [label="PSPstanza" tooltip="PSPstanza" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="usage"]
}

Public Functions

inline bool operator==(const PSPstanza &x) const
inline bool operator==(const PSPstanza &x) const

Public Members

ComponentHeader comp
std::string cparam
std::string fparam
std::string id
size_t index_size
std::string name
std::vector<std::string> nparts
streampos pos
std::streampos pos
streampos pspos
std::streampos pspos
size_t r_size
class PVQuad : public Legendre
#include <CauchyPV.H>

Inheritence diagram for PVQuad:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="Legendre" tooltip="Legendre"]
    "3" [label="OrthoPoly" tooltip="OrthoPoly"]
    "1" [label="PVQuad" tooltip="PVQuad" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for PVQuad:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="Legendre" tooltip="Legendre"]
    "3" [label="OrthoPoly" tooltip="OrthoPoly"]
    "1" [label="PVQuad" tooltip="PVQuad" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline double mu(int i)
inline double norm(int i)
inline Eigen::VectorXd &ovec(int i)
PVQuad(int N = 10)
inline Eigen::VectorXd &return_coefs(Eigen::VectorXd &input)
Eigen::VectorXd &return_coefs(std::function<double(double)> func)
inline double return_pv(double lambda)
inline double return_pv(double lambda, Eigen::VectorXd &input)
inline double return_pv(double lambda, std::function<double(double)> func)
inline double root(int i)

Private Functions

Eigen::VectorXd &get_coefs(Eigen::VectorXd&)
void get_eigenvalues(void)
double get_integral(double)
void get_orthopolies(void)
inline double q0(double x)

Private Members

Eigen::VectorXd chrs
Eigen::VectorXd coefs
Eigen::VectorXd eign
int n
Eigen::VectorXd nrml
std::vector<Eigen::VectorXd> poly
class PyModel : public EmpCylSL::AxiDisk
#include <DiskModels.H>

Inheritence diagram for PyModel:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EmpCylSL::AxiDisk" tooltip="EmpCylSL::AxiDisk"]
    "1" [label="PyModel" tooltip="PyModel" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for PyModel:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EmpCylSL::AxiDisk" tooltip="EmpCylSL::AxiDisk"]
    "1" [label="PyModel" tooltip="PyModel" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

A user-defined Python model.

Public Functions

inline virtual double operator()(double R, double z, double phi = 0.)

Density function.

inline PyModel(std::string &pyname)

Private Members

std::shared_ptr<DiskDensityFunc> pyDens
class QDHT
#include <QDHT.H>

Hankel transform based on the QDHT algorithm

See: “Computation of quasi-discrete Hankel transforms of the integer

order for propagating optical wave fields” Manuel Guizar-Sicairos and Julio C. Guitierrez-Vega J. Opt. Soc. Am. A 21 (1) 53-58 (2004)

Public Functions

void check()

Check solution.

inline const Eigen::VectorXd &getK()

Compute the transform coordinates (e.g. spatial frequencies)

inline const Eigen::VectorXd &getR()

Compute the input coordinates (e.g. radii)

double operator()(double r, Eigen::VectorXd &v)

Inverse Hankel transform at r.

Eigen::VectorXd operator()(Eigen::VectorXd &v, bool forward = true)

Compute the forward or backward Hankel transform.

inline QDHT()

Null constructor.

QDHT(int M, int N, double R)

Constructor

Parameters:
  • M – is the harmonic order

  • N – is the number of knots

  • R – is the radius at which the input function is zero

inline ~QDHT()

Destructor.

Public Static Attributes

static bool debug

For checking unitarity (default: false)

Private Members

Eigen::VectorXd Jp

Jp vector.

Eigen::VectorXd k
int N

N is number of knots.

double nu

nu is Bessel function order

double R

Dimension 1 scale.

Eigen::VectorXd r

R and K vectors.

double S

Total bandwidth.

Eigen::MatrixXd T

Transform matrix.

double V

Dimension 2 scale.

Eigen::VectorXd zeros

Will contain the zeros of the Bessel function of order nu.

class QPDistF
#include <QPDistF.H>

Compute distribution function for axisymmetric models using quadratic programming techniques

Public Functions

void compute_distribution(void)
double d2fdE2(double E, double L)
double d2fdE2_EK(double E, double K)
double d2fdEK_EK(double E, double K)
double d2fdK2_EK(double E, double K)
double dfdE(double E, double L)
double dfdE_EK(double E, double K)
double dfdK_EK(double E, double K)
double dfdL(double E, double L)
double distf(double E, double L)
double distf_EK(double E, double K)
void dump_cdf(const string &file)
pair<double, double> gen_EK(double r1, double r2)
inline void get_objective(double *OBJ0, double *OBJ, int *IFLG)
void make_cdf(int ENUM, int KNUM, double KTOL = 1.0e-3)
QPDistF(AxiSymModPtr T, AxiSymModPtr H, double rmmax, double remax, int egrid, int kgrid, int mgrid, double sigma = 2.0, double lambda = 0.0, double alpha = -4.0, double beta = 1.0, double gama = 1.0, double roff = 0.01, double eoff = 0.5, double koff = 0.5, double kmin = 0.0, double kmax = 1.0, int nint = 80, int numt = 40)

Constructor

Parameters:
  • T – is a pointer to an axisymmetric model (2 or 3 dim)

  • H – is a pointer to an axisymmetric model (3-d halo)

  • rmmax – is the maximum radius for the radial QP grid

  • remax – determines the maximum energy Phi(remax) for the energy grid

  • egrid – is the number of energy knots for Gaussian kernels

  • kgrid – is the number of kappa knots for Gaussian kernels

  • mgrid – is the number of radial knots for density evaluation

  • sigma – is the fraction over the spacing for the kernel width

  • lambda – is the penalty coefficient in powers of kappa

  • alpha – is the exponent for powers of kappa

  • beta – is the power law exponent for radial-grid spacing in mass fraction

  • gama – is the power law exponent for energy-grid spacing

  • roff – is the offset of the mass zero point

  • eoff – is the offset of the energy grid from Emin

  • koff – is the offset of the energy grid from Kmin

  • kmin – is the minimum value of kappa

  • kmax – is the maximum value of kappa

  • nint – is the number of knots in the velocity magnitude integral

  • numt – is the number of knots in the velocity angular integral

QPDistF(AxiSymModPtr T, double rmmax, double remax, int egrid, int kgrid, int mgrid, double sigma = 2.0, double lambda = 0.0, double alpha = -4.0, double beta = 1.0, double gama = 1.0, double roff = 0.01, double eoff = 0.5, double koff = 0.5, double kmin = 0.0, double kmax = 1.0, int nint = 80, int numt = 40)
QPDistF(AxiSymModPtr T, string file)
void read_state(string &name)
void set_verbose(int verbosity)
void set_verbose(void)
void write_state(string &name)
~QPDistF(void)

Public Static Attributes

static double FSIGE
static double FSIGK
static int ITERMAX
static double ITERTOL
static bool MassEGrid
static bool MassLinear

Private Types

typedef pair<double, ip> elem
typedef pair<int, int> ip

Private Functions

inline void bomb(char *s)
double kernel(double x, double y, double x0, double y0, double sx, double sy)
double kernel_x(double x, double y, double x0, double y0, double sx, double sy)
double kernel_x2(double x, double y, double x0, double y0, double sx, double sy)
double kernel_xy(double x, double y, double x0, double y0, double sx, double sy)
double kernel_y(double x, double y, double x0, double y0, double sx, double sy)
double kernel_y2(double x, double y, double x0, double y0, double sx, double sy)

Private Members

double ALPHA
double BETA
vector<double> cdf
bool df_computed
int EGRID
Eigen::VectorXd Egrid
double Emax
double Emin
double EOFF
double GAMA
int IFAIL
Eigen::VectorXd JMAX
Eigen::VectorXd JMAX2
Eigen::VectorXd JMAXE
int KGRID
Eigen::VectorXd Kgrid
double KMAX
double KMIN
double KOFF
double LAMBDA
int MGRID
int NINT
int NJMAX
bool nt
int NUME
int NUMK
int NUMT
double obj
double obj0
std::shared_ptr<SphericalOrbit> orb
vector<double> pdf
multimap<double, ip> realz
double REMAX
double RMMAX
double ROFF
double SIGMA
Eigen::VectorXd sigma_E
Eigen::VectorXd sigma_K
std::shared_ptr<AxiSymModel> t
double TOLE
double TOLK
int verbose
Eigen::VectorXd X
template<typename T>
class QuadLS
#include <QuadLS.H>

Public Functions

inline std::tuple<double, double, double> coefs() const

Access coefficients.

inline double operator()(const double x) const

Evaluate the quadratic function.

inline QuadLS()

Null constructor.

inline QuadLS(const T &x, const T &y)

Constructor.

inline virtual ~QuadLS()

Destructor.

Private Functions

inline void fit(const T &x, const T &y)
class Quadrupole_Bar
#include <models.H>

Public Functions

Eigen::Vector3d force(Eigen::Vector3d&)
double potential(Eigen::Vector3d&)
inline void set_Quadrupole_Bar(double G, double Q, double length)

Protected Attributes

double a2
double GQ
class RegularOrbit
#include <orbit.H>

Inheritence diagram for RegularOrbit:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="RegularOrbit" tooltip="RegularOrbit" fillcolor="#BFBFBF"]
    "2" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
}

Subclassed by SphericalOrbit

Public Functions

void bomb(const char *s)
void bomb(const string &s)
virtual double get_action(const int) = 0
virtual double get_angle(const int, const double) = 0
virtual double get_freq(const int) = 0
void warn(const string &fct, const string &msg)
inline virtual ~RegularOrbit()

Public Members

Eigen::Vector3d action
bool action_defined
bool angle_defined
bool biorth_defined
int dof
Eigen::Vector3d freq
bool freq_defined
bool model_defined
std::string OrbitID
class RGrid

Grid to hold tabulated basis.

Public Members

int nmax
Eigen::MatrixXd rw
Eigen::MatrixXd rw2
template<typename T, typename Container = std::vector<T>, typename Iterator = typename Container::iterator>
class RingIterator
#include <Circular.H>

Public Types

using difference_type = std::ptrdiff_t
using iterator_category = std::bidirectional_iterator_tag

Add typedefs for std::iterator_traits.

using pointer = T*
using reference = T&
using value_type = T

Public Functions

inline RingIterator erase()

Erase the current element.

inline RingIterator insert(const T &x)

Insert a new element at the current position.

inline bool operator!=(const RingIterator &x) const

Test for inequality.

inline T operator*() const

Return current data element.

inline RingIterator &operator++()

Pre-increment operator.

inline RingIterator operator++(int)

Post-increment operator.

inline RingIterator &operator--()

Pre-decrement operator.

inline RingIterator operator--(int)

Post-decrement operator.

inline Iterator operator->() const

Return current iterator.

inline bool operator==(const RingIterator &x) const

Test for equality.

inline RingIterator(Container &v)

Create from v and position at the beginning.

inline RingIterator(Container &v, const Iterator &i)

Create from v and begin at iterator i.

inline RingIterator(Container &v, const Iterator &i, const Iterator &j)

Create from v using positions i through j.

inline RingIterator(Container &v, size_t i)

Create from v and begin at position i.

Private Members

Iterator begin
Iterator cursor
Container &data
Iterator end
class RK4
#include <RK4.H>

RK4 takes one 4th-order Runge-Kutta step.

Public Types

using Force = std::function<Vref(double, Vref)>

Functoid defintion for the force.

using Vref = Eigen::Ref<Eigen::VectorXd>

Reference to an Eigen vector.

Public Functions

inline RK4(Force force)

Constructor defining the force function.

inline double step(Vref x, double t, double dt)

Take a single RK4 step.

Private Members

Force force

Force instance.

class Roots

Cache roots for spherical Bessel functions.

Public Functions

inline Roots(int L, int nmax)
inline ~Roots()

Public Members

Eigen::VectorXd a
int l
int n
class RUN
#include <massmodel.H>

A one-dimensional profile.

Public Functions

inline void resize(int N)
inline RUN()

Simple constructor. Use value of num to check for initialization.

Public Members

int num
Eigen::VectorXd x
Eigen::VectorXd y
Eigen::VectorXd y2
class RunningTime
#include <RunningTime.H>

Collaboration diagram for RunningTime:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="RunningTime" tooltip="RunningTime" fillcolor="#BFBFBF"]
    "2" [label="Timer" tooltip="Timer"]
    "1" -> "2" [dir=forward tooltip="usage"]
}

Public Functions

inline double getLast()
inline double getTavg()
inline double getTime()
inline RunningTime()
inline RunningTime(unsigned n)
inline void Start()
inline void Stop(bool final = true)

Private Functions

inline void append()
inline void initialize(unsigned n)
inline void lap()

Private Members

double accum
std::deque<double> boxcar
double current
double last
unsigned nkeep
Timer timer
double value
class ScatterMFP : public ExternalForce
#include <ScatterMFP.H>

Inheritence diagram for ScatterMFP:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="ScatterMFP" tooltip="ScatterMFP" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for ScatterMFP:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="Component" tooltip="Component"]
    "7" [label="EL3" tooltip="EL3"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "6" [label="Orient" tooltip="Orient"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="ScatterMFP" tooltip="ScatterMFP" fillcolor="#BFBFBF"]
    "8" [label="Timer" tooltip="Timer"]
    "4" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "5" -> "5" [dir=forward tooltip="usage"]
    "5" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "5" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
}

Compute acceleration based on mean free path (dark matter pressure)

Will probably never use this again …

Public Functions

ScatterMFP(const YAML::Node &conf)

Constructor.

~ScatterMFP()

Destructor.

Private Functions

virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreaded method (must be thread safe) for force computation that must be provided by all derived classes (hence pure virtual)

virtual void get_acceleration_and_potential(Component *C)

Will be called by clients to evaluate force.

virtual void initialize()

Used by derived class to initialize any storage and parameters.

Private Members

Component *c
int cntacc
vector<int> cntr
string comp_id
double dr
double *dtau
double *dtau1
int mfp_index
std::normal_distribution norm
int nscat
double rmax
vector<rpair> rr2
double tau
double tauscat
int tautab
std::uniform_real_distribution unif

Pseudorandom generation.

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class Sech2 : public OneDModel
#include <massmodel1d.H>

Inheritence diagram for Sech2:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="MassModel" tooltip="MassModel"]
    "2" [label="OneDModel" tooltip="OneDModel"]
    "1" [label="Sech2" tooltip="Sech2" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Sech2:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="MassModel" tooltip="MassModel"]
    "2" [label="OneDModel" tooltip="OneDModel"]
    "1" [label="Sech2" tooltip="Sech2" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline virtual double dfde(const double E, const double p)
inline virtual double dfdv(const double E, const double p)
inline virtual double distf(const double E, const double p)
inline virtual double get_density(const double x, const double y, const double z)

The density at (x, y, z)

inline virtual double get_density(const double z)
inline virtual double get_dpot(const double z)
inline virtual double get_dpot2(const double z)
inline virtual double get_mass(const double x, const double y, const double z)

Get the mass inside of position (x, y, z) (this is ambiguous in general and will depend on the model)

inline virtual double get_mass(const double z)
inline virtual double get_max_radius(void)
inline virtual double get_min_radius(void)
inline virtual double get_pot(const double x, const double y, const double z)

The potential at (x, y, z)

inline virtual double get_pot(const double z)
inline virtual tuple<double, double> get_pot_dpot(const double z)
inline virtual double get_scale_height(void)
inline Sech2(const double DISPZ, const double DISPX = 1.0)
inline Sech2(void)

Public Static Functions

static inline void set_hmax(double hmax)

Private Members

double dispx
double dispz
double h
double norm

Private Static Attributes

static double HMAX
class Sech2Halo : public OneDModelTable
#include <massmodel1d.H>

Inheritence diagram for Sech2Halo:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="MassModel" tooltip="MassModel"]
    "3" [label="OneDModel" tooltip="OneDModel"]
    "2" [label="OneDModelTable" tooltip="OneDModelTable"]
    "1" [label="Sech2Halo" tooltip="Sech2Halo" fillcolor="#BFBFBF"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Sech2Halo:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "6" [label="Interp1d" tooltip="Interp1d"]
    "4" [label="MassModel" tooltip="MassModel"]
    "3" [label="OneDModel" tooltip="OneDModel"]
    "2" [label="OneDModelTable" tooltip="OneDModelTable"]
    "1" [label="Sech2Halo" tooltip="Sech2Halo" fillcolor="#BFBFBF"]
    "5" [label="Spline1d" tooltip="Spline1d"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline virtual double dfde(const double E, const double p = 0.0)
inline virtual double dfdv(const double E, const double p = 0.0)
inline virtual double distf(const double E, const double p = 0.0)
inline virtual double get_dpot(const double z)
inline virtual double get_dpot2(const double z)
inline virtual double get_max_radius(void)
inline virtual double get_min_radius(void)
inline virtual double get_pot(const double z)
inline virtual std::tuple<double, double> get_pot_dpot(const double z)
inline double get_rho0(void)
inline double get_rho0_halo(void)
inline virtual double get_scale_height(void)
inline double get_scale_height_halo(void)
Sech2Halo(const double DISPZ, const double DRATIO, const double HRATIO, const double DISPX = 1.0)
inline Sech2Halo(void)

Public Static Functions

static inline void set_hmax(double hmax)

Public Static Attributes

static bool MU
static int NTABLE
static double OFFSET

Private Functions

void reset()

Private Members

double dispx
double dispz
double dratio
double h
double hh
double hmax
double hratio
bool model_computed
double norm
double rho0
double rho0h

Private Static Attributes

static double HMAX
class Sech2mu : public OneDModel
#include <massmodel1d.H>

Inheritence diagram for Sech2mu:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="MassModel" tooltip="MassModel"]
    "2" [label="OneDModel" tooltip="OneDModel"]
    "1" [label="Sech2mu" tooltip="Sech2mu" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Sech2mu:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="MassModel" tooltip="MassModel"]
    "2" [label="OneDModel" tooltip="OneDModel"]
    "1" [label="Sech2mu" tooltip="Sech2mu" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline virtual double dfde(const double E, const double p)
inline virtual double dfdv(const double E, const double p)
inline virtual double distf(const double E, const double p)
inline virtual double get_density(const double x, const double y, const double z)

The density at (x, y, z)

inline virtual double get_density(const double z)
inline virtual double get_dpot(const double z)
inline virtual double get_dpot2(const double z)
inline virtual double get_mass(const double x, const double y, const double z)

Get the mass inside of position (x, y, z) (this is ambiguous in general and will depend on the model)

inline virtual double get_mass(const double z)
inline virtual double get_max_radius(void)
inline virtual double get_min_radius(void)
inline virtual double get_pot(const double x, const double y, const double z)

The potential at (x, y, z)

inline virtual double get_pot(const double z)
inline void get_pot_dpot(const double z, double &p, double &dp)
inline virtual double get_scale_height(void)
inline Sech2mu(const double DISPZ, const double H, const double DISPX = 1.0)
inline Sech2mu(void)
inline void setMu(double Sigma0)

Public Static Functions

static inline void set_hmax(double hmax)

Private Members

double dispx
double dispz
double dnorm
double fnorm
double h
double knorm
double mu

Private Static Attributes

static double HMAX
class SechMap : public SLGridSlab::CoordMap

Inheritence diagram for SLGridSlab::SechMap:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="SLGridSlab::CoordMap" tooltip="SLGridSlab::CoordMap"]
    "1" [label="SLGridSlab::SechMap" tooltip="SLGridSlab::SechMap" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for SLGridSlab::SechMap:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="SLGridSlab::CoordMap" tooltip="SLGridSlab::CoordMap"]
    "1" [label="SLGridSlab::SechMap" tooltip="SLGridSlab::SechMap" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

x = z/sqrt(z^2 + H^2)

Public Functions

virtual double d_xi_to_z(double z)

Jacobian of the transformation.

inline SechMap(double H)
virtual double xi_to_z(double z)

Convert from mapped coordinate back to vertical.

virtual double z_to_xi(double z)

Convert from vertical to mapped coordinate.

class Shells : public PotAccel
#include <Shells.H>

Inheritence diagram for Shells:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="Shells" tooltip="Shells" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Shells:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="Component" tooltip="Component"]
    "6" [label="EL3" tooltip="EL3"]
    "5" [label="Orient" tooltip="Orient"]
    "2" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="Shells" tooltip="Shells" fillcolor="#BFBFBF"]
    "7" [label="Timer" tooltip="Timer"]
    "3" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "4" -> "4" [dir=forward tooltip="usage"]
    "4" -> "2" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="usage"]
    "4" -> "7" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "2" -> "4" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "3" -> "2" [dir=forward tooltip="usage"]
}

Computes the potential, acceleration and density using spherical, Lagrangian shells

Settable parameters:

Param nsample:

is the number of particles per sample for the shell boundary computation.

Param nselect:

is the number of particle intervals in computing the cumulative distribution

Public Functions

virtual void get_acceleration_and_potential(Component*)

The main force call.

virtual void multistep_update(int cur, int next, Component *c, int i, int id)

Implementation of level shifts.

virtual void multistep_update_begin()

Execute to begin level shifts for particles.

virtual void multistep_update_finish()

Execute to finish level shifts for particles.

Shells(Component *c0, const YAML::Node &conf)

The constructor

Parameters:
  • c0 – is the instantiating caller (a Component)

  • conf – passes in any explicit parameters

virtual ~Shells()

The constructor.

Private Types

typedef pair<double, double> Dpair

Private Functions

void determine_acceleration_and_potential(void)
virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreading implementation of the force computation.

virtual void determine_coefficients(void)

Used by get_acceleration_and_potential to request that the expansion be performed.

virtual void *determine_coefficients_thread(void *arg)

Multithreading implementation of the expansion computation.

virtual void initialize()

Used by derived class to initialize any storage and parameters.

Private Members

bool firstime_accel
vector<Dpair> grid
std::vector<std::vector<int>> igrid
std::vector<int> igrid1
std::vector<std::vector<int>> igridT
std::vector<std::map<int, double>> mgrid
vector<double> mgrid0
vector<double> mgrid1
std::vector<std::vector<double>> mgridT
int nsample
int nselect
vector<double> pgrid0
vector<int> rcvcts
vector<int> rdispl
std::vector<std::map<int, double>> rgrid
vector<double> rgrid0
vector<double> rgrid1
std::vector<std::vector<double>> rgridT
vector<int> rnumbr
vector<int> sdispl
bool self_consistent
vector<int> sndcts
vector<int> snumbr
std::vector<std::vector<int>> update_fr
std::vector<std::vector<int>> update_ii
std::vector<std::vector<int>> update_to
int used1
vector<int> usedT

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

template<typename T, bool B>
struct SignedCheck
template<typename T>
struct SignedCheck<T, false>
#include <cxxopts.H>

Public Functions

template<typename U>
inline void operator()(bool, U, const std::string&) const
template<typename T>
struct SignedCheck<T, true>
#include <cxxopts.H>

Public Functions

template<typename U>
inline void operator()(bool negative, U u, const std::string &text)
class SimAnn
#include <SimAnn.H>

Public Functions

double anneal(const int iters = -1)

Perform the annealing.

inline double Boltzmann(const double k = -1.0)
inline std::vector<double> current()
inline int dwell(const int d = -1)
inline void initial(std::vector<double> &xi)
inline int iterations(const int m = -1)
inline double jump(const double j = -1.0)
inline double learning_rate(const double r = -1.0)
double melt(const int iters = -1)

Look for the melting temprature.

inline std::vector<double> optimum()
inline double range(const double r = -1.0)
inline void report_states(std::ostream &out)
inline void save_states(const std::string &name)
inline void set_map(FuncMap f)

Set map function.

void set_up(Func1d f, const int seed = 10)

Set the objective function.

inline SimAnn()
SimAnn(std::function<double(std::vector<double>&)> f, const int d = 1)
inline double temperature(const double t = -1.0)
inline ~SimAnn()

Private Types

typedef std::function<double(std::vector<double>&)> Func1d
typedef std::function<std::vector<double>(std::vector<double>&)> FuncMap

Private Functions

int equilibrate(const double t, const int n)
void log_state(int)

Private Members

double c_jump
int ddwell
double dt
double dy
int err
std::string fname
int fsave
Func1d func
std::mt19937 gen
double K
int maxit
std::uniform_real_distribution<double> number_01
std::uniform_real_distribution<double> number_range
FuncMap pmap
double rho
double rrange
std::ostream *str
double t0
double tscale
std::vector<double> x
std::vector<double> xbest
std::vector<double> xnew
double y
double ybest
class SingIsothermalSphere : public AxiSymModel
#include <isothermal.H>

Inheritence diagram for SingIsothermalSphere:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "3" [label="MassModel" tooltip="MassModel"]
    "1" [label="SingIsothermalSphere" tooltip="SingIsothermalSphere" fillcolor="#BFBFBF"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for SingIsothermalSphere:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "7" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "8" [label="GaussQuad" tooltip="GaussQuad"]
    "3" [label="MassModel" tooltip="MassModel"]
    "6" [label="RegularOrbit" tooltip="RegularOrbit"]
    "1" [label="SingIsothermalSphere" tooltip="SingIsothermalSphere" fillcolor="#BFBFBF"]
    "5" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
    "5" -> "7" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
}

Public Functions

inline virtual double d2fde2(double E, double L)
inline virtual double dfde(double E, double L)
inline virtual double dfdl(double E, double L)
inline virtual double distf(double E, double L)
inline virtual double get_density(const double r)
inline virtual double get_dpot(const double r)
inline virtual double get_dpot2(const double r)
inline virtual double get_mass(const double r)

Required member functions.

inline virtual double get_max_radius(void)
inline virtual double get_min_radius(void)

Addiional member functions.

inline virtual double get_pot(const double r)
inline virtual void get_pot_dpot(const double r, double &ur, double &dur)
inline SingIsothermalSphere(double VROT = 1.0, double RMIN = 1.0e-6, double RMAX = 1.0e6)

Constructor.

Private Members

double F
double rmax
double rmin
double rot
class Sk
#include <PotRZ.H>

Collaboration diagram for PotRZ::Sk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="PotRZ::Sk" tooltip="PotRZ::Sk" fillcolor="#BFBFBF"]
    "2" [label="QDHT" tooltip="QDHT"]
    "1" -> "2" [dir=forward tooltip="usage"]
}

Compute the Hankel transform of the target density.

Public Functions

inline std::tuple<Eigen::VectorXd, Eigen::VectorXd> operator()(std::function<double(double)> dens)

Perform the transform.

inline Sk()

Null constructor.

inline Sk(double R, int N, int M)

Constructor with R=cutoff, N=number of knots, M=harmonic order, and a=parameter vector

Protected Attributes

int N
QDHT v
class SlabModel
#include <SLGridMP2.H>

Target density models for slabs.

Public Functions

virtual double dens(double z) = 0

Return the surface density.

virtual double dpot(double z) = 0

Return the derivative of the potential.

inline std::string ID() const

Get model ID.

virtual double pot(double z) = 0

Return the potential.

Public Static Functions

static std::shared_ptr<SlabModel> createModel(const std::string type)

Factory constructor.

Protected Attributes

std::string id

For cache identification.

class SlabSL : public PotAccel
#include <SlabSL.H>

Inheritence diagram for SlabSL:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="SlabSL" tooltip="SlabSL" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for SlabSL:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="Component" tooltip="Component"]
    "6" [label="EL3" tooltip="EL3"]
    "5" [label="Orient" tooltip="Orient"]
    "2" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="SlabSL" tooltip="SlabSL" fillcolor="#BFBFBF"]
    "8" [label="SlabSL::SlabSLCoefHeader" tooltip="SlabSL::SlabSLCoefHeader"]
    "7" [label="Timer" tooltip="Timer"]
    "3" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "4" -> "4" [dir=forward tooltip="usage"]
    "4" -> "2" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="usage"]
    "4" -> "7" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "2" -> "4" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "8" [dir=forward tooltip="usage"]
    "3" -> "2" [dir=forward tooltip="usage"]
}

This routine computes the potential, acceleration and density using expansion periodic in X & Y and outgoing vacuum boundary condtions in Z

Public Functions

virtual void dump_coefs_h5(const std::string &file)

Coefficient output.

SlabSL(Component *c0, const YAML::Node &conf)

Constructor.

virtual ~SlabSL()

Destructor.

Public Members

std::string id

Id string.

Protected Functions

virtual void initialize(void)

Parse parameters and initialize on first call.

Protected Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

Private Types

using coefType = Eigen::Tensor<std::complex<double>, 3>

Coefficients are a 3-tensor.

using coefTypePtr = std::shared_ptr<coefType>

Interpolation arrays.

Private Functions

void compute_multistep_coefficients()

Extrapolate and sum coefficents per multistep level to get a complete set of coefficients for force evaluation at an intermediate time step

virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreading implementation of the force computation.

virtual void determine_coefficients(void)

Usual evaluation interface.

virtual void *determine_coefficients_thread(void *arg)

Threading.

virtual void get_acceleration_and_potential(Component*)

The main force evaluation routine to be called by clients.

virtual void multistep_update(int cur, int next, Component *c, int i, int id)

Implementation of level shifts.

virtual void multistep_update_begin()

Update the multi time step coefficient table when moving particle i from level cur to level next

virtual void multistep_update_finish()

Execute to finish level shifts for particles.

inline void swap_coefs(std::vector<coefType> &from, std::vector<coefType> &to)

Swap coefficients.

Private Members

SlabSLCoefHeader coefheader
double dfac
std::vector<std::vector<coefType>> differ1

For updating levels.

std::vector<coefType> expccof

Current coefficient tensor.

std::vector<coefTypePtr> expccofL
std::vector<coefTypePtr> expccofN
std::vector<coefType> expccofP
std::shared_ptr<SLGridSlab> grid
double hslab
int imx
int imy
int imz
int jmax
std::complex<double> kfac
int ngrid = 1000

Default number of grid points for SLGridSlab.

int nmaxx
int nmaxy
int nmaxz
int nminx
int nminy
int nnmax
std::vector<std::complex<double>> pack
CoefClasses::SlabCoefs slabCoefs

Coefficient container instance for writing HDF5.

std::string type = "isothermal"

Default slab type (must be “isothermal”, “parabolic”, or “constant”)

std::vector<std::complex<double>> unpack
std::vector<Eigen::VectorXd> zfrc
double zmax
std::vector<Eigen::VectorXd> zpot

Private Static Attributes

static const int ID = 1
struct SlabSLCoefHeader

Header structure for Sturm-Liouville slab expansion Used for deprecated native coefficient files

Public Members

double h
int jmax
int nmaxx
int nmaxy
int nmaxz
double time
int type
double zmax
class SLGridSlab
#include <SLGridMP2.H>

Slab (one-dimensional) SL grid class.

Public Functions

inline double d_xi_to_z(double x)

Jacobian of coordinate mapping.

double eigenvalue(int kx, int ky, int n)

Members.

Get n^th eigenvalue for given wave number indices

double get_dens(double x, int kx, int ky, int n, int which = 1)

Get density for dimensionless coord with given wave numbers and index.

void get_dens(Eigen::MatrixXd &tab, double x, int which = 1)

Get density for dimensionless coord with given wave numbers Return Matrix with first dimension containing x and y wavenumbers packed with y index varying most quicly, second index is vertical order.

void get_dens(Eigen::VectorXd &vec, double x, int kx, int ky, int which = 1)

Get density for dimensionless coord with given wave numbers Return Vector for all indices

double get_force(double x, int kx, int ky, int n, int which = 1)

Get force for dimensionless coord with given wave numbers and index.

void get_force(Eigen::MatrixXd &tab, double x, int which = 1)

Get force for dimensionless coord with given wave numbers Return Matrix with first dimension containing x and y wavenumbers packed with y index varying most quicly, second index is vertical order.

void get_force(Eigen::VectorXd &vec, double x, int kx, int ky, int which = 1)

Get force for dimensionless coord with given wave numbers Return Vector for all indices

double get_pot(double x, int kx, int ky, int n, int which = 1)

Get potential for dimensionless coord with given wave numbers and index.

void get_pot(Eigen::MatrixXd &tab, double x, int which = 1)

Get potential for dimensionless coord with given wave numbers Return Matrix with first dimension containing x and y wavenumbers packed with y index varying most quicly, second index is vertical order.

void get_pot(Eigen::VectorXd &vec, double x, int kx, int ky, int which = 1)

Get potential for member for dimensionless coord with given wave numbers Return Vector for all indices

std::vector<Eigen::MatrixXd> orthoCheck(int knots = 40)

Compute the orthogonality of the basis by returning inner produce matrices

SLGridSlab(int kmax, int nmax, int numz, double zmax, const std::string type = "isothermal", bool Verbose = false)

Constructor.

inline double xi_to_z(double x)

Map from dimensionless coordinate to vertical coordinate.

inline double z_to_xi(double z)

Map from vertical coordinate to dimensionless coordinate.

~SLGridSlab()

Destructor.

Public Static Attributes

static int cache

Check for cached table, default: 1=yes.

static double H

Scale height, default=0.1.

static double L

Periodic box size, default=1.0.

static int mpi

Global MPI flag, default: 0=off.

static double ZBEG

Offset from origin, default=1.0e-4.

static double ZEND

Potential offset, default=1.0e-5.

Private Types

enum CoordMapTypes

This defines a class providing selectable maps from the infinite to finite interval

Values:

enumerator Tanh
enumerator Sech
enumerator Linear
using table_ptr_1D = std::shared_ptr<TableSlab[]>
using table_ptr_2D = std::shared_ptr<table_ptr_1D[]>

Private Functions

void bomb(string oops)
void compute_table(TableSlab *table, int kx, int ky)
void compute_table_worker(void)
void init_table(void)
int mpi_pack_table(TableSlab *table, int kx, int ky)
void mpi_setup(void)
void mpi_unpack_table(void)
bool ReadH5Cache(void)
void WriteH5Cache(void)

Private Members

Eigen::VectorXd d0
double dxi
std::unique_ptr<CoordMap> mM

The current map created by the SLGridSlab constructor.

std::shared_ptr<char[]> mpi_buf
int mpi_bufsz
int mpi_myid
int mpi_numprocs
int nmax
int numk
int numz
Eigen::VectorXd p0
table_ptr_2D table
bool tbdbg

For deep debugging.

std::string type

Model type.

Eigen::VectorXd xi
double xmax
double xmin
Eigen::VectorXd z
double zmax
class SLGridSph
#include <SLGridMP2.H>

! Spherical SL grid class

Public Functions

double d_xi_to_r(double x)

Jacobian of nondimensional coordinate mapping.

double eigenvalue(int l, int n)

Eigenvalue for index and harmonic order l.

double get_dens(double x, int l, int n, int which = 1)

Get density for dimensionless coord with harmonic order l and radial orer n

void get_dens(Eigen::MatrixXd &tab, double x, int which = 1)

Get density for dimensionless coord with harmonic order l and radial order n Return Matrix with first dim harmonic order and second dim radial order

void get_dens(Eigen::VectorXd &vec, double x, int l, int which = 1)
double get_force(double x, int l, int n, int which = 1)

Get force for dimensionless coord with harmonic order l and radial orer n.

void get_force(Eigen::MatrixXd &tab, double x, int which = 1)

Get force for dimensionless coord with harmonic order l and radial order n Return Matrix with first dim harmonic order and second dim radial order

void get_force(Eigen::VectorXd &vec, double x, int l, int which = 1)

Get force for dimensionless coord with harmonic order l and radial orer n Return all radial order values in Vector

double get_pot(double x, int l, int n, int which = 1)

Get potential for dimensionless coord with harmonic order l and radial orer n.

void get_pot(Eigen::MatrixXd &tab, double x, int which = 1)

Get potential for dimensionless coord with harmonic order l and radial order n Return Matrix with first dim harmonic order and second dim radial order

void get_pot(Eigen::VectorXd &vec, double x, int l, int which = 1)

Get potential for dimensionless coord with harmonic order l and radial orer n Return all radial order values in Vector

inline int getLmax()

Get expansion limits.

inline int getNmax()
inline double getRmax()
inline double getRmin()

Get the current minimum and maximum radii for the expansion.

std::vector<Eigen::MatrixXd> orthoCheck(int knots = 40)

Compute the orthogonality of the basis by returning inner produce matrices

double r_to_xi(double r)

Map radial coordinate to nondimensional coordinate.

SLGridSph(std::shared_ptr<SphericalModelTable> mod, int lmax, int nmax, int numr, double rmin, double rmax, bool cache, int Cmap, double RMAP, std::string cachename = ".slgrid_sph_cache", bool Verbose = false)

Constructor with model table.

SLGridSph(std::string cachename)

Constructor (from cache file)

SLGridSph(std::string modelname, int lmax, int nmax, int numr, double rmin, double rmax, bool cache, int Cmap, double RMAP, int DIVERGE, double DFAC, std::string cachename = ".slgrid_sph_cache", bool Verbose = false)

Constructor (uses file model_file_name for file)

double xi_to_r(double x)

Map nondimensional coordinate to radial coordinate.

virtual ~SLGridSph()

Destructor.

Public Static Functions

static std::map<std::string, std::string> cacheInfo(const std::string &cachefile, bool verbose = true)

Get density for dimensionless coord with harmonic order l and radial orer n Return all radial order values in Vector Read and print the cache and return the header parameters as a map/dictionary

static YAML::Node getHeader(const std::string &cachefile)

Read the cache and report parameters.

Public Static Attributes

static int mpi

Flag for MPI enabled (default: 0=off)

Private Types

using table_ptr_1D = std::shared_ptr<TableSph[]>

Private Functions

void bomb(string oops)
void compute_table(TableSph *table, int L)
void compute_table_worker(void)
void init_table(void)
void initialize(int LMAX, int NMAX, int NUMR, double RMIN, double RMAX, bool CACHE, int CMAP, double RMAP)
int mpi_pack_table(TableSph *table, int l)
void mpi_setup(void)
void mpi_unpack_table(void)
bool ReadH5Cache()

Read HDF5 cache.

void WriteH5Cache()

Write HDF5 cache.

Private Members

bool cache

Use basis cache.

int cmap
Eigen::VectorXd d0
const std::string default_cache = ".slgrid_sph_cache"

Default cache file name.

const std::string default_model = "SLGridSph.model"

Default model file name.

double dfac
int diverge
double dxi
int lmax
std::string model_file_name

Model file name.

std::shared_ptr<char[]> mpi_buf
int mpi_bufsz
int mpi_myid
int mpi_numprocs
int nmax
int numr
Eigen::VectorXd p0
Eigen::VectorXd r
double rmap
double rmax
double rmin
std::string sph_cache_name

Cache file name.

table_ptr_1D table
bool tbdbg

For deep debugging.

Eigen::VectorXd xi
double xmax
double xmin

Private Static Attributes

static double Lalpha

For l>=Lswitch: rmin=rmap/rfac, rmax=rmap*rfac with rfac=pow(10, Lalpha/l)

static int Lswitch

Use entire grid for l<Lswitch.

Rmin heuristic for grid construction to prevent underflow issues in Sturm-Liouville solver: sledge

static const std::string Version = "1.0"

Cache versioning.

class SoftKernel
#include <GravKernel.H>

Inheritence diagram for SoftKernel:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="PlummerSoft" tooltip="PlummerSoft"]
    "1" [label="SoftKernel" tooltip="SoftKernel" fillcolor="#BFBFBF"]
    "3" [label="SplineSoft" tooltip="SplineSoft"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
}

Abstract class for smoothing kernel. Derive all new kernels from this class.

Subclassed by PlummerSoft, SplineSoft

Public Functions

virtual std::pair<double, double> operator()(double r, double eps) = 0

This operator returns the fractional mass and gravitational potential inside of radius

Parameters:
  • r – for softening

  • eps

Public Members

const double tol = 1.0e-8

Separations smaller than this value are considered to be the same particle.

class SParticle
#include <SParticle.H>

An abbreviated particle class for transferring phase space between processors and writing initial conditions. Changes in or additions to the Particle class should not affect this class.

Public Functions

inline double datr(int i)
inline double datr(int i)
inline int iatr(int i)
inline int iatr(int i)
inline int indx()
inline int indx()
inline double mass()
inline double mass()
inline int ndatr()
inline int ndatr()
inline int niatr()
inline int niatr()
inline void operator[](const Particle &p)

Copy contents of a Particle to an SParticle.

inline double phi()
inline double phi()
inline double pos(int i)
inline double pos(int i)
inline void read(std::istream &in, unsigned rsize, int pcount, list<PSPstanza>::iterator spos)
inline void read(std::istream &in, unsigned rsize, int pcount, std::list<PSPstanza>::iterator spos)
inline void setSize(unsigned rsize)
inline void setSize(unsigned rsize)
inline SParticle()
inline SParticle()

Null constructor.

inline SParticle()
inline SParticle(const Particle &p)

Construct instance from a Particle.

inline double vel(int i)
inline double vel(int i)
void write(std::ostream &out, bool real4, size_t isiz)
void write(std::ostream &out, bool real4, size_t isiz)

Public Members

std::shared_ptr<PParticle<double>> d
std::shared_ptr<PParticle<float>> f
double mass

Data fields.

double pos[3]
double vel[3]

Private Functions

inline void cpy(const Particle &p)

Copy Particle contents.

Private Members

unsigned s
struct SphCoefHeader
#include <coef.H>

Header structure for spherical expansion.

Public Members

char id[64]
int Lmax
int nmax
double scale
double tnow
struct SphCoefs
#include <Coefs.H>

Collaboration diagram for SphCoefs:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="SphCoefHeader" tooltip="SphCoefHeader"]
    "1" [label="SphCoefs" tooltip="SphCoefs" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="usage"]
}

Public Types

typedef Eigen::Matrix<double, Eigen::Dynamic, Eigen::Dynamic, Eigen::ColMajor> EigenColMajor

Public Functions

bool read(std::istream &in, bool exp_type)

Public Members

std::shared_ptr<char[]> buf
EigenColMajor coefs
SphCoefHeader header
class Sphere : public SphericalBasis
#include <Sphere.H>

Inheritence diagram for Sphere:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="AxisymmetricBasis" tooltip="AxisymmetricBasis"]
    "4" [label="Basis" tooltip="Basis"]
    "5" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="Sphere" tooltip="Sphere" fillcolor="#BFBFBF"]
    "2" [label="SphericalBasis" tooltip="SphericalBasis"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "4" -> "5" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Sphere:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="AxisymmetricBasis" tooltip="AxisymmetricBasis"]
    "4" [label="Basis" tooltip="Basis"]
    "7" [label="Component" tooltip="Component"]
    "9" [label="EL3" tooltip="EL3"]
    "11" [label="MixtureBasis" tooltip="MixtureBasis"]
    "8" [label="Orient" tooltip="Orient"]
    "5" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="Sphere" tooltip="Sphere" fillcolor="#BFBFBF"]
    "2" [label="SphericalBasis" tooltip="SphericalBasis"]
    "10" [label="Timer" tooltip="Timer"]
    "12" [label="TwoCenter" tooltip="TwoCenter"]
    "6" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "4" -> "5" [dir=forward tooltip="public-inheritance"]
    "7" -> "7" [dir=forward tooltip="usage"]
    "7" -> "5" [dir=forward tooltip="usage"]
    "7" -> "8" [dir=forward tooltip="usage"]
    "7" -> "10" [dir=forward tooltip="usage"]
    "11" -> "12" [dir=forward tooltip="usage"]
    "8" -> "9" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "7" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "11" [dir=forward tooltip="usage"]
    "12" -> "5" [dir=forward tooltip="public-inheritance"]
    "12" -> "4" [dir=forward tooltip="usage"]
    "12" -> "11" [dir=forward tooltip="usage"]
    "6" -> "5" [dir=forward tooltip="usage"]
}

Computes the potential, acceleration and density using the Sturm Liouville direct solution.

YAML configuration

Param rmapping:

is the halo scale length (default is 0.067*rmax). This is used to for the coordinate mapping (see below).

Param cmap:

should be 1 for algebraic coordinate scaling, 2 for log coordinate scaling, 0 for no scaling as follows:

\[ x = {r/r_s-1 \over r/r_s+1} \]
when cmap=1 and
\[ x = \log(r) \]
when cmap=2. Algebraic coordinate scaling is a good general choice. For spherical models with a very large dynamic range (e.g. deep, cuspy halos), logarithmic scaling will be a better choice. Logarithmic scaling will insist that the rmin>0.

Param numr:

is the number radial coordinate knots in the table (default: 2000)

Param nums:

is the number of bins in the empirical mass array (default: 2000)

Param noff:

is the offset into the empirical mass array for computing upper and lower grid boundaries (default: 32)

Param diverge:

set to true means assume a cuspy profile

Param dfac:

is the power of the “divergent” cusp

Param modelname:

is the file containing the input background model profile

Param cachename:

is the name for the SL grid cache file

Param dtime:

is the interval between basis recomputations (<=0 for never)

Param diverge:

sets the power law extrapolation of a cusp profile

Param dfac:

is the inverse slope of the power law

Param logr:

set to true uses a logarithmic spacing for the empirical radial grid (default: false)

Param plummer:

set to true uses a Plummer-model fit to the empirical mass array to make basis model (default: true)

Public Functions

inline virtual void determine_coefficients(void)

Override to redetermine basis, as desired.

Sphere(Component *c0, const YAML::Node &conf, MixtureBasis *m = 0)

Constructor

Parameters:
  • c0 – is the instantiating caller (Component)

  • conf – passes any parameters to basis instance (rsphSL, rmin and numr

  • m – allows the spherical basis to be used for multiple center expansions

virtual ~Sphere()

Destructor.

Private Functions

inline virtual double d_r_to_xi(double r)
inline double d_xi_to_r(double x)
virtual void get_dens(int lmax, int nmax, double r, Eigen::MatrixXd &p, int tid)

Get derivative of potential

Parameters:
  • lmax – is the maximum harmonic order

  • nmax – is the maximum radial order

  • r – is the evaluation radius

  • d – will be returned array in harmonics l and radial order n for the density

  • tid – is the thread enumerator that allows the function to provide some thread safety

virtual void get_dpotl(int lmax, int nmax, double r, Eigen::MatrixXd &p, Eigen::MatrixXd &dp, int tid)

Get derivative of potential

Parameters:
  • lmax – is the maximum harmonic order

  • nmax – is the maximum radial order

  • r – is the evaluation radius

  • p – will be returned array in harmonics l and radial order n for the potential

  • dp – will be returned array in harmonics l and radial order n for the derivative of the potential

  • tid – is the thread enumerator that allows the function to provide some thread safety

virtual void get_potl(int lmax, int nmax, double r, Eigen::MatrixXd &p, int tid)

Get derivative of potential

Parameters:
  • lmax – is the maximum harmonic order

  • nmax – is the maximum radial order

  • r – is the evaluation radius

  • p – will be returned array in harmonics l and radial order n for the potential

  • tid – is the thread enumerator that allows the function to provide some thread safety

virtual void get_potl_dens(int lmax, int nmax, double r, Eigen::MatrixXd &p, Eigen::MatrixXd &d, int tid)

Get derivative of potential

Parameters:
  • lmax – is the maximum harmonic order

  • nmax – is the maximum radial order

  • r – is the evaluation radius

  • p – will be returned array in harmonics l and radial order n for the potential

  • d – will be returned array in harmonics l and radial order n for the density

  • tid – is the thread enumerator that allows the function to provide some thread safety

virtual void initialize(void)

Initialize method.

inline void make_model()
void make_model_bin()
void make_model_plummer()
double mapDeriv(const std::map<double, double> &data, double x)
double mapIntrp(const std::map<double, double> &data, double x)
inline virtual double r_to_xi(double r)

Coordinate mapping.

inline virtual double xi_to_r(double x)

Private Members

string cache_file
int cmap
double dfac
int diverge
double dtime
bool logr
string model_file
int noff
int numr
int nums
SLGridSphPtr ortho
bool plummer
bool recompute
double rmap
double rsphSL
double tnext

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class SphereSL : public AxiSymBiorth
#include <sphereSL.H>

Inheritence diagram for SphereSL:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymBiorth" tooltip="AxiSymBiorth"]
    "3" [label="Biorth" tooltip="Biorth"]
    "1" [label="SphereSL" tooltip="SphereSL" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for SphereSL:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymBiorth" tooltip="AxiSymBiorth"]
    "3" [label="Biorth" tooltip="Biorth"]
    "4" [label="SLGridSph" tooltip="SLGridSph"]
    "1" [label="SphereSL" tooltip="SphereSL" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "4" [dir=forward tooltip="usage"]
}

Public Functions

virtual double d_r_to_rb(double const x)
double d_rb_to_r(const double x)
virtual double dens(const int n, const int l, const double x)
virtual void dens(const int n, const int l, const double x, Eigen::VectorXd &t)
double get_dens(const double r, const int l, const Eigen::VectorXd &coef)
double get_potl(const double r, const int l, const Eigen::VectorXd &coef)
inline virtual double krnl(const int n, const int l)
inline virtual double norm(const int n, const int l)
virtual double potl(const int n, const int l, const double x)
virtual void potl(const int n, const int l, const double x, Eigen::VectorXd &t)
inline virtual double potlR(const int n, const int l, const double r)
inline virtual double potlRZ(const int n, const int l, const double r, const double z)
virtual double r_to_rb(double const r)
inline virtual double rb_max(void)
inline virtual double rb_min(void)
virtual double rb_to_r(double const x)
SphereSL(int lmax, int nmax, int numr, double rmin, double rmax, double scale, std::shared_ptr<SphericalModelTable> mod)
~SphereSL(void)

Public Static Attributes

static bool cache
static int mpi

Private Members

int lmax
int nmax
int numr
double rmax
double rmin
double scale
SLGridSph *slgrid
class SphericalBasis : public AxisymmetricBasis
#include <SphericalBasis.H>

Inheritence diagram for SphericalBasis:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxisymmetricBasis" tooltip="AxisymmetricBasis"]
    "3" [label="Basis" tooltip="Basis"]
    "5" [label="Bessel" tooltip="Bessel"]
    "4" [label="PotAccel" tooltip="PotAccel"]
    "6" [label="Sphere" tooltip="Sphere"]
    "1" [label="SphericalBasis" tooltip="SphericalBasis" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "5" -> "1" [dir=forward tooltip="public-inheritance"]
    "6" -> "1" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for SphericalBasis:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxisymmetricBasis" tooltip="AxisymmetricBasis"]
    "3" [label="Basis" tooltip="Basis"]
    "6" [label="Component" tooltip="Component"]
    "8" [label="EL3" tooltip="EL3"]
    "10" [label="MixtureBasis" tooltip="MixtureBasis"]
    "7" [label="Orient" tooltip="Orient"]
    "4" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="SphericalBasis" tooltip="SphericalBasis" fillcolor="#BFBFBF"]
    "9" [label="Timer" tooltip="Timer"]
    "11" [label="TwoCenter" tooltip="TwoCenter"]
    "5" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "6" -> "6" [dir=forward tooltip="usage"]
    "6" -> "4" [dir=forward tooltip="usage"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "6" -> "9" [dir=forward tooltip="usage"]
    "10" -> "11" [dir=forward tooltip="usage"]
    "7" -> "8" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="usage"]
    "4" -> "6" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "10" [dir=forward tooltip="usage"]
    "11" -> "4" [dir=forward tooltip="public-inheritance"]
    "11" -> "3" [dir=forward tooltip="usage"]
    "11" -> "10" [dir=forward tooltip="usage"]
    "5" -> "4" [dir=forward tooltip="usage"]
}

Defines a spherical basis with members specific to spherical symmetry.

YAML configuration

Param scale:

Radial scale factor between particle coordinates and the basis coorindates. The default is 1 and should be 1 if the input basis model matches the phase-space coordinates of the particles.

Param rmin:

is the lower-bound of the target basis. This will be set to minimum radius in the input model by default.

Param rmax:

is the upper-bound of the target basis. This will be set to maximum radius in the input model by default.

Param self_consistent:

set to true allows the particles to evolve under the time-dependent basis expansion. For a basis fixed in time to the initial time: set to false.

Param FIX_L0:

set to true saves the monopole coefficients on the first evaluation

Param NO_L0:

set to true disables the monopole coefficients altogehter for all time

Param NO_L1:

set to true disables the dipole coefficients altogehter for all time

Param EVEN_L:

set to true eliminates all \(l\) harmonic coefficients of odd order for all time

Param EVEN_M:

set to true eliminates all \(m\) harmonic coefficients of odd order for all time

Param M0_ONLY:

set to true eliminates all \(|m|>0\) harmonic coefficients for all time

Param NOISE:

set to true enables the signal-to-noise ratio computation for diagnostic purposes

Param noiseN:

is the variance scale factor for estimating the RMS noise (1.0e-6 by default; \(1/N\) is a good choice for the standard deviation of the noise)

Param noise_model_file:

is the filename for the background model model used to estimate the noise

Param seedN:

is the random number generator seed for the noise computation

Param ssfrac:

sets a fraction of the total phase space used for coefficient estimation (this is an experimental feature)

Param “playback:

set to true uses a coefficient file to evaluate the coefficients rather than direct expansion

Param coefCompute:

set to true computes a new set of coefficients during playback for comparison

Param coefMaster:

set to true evaluates the playback coefficients on a single node which are then broadcast to all nodes

Param orthocheck:

set to true computed the basis biorthgoonal check by direct quadrature

Subclassed by Bessel, Sphere

Public Functions

virtual void determine_acceleration_and_potential(void)

Required member to compute accleration and potential with threading.

The thread member must be supplied by the derived class

inline virtual void determine_coefficients(Component *c)

Compute coefficients with threading using the provided component.

virtual void determine_coefficients(void)

Required member to compute coeifficients with threading.

The thread member must be supplied by the derived class

virtual void determine_fields_at_point(double x, double y, double z, double *tdens0, double *tpotl0, double *tdens, double *tpotl, double *tpotx, double *tpoty, double *tpotz)

Return the value for the fields in Cartesian coordinates.

virtual void determine_fields_at_point_cyl(double r, double z, double phi, double *tdens0, double *tpotl0, double *tdens, double *tpotl, double *tpotr, double *tpotz, double *tpotp)

Returns the potential, its derivatives & density in cylindrical coords.

virtual void determine_fields_at_point_sph(double r, double theta, double phi, double *tdens0, double *tpotl0, double *tdens, double *tpotl, double *tpotr, double *tpott, double *tpotp)

Returns the potential, its derivatives & density in spherical coords.

virtual void dump_coefs(ostream&)

Dump current coefficients.

virtual void dump_coefs_h5(const std::string &file)

Dump current coefficients into named HDF5 file.

virtual void get_acceleration_and_potential(Component *cC)

Required member to compute accelration and potential.

This implemenation should be fine for most cases

virtual void get_dens(int lmax, int nmax, double r, Eigen::MatrixXd &d, int tid) = 0

Get derivative of potential

Parameters:
  • lmax – is the maximum harmonic order

  • nmax – is the maximum radial order

  • r – is the evaluation radius

  • d – will be returned array in harmonics l and radial order n for the density

  • tid – is the thread enumerator that allows the function to provide some thread safety

virtual void get_dpotl(int lmax, int nmax, double r, Eigen::MatrixXd &p, Eigen::MatrixXd &dp, int tid) = 0

Get derivative of potential

Parameters:
  • lmax – is the maximum harmonic order

  • nmax – is the maximum radial order

  • r – is the evaluation radius

  • p – will be returned array in harmonics l and radial order n for the potential

  • dp – will be returned array in harmonics l and radial order n for the derivative of the potential

  • tid – is the thread enumerator that allows the function to provide some thread safety

virtual void get_potl(int lmax, int nmax, double r, Eigen::MatrixXd &p, int tid) = 0

Get derivative of potential

Parameters:
  • lmax – is the maximum harmonic order

  • nmax – is the maximum radial order

  • r – is the evaluation radius

  • p – will be returned array in harmonics l and radial order n for the potential

  • tid – is the thread enumerator that allows the function to provide some thread safety

virtual void get_potl_dens(int lmax, int nmax, double r, Eigen::MatrixXd &p, Eigen::MatrixXd &d, int tid) = 0

Get derivative of potential

Parameters:
  • lmax – is the maximum harmonic order

  • nmax – is the maximum radial order

  • r – is the evaluation radius

  • p – will be returned array in harmonics l and radial order n for the potential

  • d – will be returned array in harmonics l and radial order n for the density

  • tid – is the thread enumerator that allows the function to provide some thread safety

inline virtual double knl(int, int)

Kernel value for recursion relation basis.

inline virtual void multistep_add_debug(const std::vector<std::vector<std::pair<unsigned, unsigned>>> &data)
virtual void multistep_reset()

Update the multi time step coefficient table when moving particle i from level cur to level next

virtual void multistep_update(int cur, int next, Component *c, int i, int id)

Implementation of level shifts.

virtual void multistep_update_begin()

Execute to begin level shifts for particles.

Update the multi time step force algorithm when moving particle i from level cur to level next

virtual void multistep_update_finish()

Execute to finish level shifts for particles.

inline virtual double norm(int, int)

Normalization for recursion relation basis.

SphericalBasis(Component *c0, const YAML::Node &conf, MixtureBasis *m = 0)

Constructor (line contains the paramter list)

SphericalBasis(const SphericalBasis &p)

Copy constructor.

virtual ~SphericalBasis()

Destructor.

Public Static Attributes

static bool NewCoefs

Use YAML header in coefficient file.

Protected Types

typedef std::shared_ptr<Eigen::VectorXd> VectorXdP

Matrices per thread for obtaining expansion coefficients.

Protected Functions

void biorthogonality_check()
virtual void check_range()

Provided by derived classes to check consistency.

void compute_multistep_coefficients()

Extrapolate and sum coefficents per multistep level to get a complete set of coefficients for force evaluation at an intermediate time step

void compute_rms_coefs(void)

Compute rms coefficients.

inline virtual double d_r_to_xi(double r)
virtual void *determine_acceleration_and_potential_thread(void *arg)

Thread method for accerlation compuation.

virtual void determine_coefficients_particles(void)

Compute the coefficients from particles.

virtual void determine_coefficients_playback(void)

Compute the coefficients from an table.

virtual void *determine_coefficients_thread(void *arg)

Thread method for coefficient accumulation.

void dump_coefs_all(ostream&)

Dump current coefficients (all multistep levels) For debugging …

void get_dens_coefs(int l, Eigen::VectorXd &coef, double &p)

Get density from coefficient vector.

void get_pot_coefs(int l, const Eigen::VectorXd &coef, double &p, double &dp)

Get potential and accel field values from coefficients.

void get_pot_coefs_safe(int l, const Eigen::VectorXd &coef, double &p, double &dp, Eigen::MatrixXd &potd1, Eigen::MatrixXd &dpot1)

Get potential and field values from coefficients (provide workspace for thread safety)

virtual void initialize()

Initialize method.

void occt_output()

Print deep debugging data.

inline virtual double r_to_xi(double r)

Radial coordinate mapping (r->x, and x->r)

void setup()

Should be called by derived classes after initialization.

void update_noise(void)

Add noise.

inline virtual double xi_to_r(double x)

Protected Attributes

Eigen::VectorXd C0

Frozen monopole coefficients.

const unsigned int cmagic = 0xc0a57a2

Coefficient magic number.

bool coefMaster

Master node ships coefficients to hosts. True (default) implies that only the master node caches the coefficients for playback to save core memory. This is set in the config input using the ‘coefMaster: bool’ parameter. Once I am sure that there are no algorithmic issues, I will remove this as an option.

std::vector<Eigen::VectorXd> cosm

Work vectors for cosines for all values m

Eigen::MatrixXd dend

Work matrix.

std::vector<std::vector<Eigen::MatrixXd>> differ1

For updating levels.

std::vector<Eigen::MatrixXd> dlegs

Matrices per thread for obtaining derivatives legendre coefficients.

std::vector<Eigen::MatrixXd> dpot

Matrices per thread for obtaining derivative of potential field.

std::vector<Eigen::VectorXd> du

Work vectors to make recursion evaluations thread safe.

bool EVEN_L

Flag use of even l harmonics only.

bool EVEN_M

Flag use of even m harmonics only.

std::vector<std::vector<VectorXdP>> expcoef0
Eigen::MatrixXd factorial

Cache factorial values.

bool firstime_accel

Flag whether or not work space has been initialized for acceleration.

bool firstime_coef

Flag whether or not work space has been initialized for coefficients.

bool FIX_L0

Freeze monopole.

Eigen::MatrixXd krnl

Will cache values of the kernel required for recursion relations.

double lastPlayTime

Last playback coefficient evaluation time.

std::vector<Eigen::MatrixXd> legs

Matrices per thread for obtaining legendre coefficients.

bool M0_only

Use axisymmetric term s.

Eigen::VectorXd meanC

Expected coefficient values for RMS noise computation.

MixtureBasis *mix

For massive satellite simulations.

double muse0
vector<double> muse1

Mass accumulation for PCA.

bool NO_L0

Flag fixed monopole.

bool NO_L1

Flag drop l=1 term.

bool NOISE

Flag adding noise to coefficients (for testing diffusion)

string noise_model_file

Model for RMS noise computation.

double noiseN

Number of “effective” points for RMS noise computation.

std::normal_distribution nrand
std::vector<std::vector<unsigned>> occt

CUDA method for coefficient accumulation.

Test change level counts for deep debugging enabled by setting SPH_UPDATE_TABLE at the top of this header file

bool ortho_check

Compute the biorthogonality inner product and write to a file for internal self-consistency check. Enabled by including the YAML boolean ‘orthocheck’.

std::vector<double> pack
std::shared_ptr<CoefClasses::SphCoefs> playback

Coefficient playback instance. Using shared_ptr to avoid constructing a simple pointer or null instance

std::vector<Eigen::MatrixXd> potd

Matrices per thread for obtaining potential field.

double resetT

Time at last multistep reset.

std::mt19937 rgen
double rmax

The maximum radius.

double rmin

The minimum radius.

Eigen::MatrixXd rmsC

Expected squared coefficient values for RMS noise computation.

unsigned int seedN

Pseudorandom generation.

bool self_consistent

Flag self_consitency.

bool setup_noise
std::vector<Eigen::VectorXd> sinm

Work vectors for sines for all values m

CoefClasses::SphCoefs sphCoefs

Coefficient container instance for writing HDF5.

double ssfrac

Subsample fraction of particles.

bool subset

Flag to use subset.

std::vector<Eigen::VectorXd> u

Work vectors to make recursion evaluations thread safe.

std::vector<double> unpack

Protected Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class SphericalModelMulti : public AxiSymModel
#include <massmodel.H>

Inheritence diagram for SphericalModelMulti:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "3" [label="MassModel" tooltip="MassModel"]
    "1" [label="SphericalModelMulti" tooltip="SphericalModelMulti" fillcolor="#BFBFBF"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for SphericalModelMulti:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "7" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "8" [label="GaussQuad" tooltip="GaussQuad"]
    "3" [label="MassModel" tooltip="MassModel"]
    "6" [label="RegularOrbit" tooltip="RegularOrbit"]
    "1" [label="SphericalModelMulti" tooltip="SphericalModelMulti" fillcolor="#BFBFBF"]
    "5" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "5" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
    "5" -> "7" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
}

This uses two SphericalModelTables to define a mass profile and a number profile for generating a distribution with variable mass per particle.

Public Functions

inline void allowNegativeMass()

Turn off negative mass suppression by NOT requeueing particle selection if the DF ratio is negative

inline virtual double d2fde2(double E, double L)
inline virtual double dfde(double E, double L)
inline virtual double dfdl(double E, double L)
inline virtual double distf(double E, double L)

Evaluate distribution function and its partial derivatives.

virtual PSret gen_point()

Overloaded to provide mass distribution from Real and Number distribution from Fake.

virtual PSret gen_point(double Emin, double Emax, double Kmin, double Kmax)

Generate a phase-space point at a particular energy and angular momentum.

virtual PSret gen_point(double r)

Generate a phase-space point at a particular radius.

virtual PSret gen_point(double r, double theta, double phi)

Generate a phase-space point at a particular radius, theta, and phi.

inline virtual double get_density(const double r)
inline virtual double get_density(const double x1, const double x2, const double x3)

The density at (x, y, z)

inline virtual double get_dpot(const double r)
inline virtual double get_dpot2(const double r)
inline virtual double get_mass(const double r)

Evaluate the profile at a radial point.

inline virtual double get_mass(const double x1, const double x2, const double x3)

Get the mass inside of position (x, y, z) (this is ambiguous in general and will depend on the model)

inline virtual double get_max_radius(void)
inline virtual double get_min_radius(void)

Additional member functions.

inline virtual double get_pot(const double r)
inline virtual double get_pot(const double x1, const double x2, const double x3)

The potential at (x, y, z)

inline virtual void get_pot_dpot(const double r, double &p, double &dp)
inline void set_max_radius(const double &r)
inline void set_min_radius(const double &r)

Set new minimum and maximum for realization.

SphericalModelMulti(std::shared_ptr<AxiSymModel> Real, std::shared_ptr<AxiSymModel> Fake)

Constructor.

Protected Attributes

std::shared_ptr<AxiSymModel> fake
SphericalOrbit gen_orb
bool noneg
SphericalOrbit orb
std::shared_ptr<AxiSymModel> real
double rmax_gen
double rmin_gen
class SphericalModelTable : public AxiSymModel
#include <massmodel.H>

Inheritence diagram for SphericalModelTable:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "5" [label="KingSphere" tooltip="KingSphere"]
    "3" [label="MassModel" tooltip="MassModel"]
    "1" [label="SphericalModelTable" tooltip="SphericalModelTable" fillcolor="#BFBFBF"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "5" -> "1" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for SphericalModelTable:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "7" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "12" [label="Cheby1d" tooltip="Cheby1d"]
    "10" [label="FDIST" tooltip="FDIST"]
    "11" [label="FDISTC" tooltip="FDISTC"]
    "8" [label="GaussQuad" tooltip="GaussQuad"]
    "13" [label="Interp1d" tooltip="Interp1d"]
    "3" [label="MassModel" tooltip="MassModel"]
    "9" [label="RUN" tooltip="RUN"]
    "6" [label="RegularOrbit" tooltip="RegularOrbit"]
    "1" [label="SphericalModelTable" tooltip="SphericalModelTable" fillcolor="#BFBFBF"]
    "5" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "12" -> "13" [dir=forward tooltip="public-inheritance"]
    "11" -> "12" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "9" [dir=forward tooltip="usage"]
    "1" -> "10" [dir=forward tooltip="usage"]
    "1" -> "11" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
    "5" -> "7" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
}

Describe a spherical model from a four-column table of radius, density, enclosed mass, and gravitational potential

The file may have any number of leading comment lines, any line that starts with a “!” or a “#”. The first non-comment record is assumed to be an integer containing the number of lines. The subseuqnet lines are assumed to be records beginning the radius and followed by the triple of (density, enclosed mass, gravitational potential).

Subclassed by KingSphere

Public Functions

virtual double d2fde2(double E, double L)
virtual double dfde(double E, double L)
virtual double dfdl(double E, double L)
virtual double distf(double E, double L)

Evaluate the distribution function.

inline virtual double get_density(const double x1, const double x2, const double x3)

The density at (x, y, z)

virtual double get_density(const double)
virtual double get_dpot(const double)
virtual double get_dpot2(const double)
inline virtual double get_mass(const double x1, const double x2, const double x3)

Get the mass inside of position (x, y, z) (this is ambiguous in general and will depend on the model)

virtual double get_mass(const double)

Evaluate the profile at a particular radius.

inline virtual double get_max_radius(void)
inline virtual double get_min_radius(void)
inline int get_num_param(void)

Get info about the model.

inline double get_param(int i)
inline virtual double get_pot(const double x1, const double x2, const double x3)

The potential at (x, y, z)

virtual double get_pot(const double)
virtual void get_pot_dpot(const double, double&, double&)
inline double get_ra2(void)
inline int grid_size(void)
void print_df(const std::string &name)
void print_model(const std::string &name)
void print_model_eval(const std::string &name, int number)
void setup_df(int NUM, double RA = 1.0e20)

Set up and get info about the phase-space distribution.

SphericalModelTable(int num, double *r, double *d, double *m, double *p, int DIVERGE = 0, double DIVERGE_RFAC = 0, int EXTERNAL = 0, std::string ID = "")

Constructor (from array pointers)

SphericalModelTable(std::vector<double> &r, std::vector<double> &d, std::vector<double> &m, std::vector<double> &p, int DIVERGE = 0, double DIVERGE_RFAC = 0, int EXTERNAL = 0, std::string ID = "")

Constructor (from vectors)

SphericalModelTable(string filename, int DIVERGE = 0, double DIVERGE_RFAC = 1.0, int EXTERNAL = 0)

Constructor (from a table)

virtual ~SphericalModelTable()

Destructor.

Public Static Attributes

static int chebyN

Chebyshev order (default: 0, no Chebyshev)

static int count

Count the number of instantiations (for debugging)

static int even

Assume even spacing in the mass model table (default: yes)

static int linear

Linear interpolation in model (default: no)

Private Functions

void debug_fdist()

Private Members

RUN density
FDIST df
FDISTC dfc
int diverge
double diverge_rfac
int external
double foffset
RUN mass
int num
int num_params
int numdf
std::vector<double> params
RUN pot
class SphericalOrbit : public RegularOrbit
#include <orbit.H>

Inheritence diagram for SphericalOrbit:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="RegularOrbit" tooltip="RegularOrbit"]
    "1" [label="SphericalOrbit" tooltip="SphericalOrbit" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for SphericalOrbit:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "4" [label="GaussQuad" tooltip="GaussQuad"]
    "2" [label="RegularOrbit" tooltip="RegularOrbit"]
    "1" [label="SphericalOrbit" tooltip="SphericalOrbit" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "3" [dir=forward tooltip="usage"]
    "1" -> "4" [dir=forward tooltip="usage"]
}

Public Functions

inline double AngMom(void)

The value of the orbital angular momentum.

inline double apo(void)

Radius of the apocenter of this orbit.

inline double Beta(void)

The specified altitude of the orbital plane.

inline double circ(void)

Radius of the circular orbit with energy E.

inline double Energy(void)

Safe access to internal quantities.

The value of the orbital energy

inline virtual double get_action(const int i)

Required functions for accessing phase-space parameters.

Return the action where: index 0 is radial action, I_r index 1 is angular action, J index 2 should be J_z/J, current set to zero

virtual double get_angle(const int i, const double time)

Get angle dependent quantities for the orbit where the index signifies:

i val

1 w1 2 w2 3 t 4 dw1dt 5 f 6 r 7 phi

inline struct ANGLE_GRID *get_angle_grid(void)

Access to underlying grid for pot_trans.

inline virtual double get_freq(const int i)

Return the orbital frequency where: index 0 is radial frequency, I_r index 1 is angular frequency, J index 2 is frequency of line of nodes (zero for a spherical system)

double get_w1(double r, double vr)

Get radial angle for a given radius.

inline double Jmax(void)

The value of the current J_{max}(E)

inline double Kappa(void)

The value of the current J/J_{max}(E)

inline AxiSymModel &modl(void)

Get the underlying axisymmetric model object.

void new_orbit(double Energy, double kappa, double beta = 0.0)

Set the energy and kappa for the orbit.

SphericalOrbit &operator=(const SphericalOrbit&)
inline AxiSymBiorth &orth(void)

Get the underlying biorthogonal function object.

inline double peri(void)

Radius of the pericenter of this orbit.

void pot_trans(int l1, int l2, Eigen::VectorXd &t)
double pot_trans(int l1, int l2, int n)
double pot_trans(int l1, int l2, std::function<double(double)> func)
inline void set_biorth(std::shared_ptr<AxiSymBiorth> type, int ll, int max, int recur = 0)

Set the biorthogonal ffunction type.

inline void set_numerical_params(int RECS = 64, int NMAX = 40, int NBSCT = 3)

Set the numerical parameters for angle transform computation.

SphericalOrbit(const SphericalOrbit&)
SphericalOrbit(std::shared_ptr<AxiSymModel> model)
SphericalOrbit(std::shared_ptr<AxiSymModel> model, double Energy, double kappa, double beta = 0.0)
SphericalOrbit(void)
inline virtual ~SphericalOrbit()

Public Static Attributes

static bool guard
static int Nseg
static double RMAXF
static double tol
static double tolnr
static double ZFRAC

Private Functions

inline void compute_action(void)
void compute_angles(void)
void compute_angles_epi(void)
void compute_angles_old(void)
void compute_biorth(void)
void compute_freq(void)
void compute_freq_epi(void)
std::tuple<double, double, bool> search(std::function<double(double)> func, double rmin, double rmax)

Private Members

double am
struct ANGLE_GRID angle_grid
double ap
double beta
std::shared_ptr<AxiSymBiorth> biorth
Eigen::VectorXd cosvec
double energy
GaussQuad Gkn
double jmax
double kappa
int l
int l1s
int l2s
std::shared_ptr<AxiSymModel> model
int nbsct
int nmax
double r_apo
double r_circ
double r_peri
int recs
int RECUR
double sm
double sp
class SphericalSL
#include <SphericalSL.H>

Public Functions

void accumulate(vector<Particle> &particles)
void determine_fields_at_point(double r, double theta, double phi, double *tdens, double *tpotl, double *tpotr, double *tpott, double *tpotp, int id = 0)
void dump_basis(string &dumpname)
void dump_coefs(ofstream &out, bool binary)
void get_dens_coefs(int l, const Eigen::VectorXd &coef, double &p, int id = 0)
inline int get_maxNL(void)
inline int get_maxNR(void)
void get_pot_coefs(int l, const Eigen::VectorXd &coef, double &p, double &dp, int id = 0)
inline void get_potl_dens(int l, int n, double r, int id = 0)
void reset(std::string file, int Nth, int lmax, int nmax, int CMAP, double SCALE)
inline void set_compute()
inline std::shared_ptr<SLGridSph> SL(void)
SphericalSL(std::string file, int Nth, int lmax, int nmax, int CMAP, double SCALE = 1.0)
SphericalSL(void)
inline void unset_compute()
~SphericalSL(void)

Public Static Attributes

static int NUMR
static double RMAX
static double RMIN
static int selector
static int tk_type
static double tkcum
static double tksmooth

Private Functions

inline void bomb(const char *s)
void compute_coefficients_single(vector<Particle> &part)
void compute_coefficients_thread(vector<Particle> &part)
void compute_coefficients_thread_call(int id, vector<Particle> *p)
void initialize(void)
void parallel_distribute_coefficients(Eigen::MatrixXd &expcoef)
void parallel_gather_coefficients(Eigen::MatrixXd &expcoef, Eigen::MatrixXd &expcoef1, std::vector<Eigen::MatrixXd> &cc, std::vector<Eigen::MatrixXd> &cc1, int lmax)
void pca_hall(int compute, Eigen::MatrixXd &expcoef, std::vector<Eigen::MatrixXd> &cc, Eigen::MatrixXd &normM)

Private Members

std::vector<Eigen::MatrixXd> cc
std::vector<std::vector<Eigen::MatrixXd>> cc1
bool coefs_made
int compute
std::vector<Eigen::VectorXd> cosm
std::vector<Eigen::MatrixXd> dend
std::vector<Eigen::MatrixXd> dlegs
std::vector<Eigen::MatrixXd> dpot
Eigen::MatrixXd expcoef
std::vector<Eigen::MatrixXd> expcoef1
Eigen::MatrixXd factorial
bool initialized
Eigen::MatrixXd krnl
std::vector<Eigen::MatrixXd> legs
int LMAX
double *MPIin
double *MPIout
bool MPIset
int n
int NMAX
Eigen::MatrixXd normM
int nthrds
std::shared_ptr<SLGridSph> ortho
std::vector<Eigen::MatrixXd> potd
std::vector<Eigen::VectorXd> sinm
std::vector<int> use
int used
class SphSL
#include <SphSL.H>

Uses SLGridSph basis to evaluate expansion coeffients and provide potential and density basis fields

Public Functions

void accumulate(double x, double y, double z, double mass)

Accumulate new coefficients.

void all_eval(double r, double costh, double phi, double &den0, double &den1, double &pot0, double &pot1, double &potr, double &pott, double &potp, int L1 = 0, int L2 = 10000, int N1 = 0, int N2 = 10000)
inline std::shared_ptr<SLGridSph> basis(void)

Access to basis.

void dens_pot_eval(double r, double costh, double phi, double &dens0, double &dens, double &potl0, double &potl, int L1 = 0, int L2 = 10000, int N1 = 0, int N2 = 10000)

Evaluate potential and density.

void dump_coefs(double time, std::ostream &out)

Dump coefficients using the standard header.

inline Eigen::MatrixXd get_pot(double x)

Retrieve potential.

double get_power(double snr, double mass)

Get fractional power in trimmed coefficients.

Eigen::MatrixXd get_trimmed(double snr, double mass, bool Hall = false)

Retrieve coefficients with SNR trim.

inline int getLmax()

Return current maximum harmonic order in expansion.

inline double getMass(void)

Get mass on grid.

inline double getMaxSNR(void)

Maximum SNR coefficient value.

inline double getMinSNR(void)

Minimum SNR coefficient value.

inline int getNmax()

Return current maximum order in radial expansion.

void install_coefs(Eigen::MatrixXd &newcoef)

Install coefficients.

void legendre_R(int lmax, double x, Eigen::MatrixXd &p)
void legendre_R(int lmax, double x, Eigen::MatrixXd &p, Eigen::MatrixXd &dp)
void legendre_R(int lmax, double x, Eigen::MatrixXd &p, Eigen::MatrixXd &dp, Eigen::MatrixXd &d2p)
void make_coefs(void)

Make coefficients after accumulation.

void make_covar(bool verbose = false)

Covariance analysis.

void pot_force_eval(double r, double costh, double phi, double &potl, double &potr, double &pott, double &potp, int L1 = 0, int L2 = 10000, int N1 = 0, int N2 = 10000)

Evaluate potential and force.

void reset_coefs(void)

Zero out coefficients to prepare for a new expansion.

inline Eigen::MatrixXd retrieve_coefs(void)

Retrieve coefficients.

inline std::vector<Eigen::MatrixXd> retrieve_covar(void)

Retrieve coefficients.

inline void set_scale(const double scl)

Prescaling factor.

SphSL(std::shared_ptr<SphericalModelTable> mod, int LMAX, int NMAX, int CMAP = 0, double SCALE = 0.067, bool COVAR = false, int NPART = 0)

Constructor

Parameters:
  • mod – instance of SphericalModelTable to condition eigenfunctions

  • LMAX – is the maximum harmonic order

  • NMAX – is the maximum radial order

  • CMAP – is the SLGridSph coordindate mapping type

  • SCALE – is the SLGridSph coordindate scale length

  • COVAR – true will evaluate the covariance matrix for coeffficients

  • NPART – >0 will evaluate the covariance matrix using a jackknife partition with number given

~SphSL(void)

Destructor.

Public Static Attributes

static double HEXP

Hall exponent (default: 1)

static bool mpi

Use MPI? (default: false)

static int NEV

Number of eigenfunctions for each subspace for PNG figure.

static int NUMR

Number of radial points in table (default: 800)

Private Types

typedef Eigen::Matrix<double, Eigen::Dynamic, Eigen::Dynamic, Eigen::ColMajor> EigenColMajor

For coefficient writing.

using matT = std::vector<Eigen::MatrixXd>
using vecT = std::vector<Eigen::VectorXd>

Private Functions

void bomb(char *s)

Private Members

const unsigned int cmagic = 0xc0a57a2

Coefficient magic number.

bool coefs_defined
bool compute_covar
matT covar
int curbin
Eigen::MatrixXd d2legs
Eigen::MatrixXd dend
Eigen::MatrixXd dlegs
Eigen::MatrixXd dpot
Eigen::MatrixXd dpt2
Eigen::MatrixXd expcoef
Eigen::MatrixXd factorial
Eigen::MatrixXd legs
int lmax
std::vector<double> massB
double maxSNR
vecT mean
std::vector<vecT> meanB
double minSNR
int nmax
int npart
Eigen::MatrixXd potd
double rmax
double rmin
double rscl
std::shared_ptr<SLGridSph> sl
vecT svar
double totalMass
int used
matT uvec
Eigen::VectorXd work
class Spline1d : public Interp1d
#include <interp.H>

Inheritence diagram for Spline1d:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="Interp1d" tooltip="Interp1d"]
    "1" [label="Spline1d" tooltip="Spline1d" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Spline1d:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="Interp1d" tooltip="Interp1d"]
    "1" [label="Spline1d" tooltip="Spline1d" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

virtual double deriv(const double &x)

Evaluate first derivative.

virtual double eval(const double &x)

Evaluate the interpolant.

void eval(const double &x, double &val, double &deriv)

Evaluate the interpolant and its first derivative.

Spline1d &operator=(const Spline1d&)

Copy constructor.

Spline1d()

Null constructor.

Spline1d(const Eigen::VectorXd &x, const Eigen::VectorXd &y, double d1 = -1.0e30, double d2 = -1.0e30)

Consruct with Eigen input. d1 and d2 are 2nd derivative BCs.

Spline1d(const std::vector<double> &x, const std::vector<double> &y, double d1 = -1.0e30, double d2 = -1.0e30)

Consruct with std::vector input. d1 and d2 are 2nd derivative BCs.

inline virtual double xhi()
inline virtual double xlo()

Data limits.

~Spline1d()

Destructor.

Private Members

Eigen::VectorXd x
Eigen::VectorXd y
Eigen::VectorXd y2
class Spline2d
#include <interp.H>

Two dimensional spline interpolator.

Public Functions

double eval(const double &x, const double &y)

Evaluate the interpolant.

Spline2d &operator=(const Spline2d&)

Copy constructor.

Spline2d(const Eigen::VectorXd &x, const Eigen::VectorXd &y, const Eigen::MatrixXd &mat)

Construct from Eigen input.

Spline2d(void)

Null constructor.

Public Static Attributes

static double DERIV

Private Members

Eigen::MatrixXd mat
Eigen::MatrixXd mat2d
Eigen::VectorXd x
Eigen::VectorXd xval
Eigen::VectorXd xval2
Eigen::VectorXd y
class SplineSoft : public SoftKernel
#include <GravKernel.H>

Inheritence diagram for SplineSoft:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="SoftKernel" tooltip="SoftKernel"]
    "1" [label="SplineSoft" tooltip="SplineSoft" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for SplineSoft:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="SoftKernel" tooltip="SoftKernel"]
    "1" [label="SplineSoft" tooltip="SplineSoft" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Cubic-spline softened gravity (compact support)

Public Functions

virtual std::pair<double, double> operator()(double r, double eps)

Main operator returning enclosed mass and gravitational potential

inline SplineSoft()

Constructor.

Private Functions

inline double m1(double x)

Spline kernel integrals.

inline double m2(double x)
inline double p1(double x)
inline double p2(double x)

Private Members

double eps
double fac0
double fac1
double fac2
class SPLInput
Input class to adaptively handle SPL. format specifically

inputs
---------------
filename : str
    the input filename to be read
comp     : str, optional
    the name of the component for which to extract data. If None, will read primary header and exit.
verbose  : int, default 0
    verbosity flag.

returns
---------------
self        : Input instance
  .header   : dict, all header values pulled from the file
    the .keys() are the names of each component
    each component has a dictionary of values, including 'parameters'
    the details of the force calculation are in 'force'
  .filename : str, the filename that was read
  .comp     : str, name of the component
  .time     : float, the time in the output file
  .data     : dictionary, with keys:
    x       : float, the x position
    y       : float, the y position
    z       : float, the z position
    vx      : float, the x velocity
    vy      : float, the y velocity
    vz      : float, the z velocity
    mass    : float, the mass of the particle
    index   : int, the integer index of the particle
    potE    : float, the potential energy value

Public Members

comp
component_map
data
f
filename
header
indexing
indir
nprocs
primary_header
subfiles
time
verbose
class SPtype
#include <SParticle.H>

Create an MPI particle type SParticle. The class creates and registers the particle type. It is freed when the instance goes out of scope and/or is destroyed.

Public Functions

inline MPI_Datatype operator()()
SPtype()
~SPtype()

Private Members

MPI_Datatype Particletype
template<typename T>
class standard_value : public cxxopts::values::abstract_value<T>
#include <cxxopts.H>

Inheritence diagram for cxxopts::values::standard_value:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::Value" tooltip="cxxopts::Value"]
    "2" [label="cxxopts::values::abstract_value< T >" tooltip="cxxopts::values::abstract_value< T >"]
    "1" [label="cxxopts::values::standard_value< T >" tooltip="cxxopts::values::standard_value< T >" fillcolor="#BFBFBF"]
    "4" [label="std::enable_shared_from_this< Value >" tooltip="std::enable_shared_from_this< Value >"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for cxxopts::values::standard_value:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::Value" tooltip="cxxopts::Value"]
    "2" [label="cxxopts::values::abstract_value< T >" tooltip="cxxopts::values::abstract_value< T >"]
    "1" [label="cxxopts::values::standard_value< T >" tooltip="cxxopts::values::standard_value< T >" fillcolor="#BFBFBF"]
    "4" [label="std::enable_shared_from_this< Value >" tooltip="std::enable_shared_from_this< Value >"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline virtual CXXOPTS_NODISCARD std::shared_ptr< Value > clone () const override
template<>
class standard_value<bool> : public cxxopts::values::abstract_value<bool>
#include <cxxopts.H>

Inheritence diagram for cxxopts::values::standard_value< bool >:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="cxxopts::values::abstract_value< bool >" tooltip="cxxopts::values::abstract_value< bool >"]
    "3" [label="cxxopts::Value" tooltip="cxxopts::Value"]
    "1" [label="cxxopts::values::standard_value< bool >" tooltip="cxxopts::values::standard_value< bool >" fillcolor="#BFBFBF"]
    "4" [label="std::enable_shared_from_this< Value >" tooltip="std::enable_shared_from_this< Value >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for cxxopts::values::standard_value< bool >:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="cxxopts::values::abstract_value< bool >" tooltip="cxxopts::values::abstract_value< bool >"]
    "3" [label="cxxopts::Value" tooltip="cxxopts::Value"]
    "1" [label="cxxopts::values::standard_value< bool >" tooltip="cxxopts::values::standard_value< bool >" fillcolor="#BFBFBF"]
    "4" [label="std::enable_shared_from_this< Value >" tooltip="std::enable_shared_from_this< Value >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline virtual std::shared_ptr<Value> clone() const override
inline standard_value()
inline explicit standard_value(bool *b)
~standard_value() override = default

Private Functions

inline void set_default_and_implicit()
struct star_particle
#include <tipsydefs.h>

Tipsy particle structure for a star particle.

Public Members

Real eps

Smoothing.

Real mass

particle mass

Real metals

Metallicty value.

Real phi

Gravitational potential.

Real pos[MAXDIM]

particle position vector

Real tform

Formation time.

Real vel[MAXDIM]

particle velocity vector

struct star_particle
#include <tipsy.H>

Public Functions

inline int ID() const

Convert phi to index.

Public Members

Real eps
Real mass

Particle data.

Real metals
Real phi
Real pos[MAXDIM]
Real tform
Real vel[MAXDIM]
class StatsMPI
#include <StatsMPI.H>

A class for accumulating data and computing rate coefficients from the DSMC simulation distribution.

Public Types

typedef std::map<speciesKey, SpStat> Return
typedef std::array<double, 4> SpStat

Public Functions

inline void add(const speciesKey &k, double wgt, double val)

Add a value.

inline void clear()

Reset values.

inline Return stats()

Gather values from nodes and return count, mean weighted value, and min and max preweighted value

inline StatsMPI()

Constructor.

Private Functions

inline void share()

Gather from MPI nodes.

Private Members

std::map<speciesKey, double> ccnt
std::map<speciesKey, double> cntT
std::map<speciesKey, double> curT
std::map<speciesKey, double> vmax
std::map<speciesKey, double> vmin
std::map<speciesKey, double> vsum
template<class T>
class StringTok
#include <StringTok.H>

Public Functions

T operator()(const T &delim)
inline StringTok(const T seq, typename T::size_type pos = 0)

Private Members

T::size_type pos_
const T seq_
template<class T>
class Swap
#include <Swap.H>

Public Functions

inline T &in()
inline T out()
inline T &rin()
inline Swap()
inline Swap(T i)

Public Members

unsigned char b[sizeof(T)]
T n

Private Members

int done
union Swap u
class TableCyl
#include <sltableMP2.H>

Public Members

Eigen::MatrixXd ef
Eigen::VectorXd ev
int k
int m
class TableGrid : public ThreeDGrid
#include <TableGrid.H>

Inheritence diagram for TableGrid:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="TableGrid" tooltip="TableGrid" fillcolor="#BFBFBF"]
    "2" [label="ThreeDGrid" tooltip="ThreeDGrid"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for TableGrid:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="TableGrid" tooltip="TableGrid" fillcolor="#BFBFBF"]
    "2" [label="ThreeDGrid" tooltip="ThreeDGrid"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

This implementation of ThreeDGrid will write ascii files with records of the form X, Y, Z, D1, D2, D3, … where Dn are the data fields loaded by n called to the Add() member.

Public Functions

virtual void Add(const std::vector<double> &data, const std::string &name)

Add data.

TableGrid(int nx, int ny, int nz, double xmin, double xmax, double ymin, double ymax, double zmin, double zmax)

Constructor.

virtual void Write(const std::string &name)

Write output file.

Protected Types

typedef std::shared_ptr<dtype> dptr
typedef Dynamic3dArray<double> dtype

Protected Attributes

std::map<std::string, dptr> arrays
std::vector<float> XX
std::vector<float> YY
std::vector<float> ZZ
class TableSlab
#include <sltableMP2.H>

Public Members

Eigen::MatrixXd ef
Eigen::VectorXd ev
int kx
int ky
class TableSph
#include <sltableMP2.H>

Public Members

Eigen::MatrixXd ef
Eigen::VectorXd ev
int l
class TanhMap : public SLGridSlab::CoordMap

Inheritence diagram for SLGridSlab::TanhMap:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="SLGridSlab::CoordMap" tooltip="SLGridSlab::CoordMap"]
    "1" [label="SLGridSlab::TanhMap" tooltip="SLGridSlab::TanhMap" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for SLGridSlab::TanhMap:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="SLGridSlab::CoordMap" tooltip="SLGridSlab::CoordMap"]
    "1" [label="SLGridSlab::TanhMap" tooltip="SLGridSlab::TanhMap" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

x = tanh(z/H)

Public Functions

virtual double d_xi_to_z(double z)

Jacobian of the transformation.

inline TanhMap(double H)
virtual double xi_to_z(double z)

Convert from mapped coordinate back to vertical.

virtual double z_to_xi(double z)

Convert from vertical to mapped coordinate.

class TaperedMestelDisk : public MestelDisk
#include <mestel.H>

Inheritence diagram for TaperedMestelDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="AxiSymModel" tooltip="AxiSymModel"]
    "4" [label="MassModel" tooltip="MassModel"]
    "2" [label="MestelDisk" tooltip="MestelDisk"]
    "1" [label="TaperedMestelDisk" tooltip="TaperedMestelDisk" fillcolor="#BFBFBF"]
    "5" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "3" -> "5" [dir=forward tooltip="public-inheritance"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for TaperedMestelDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "8" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "3" [label="AxiSymModel" tooltip="AxiSymModel"]
    "9" [label="GaussQuad" tooltip="GaussQuad"]
    "4" [label="MassModel" tooltip="MassModel"]
    "2" [label="MestelDisk" tooltip="MestelDisk"]
    "7" [label="RegularOrbit" tooltip="RegularOrbit"]
    "6" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "1" [label="TaperedMestelDisk" tooltip="TaperedMestelDisk" fillcolor="#BFBFBF"]
    "5" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "3" -> "4" [dir=forward tooltip="public-inheritance"]
    "3" -> "5" [dir=forward tooltip="public-inheritance"]
    "3" -> "6" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "6" -> "7" [dir=forward tooltip="public-inheritance"]
    "6" -> "8" [dir=forward tooltip="usage"]
    "6" -> "9" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Doubly tapered Mestel Disk.

Public Functions

virtual double d2fde2(double E, double L)
virtual double dfde(double E, double L)
virtual double dfdl(double E, double L)
virtual double distf(double E, double L)

Overloaded DF member functions.

virtual double get_density(const double R)

Overloaded density function.

virtual double get_mass(double R)

Overloaded cumulative mass function.

TaperedMestelDisk(double nu, double mu, double Ri, double Ro, double VROT = 1.0, double RMIN = 1.0e-6, double RMAX = 1.0e6)

Constructor.

Protected Functions

double dTinner(double Jp)

Deriv of inner taper function.

double dTouter(double Jp)

Deriv of outer taper function.

double Tinner(double Jp)

Inner taper function.

double Touter(double Jp)

Outer taper function.

Protected Attributes

double mu
double nu

Taper exponents.

double Ri

Inner taper radius.

double Ro

Outer taper radius.

double Tifac

Taper factors.

double Tofac

Private Members

std::shared_ptr<Linear1d> interp
struct thrd_pass_posvel
#include <global.H>

Helper class to pass info for incr_postion and incr_velocity.

Public Members

double dt

Time step.

int id

Thread counter id.

int mlevel

Levels flag.

struct thrd_pass_PotAccel
#include <PotAccel.H>

Collaboration diagram for thrd_pass_PotAccel:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="Component" tooltip="Component"]
    "5" [label="EL3" tooltip="EL3"]
    "4" [label="Orient" tooltip="Orient"]
    "2" [label="PotAccel" tooltip="PotAccel"]
    "6" [label="Timer" tooltip="Timer"]
    "1" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel" fillcolor="#BFBFBF"]
    "3" -> "3" [dir=forward tooltip="usage"]
    "3" -> "2" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "6" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="usage"]
    "2" -> "1" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="usage"]
}

Helper class to pass info to threaded member.

Public Members

bool coef

Call coefficient thread member (true) or acceleration/potential (false)

int id

Thread counter id.

PotAccel *t

Pointer to force.

class ThreeDGrid
#include <ThreeDGrid.H>

Inheritence diagram for ThreeDGrid:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="DataGrid" tooltip="DataGrid"]
    "3" [label="TableGrid" tooltip="TableGrid"]
    "1" [label="ThreeDGrid" tooltip="ThreeDGrid" fillcolor="#BFBFBF"]
    "4" [label="VtkGrid" tooltip="VtkGrid"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "4" -> "1" [dir=forward tooltip="public-inheritance"]
}

This is an API for populating a 3d grid rectangular grid database for diagnostic output.

The user provides the size of the grid and extents. Calls to Add() add additiional data fields with the predefined rectangular grid shape. The input array is flattened and packed in C (not Fortran) order. A call to Write() dumps the array in the format implemented by the derived class.

Subclassed by DataGrid, TableGrid, VtkGrid

Public Functions

virtual void Add(const std::vector<double> &data, const std::string &name) = 0

Add a data field to the rectangular grid database.

inline ThreeDGrid()

Null constructor.

inline ThreeDGrid(int nx, int ny, int nz, double xmin, double xmax, double ymin, double ymax, double zmin, double zmax)

Constructor.

virtual void Write(const std::string &name) = 0

Write output file.

Protected Attributes

int nx
int ny
int nz
float xmax
float xmin
float ymax
float ymin
float zmax
float zmin
class tidalField : public ExternalForce
#include <tidalField.H>

Inheritence diagram for tidalField:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="tidalField" tooltip="tidalField" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for tidalField:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="Component" tooltip="Component"]
    "7" [label="EL3" tooltip="EL3"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "6" [label="Orient" tooltip="Orient"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "8" [label="Timer" tooltip="Timer"]
    "4" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "1" [label="tidalField" tooltip="tidalField" fillcolor="#BFBFBF"]
    "5" -> "5" [dir=forward tooltip="usage"]
    "5" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "5" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Compute tidal acceleration and potential in the Hills limit.

The calculation is done in a frame having its cartesian axis directions fixed in space; i.e., the system is not phase locked with the perturber as is usually the case. Unfortunately, I know of no conserved quantities in this frame. int freeze_particle(int i) Freeze the i-th particle if it has gone too far away from the origin.

Public Functions

tidalField(const YAML::Node &config)

Constructor.

inline virtual ~tidalField()

Destructor.

Private Functions

virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreaded method (must be thread safe) for force computation that must be provided by all derived classes (hence pure virtual)

virtual void initialize()

Used by derived class to initialize any storage and parameters.

Private Members

double hills_omega
double hills_p

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class Time
#include <chkTimer.H>

A “helper” class to print time_t intervals.

Public Functions

inline Time(double T)

Constructor for double input.

inline Time(time_t T)

Constructor for time_t input.

Protected Attributes

time_t t

Friends

friend ostream &operator<<(ostream &out, Time const &T)

std output stream manipulator

class Timer
#include <Timer.H>

This is a diagnostic stopwatch-like timer implemented using std::chrono.

Public Functions

inline double getTime()

Return time measured up to this point.

inline bool isStarted()

Return the status of the timer.

inline double operator()()

Return time measured up to this point.

inline void reset()

Reset the timer, this will reset the time measured to 0 and reset the zero point if the timer is active

inline void start()

Start timer, if already started then do nothing.

inline double stop()

Stop timer and return time measured so far. If timer was stopped the time returned will be the current elapsed time.

inline Timer()

Constructor.

inline Timer(const Timer &t)

Copy consructor.

Private Members

std::chrono::high_resolution_clock::time_point begin

Time structures (will initialize to zero by default)

std::chrono::high_resolution_clock::time_point end
double rtime

The time measured so far.

bool started

Indicate whether the timer has been started.

class Tipsy : public PR::ParticleReader
#include <ParticleReader.H>

Inheritence diagram for PR::Tipsy:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="PR::ParticleReader" tooltip="PR::ParticleReader"]
    "1" [label="PR::Tipsy" tooltip="PR::Tipsy" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for PR::Tipsy:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="PR::ParticleReader" tooltip="PR::ParticleReader"]
    "1" [label="PR::Tipsy" tooltip="PR::Tipsy" fillcolor="#BFBFBF"]
    "3" [label="Particle" tooltip="Particle"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "3" [dir=forward tooltip="usage"]
}

Class to access a Tipsy file

Public Types

enum class TipsyType

Values:

enumerator native
enumerator xdr
enumerator bonsai

Public Functions

virtual unsigned long CurrentNumber()

Number of particles in the chosen type.

inline virtual double CurrentTime()

Get current time.

virtual const Particle *firstParticle()

Particle access.

inline virtual std::vector<std::string> GetTypes()

Return list of particle types.

virtual const Particle *nextParticle()

Get the next particle.

virtual void SelectType(const std::string &type)

Select a particular particle type and reset the iterator.

Tipsy(const std::string &file, TipsyType type = TipsyType::native, bool verbose = false)

Single-file constructor.

Tipsy(const std::vector<std::string> &file, TipsyType type = TipsyType::native, bool verbose = false)

Constructor.

inline virtual ~Tipsy()

Destructor.

Protected Functions

void getNumbers()
bool nextFile()
void packParticle()

Protected Attributes

unsigned pcount
int ptype

Protected Static Attributes

static std::unordered_map<std::string, int> findP
static std::vector<std::string> Ptypes

Private Members

std::vector<std::string>::iterator curfile

Current file.

std::string curName

Current name.

std::vector<std::string> curTypes

Current types.

std::vector<std::string> files

List of files.

unsigned long Ndark
unsigned long Ngas

Totals.

unsigned long Nstar
Particle P

Temporary for packing array.

std::shared_ptr<TipsyReader::TipsyFile> ps

Pointer to Tipsy particle structures.

TipsyType ttype

Tipsy file type.

class TipsyFile
#include <tipsy.H>

Inheritence diagram for TipsyReader::TipsyFile:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="TipsyReader::TipsyFile" tooltip="TipsyReader::TipsyFile" fillcolor="#BFBFBF"]
    "2" [label="TipsyReader::TipsyNative" tooltip="TipsyReader::TipsyNative"]
    "2" -> "1" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for TipsyReader::TipsyFile:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="TipsyReader::Header" tooltip="TipsyReader::Header"]
    "1" [label="TipsyReader::TipsyFile" tooltip="TipsyReader::TipsyFile" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="usage"]
}

Subclassed by TipsyReader::TipsyNative

Public Functions

virtual int readParticles() = 0
inline virtual ~TipsyFile()

Public Members

std::vector<dark_particle> dark_particles
std::vector<gas_particle> gas_particles
Header header
std::vector<star_particle> star_particles

Protected Functions

virtual void read_dark() = 0
virtual void read_gas() = 0
virtual void read_star() = 0
class TipsyNative : public TipsyReader::TipsyFile
#include <tipsy.H>

Inheritence diagram for TipsyReader::TipsyNative:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="TipsyReader::TipsyFile" tooltip="TipsyReader::TipsyFile"]
    "1" [label="TipsyReader::TipsyNative" tooltip="TipsyReader::TipsyNative" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for TipsyReader::TipsyNative:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="TipsyReader::Header" tooltip="TipsyReader::Header"]
    "2" [label="TipsyReader::TipsyFile" tooltip="TipsyReader::TipsyFile"]
    "1" [label="TipsyReader::TipsyNative" tooltip="TipsyReader::TipsyNative" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline virtual int readParticles()
inline TipsyNative(const std::string filename)
inline ~TipsyNative()

Private Functions

inline int native_header()

Read the header.

inline int native_init(const std::string &filename)
inline int native_read()
inline virtual void read_dark()
inline virtual void read_gas()
inline virtual void read_star()

Private Members

std::ifstream input

The input file stream.

Friends

friend class PR::Tipsy
class ToomreDisk : public AxiSymModel
#include <toomre.H>

Inheritence diagram for ToomreDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "3" [label="MassModel" tooltip="MassModel"]
    "1" [label="ToomreDisk" tooltip="ToomreDisk" fillcolor="#BFBFBF"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for ToomreDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "7" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "2" [label="AxiSymModel" tooltip="AxiSymModel"]
    "8" [label="GaussQuad" tooltip="GaussQuad"]
    "3" [label="MassModel" tooltip="MassModel"]
    "6" [label="RegularOrbit" tooltip="RegularOrbit"]
    "5" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "1" [label="ToomreDisk" tooltip="ToomreDisk" fillcolor="#BFBFBF"]
    "4" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "2" -> "4" [dir=forward tooltip="public-inheritance"]
    "2" -> "5" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="public-inheritance"]
    "5" -> "7" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

virtual double d2fde2(double E, double L)
virtual double dfde(double E, double L)
virtual double dfdl(double E, double L)
virtual double distf(double E, double L)
inline virtual double get_density(const double r)
inline virtual double get_dpot(const double r)
inline virtual double get_dpot2(const double r)
inline virtual double get_mass(const double r)

Access the profile.

inline virtual double get_max_radius(void)
inline virtual double get_min_radius(void)
inline virtual double get_pot(const double r)
inline virtual void get_pot_dpot(const double r, double &ur, double &dur)
inline ToomreDisk(int M = 0, double RMAX = 1.0e6)

Private Functions

void pdist(double E, double L)

Private Members

double e
double m
double p0
double p1
double p2
double rmax
double x
class TransformFFT
#include <TransformFFT.H>

Public Functions

void Inverse(Eigen::VectorXd &F, Eigen::VectorXcd &W)
void Inverse(std::vector<double> &F, std::vector<double> &Wr, std::vector<double> &Wi)
void Power(Eigen::VectorXd &F, Eigen::VectorXd &P)
void Power(std::vector<double> &F, std::vector<double> &P)
TransformFFT(double dr, Eigen::VectorXd &Y)
TransformFFT(double dr, std::vector<double> &Y)
~TransformFFT()

Private Members

double dk
double dr
int hi
std::vector<double> in
int lo
int N
std::vector<std::complex<double>> out
fftw_plan p
class Truncated : public EmpCylSL::AxiDisk
#include <DiskModels.H>

Inheritence diagram for Truncated:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EmpCylSL::AxiDisk" tooltip="EmpCylSL::AxiDisk"]
    "1" [label="Truncated" tooltip="Truncated" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Truncated:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EmpCylSL::AxiDisk" tooltip="EmpCylSL::AxiDisk"]
    "1" [label="Truncated" tooltip="Truncated" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Truncate a AxiDisk.

Public Functions

inline virtual double operator()(double R, double z, double phi = 0.)

Density function.

inline Truncated(double R, double W, AxiDiskPtr p)

Private Types

typedef std::shared_ptr<EmpCylSL::AxiDisk> AxiDiskPtr

Private Members

AxiDiskPtr model
double rt
double rw
class TwoCenter : public PotAccel
#include <TwoCenter.H>

Inheritence diagram for TwoCenter:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="EJcom" tooltip="EJcom"]
    "2" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="TwoCenter" tooltip="TwoCenter" fillcolor="#BFBFBF"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for TwoCenter:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "8" [label="Basis" tooltip="Basis"]
    "4" [label="Component" tooltip="Component"]
    "6" [label="EL3" tooltip="EL3"]
    "9" [label="MixtureBasis" tooltip="MixtureBasis"]
    "5" [label="Orient" tooltip="Orient"]
    "2" [label="PotAccel" tooltip="PotAccel"]
    "7" [label="Timer" tooltip="Timer"]
    "1" [label="TwoCenter" tooltip="TwoCenter" fillcolor="#BFBFBF"]
    "3" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "8" -> "2" [dir=forward tooltip="public-inheritance"]
    "4" -> "4" [dir=forward tooltip="usage"]
    "4" -> "2" [dir=forward tooltip="usage"]
    "4" -> "5" [dir=forward tooltip="usage"]
    "4" -> "7" [dir=forward tooltip="usage"]
    "9" -> "1" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="usage"]
    "2" -> "4" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "8" [dir=forward tooltip="usage"]
    "1" -> "9" [dir=forward tooltip="usage"]
    "3" -> "2" [dir=forward tooltip="usage"]
}

Computes the potential, acceleration and density using two basis sets with different expansion centers

This class provides a virtual member “mixture(double *pos)” that must be implemented by a derived class to provide the mixture function for associating particles with a force center for gravitational field determination. EJcom is an example of an implementation using an erf-based ramp whose argument is the distance from the particle to the inner center and the width is the distance between the centers.

All parameters are parsed by the underlying basis instances for the two centers. There is only one diagnostic parameter:

Param nhisto:

enables diagnostic output of mixture distribution if set to a value larger than 1

Param basis:

is the name of the force method to use for the two-center expansion. Available types are: “bessel” (Bessel), “sphereSL” (Sphere), “cylinder” (Cylinder).

Subclassed by EJcom

Public Types

typedef double (TwoCenter::* mixFunc)(double *p)

The mixture function.

Public Functions

inline double Cmixture(double *p)

The complement of the mixture function, also in [0,1].

virtual void determine_coefficients(Component *c)

Call Basis routines to make coefficients.

virtual void determine_coefficients(void)

Used by get_acceleration_and_potential to request that the expansion be performed.

virtual void get_acceleration_and_potential(Component*)

Main force evaluation routine: cycle through each grid.

virtual double mixture(double *p) = 0

Mixture function for the two expansions.

To be provided: must return a value in [0,1]

inline virtual void multistep_debug()

Print debug info.

inline virtual void multistep_reset()

Reset data for multistep.

inline virtual void multistep_update(int cur, int next, Component *c, int i, int id)

Implementation of level shifts.

inline virtual void multistep_update_begin()

Execute to begin level shifts for particles.

Update the multi time step force algorithm when moving particle i from level cur to level next

inline virtual void multistep_update_finish()

Execute to finish level shifts for particles.

inline virtual void RegisterComponent(Component *c)

For access to parent component.

inline virtual void set_multistep_level(unsigned n)

Multistepping routines: call the basis members for each component.

TwoCenter(Component *c0, const YAML::Node &conf)

Constructor

Parameters:
  • c0 – is the instantiating caller (a Component)

  • line – passes any parameters (rsphSL, rmin and numr)

~TwoCenter()

Destructor.

Public Members

vector<double> inner

INNER center for current component.

vector<double> outer

OUTER center for current component.

Protected Functions

void accum_histo(double value)

Make a histogram for debugging the mixture factor distribution.

Protected Attributes

double dz

The bin spacing.

vector<double> histo

The histogram bins.

unsigned nhisto

Number of bins.

string ohisto

Name for the histogram file.

Protected Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

Private Functions

inline virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreading implementation of the force computation.

inline virtual void *determine_coefficients_thread(void *arg)

The required force members, but this class does not multithread directly.

virtual void initialize(void)

Force initialization.

void reset_histo()

Zero out the histogram bins.

void write_histo()

Write the current histogram to the log file.

Private Members

string basis

The name of the basis (for reflection)

Basis *exp_in
Basis *exp_out
MixtureBasis *mix_in

Mixture containers for each basis.

MixtureBasis *mix_out
class TwoDCoefs
#include <TwoDCoefs.H>

Public Types

using CoefPtr = std::shared_ptr<Coefs>
using DataPtr = std::shared_ptr<Eigen::MatrixXd>
using LMkey = std::tuple<unsigned, unsigned>

Public Functions

DataPtr interpolate(const double time)
DataPtr operator()(const double time)
TwoDCoefs(const std::string &file, unsigned stride = 1)

Public Members

std::map<double, Eigen::MatrixXd> coefs
int Lmax
int nmax
int ntimes
std::vector<double> times

Private Functions

inline double to_ndigits(double x)
DataPtr zero_ret()

Private Members

int ndigits
DataPtr ret
template<typename T>
struct type_is_container
#include <cxxopts.H>

Public Static Attributes

static constexpr bool value = false
template<typename T>
struct type_is_container<std::vector<T>>
#include <cxxopts.H>

Public Static Attributes

static constexpr bool value = true
class Ultra : public OrthoPoly
#include <OrthoPoly.H>

Inheritence diagram for Ultra:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="OrthoPoly" tooltip="OrthoPoly"]
    "1" [label="Ultra" tooltip="Ultra" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for Ultra:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="OrthoPoly" tooltip="OrthoPoly"]
    "1" [label="Ultra" tooltip="Ultra" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline virtual double coef1(const int n)
inline virtual double coef2(const int n)
inline virtual double coef3(const int n)
inline virtual double coef4(const int n)
inline virtual double f0(const double x)
inline virtual double f1(const double x)
inline virtual double h(const int n)
inline Ultra(double A)
inline virtual double w(const double x)

Private Members

double alpha
class UserBar : public ExternalForce
#include <UserBar.H>

Inheritence diagram for UserBar:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="UserBar" tooltip="UserBar" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for UserBar:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="Component" tooltip="Component"]
    "7" [label="EL3" tooltip="EL3"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "6" [label="Orient" tooltip="Orient"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "8" [label="Timer" tooltip="Timer"]
    "1" [label="UserBar" tooltip="UserBar" fillcolor="#BFBFBF"]
    "4" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "5" -> "5" [dir=forward tooltip="usage"]
    "5" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "5" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
}

Bar rotating at specified fraction of corotation

Param length:

is the bar length

Param bratio:

is the ratio of the submajor axis to the major axis

Param cratio:

is the ratio of the minor axis to the submajor axis

Param amp:

is the bar amplitude in fraction of the monopole mass

Param Ton:

is the time at the center of the erf turn on

Param Toff:

is the time at the center of the erf turn off

Param DeltaT:

is the spread of the turn on

Param Fcorot:

is fraction of the length relative to the corotation radius

Param fixed:

if nonzero, pattern speed is computed at every step from the current potential, if zero, pattern speed is evaluated once to start (default: false).

Param soft:

use the shallow form of the potential (default: false)

Param ctr_name:

defines the component that defines the bar center

Param angm_name:

defines the component that defines the L_z reservoir

Public Functions

UserBar(const YAML::Node &conf)

Constructor.

~UserBar()

Destructor.

Private Functions

virtual void determine_acceleration_and_potential(void)

Called to evaluate acceleration Default version calls the provided thread function. Can be overloaded to provide additional non-threaded tasks.

virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreaded method (must be thread safe) for force computation that must be provided by all derived classes (hence pure virtual)

virtual void initialize()

Used by derived class to initialize any storage and parameters.

void userinfo()

Private Members

double afac
double amplitude
std::string angm_name
double b5
double bratio
Component *c0
Component *c1
double cratio
std::string ctr_name
double DeltaT
double Fcorot
string filename
bool firstime
bool fixed
double Iz
double lastomega
double lasttime
double length
double Lz
double Lz0
double Lzbar
string name
double omega
double posang
bool soft
double Toff
double Ton

Private Static Attributes

static constexpr double numfac = 3.86274202023190e-01
static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class UserDisk : public ExternalForce
#include <UserDisk.H>

Inheritence diagram for UserDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="UserDisk" tooltip="UserDisk" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for UserDisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="Component" tooltip="Component"]
    "7" [label="EL3" tooltip="EL3"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "6" [label="Orient" tooltip="Orient"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "8" [label="Timer" tooltip="Timer"]
    "1" [label="UserDisk" tooltip="UserDisk" fillcolor="#BFBFBF"]
    "4" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "5" -> "5" [dir=forward tooltip="usage"]
    "5" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "5" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
}

Potential and force of a thin exponential disk. The force is tabulated on a two-dimensional grid with positive Z and interpolated using bilinear interpolation.

The default values for Nscale, Ngrid and Nint should suffice for most applications.

Param a:

is the disk scale length

Param mass:

is the total mass of the disk

Param Ton:

is the time at the center of the erf turn on

Param Toff:

is the time at the center of the erf turn off

Param DeltaT:

is the spread of the turn on

Param ctrname:

defines the component that defines the center (otherwise the center is fixed to the origin)

Param Nscale:

is the physical scale of the grid in numbers of disk scale lengths

Param Ngrid:

is the number of table points in each dimension

Param Nint:

is the number of integration knots

Public Functions

UserDisk(const YAML::Node &conf)

Constructor.

~UserDisk()

Destructor.

Private Functions

virtual void determine_acceleration_and_potential(void)

Called to evaluate acceleration Default version calls the provided thread function. Can be overloaded to provide additional non-threaded tasks.

virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreaded method (must be thread safe) for force computation that must be provided by all derived classes (hence pure virtual)

void genTable()
void getTable(double R, double Z, double &pot, double &fr, double &fz)
virtual void initialize()

Used by derived class to initialize any storage and parameters.

void printTable()
void userinfo()

Private Members

double a
Component *c0
string ctr_name
bool debug
double DeltaT
double dfac
double dR
double dZ
double mass
string name
int Ngrid
int Nint
double Nscale
double *Ptable
double Rmax
double *Rtable
double Toff
double Ton
double Zmax
double *Ztable

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class UserHalo : public ExternalForce
#include <UserHalo.H>

Inheritence diagram for UserHalo:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="UserHalo" tooltip="UserHalo" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for UserHalo:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "15" [label="ANGLE_GRID" tooltip="ANGLE_GRID"]
    "10" [label="AxiSymModel" tooltip="AxiSymModel"]
    "20" [label="Cheby1d" tooltip="Cheby1d"]
    "5" [label="Component" tooltip="Component"]
    "7" [label="EL3" tooltip="EL3"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "18" [label="FDIST" tooltip="FDIST"]
    "19" [label="FDISTC" tooltip="FDISTC"]
    "16" [label="GaussQuad" tooltip="GaussQuad"]
    "21" [label="Interp1d" tooltip="Interp1d"]
    "11" [label="MassModel" tooltip="MassModel"]
    "6" [label="Orient" tooltip="Orient"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "17" [label="RUN" tooltip="RUN"]
    "14" [label="RegularOrbit" tooltip="RegularOrbit"]
    "9" [label="SphericalModelTable" tooltip="SphericalModelTable"]
    "13" [label="SphericalOrbit" tooltip="SphericalOrbit"]
    "8" [label="Timer" tooltip="Timer"]
    "1" [label="UserHalo" tooltip="UserHalo" fillcolor="#BFBFBF"]
    "12" [label="std::enable_shared_from_this< AxiSymModel >" tooltip="std::enable_shared_from_this< AxiSymModel >"]
    "4" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "10" -> "11" [dir=forward tooltip="public-inheritance"]
    "10" -> "12" [dir=forward tooltip="public-inheritance"]
    "10" -> "13" [dir=forward tooltip="usage"]
    "20" -> "21" [dir=forward tooltip="public-inheritance"]
    "5" -> "5" [dir=forward tooltip="usage"]
    "5" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "19" -> "20" [dir=forward tooltip="usage"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "5" [dir=forward tooltip="usage"]
    "9" -> "10" [dir=forward tooltip="public-inheritance"]
    "9" -> "17" [dir=forward tooltip="usage"]
    "9" -> "18" [dir=forward tooltip="usage"]
    "9" -> "19" [dir=forward tooltip="usage"]
    "13" -> "14" [dir=forward tooltip="public-inheritance"]
    "13" -> "15" [dir=forward tooltip="usage"]
    "13" -> "16" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "9" [dir=forward tooltip="usage"]
    "1" -> "5" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
}

Halo model based on SphericalModelTable

Param model_file:

is the filename

Param comp_name:

is the component to apply this (blank for all, default=””)

Param diverge:

set to 1 uses a power law inner profile

Param diverge_rfac:

is the value of power law exponent

Param q0:

is the x-axis scaling (for simulating a triaxial halo, default: 1)

Param q1:

is the y-axis scaling (for simulating a triaxial halo, default: 1)

Param q2:

is the z-axis scaling (for simulating a triaxial halo, default: 1)

Public Functions

UserHalo(const YAML::Node &conf)

Constructor.

~UserHalo()

Destructor.

Private Functions

virtual void determine_acceleration_and_potential(void)

Called to evaluate acceleration Default version calls the provided thread function. Can be overloaded to provide additional non-threaded tasks.

virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreaded method (must be thread safe) for force computation that must be provided by all derived classes (hence pure virtual)

virtual void initialize()

Used by derived class to initialize any storage and parameters.

void userinfo()

Private Members

Component *c0
std::string comp_name
int diverge
double diverge_rfac
SphericalModelTable *model
std::string model_file
double q1
double q2
double q3

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class UserLogPot : public ExternalForce
#include <UserLogPot.H>

Inheritence diagram for UserLogPot:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="UserLogPot" tooltip="UserLogPot" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for UserLogPot:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="Component" tooltip="Component"]
    "7" [label="EL3" tooltip="EL3"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "6" [label="Orient" tooltip="Orient"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "8" [label="Timer" tooltip="Timer"]
    "1" [label="UserLogPot" tooltip="UserLogPot" fillcolor="#BFBFBF"]
    "4" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "5" -> "5" [dir=forward tooltip="usage"]
    "5" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "4" -> "3" [dir=forward tooltip="usage"]
}

Logarithmic triaxial potential

Param R:

is the core size

Param b:

is the y-axis scale factor

Param c:

is the z-axis scale factor

Param v2:

is the amplitude (e.g. the velocity on the axis at x=1)

Public Functions

UserLogPot(const YAML::Node &conf)

Constructor.

~UserLogPot()

Destructor.

Private Functions

virtual void determine_acceleration_and_potential(void)

Called to evaluate acceleration Default version calls the provided thread function. Can be overloaded to provide additional non-threaded tasks.

virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreaded method (must be thread safe) for force computation that must be provided by all derived classes (hence pure virtual)

virtual void initialize()

Used by derived class to initialize any storage and parameters.

void userinfo()

Private Members

double b
double c
double R
double v2

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class UserMNdisk : public ExternalForce
#include <UserMNdisk.H>

Inheritence diagram for UserMNdisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="UserMNdisk" tooltip="UserMNdisk" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for UserMNdisk:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="Component" tooltip="Component"]
    "7" [label="EL3" tooltip="EL3"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "6" [label="Orient" tooltip="Orient"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "8" [label="Timer" tooltip="Timer"]
    "1" [label="UserMNdisk" tooltip="UserMNdisk" fillcolor="#BFBFBF"]
    "4" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "5" -> "5" [dir=forward tooltip="usage"]
    "5" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "5" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
}

Potential and force of the Miyamoto-Nagai disk.

Param a:

is the disk scale length parameter

Param b:

is the disk scale height parameter

Param mass:

is the total mass of the disk

Param Ton:

is the time at the center of the erf turn on

Param Toff:

is the time at the center of the erf turn off

Param DeltaT:

is the spread of the turn on

Param ctrname:

defines the component that defines the center (otherwise the center is fixed to the origin)

Public Functions

UserMNdisk(const YAML::Node &conf)

Constructor.

~UserMNdisk()

Destructor.

Private Functions

virtual void determine_acceleration_and_potential(void)

Called to evaluate acceleration Default version calls the provided thread function. Can be overloaded to provide additional non-threaded tasks.

virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreaded method (must be thread safe) for force computation that must be provided by all derived classes (hence pure virtual)

virtual void initialize()

Used by derived class to initialize any storage and parameters.

void userinfo()

Private Members

double a
double b
Component *c0
string ctr_name
double DeltaT
double mass
string name
double Toff
double Ton

Private Static Attributes

static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class UserMW : public ExternalForce
#include <UserMW.H>

Inheritence diagram for UserMW:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="UserMW" tooltip="UserMW" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for UserMW:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="Component" tooltip="Component"]
    "7" [label="EL3" tooltip="EL3"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "6" [label="Orient" tooltip="Orient"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "8" [label="Timer" tooltip="Timer"]
    "1" [label="UserMW" tooltip="UserMW" fillcolor="#BFBFBF"]
    "4" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "5" -> "5" [dir=forward tooltip="usage"]
    "5" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "1" -> "5" [dir=forward tooltip="usage"]
    "4" -> "3" [dir=forward tooltip="usage"]
}

Potential and force of the Milky Way, a la Gala.

!!!ADD ALL PARAMETERS YOU WANT TO DEFINE, using this format (for automatic documentation)!!! Done

Param G:

is the gravitational constant

Param M_halo:

is the total mass of the Navarro-Frank-White (NFW) halo component

Param rs_halo:

is the scale radius of the Navarro-Frank-White (NFW) halo component

Param M_disk:

is the total mass of the Miyamoto-Nagai (MN) disk component

Param a_disk:

is the scale length of the Miyamoto-Nagai (MN) disk component

Param b_disk:

is the scale height of the Miyamoto-Nagai (MN) disk component

Param M_nucl:

is the total mass of the Hernquist (HN) nucleus component

Param c_nucl:

is the concentration of the Hernquist (HN) nucleus component

Param M_bulge:

is the total mass of the Hernquist (HN) bulge component

Param c_bulge:

is the concentration of the Hernquist (HN) bulge component

Param Ton:

is the time at the center of the erf turn on

Param Toff:

is the time at the center of the erf turn off

Param DeltaT:

is the spread of the turn on

Param ctrname:

defines the component that defines the center (otherwise the center is fixed to the origin)

Public Functions

UserMW(const YAML::Node &conf)

Constructor.

~UserMW()

Destructor.

Private Functions

virtual void determine_acceleration_and_potential(void)

Called to evaluate acceleration Default version calls the provided thread function. Can be overloaded to provide additional non-threaded tasks.

virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreaded method (must be thread safe) for force computation that must be provided by all derived classes (hence pure virtual)

inline void HN_bulge_dphi_dr(double x, double y, double z, double *ax3, double *ay3, double *az3)
inline double HN_bulge_pot(double r)
inline void HN_nucl_dphi_dr(double x, double y, double z, double *ax2, double *ay2, double *az2)
inline double HN_nucl_pot(double r)
virtual void initialize()

Used by derived class to initialize any storage and parameters.

inline void MN_dphi_dR_dz(double x, double y, double z, double *ax4, double *ay4, double *az4)
inline double MN_pot(double z, double R)
inline void NFW_dphi_dr(double x, double y, double z, double *ax1, double *ay1, double *az1)
inline double NFW_pot(double r)
void userinfo()

Private Members

double a_disk
double b_disk
Component *c0
double c_bulge
double c_nucl
string ctr_name
double DeltaT
double G
double M_bulge
double M_disk
double M_halo
double M_nucl
string name
double rs_halo
double Toff
double Ton
class UserTest : public ExternalForce
#include <UserTest.H>

Inheritence diagram for UserTest:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="UserTest" tooltip="UserTest" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for UserTest:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="Component" tooltip="Component"]
    "7" [label="EL3" tooltip="EL3"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "6" [label="Orient" tooltip="Orient"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "8" [label="Timer" tooltip="Timer"]
    "1" [label="UserTest" tooltip="UserTest" fillcolor="#BFBFBF"]
    "4" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "5" -> "5" [dir=forward tooltip="usage"]
    "5" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "4" -> "3" [dir=forward tooltip="usage"]
}

Simple skeleton user routine Does nothing but print out messages at each call

Public Functions

UserTest(const YAML::Node &conf)

Constructor.

~UserTest()

Destructor.

Private Functions

virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreaded method (must be thread safe) for force computation that must be provided by all derived classes (hence pure virtual)

virtual void initialize()

Used by derived class to initialize any storage and parameters.

class UserTestCuda : public ExternalForce
#include <UserTestCuda.H>

Inheritence diagram for UserTestCuda:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "1" [label="UserTestCuda" tooltip="UserTestCuda" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for UserTestCuda:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="Component" tooltip="Component"]
    "7" [label="EL3" tooltip="EL3"]
    "2" [label="ExternalForce" tooltip="ExternalForce"]
    "6" [label="Orient" tooltip="Orient"]
    "3" [label="PotAccel" tooltip="PotAccel"]
    "8" [label="Timer" tooltip="Timer"]
    "1" [label="UserTestCuda" tooltip="UserTestCuda" fillcolor="#BFBFBF"]
    "4" [label="thrd_pass_PotAccel" tooltip="thrd_pass_PotAccel"]
    "5" -> "5" [dir=forward tooltip="usage"]
    "5" -> "3" [dir=forward tooltip="usage"]
    "5" -> "6" [dir=forward tooltip="usage"]
    "5" -> "8" [dir=forward tooltip="usage"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "6" -> "7" [dir=forward tooltip="usage"]
    "3" -> "4" [dir=forward tooltip="usage"]
    "3" -> "5" [dir=forward tooltip="usage"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "4" -> "3" [dir=forward tooltip="usage"]
}

Public Functions

UserTestCuda(const YAML::Node &conf)
~UserTestCuda()

Private Functions

virtual void *determine_acceleration_and_potential_thread(void *arg)

Multithreaded method (must be thread safe) for force computation that must be provided by all derived classes (hence pure virtual)

virtual void initialize()

Used by derived class to initialize any storage and parameters.

Private Members

int callno
int instance
int maxcall

Private Static Attributes

static int total
static const std::set<std::string> valid_keys

Valid keys for YAML configurations.

class Value : public std::enable_shared_from_this<Value>
#include <cxxopts.H>

Inheritence diagram for cxxopts::Value:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="cxxopts::values::abstract_value< bool >" tooltip="cxxopts::values::abstract_value< bool >"]
    "1" [label="cxxopts::Value" tooltip="cxxopts::Value" fillcolor="#BFBFBF"]
    "5" [label="cxxopts::values::abstract_value< T >" tooltip="cxxopts::values::abstract_value< T >"]
    "6" [label="cxxopts::values::standard_value< T >" tooltip="cxxopts::values::standard_value< T >"]
    "4" [label="cxxopts::values::standard_value< bool >" tooltip="cxxopts::values::standard_value< bool >"]
    "2" [label="std::enable_shared_from_this< Value >" tooltip="std::enable_shared_from_this< Value >"]
    "3" -> "1" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
    "5" -> "1" [dir=forward tooltip="public-inheritance"]
    "6" -> "5" [dir=forward tooltip="public-inheritance"]
    "4" -> "3" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for cxxopts::Value:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="cxxopts::Value" tooltip="cxxopts::Value" fillcolor="#BFBFBF"]
    "2" [label="std::enable_shared_from_this< Value >" tooltip="std::enable_shared_from_this< Value >"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Subclassed by cxxopts::values::abstract_value< bool >, cxxopts::values::abstract_value< T >

Public Functions

virtual std::shared_ptr<Value> clone() const = 0
virtual std::shared_ptr<Value> default_value(const std::string &value) = 0
virtual std::string get_default_value() const = 0
virtual std::string get_implicit_value() const = 0
virtual bool has_default() const = 0
virtual bool has_implicit() const = 0
virtual std::shared_ptr<Value> implicit_value(const std::string &value) = 0
virtual bool is_boolean() const = 0
virtual bool is_container() const = 0
virtual std::shared_ptr<Value> no_implicit_value() = 0
virtual void parse() const = 0
virtual void parse(const std::string &text) const = 0
virtual ~Value() = default
class VtkGrid : public ThreeDGrid
#include <VtkGrid.H>

Inheritence diagram for VtkGrid:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="ThreeDGrid" tooltip="ThreeDGrid"]
    "1" [label="VtkGrid" tooltip="VtkGrid" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for VtkGrid:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="ThreeDGrid" tooltip="ThreeDGrid"]
    "1" [label="VtkGrid" tooltip="VtkGrid" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

A ThreeDGrid implementation of the rectangular grid database implement in VTK and designed for consumption by PyVTK or ParaView.

Public Functions

virtual void Add(const std::vector<double> &data, const std::string &name)

Add data for two-dimensional cylindrical basis.

VtkGrid(int nx, int ny, int nz, double xmin, double xmax, double ymin, double ymax, double zmin, double zmax)

Constructor.

virtual void Write(const std::string &name)

Write output file.

Private Functions

void replaceAll(std::string &str, const std::string &from, const std::string &to)
void writeBeg(std::ofstream &file)
void writeCoords(std::ofstream &file)
void writeEnd(std::ofstream &file)
void writeFields(std::ofstream &file)

Private Members

std::map<std::string, std::vector<float>> coord
std::map<std::string, std::vector<float>> dataSet
class VtkPCA
#include <VtkPCA.H>

Public Functions

void Add(const Eigen::VectorXd &coef, const Eigen::VectorXd &hall, const Eigen::VectorXd &snr, const Eigen::VectorXd &eval, const Eigen::MatrixXd &evec, const Eigen::MatrixXd &covr, int l, int m)

Add data for three-dimensional spherical basis.

void Add(const Eigen::VectorXd &coef, const Eigen::VectorXd &hall, const Eigen::VectorXd &snr, const Eigen::VectorXd &eval, const Eigen::MatrixXd &evec, const Eigen::MatrixXd &covr, int m)

Add data for two-dimensional cylindrical basis.

VtkPCA(int N, bool reorder = false, bool smooth = false)

Constructor.

void Write(const std::string &name)

Write output file.

Private Members

std::vector<vtkFloatArrayP> coef
std::vector<vtkFloatArrayP> covr
vtkRectilinearGridP dataSet
std::vector<std::string> elab
std::vector<vtkFloatArrayP> eval
std::vector<vtkFloatArrayP> hall
int nmax
bool reorder
bool smooth
std::vector<vtkFloatArrayP> snrv
std::vector<vtkFloatArrayP> vec2
std::vector<vtkFloatArrayP> vecs
vtkFloatArrayP XX
vtkFloatArrayP YY
vtkFloatArrayP ZZ
class WRgrid
#include <massmodel.H>

Public Members

vector<double> r
vector<double> w1
class YamlConfigError : public EXPException
#include <EXPException.H>

Inheritence diagram for YamlConfigError:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EXPException" tooltip="EXPException"]
    "1" [label="YamlConfigError" tooltip="YamlConfigError" fillcolor="#BFBFBF"]
    "3" [label="std::exception" tooltip="std::exception"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for YamlConfigError:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EXPException" tooltip="EXPException"]
    "1" [label="YamlConfigError" tooltip="YamlConfigError" fillcolor="#BFBFBF"]
    "3" [label="std::exception" tooltip="std::exception"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Configuration error.

Public Functions

inline YamlConfigError(const std::string classname, const std::string type, const std::set<std::string> keys, const std::string sourcefilename, int sourcelinenumber, int errorcode = -1, bool deadlock = false)

Constructor.

class ZangCyl : public EmpCyl2d::MestelCyl
#include <EmpCyl2d.H>

Inheritence diagram for EmpCyl2d::ZangCyl:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EmpCyl2d::MestelCyl" tooltip="EmpCyl2d::MestelCyl"]
    "3" [label="EmpCyl2d::ModelCyl" tooltip="EmpCyl2d::ModelCyl"]
    "1" [label="EmpCyl2d::ZangCyl" tooltip="EmpCyl2d::ZangCyl" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Collaboration diagram for EmpCyl2d::ZangCyl:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="EmpCyl2d::MestelCyl" tooltip="EmpCyl2d::MestelCyl"]
    "3" [label="EmpCyl2d::ModelCyl" tooltip="EmpCyl2d::ModelCyl"]
    "1" [label="EmpCyl2d::ZangCyl" tooltip="EmpCyl2d::ZangCyl" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=forward tooltip="public-inheritance"]
    "1" -> "2" [dir=forward tooltip="public-inheritance"]
}

Public Functions

inline virtual double dens(double R)

Surface density.

inline ZangCyl(const YAML::Node &par)

Constructor.

Protected Functions

inline virtual void parse(const YAML::Node &conf)

Assign values from YAML.

Private Functions

inline double dTinner(double Jp)

Deriv of inner taper function.

inline double dTouter(double Jp)

Deriv of outer taper function.

inline double Tinner(double Jp)

Inner taper function.

inline double Touter(double Jp)

Outer taper function.

Private Members

double asoft = 1.0e-8

Softening factor (not currently used)

bool Inner = true

Ignore inner cut-off for N<0.05.

double mu

Parameters.

double nu
double ri
double ro
double Tifac

Taper factors.

double Tofac
template<class T>
class ZBrent
#include <ZBrent.H>

Public Functions

ZBrentReturn find(func_T func, T &param, double x1, double x2, double tol, double &result)
inline ZBrent()

Public Static Attributes

static double EPS = 1.0e-16
static double epsilon = 1.0e-3
static int ITMAX = 100

Private Types

using func_T = std::function<double(double, T&)>
namespace AltMath

Functions

double assoc_laguerre(unsigned l, unsigned n, double x)
double cyl_bessel_i(double nu, double x)
double cyl_bessel_j(double nu, double x)
double cyl_bessel_k(double nu, double x)
double sph_bessel(unsigned n, double x)
namespace cxxopts

Typedefs

using NameHashMap = std::unordered_map<std::string, size_t>
using OptionMap = std::unordered_map<std::string, std::shared_ptr<OptionDetails>>
using ParsedHashMap = std::unordered_map<size_t, OptionValue>
using PositionalList = std::vector<std::string>
using PositionalListIterator = PositionalList::const_iterator
using String = std::string

Functions

inline bool empty(const std::string &s)
inline String &stringAppend(String &s, const String &a)
template<typename Iterator>
String &stringAppend(String &s, Iterator begin, Iterator end)
inline String &stringAppend(String &s, size_t n, char c)
inline size_t stringLength(const String &s)
template<typename T>
void throw_or_mimic(const std::string &text)
template<typename T>
T toLocalString(T &&t)
template<typename T>
std::string toUTF8String(T &&t)
template<typename T>
std::shared_ptr<Value> value()
template<typename T>
std::shared_ptr<Value> value(T &t)

Variables

uint8_t major
uint8_t minor
uint8_t patch
static constexpr struct cxxopts version = {CXXOPTS__VERSION_MAJOR, CXXOPTS__VERSION_MINOR, CXXOPTS__VERSION_PATCH}
namespace cxxopts
namespace values

Functions

template<typename R, typename T>
void checked_negate(R&, T&&, const std::string &text, std::false_type)
template<typename R, typename T>
void checked_negate(R &r, T &&t, const std::string&, std::true_type)
template<typename T>
void integer_parser(const std::string &text, T &value)
inline void parse_value(const std::string &text, bool &value)
inline void parse_value(const std::string &text, char &c)
inline void parse_value(const std::string &text, std::string &value)
template<typename T>
void parse_value(const std::string &text, std::vector<T> &value)
template<typename T, typename std::enable_if<std::is_integral<T>::value>::type* = nullptr>
void parse_value(const std::string &text, T &value)
template<typename T>
void stringstream_parser(const std::string &text, T &value)
namespace detail

Functions

template<typename T, typename U>
void check_signed_range(bool negative, U value, const std::string &text)
namespace parser_tool

Functions

inline bool IsFalseText(const std::string &text)
inline bool IsTrueText(const std::string &text)
inline ArguDesc ParseArgument(const char *arg, bool &matched)
inline IntegerDesc SplitInteger(const std::string &text)
inline std::pair<std::string, std::string> SplitSwitchDef(const std::string &text)
namespace parser_tool
namespace Eigen
namespace KDE
namespace KDtree

Functions

template<typename coordinate_type, size_t dimensions>
std::ostream &operator<<(std::ostream &out, const point<coordinate_type, dimensions> &pt)

For iostream printing of points.

namespace ODE
namespace PR

Typedefs

typedef std::shared_ptr<ParticleReader> PRptr
namespace progress
module psp_io
psp_io.py
   driver for input classes and handling particle data in Python

MSP 25 Oct 2021 Overhauled version


TODO
namespace std
namespace TipsyReader

Typedefs

using Real = float

Variables

const int MAXDIM = 3
file AsciiHisto.H
#include <iostream>
#include <iomanip>
#include <vector>
#include <memory>

Include dependency graph for AsciiHisto.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/AsciiHisto.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/AsciiHisto.H" fillcolor="#BFBFBF"]
    "3" [label="iomanip" tooltip="iomanip"]
    "2" [label="iostream" tooltip="iostream"]
    "5" [label="memory" tooltip="memory"]
    "4" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
}

Typedefs

typedef std::shared_ptr<AsciiHisto<double>> ahistoDPtr
typedef std::shared_ptr<AsciiHisto<int>> ahistoIPtr
typedef std::shared_ptr<AsciiHisto<unsigned>> ahistoUPtr
file BarrierWrapper.H
#include <iostream>
#include <iomanip>
#include <vector>
#include <string>
#include <list>
#include <map>
#include <set>
#include <memory>
#include <Timer.H>
#include <mpi.h>

Include dependency graph for BarrierWrapper.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BarrierWrapper.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BarrierWrapper.H" fillcolor="#BFBFBF"]
    "10" [label="Timer.H" tooltip="Timer.H"]
    "12" [label="chrono" tooltip="chrono"]
    "11" [label="cstdlib" tooltip="cstdlib"]
    "3" [label="iomanip" tooltip="iomanip"]
    "2" [label="iostream" tooltip="iostream"]
    "6" [label="list" tooltip="list"]
    "7" [label="map" tooltip="map"]
    "9" [label="memory" tooltip="memory"]
    "13" [label="mpi.h" tooltip="mpi.h"]
    "8" [label="set" tooltip="set"]
    "5" [label="string" tooltip="string"]
    "4" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "1" -> "10" [dir=forward tooltip="include"]
    "1" -> "13" [dir=forward tooltip="include"]
    "10" -> "2" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "12" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include BarrierWrapper.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BarrierWrapper.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BarrierWrapper.H" fillcolor="#BFBFBF"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/global.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/global.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "21" [dir=back tooltip="include"]
    "3" -> "25" [dir=back tooltip="include"]
    "3" -> "26" [dir=back tooltip="include"]
    "3" -> "27" [dir=back tooltip="include"]
    "3" -> "28" [dir=back tooltip="include"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "14" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
    "5" -> "7" [dir=back tooltip="include"]
    "5" -> "8" [dir=back tooltip="include"]
    "5" -> "9" [dir=back tooltip="include"]
    "5" -> "10" [dir=back tooltip="include"]
    "5" -> "11" [dir=back tooltip="include"]
    "5" -> "12" [dir=back tooltip="include"]
    "5" -> "13" [dir=back tooltip="include"]
    "21" -> "5" [dir=back tooltip="include"]
    "21" -> "22" [dir=back tooltip="include"]
    "21" -> "23" [dir=back tooltip="include"]
    "21" -> "14" [dir=back tooltip="include"]
    "21" -> "24" [dir=back tooltip="include"]
    "25" -> "25" [dir=back tooltip="include"]
    "17" -> "18" [dir=back tooltip="include"]
    "17" -> "19" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "14" -> "20" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "15" [dir=back tooltip="include"]
    "2" -> "14" [dir=back tooltip="include"]
}

Typedefs

typedef std::shared_ptr<BWData> BWPtr
typedef std::shared_ptr<char> CharPtr
typedef std::shared_ptr<Info> InfoPtr
typedef std::shared_ptr<MPI_Request> ReqPtr
file biorth.H
#include <iostream>
#include <iomanip>
#include <cstdlib>
#include <string>
#include <memory>
#include <Eigen/Eigen>

Include dependency graph for biorth.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/biorth.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/biorth.H" fillcolor="#BFBFBF"]
    "7" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "4" [label="cstdlib" tooltip="cstdlib"]
    "3" [label="iomanip" tooltip="iomanip"]
    "2" [label="iostream" tooltip="iostream"]
    "6" [label="memory" tooltip="memory"]
    "5" [label="string" tooltip="string"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include biorth.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/biorth.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/biorth.H" fillcolor="#BFBFBF"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/biorth1d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/biorth1d.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/biorth2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/biorth2d.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/biorth_wake.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/biorth_wake.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "4" [dir=back tooltip="include"]
    "1" -> "5" [dir=back tooltip="include"]
    "1" -> "6" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
}

Typedefs

typedef std::shared_ptr<AxiSymBiorth> AxiSymBioPtr

Enums

enum BiorthFcts3d

Values:

enumerator bessel
enumerator clutton_brock
enumerator hernquist
enumerator sturm
enum ScalarType

Values:

enumerator density
enumerator potential

Functions

Eigen::VectorXd scalar_prod(ScalarType type, double rmin, double rmax, int l, int m, AxiSymBiorth &s, std::function<double(double, int, int)> func, int nc, int ng)
std::string &ScalarTypeName(ScalarType i)

Variables

static std::string BiorthFcts3dName[] = {"BSSphere", "CBSphere", "HQSphere", "SphereSL"}
file biorth1d.H
#include <cmath>
#include <biorth.H>

Include dependency graph for biorth1d.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="biorth.H" tooltip="biorth.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/biorth1d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/biorth1d.H" fillcolor="#BFBFBF"]
    "9" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "2" [label="cmath" tooltip="cmath"]
    "6" [label="cstdlib" tooltip="cstdlib"]
    "5" [label="iomanip" tooltip="iomanip"]
    "4" [label="iostream" tooltip="iostream"]
    "8" [label="memory" tooltip="memory"]
    "7" [label="string" tooltip="string"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "5" [dir=forward tooltip="include"]
    "3" -> "6" [dir=forward tooltip="include"]
    "3" -> "7" [dir=forward tooltip="include"]
    "3" -> "8" [dir=forward tooltip="include"]
    "3" -> "9" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include biorth1d.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/biorth1d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/biorth1d.H" fillcolor="#BFBFBF"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H"]
    "1" -> "2" [dir=back tooltip="include"]
}
file biorth2d.H
#include <string>
#include <biorth.H>

Include dependency graph for biorth2d.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="biorth.H" tooltip="biorth.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/biorth2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/biorth2d.H" fillcolor="#BFBFBF"]
    "8" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "6" [label="cstdlib" tooltip="cstdlib"]
    "5" [label="iomanip" tooltip="iomanip"]
    "4" [label="iostream" tooltip="iostream"]
    "7" [label="memory" tooltip="memory"]
    "2" [label="string" tooltip="string"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "5" [dir=forward tooltip="include"]
    "3" -> "6" [dir=forward tooltip="include"]
    "3" -> "2" [dir=forward tooltip="include"]
    "3" -> "7" [dir=forward tooltip="include"]
    "3" -> "8" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
}

Enums

enum BiorthFcts2d

Values:

enumerator clutton_brock_2d
enumerator bessel_2d
file biorth_wake.H
#include <Eigen/Eigen>
#include <complex>
#include <biorth.H>

Include dependency graph for biorth_wake.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="biorth.H" tooltip="biorth.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/biorth_wake.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/biorth_wake.H" fillcolor="#BFBFBF"]
    "2" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "3" [label="complex" tooltip="complex"]
    "7" [label="cstdlib" tooltip="cstdlib"]
    "6" [label="iomanip" tooltip="iomanip"]
    "5" [label="iostream" tooltip="iostream"]
    "9" [label="memory" tooltip="memory"]
    "8" [label="string" tooltip="string"]
    "4" -> "5" [dir=forward tooltip="include"]
    "4" -> "6" [dir=forward tooltip="include"]
    "4" -> "7" [dir=forward tooltip="include"]
    "4" -> "8" [dir=forward tooltip="include"]
    "4" -> "9" [dir=forward tooltip="include"]
    "4" -> "2" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
}
file BiorthCube.H
#include <iostream>
#include <fstream>
#include <string>
#include <cmath>
#include <Eigen/Eigen>
#include <mpi.h>
#include <localmpi.H>
#include <config_exp.h>
#include <massmodel.H>
#include <yaml-cpp/yaml.h>
#include <highfive/H5File.hpp>
#include <highfive/H5DataSet.hpp>
#include <highfive/H5DataSpace.hpp>
#include <highfive/H5Attribute.hpp>
#include <EmpCyl2d.H>

Include dependency graph for BiorthCube.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H" fillcolor="#BFBFBF"]
    "26" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "36" [label="EXPmath.H" tooltip="EXPmath.H"]
    "32" [label="EmpCyl2d.H" tooltip="EmpCyl2d.H"]
    "18" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "25" [label="QPDistF.H" tooltip="QPDistF.H"]
    "22" [label="gaussQ.H" tooltip="gaussQ.H"]
    "16" [label="interp.H" tooltip="interp.H"]
    "8" [label="localmpi.H" tooltip="localmpi.H"]
    "11" [label="massmodel.H" tooltip="massmodel.H"]
    "20" [label="orbit.H" tooltip="orbit.H"]
    "6" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "35" [label="Eigen/Eigenvalues" tooltip="Eigen/Eigenvalues"]
    "33" [label="algorithm" tooltip="algorithm"]
    "34" [label="array" tooltip="array"]
    "5" [label="cmath" tooltip="cmath"]
    "10" [label="config_exp.h" tooltip="config_exp.h"]
    "24" [label="cstdlib" tooltip="cstdlib"]
    "17" [label="deque" tooltip="deque"]
    "3" [label="fstream" tooltip="fstream"]
    "21" [label="functional" tooltip="functional"]
    "31" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
    "29" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
    "30" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
    "28" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
    "38" [label="highfive/eigen.hpp" tooltip="highfive/eigen.hpp"]
    "37" [label="highfive/highfive.hpp" tooltip="highfive/highfive.hpp"]
    "9" [label="iomanip" tooltip="iomanip"]
    "2" [label="iostream" tooltip="iostream"]
    "19" [label="map" tooltip="map"]
    "13" [label="memory" tooltip="memory"]
    "7" [label="mpi.h" tooltip="mpi.h"]
    "14" [label="random" tooltip="random"]
    "23" [label="sstream" tooltip="sstream"]
    "4" [label="string" tooltip="string"]
    "15" [label="tuple" tooltip="tuple"]
    "12" [label="vector" tooltip="vector"]
    "27" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "10" [dir=forward tooltip="include"]
    "1" -> "11" [dir=forward tooltip="include"]
    "1" -> "27" [dir=forward tooltip="include"]
    "1" -> "28" [dir=forward tooltip="include"]
    "1" -> "29" [dir=forward tooltip="include"]
    "1" -> "30" [dir=forward tooltip="include"]
    "1" -> "31" [dir=forward tooltip="include"]
    "1" -> "32" [dir=forward tooltip="include"]
    "26" -> "11" [dir=forward tooltip="include"]
    "32" -> "33" [dir=forward tooltip="include"]
    "32" -> "13" [dir=forward tooltip="include"]
    "32" -> "4" [dir=forward tooltip="include"]
    "32" -> "12" [dir=forward tooltip="include"]
    "32" -> "34" [dir=forward tooltip="include"]
    "32" -> "15" [dir=forward tooltip="include"]
    "32" -> "6" [dir=forward tooltip="include"]
    "32" -> "35" [dir=forward tooltip="include"]
    "32" -> "27" [dir=forward tooltip="include"]
    "32" -> "10" [dir=forward tooltip="include"]
    "32" -> "22" [dir=forward tooltip="include"]
    "32" -> "36" [dir=forward tooltip="include"]
    "32" -> "8" [dir=forward tooltip="include"]
    "32" -> "37" [dir=forward tooltip="include"]
    "32" -> "38" [dir=forward tooltip="include"]
    "18" -> "12" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "4" [dir=forward tooltip="include"]
    "25" -> "9" [dir=forward tooltip="include"]
    "25" -> "4" [dir=forward tooltip="include"]
    "25" -> "19" [dir=forward tooltip="include"]
    "25" -> "11" [dir=forward tooltip="include"]
    "25" -> "26" [dir=forward tooltip="include"]
    "25" -> "20" [dir=forward tooltip="include"]
    "22" -> "2" [dir=forward tooltip="include"]
    "22" -> "9" [dir=forward tooltip="include"]
    "22" -> "23" [dir=forward tooltip="include"]
    "22" -> "24" [dir=forward tooltip="include"]
    "22" -> "4" [dir=forward tooltip="include"]
    "22" -> "12" [dir=forward tooltip="include"]
    "16" -> "6" [dir=forward tooltip="include"]
    "16" -> "12" [dir=forward tooltip="include"]
    "16" -> "17" [dir=forward tooltip="include"]
    "16" -> "18" [dir=forward tooltip="include"]
    "8" -> "7" [dir=forward tooltip="include"]
    "8" -> "2" [dir=forward tooltip="include"]
    "8" -> "3" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "4" [dir=forward tooltip="include"]
    "11" -> "12" [dir=forward tooltip="include"]
    "11" -> "13" [dir=forward tooltip="include"]
    "11" -> "14" [dir=forward tooltip="include"]
    "11" -> "15" [dir=forward tooltip="include"]
    "11" -> "6" [dir=forward tooltip="include"]
    "11" -> "16" [dir=forward tooltip="include"]
    "11" -> "20" [dir=forward tooltip="include"]
    "11" -> "25" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "13" [dir=forward tooltip="include"]
    "20" -> "6" [dir=forward tooltip="include"]
    "20" -> "22" [dir=forward tooltip="include"]
}
file BiorthCyl.H
#include <iostream>
#include <fstream>
#include <string>
#include <cmath>
#include <Eigen/Eigen>
#include <mpi.h>
#include <localmpi.H>
#include <config_exp.h>
#include <massmodel.H>
#include <yaml-cpp/yaml.h>
#include <highfive/H5File.hpp>
#include <highfive/H5DataSet.hpp>
#include <highfive/H5DataSpace.hpp>
#include <highfive/H5Attribute.hpp>
#include <EmpCyl2d.H>

Include dependency graph for BiorthCyl.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H" fillcolor="#BFBFBF"]
    "26" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "36" [label="EXPmath.H" tooltip="EXPmath.H"]
    "32" [label="EmpCyl2d.H" tooltip="EmpCyl2d.H"]
    "18" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "25" [label="QPDistF.H" tooltip="QPDistF.H"]
    "22" [label="gaussQ.H" tooltip="gaussQ.H"]
    "16" [label="interp.H" tooltip="interp.H"]
    "8" [label="localmpi.H" tooltip="localmpi.H"]
    "11" [label="massmodel.H" tooltip="massmodel.H"]
    "20" [label="orbit.H" tooltip="orbit.H"]
    "6" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "35" [label="Eigen/Eigenvalues" tooltip="Eigen/Eigenvalues"]
    "33" [label="algorithm" tooltip="algorithm"]
    "34" [label="array" tooltip="array"]
    "5" [label="cmath" tooltip="cmath"]
    "10" [label="config_exp.h" tooltip="config_exp.h"]
    "24" [label="cstdlib" tooltip="cstdlib"]
    "17" [label="deque" tooltip="deque"]
    "3" [label="fstream" tooltip="fstream"]
    "21" [label="functional" tooltip="functional"]
    "31" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
    "29" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
    "30" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
    "28" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
    "38" [label="highfive/eigen.hpp" tooltip="highfive/eigen.hpp"]
    "37" [label="highfive/highfive.hpp" tooltip="highfive/highfive.hpp"]
    "9" [label="iomanip" tooltip="iomanip"]
    "2" [label="iostream" tooltip="iostream"]
    "19" [label="map" tooltip="map"]
    "13" [label="memory" tooltip="memory"]
    "7" [label="mpi.h" tooltip="mpi.h"]
    "14" [label="random" tooltip="random"]
    "23" [label="sstream" tooltip="sstream"]
    "4" [label="string" tooltip="string"]
    "15" [label="tuple" tooltip="tuple"]
    "12" [label="vector" tooltip="vector"]
    "27" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "10" [dir=forward tooltip="include"]
    "1" -> "11" [dir=forward tooltip="include"]
    "1" -> "27" [dir=forward tooltip="include"]
    "1" -> "28" [dir=forward tooltip="include"]
    "1" -> "29" [dir=forward tooltip="include"]
    "1" -> "30" [dir=forward tooltip="include"]
    "1" -> "31" [dir=forward tooltip="include"]
    "1" -> "32" [dir=forward tooltip="include"]
    "26" -> "11" [dir=forward tooltip="include"]
    "32" -> "33" [dir=forward tooltip="include"]
    "32" -> "13" [dir=forward tooltip="include"]
    "32" -> "4" [dir=forward tooltip="include"]
    "32" -> "12" [dir=forward tooltip="include"]
    "32" -> "34" [dir=forward tooltip="include"]
    "32" -> "15" [dir=forward tooltip="include"]
    "32" -> "6" [dir=forward tooltip="include"]
    "32" -> "35" [dir=forward tooltip="include"]
    "32" -> "27" [dir=forward tooltip="include"]
    "32" -> "10" [dir=forward tooltip="include"]
    "32" -> "22" [dir=forward tooltip="include"]
    "32" -> "36" [dir=forward tooltip="include"]
    "32" -> "8" [dir=forward tooltip="include"]
    "32" -> "37" [dir=forward tooltip="include"]
    "32" -> "38" [dir=forward tooltip="include"]
    "18" -> "12" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "4" [dir=forward tooltip="include"]
    "25" -> "9" [dir=forward tooltip="include"]
    "25" -> "4" [dir=forward tooltip="include"]
    "25" -> "19" [dir=forward tooltip="include"]
    "25" -> "11" [dir=forward tooltip="include"]
    "25" -> "26" [dir=forward tooltip="include"]
    "25" -> "20" [dir=forward tooltip="include"]
    "22" -> "2" [dir=forward tooltip="include"]
    "22" -> "9" [dir=forward tooltip="include"]
    "22" -> "23" [dir=forward tooltip="include"]
    "22" -> "24" [dir=forward tooltip="include"]
    "22" -> "4" [dir=forward tooltip="include"]
    "22" -> "12" [dir=forward tooltip="include"]
    "16" -> "6" [dir=forward tooltip="include"]
    "16" -> "12" [dir=forward tooltip="include"]
    "16" -> "17" [dir=forward tooltip="include"]
    "16" -> "18" [dir=forward tooltip="include"]
    "8" -> "7" [dir=forward tooltip="include"]
    "8" -> "2" [dir=forward tooltip="include"]
    "8" -> "3" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "4" [dir=forward tooltip="include"]
    "11" -> "12" [dir=forward tooltip="include"]
    "11" -> "13" [dir=forward tooltip="include"]
    "11" -> "14" [dir=forward tooltip="include"]
    "11" -> "15" [dir=forward tooltip="include"]
    "11" -> "6" [dir=forward tooltip="include"]
    "11" -> "16" [dir=forward tooltip="include"]
    "11" -> "20" [dir=forward tooltip="include"]
    "11" -> "25" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "13" [dir=forward tooltip="include"]
    "20" -> "6" [dir=forward tooltip="include"]
    "20" -> "22" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include BiorthCyl.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H" fillcolor="#BFBFBF"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
    "1" -> "5" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "2" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
}
file BWHelper.H
#include <iostream>
#include <iomanip>
#include <vector>
#include <string>
#include <limits>
#include <set>

Include dependency graph for BWHelper.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BWHelper.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BWHelper.H" fillcolor="#BFBFBF"]
    "3" [label="iomanip" tooltip="iomanip"]
    "2" [label="iostream" tooltip="iostream"]
    "6" [label="limits" tooltip="limits"]
    "7" [label="set" tooltip="set"]
    "5" [label="string" tooltip="string"]
    "4" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
}
file CauchyPV.H
#include <vector>
#include <Eigen/Eigen>

Include dependency graph for CauchyPV.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/CauchyPV.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/CauchyPV.H" fillcolor="#BFBFBF"]
    "3" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "2" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
}
file CenterFile.H
#include <fstream>
#include <vector>
#include <array>
#include <yaml-cpp/yaml.h>

Include dependency graph for CenterFile.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/CenterFile.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/CenterFile.H" fillcolor="#BFBFBF"]
    "4" [label="array" tooltip="array"]
    "2" [label="fstream" tooltip="fstream"]
    "3" [label="vector" tooltip="vector"]
    "5" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include CenterFile.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/CenterFile.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/CenterFile.H" fillcolor="#BFBFBF"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "20" [dir=back tooltip="include"]
    "2" -> "24" [dir=back tooltip="include"]
    "2" -> "25" [dir=back tooltip="include"]
    "2" -> "26" [dir=back tooltip="include"]
    "2" -> "27" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "13" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "6" [dir=back tooltip="include"]
    "4" -> "7" [dir=back tooltip="include"]
    "4" -> "8" [dir=back tooltip="include"]
    "4" -> "9" [dir=back tooltip="include"]
    "4" -> "10" [dir=back tooltip="include"]
    "4" -> "11" [dir=back tooltip="include"]
    "4" -> "12" [dir=back tooltip="include"]
    "20" -> "4" [dir=back tooltip="include"]
    "20" -> "21" [dir=back tooltip="include"]
    "20" -> "22" [dir=back tooltip="include"]
    "20" -> "13" [dir=back tooltip="include"]
    "20" -> "23" [dir=back tooltip="include"]
    "24" -> "24" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "16" -> "18" [dir=back tooltip="include"]
    "13" -> "14" [dir=back tooltip="include"]
    "13" -> "19" [dir=back tooltip="include"]
}
file Circular.H
#include <vector>

Include dependency graph for Circular.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Circular.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Circular.H" fillcolor="#BFBFBF"]
    "2" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include Circular.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Circular.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Circular.H" fillcolor="#BFBFBF"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "20" [dir=back tooltip="include"]
    "2" -> "24" [dir=back tooltip="include"]
    "2" -> "25" [dir=back tooltip="include"]
    "2" -> "26" [dir=back tooltip="include"]
    "2" -> "27" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "13" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "6" [dir=back tooltip="include"]
    "4" -> "7" [dir=back tooltip="include"]
    "4" -> "8" [dir=back tooltip="include"]
    "4" -> "9" [dir=back tooltip="include"]
    "4" -> "10" [dir=back tooltip="include"]
    "4" -> "11" [dir=back tooltip="include"]
    "4" -> "12" [dir=back tooltip="include"]
    "20" -> "4" [dir=back tooltip="include"]
    "20" -> "21" [dir=back tooltip="include"]
    "20" -> "22" [dir=back tooltip="include"]
    "20" -> "13" [dir=back tooltip="include"]
    "20" -> "23" [dir=back tooltip="include"]
    "24" -> "24" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "16" -> "18" [dir=back tooltip="include"]
    "13" -> "14" [dir=back tooltip="include"]
    "13" -> "19" [dir=back tooltip="include"]
}
file circular_buffer.H
#include <algorithm>
#include <iterator>
#include <mutex>
#include <memory>
#include <stdexcept>
#include <utility>

Include dependency graph for circular_buffer.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/circular_buffer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/circular_buffer.H" fillcolor="#BFBFBF"]
    "2" [label="algorithm" tooltip="algorithm"]
    "3" [label="iterator" tooltip="iterator"]
    "5" [label="memory" tooltip="memory"]
    "4" [label="mutex" tooltip="mutex"]
    "6" [label="stdexcept" tooltip="stdexcept"]
    "7" [label="utility" tooltip="utility"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
}
file coef.H

This graph shows which files directly or indirectly include coef.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/coef.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/coef.H" fillcolor="#BFBFBF"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H"]
    "3" -> "4" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "5" [dir=back tooltip="include"]
    "2" -> "10" [dir=back tooltip="include"]
    "2" -> "4" [dir=back tooltip="include"]
    "2" -> "11" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
    "6" -> "7" [dir=back tooltip="include"]
    "7" -> "8" [dir=back tooltip="include"]
    "7" -> "9" [dir=back tooltip="include"]
}
file coef.H

This graph shows which files directly or indirectly include coef.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Coefs.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Coefs.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "29" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/coef.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/coef.H" fillcolor="#BFBFBF"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/global.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/global.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "22" [dir=back tooltip="include"]
    "4" -> "26" [dir=back tooltip="include"]
    "4" -> "27" [dir=back tooltip="include"]
    "4" -> "28" [dir=back tooltip="include"]
    "4" -> "29" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
    "5" -> "15" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "17" -> "18" [dir=back tooltip="include"]
    "6" -> "7" [dir=back tooltip="include"]
    "6" -> "8" [dir=back tooltip="include"]
    "6" -> "9" [dir=back tooltip="include"]
    "6" -> "10" [dir=back tooltip="include"]
    "6" -> "11" [dir=back tooltip="include"]
    "6" -> "12" [dir=back tooltip="include"]
    "6" -> "13" [dir=back tooltip="include"]
    "6" -> "14" [dir=back tooltip="include"]
    "22" -> "6" [dir=back tooltip="include"]
    "22" -> "23" [dir=back tooltip="include"]
    "22" -> "24" [dir=back tooltip="include"]
    "22" -> "15" [dir=back tooltip="include"]
    "22" -> "25" [dir=back tooltip="include"]
    "26" -> "26" [dir=back tooltip="include"]
    "18" -> "19" [dir=back tooltip="include"]
    "18" -> "20" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "15" -> "21" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "16" [dir=back tooltip="include"]
    "3" -> "15" [dir=back tooltip="include"]
}
file Coefs.H
#include <memory>
#include <Eigen/Eigen>
#include <yaml-cpp/yaml.h>
#include “src/coef.H

Include dependency graph for Coefs.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Coefs.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Coefs.H" fillcolor="#BFBFBF"]
    "5" [label="src/coef.H" tooltip="src/coef.H"]
    "3" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "2" [label="memory" tooltip="memory"]
    "4" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
}

Typedefs

typedef std::shared_ptr<CylCoefs> CylCoefsPtr
typedef std::shared_ptr<SphCoefs> SphCoefsPtr
file ColorGradient.H
#include <png++/png.hpp>

Include dependency graph for ColorGradient.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ColorGradient.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ColorGradient.H" fillcolor="#BFBFBF"]
    "2" [label="png++/png.hpp" tooltip="png++/png.hpp"]
    "1" -> "2" [dir=forward tooltip="include"]
}
file cpoly.H
#include “poly.H

Include dependency graph for cpoly.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/cpoly.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/cpoly.H" fillcolor="#BFBFBF"]
    "2" [label="poly.H" tooltip="poly.H"]
    "5" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "4" [label="fstream" tooltip="fstream"]
    "3" [label="iostream" tooltip="iostream"]
    "1" -> "2" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
}

Functions

void bomb_CPoly(const char*)
void bomb_CPoly_operation(const char*)
file Cspline.H
#include <iostream>
#include <vector>

Include dependency graph for Cspline.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Cspline.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Cspline.H" fillcolor="#BFBFBF"]
    "2" [label="iostream" tooltip="iostream"]
    "3" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
}
file cubic.H
#include <Eigen/Eigen>

Include dependency graph for cubic.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/cubic.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/cubic.H" fillcolor="#BFBFBF"]
    "2" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "1" -> "2" [dir=forward tooltip="include"]
}
file cxxopts.H
#include <cctype>
#include <cstring>
#include <exception>
#include <iostream>
#include <limits>
#include <list>
#include <map>
#include <memory>
#include <sstream>
#include <string>
#include <unordered_map>
#include <unordered_set>
#include <utility>
#include <vector>
#include <algorithm>
#include <regex>

Include dependency graph for cxxopts.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/cxxopts.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/cxxopts.H" fillcolor="#BFBFBF"]
    "16" [label="algorithm" tooltip="algorithm"]
    "2" [label="cctype" tooltip="cctype"]
    "3" [label="cstring" tooltip="cstring"]
    "4" [label="exception" tooltip="exception"]
    "5" [label="iostream" tooltip="iostream"]
    "6" [label="limits" tooltip="limits"]
    "7" [label="list" tooltip="list"]
    "8" [label="map" tooltip="map"]
    "9" [label="memory" tooltip="memory"]
    "17" [label="regex" tooltip="regex"]
    "10" [label="sstream" tooltip="sstream"]
    "11" [label="string" tooltip="string"]
    "12" [label="unordered_map" tooltip="unordered_map"]
    "13" [label="unordered_set" tooltip="unordered_set"]
    "14" [label="utility" tooltip="utility"]
    "15" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "1" -> "10" [dir=forward tooltip="include"]
    "1" -> "11" [dir=forward tooltip="include"]
    "1" -> "12" [dir=forward tooltip="include"]
    "1" -> "13" [dir=forward tooltip="include"]
    "1" -> "14" [dir=forward tooltip="include"]
    "1" -> "15" [dir=forward tooltip="include"]
    "1" -> "16" [dir=forward tooltip="include"]
    "1" -> "17" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include cxxopts.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EXPini.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EXPini.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/YamlConfig.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/YamlConfig.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/cxxopts.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/cxxopts.H" fillcolor="#BFBFBF"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/KDE2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/KDE2d.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
    "1" -> "4" [dir=back tooltip="include"]
}

Defines

CXXOPTS__VERSION_MAJOR
CXXOPTS__VERSION_MINOR
CXXOPTS__VERSION_PATCH
CXXOPTS_NODISCARD
CXXOPTS_VECTOR_DELIMITER
file DataGrid.H
#include <vector>
#include <sstream>
#include <memory>
#include <config_exp.h>
#include <TableGrid.H>
#include <VtkGrid.H>

Include dependency graph for DataGrid.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DataGrid.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DataGrid.H" fillcolor="#BFBFBF"]
    "6" [label="TableGrid.H" tooltip="TableGrid.H"]
    "8" [label="ThreeDGrid.H" tooltip="ThreeDGrid.H"]
    "9" [label="VtkGrid.H" tooltip="VtkGrid.H"]
    "10" [label="algorithm" tooltip="algorithm"]
    "5" [label="config_exp.h" tooltip="config_exp.h"]
    "11" [label="fstream" tooltip="fstream"]
    "12" [label="limits" tooltip="limits"]
    "7" [label="map" tooltip="map"]
    "4" [label="memory" tooltip="memory"]
    "3" [label="sstream" tooltip="sstream"]
    "2" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "6" -> "3" [dir=forward tooltip="include"]
    "6" -> "2" [dir=forward tooltip="include"]
    "6" -> "4" [dir=forward tooltip="include"]
    "6" -> "7" [dir=forward tooltip="include"]
    "6" -> "8" [dir=forward tooltip="include"]
    "8" -> "2" [dir=forward tooltip="include"]
    "8" -> "3" [dir=forward tooltip="include"]
    "8" -> "4" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "11" [dir=forward tooltip="include"]
    "9" -> "3" [dir=forward tooltip="include"]
    "9" -> "2" [dir=forward tooltip="include"]
    "9" -> "4" [dir=forward tooltip="include"]
    "9" -> "12" [dir=forward tooltip="include"]
    "9" -> "7" [dir=forward tooltip="include"]
    "9" -> "8" [dir=forward tooltip="include"]
}

Typedefs

typedef std::shared_ptr<DataGrid> DataGridPtr
file DiskDensityFunc.H
#include <functional>
#include <pybind11/pybind11.h>
#include <pybind11/embed.h>

Include dependency graph for DiskDensityFunc.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskDensityFunc.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskDensityFunc.H" fillcolor="#BFBFBF"]
    "2" [label="functional" tooltip="functional"]
    "4" [label="pybind11/embed.h" tooltip="pybind11/embed.h"]
    "3" [label="pybind11/pybind11.h" tooltip="pybind11/pybind11.h"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include DiskDensityFunc.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskDensityFunc.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskDensityFunc.H" fillcolor="#BFBFBF"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
}
file DiskModels.H
#include <EmpCylSL.H>
#include <DiskDensityFunc.H>

Include dependency graph for DiskModels.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "39" [label="DiskDensityFunc.H" tooltip="DiskDensityFunc.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H" fillcolor="#BFBFBF"]
    "34" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "2" [label="EmpCylSL.H" tooltip="EmpCylSL.H"]
    "17" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "21" [label="Particle.H" tooltip="Particle.H"]
    "33" [label="QPDistF.H" tooltip="QPDistF.H"]
    "23" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
    "19" [label="Timer.H" tooltip="Timer.H"]
    "38" [label="coef.H" tooltip="coef.H"]
    "9" [label="gaussQ.H" tooltip="gaussQ.H"]
    "15" [label="interp.H" tooltip="interp.H"]
    "37" [label="libvars.H" tooltip="libvars.H"]
    "27" [label="localmpi.H" tooltip="localmpi.H"]
    "29" [label="massmodel.H" tooltip="massmodel.H"]
    "32" [label="orbit.H" tooltip="orbit.H"]
    "35" [label="sltableMP2.H" tooltip="sltableMP2.H"]
    "8" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "20" [label="chrono" tooltip="chrono"]
    "7" [label="cmath" tooltip="cmath"]
    "28" [label="config_exp.h" tooltip="config_exp.h"]
    "13" [label="cstdlib" tooltip="cstdlib"]
    "16" [label="deque" tooltip="deque"]
    "25" [label="fstream" tooltip="fstream"]
    "3" [label="functional" tooltip="functional"]
    "11" [label="iomanip" tooltip="iomanip"]
    "10" [label="iostream" tooltip="iostream"]
    "6" [label="limits" tooltip="limits"]
    "18" [label="map" tooltip="map"]
    "24" [label="math.h" tooltip="math.h"]
    "5" [label="memory" tooltip="memory"]
    "26" [label="mpi.h" tooltip="mpi.h"]
    "41" [label="pybind11/embed.h" tooltip="pybind11/embed.h"]
    "40" [label="pybind11/pybind11.h" tooltip="pybind11/pybind11.h"]
    "30" [label="random" tooltip="random"]
    "12" [label="sstream" tooltip="sstream"]
    "14" [label="string" tooltip="string"]
    "31" [label="tuple" tooltip="tuple"]
    "22" [label="unordered_map" tooltip="unordered_map"]
    "4" [label="vector" tooltip="vector"]
    "36" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "39" -> "3" [dir=forward tooltip="include"]
    "39" -> "40" [dir=forward tooltip="include"]
    "39" -> "41" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "39" [dir=forward tooltip="include"]
    "34" -> "29" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "2" -> "7" [dir=forward tooltip="include"]
    "2" -> "8" [dir=forward tooltip="include"]
    "2" -> "9" [dir=forward tooltip="include"]
    "2" -> "15" [dir=forward tooltip="include"]
    "2" -> "19" [dir=forward tooltip="include"]
    "2" -> "21" [dir=forward tooltip="include"]
    "2" -> "23" [dir=forward tooltip="include"]
    "2" -> "38" [dir=forward tooltip="include"]
    "2" -> "37" [dir=forward tooltip="include"]
    "17" -> "4" [dir=forward tooltip="include"]
    "17" -> "18" [dir=forward tooltip="include"]
    "17" -> "14" [dir=forward tooltip="include"]
    "21" -> "22" [dir=forward tooltip="include"]
    "21" -> "4" [dir=forward tooltip="include"]
    "21" -> "5" [dir=forward tooltip="include"]
    "33" -> "11" [dir=forward tooltip="include"]
    "33" -> "14" [dir=forward tooltip="include"]
    "33" -> "18" [dir=forward tooltip="include"]
    "33" -> "29" [dir=forward tooltip="include"]
    "33" -> "34" [dir=forward tooltip="include"]
    "33" -> "32" [dir=forward tooltip="include"]
    "23" -> "24" [dir=forward tooltip="include"]
    "23" -> "10" [dir=forward tooltip="include"]
    "23" -> "25" [dir=forward tooltip="include"]
    "23" -> "14" [dir=forward tooltip="include"]
    "23" -> "26" [dir=forward tooltip="include"]
    "23" -> "27" [dir=forward tooltip="include"]
    "23" -> "28" [dir=forward tooltip="include"]
    "23" -> "29" [dir=forward tooltip="include"]
    "23" -> "35" [dir=forward tooltip="include"]
    "23" -> "36" [dir=forward tooltip="include"]
    "23" -> "37" [dir=forward tooltip="include"]
    "19" -> "10" [dir=forward tooltip="include"]
    "19" -> "13" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "11" [dir=forward tooltip="include"]
    "9" -> "12" [dir=forward tooltip="include"]
    "9" -> "13" [dir=forward tooltip="include"]
    "9" -> "14" [dir=forward tooltip="include"]
    "9" -> "4" [dir=forward tooltip="include"]
    "15" -> "8" [dir=forward tooltip="include"]
    "15" -> "4" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "17" [dir=forward tooltip="include"]
    "37" -> "30" [dir=forward tooltip="include"]
    "37" -> "26" [dir=forward tooltip="include"]
    "27" -> "26" [dir=forward tooltip="include"]
    "27" -> "10" [dir=forward tooltip="include"]
    "27" -> "25" [dir=forward tooltip="include"]
    "27" -> "11" [dir=forward tooltip="include"]
    "27" -> "14" [dir=forward tooltip="include"]
    "29" -> "4" [dir=forward tooltip="include"]
    "29" -> "5" [dir=forward tooltip="include"]
    "29" -> "30" [dir=forward tooltip="include"]
    "29" -> "31" [dir=forward tooltip="include"]
    "29" -> "8" [dir=forward tooltip="include"]
    "29" -> "15" [dir=forward tooltip="include"]
    "29" -> "32" [dir=forward tooltip="include"]
    "29" -> "33" [dir=forward tooltip="include"]
    "32" -> "3" [dir=forward tooltip="include"]
    "32" -> "5" [dir=forward tooltip="include"]
    "32" -> "8" [dir=forward tooltip="include"]
    "32" -> "9" [dir=forward tooltip="include"]
    "35" -> "8" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include DiskModels.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H" fillcolor="#BFBFBF"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H"]
    "1" -> "2" [dir=back tooltip="include"]
}
file DiskWithHalo.H
#include <massmodel.H>

Include dependency graph for DiskWithHalo.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskWithHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskWithHalo.H" fillcolor="#BFBFBF"]
    "10" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "20" [label="QPDistF.H" tooltip="QPDistF.H"]
    "15" [label="gaussQ.H" tooltip="gaussQ.H"]
    "8" [label="interp.H" tooltip="interp.H"]
    "2" [label="massmodel.H" tooltip="massmodel.H"]
    "13" [label="orbit.H" tooltip="orbit.H"]
    "7" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "19" [label="cstdlib" tooltip="cstdlib"]
    "9" [label="deque" tooltip="deque"]
    "14" [label="functional" tooltip="functional"]
    "17" [label="iomanip" tooltip="iomanip"]
    "16" [label="iostream" tooltip="iostream"]
    "11" [label="map" tooltip="map"]
    "4" [label="memory" tooltip="memory"]
    "5" [label="random" tooltip="random"]
    "18" [label="sstream" tooltip="sstream"]
    "12" [label="string" tooltip="string"]
    "6" [label="tuple" tooltip="tuple"]
    "3" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "10" -> "3" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "12" [dir=forward tooltip="include"]
    "20" -> "17" [dir=forward tooltip="include"]
    "20" -> "12" [dir=forward tooltip="include"]
    "20" -> "11" [dir=forward tooltip="include"]
    "20" -> "2" [dir=forward tooltip="include"]
    "20" -> "1" [dir=forward tooltip="include"]
    "20" -> "13" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "17" [dir=forward tooltip="include"]
    "15" -> "18" [dir=forward tooltip="include"]
    "15" -> "19" [dir=forward tooltip="include"]
    "15" -> "12" [dir=forward tooltip="include"]
    "15" -> "3" [dir=forward tooltip="include"]
    "8" -> "7" [dir=forward tooltip="include"]
    "8" -> "3" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "10" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "2" -> "7" [dir=forward tooltip="include"]
    "2" -> "8" [dir=forward tooltip="include"]
    "2" -> "13" [dir=forward tooltip="include"]
    "2" -> "20" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "4" [dir=forward tooltip="include"]
    "13" -> "7" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include DiskWithHalo.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskWithHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskWithHalo.H" fillcolor="#BFBFBF"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/GenPoly.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/GenPoly.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/HunterX.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/HunterX.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QPDistF.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QPDistF.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H"]
    "29" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exponential.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exponential.H"]
    "30" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hernquist_model.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hernquist_model.H"]
    "31" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hunter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hunter.H"]
    "32" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/isothermal.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/isothermal.H"]
    "33" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/king.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/king.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/massmodel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/massmodel.H"]
    "34" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/mestel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/mestel.H"]
    "35" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/plummer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/plummer.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H"]
    "36" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/toomre.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/toomre.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "37" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H"]
    "38" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "39" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/externalShock.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/externalShock.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H"]
    "40" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddDisk.H"]
    "41" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddSpheres.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddSpheres.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H"]
    "42" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/massmodel1d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/massmodel1d.H"]
    "43" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/MakeModel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/MakeModel.H"]
    "5" -> "6" [dir=back tooltip="include"]
    "5" -> "7" [dir=back tooltip="include"]
    "5" -> "9" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "14" -> "17" [dir=back tooltip="include"]
    "14" -> "22" [dir=back tooltip="include"]
    "14" -> "16" [dir=back tooltip="include"]
    "14" -> "23" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "13" -> "14" [dir=back tooltip="include"]
    "13" -> "24" [dir=back tooltip="include"]
    "13" -> "25" [dir=back tooltip="include"]
    "13" -> "26" [dir=back tooltip="include"]
    "13" -> "19" [dir=back tooltip="include"]
    "13" -> "27" [dir=back tooltip="include"]
    "13" -> "28" [dir=back tooltip="include"]
    "29" -> "10" [dir=back tooltip="include"]
    "29" -> "23" [dir=back tooltip="include"]
    "31" -> "12" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "5" [dir=back tooltip="include"]
    "3" -> "1" [dir=back tooltip="include"]
    "3" -> "11" [dir=back tooltip="include"]
    "3" -> "12" [dir=back tooltip="include"]
    "3" -> "2" [dir=back tooltip="include"]
    "3" -> "13" [dir=back tooltip="include"]
    "3" -> "29" [dir=back tooltip="include"]
    "3" -> "30" [dir=back tooltip="include"]
    "3" -> "31" [dir=back tooltip="include"]
    "3" -> "32" [dir=back tooltip="include"]
    "3" -> "33" [dir=back tooltip="include"]
    "3" -> "34" [dir=back tooltip="include"]
    "3" -> "35" [dir=back tooltip="include"]
    "3" -> "36" [dir=back tooltip="include"]
    "3" -> "37" [dir=back tooltip="include"]
    "3" -> "38" [dir=back tooltip="include"]
    "3" -> "39" [dir=back tooltip="include"]
    "3" -> "40" [dir=back tooltip="include"]
    "3" -> "41" [dir=back tooltip="include"]
    "3" -> "22" [dir=back tooltip="include"]
    "3" -> "10" [dir=back tooltip="include"]
    "3" -> "23" [dir=back tooltip="include"]
    "3" -> "42" [dir=back tooltip="include"]
    "3" -> "43" [dir=back tooltip="include"]
    "17" -> "18" [dir=back tooltip="include"]
    "18" -> "19" [dir=back tooltip="include"]
    "7" -> "8" [dir=back tooltip="include"]
    "7" -> "6" [dir=back tooltip="include"]
    "26" -> "19" [dir=back tooltip="include"]
    "19" -> "20" [dir=back tooltip="include"]
    "19" -> "21" [dir=back tooltip="include"]
    "40" -> "10" [dir=back tooltip="include"]
    "40" -> "23" [dir=back tooltip="include"]
    "9" -> "10" [dir=back tooltip="include"]
    "28" -> "10" [dir=back tooltip="include"]
    "28" -> "23" [dir=back tooltip="include"]
}
file EmpCyl2d.H
#include <algorithm>
#include <memory>
#include <string>
#include <vector>
#include <array>
#include <tuple>
#include <Eigen/Eigen>
#include <Eigen/Eigenvalues>
#include <yaml-cpp/yaml.h>
#include <config_exp.h>
#include <gaussQ.H>
#include <EXPmath.H>
#include <localmpi.H>
#include <highfive/highfive.hpp>
#include <highfive/eigen.hpp>

Include dependency graph for EmpCyl2d.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "17" [label="EXPmath.H" tooltip="EXPmath.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCyl2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCyl2d.H" fillcolor="#BFBFBF"]
    "12" [label="gaussQ.H" tooltip="gaussQ.H"]
    "18" [label="localmpi.H" tooltip="localmpi.H"]
    "8" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "9" [label="Eigen/Eigenvalues" tooltip="Eigen/Eigenvalues"]
    "2" [label="algorithm" tooltip="algorithm"]
    "6" [label="array" tooltip="array"]
    "11" [label="config_exp.h" tooltip="config_exp.h"]
    "16" [label="cstdlib" tooltip="cstdlib"]
    "20" [label="fstream" tooltip="fstream"]
    "22" [label="highfive/eigen.hpp" tooltip="highfive/eigen.hpp"]
    "21" [label="highfive/highfive.hpp" tooltip="highfive/highfive.hpp"]
    "14" [label="iomanip" tooltip="iomanip"]
    "13" [label="iostream" tooltip="iostream"]
    "3" [label="memory" tooltip="memory"]
    "19" [label="mpi.h" tooltip="mpi.h"]
    "15" [label="sstream" tooltip="sstream"]
    "4" [label="string" tooltip="string"]
    "7" [label="tuple" tooltip="tuple"]
    "5" [label="vector" tooltip="vector"]
    "10" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "1" -> "10" [dir=forward tooltip="include"]
    "1" -> "11" [dir=forward tooltip="include"]
    "1" -> "12" [dir=forward tooltip="include"]
    "1" -> "17" [dir=forward tooltip="include"]
    "1" -> "18" [dir=forward tooltip="include"]
    "1" -> "21" [dir=forward tooltip="include"]
    "1" -> "22" [dir=forward tooltip="include"]
    "12" -> "13" [dir=forward tooltip="include"]
    "12" -> "14" [dir=forward tooltip="include"]
    "12" -> "15" [dir=forward tooltip="include"]
    "12" -> "16" [dir=forward tooltip="include"]
    "12" -> "4" [dir=forward tooltip="include"]
    "12" -> "5" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "13" [dir=forward tooltip="include"]
    "18" -> "20" [dir=forward tooltip="include"]
    "18" -> "14" [dir=forward tooltip="include"]
    "18" -> "4" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include EmpCyl2d.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCyl2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCyl2d.H" fillcolor="#BFBFBF"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "5" [dir=back tooltip="include"]
    "3" -> "7" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
    "5" -> "4" [dir=back tooltip="include"]
    "7" -> "8" [dir=back tooltip="include"]
}
file EmpCylSL.H
#include <functional>
#include <vector>
#include <memory>
#include <limits>
#include <cmath>
#include <Eigen/Eigen>
#include <gaussQ.H>
#include <interp.H>
#include <Timer.H>
#include <Particle.H>
#include <SLGridMP2.H>
#include <coef.H>
#include <libvars.H>

Include dependency graph for EmpCylSL.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "33" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H" fillcolor="#BFBFBF"]
    "16" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "20" [label="Particle.H" tooltip="Particle.H"]
    "32" [label="QPDistF.H" tooltip="QPDistF.H"]
    "22" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
    "18" [label="Timer.H" tooltip="Timer.H"]
    "37" [label="coef.H" tooltip="coef.H"]
    "8" [label="gaussQ.H" tooltip="gaussQ.H"]
    "14" [label="interp.H" tooltip="interp.H"]
    "36" [label="libvars.H" tooltip="libvars.H"]
    "26" [label="localmpi.H" tooltip="localmpi.H"]
    "28" [label="massmodel.H" tooltip="massmodel.H"]
    "31" [label="orbit.H" tooltip="orbit.H"]
    "34" [label="sltableMP2.H" tooltip="sltableMP2.H"]
    "7" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "19" [label="chrono" tooltip="chrono"]
    "6" [label="cmath" tooltip="cmath"]
    "27" [label="config_exp.h" tooltip="config_exp.h"]
    "12" [label="cstdlib" tooltip="cstdlib"]
    "15" [label="deque" tooltip="deque"]
    "24" [label="fstream" tooltip="fstream"]
    "2" [label="functional" tooltip="functional"]
    "10" [label="iomanip" tooltip="iomanip"]
    "9" [label="iostream" tooltip="iostream"]
    "5" [label="limits" tooltip="limits"]
    "17" [label="map" tooltip="map"]
    "23" [label="math.h" tooltip="math.h"]
    "4" [label="memory" tooltip="memory"]
    "25" [label="mpi.h" tooltip="mpi.h"]
    "29" [label="random" tooltip="random"]
    "11" [label="sstream" tooltip="sstream"]
    "13" [label="string" tooltip="string"]
    "30" [label="tuple" tooltip="tuple"]
    "21" [label="unordered_map" tooltip="unordered_map"]
    "3" [label="vector" tooltip="vector"]
    "35" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "33" -> "28" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "14" [dir=forward tooltip="include"]
    "1" -> "18" [dir=forward tooltip="include"]
    "1" -> "20" [dir=forward tooltip="include"]
    "1" -> "22" [dir=forward tooltip="include"]
    "1" -> "37" [dir=forward tooltip="include"]
    "1" -> "36" [dir=forward tooltip="include"]
    "16" -> "3" [dir=forward tooltip="include"]
    "16" -> "17" [dir=forward tooltip="include"]
    "16" -> "13" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "3" [dir=forward tooltip="include"]
    "20" -> "4" [dir=forward tooltip="include"]
    "32" -> "10" [dir=forward tooltip="include"]
    "32" -> "13" [dir=forward tooltip="include"]
    "32" -> "17" [dir=forward tooltip="include"]
    "32" -> "28" [dir=forward tooltip="include"]
    "32" -> "33" [dir=forward tooltip="include"]
    "32" -> "31" [dir=forward tooltip="include"]
    "22" -> "23" [dir=forward tooltip="include"]
    "22" -> "9" [dir=forward tooltip="include"]
    "22" -> "24" [dir=forward tooltip="include"]
    "22" -> "13" [dir=forward tooltip="include"]
    "22" -> "25" [dir=forward tooltip="include"]
    "22" -> "26" [dir=forward tooltip="include"]
    "22" -> "27" [dir=forward tooltip="include"]
    "22" -> "28" [dir=forward tooltip="include"]
    "22" -> "34" [dir=forward tooltip="include"]
    "22" -> "35" [dir=forward tooltip="include"]
    "22" -> "36" [dir=forward tooltip="include"]
    "18" -> "9" [dir=forward tooltip="include"]
    "18" -> "12" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "10" [dir=forward tooltip="include"]
    "8" -> "11" [dir=forward tooltip="include"]
    "8" -> "12" [dir=forward tooltip="include"]
    "8" -> "13" [dir=forward tooltip="include"]
    "8" -> "3" [dir=forward tooltip="include"]
    "14" -> "7" [dir=forward tooltip="include"]
    "14" -> "3" [dir=forward tooltip="include"]
    "14" -> "15" [dir=forward tooltip="include"]
    "14" -> "16" [dir=forward tooltip="include"]
    "36" -> "29" [dir=forward tooltip="include"]
    "36" -> "25" [dir=forward tooltip="include"]
    "26" -> "25" [dir=forward tooltip="include"]
    "26" -> "9" [dir=forward tooltip="include"]
    "26" -> "24" [dir=forward tooltip="include"]
    "26" -> "10" [dir=forward tooltip="include"]
    "26" -> "13" [dir=forward tooltip="include"]
    "28" -> "3" [dir=forward tooltip="include"]
    "28" -> "4" [dir=forward tooltip="include"]
    "28" -> "29" [dir=forward tooltip="include"]
    "28" -> "30" [dir=forward tooltip="include"]
    "28" -> "7" [dir=forward tooltip="include"]
    "28" -> "14" [dir=forward tooltip="include"]
    "28" -> "31" [dir=forward tooltip="include"]
    "28" -> "32" [dir=forward tooltip="include"]
    "31" -> "2" [dir=forward tooltip="include"]
    "31" -> "4" [dir=forward tooltip="include"]
    "31" -> "7" [dir=forward tooltip="include"]
    "31" -> "8" [dir=forward tooltip="include"]
    "34" -> "7" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include EmpCylSL.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H" fillcolor="#BFBFBF"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H"]
    "2" -> "3" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "4" [dir=back tooltip="include"]
    "1" -> "9" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
    "1" -> "10" [dir=back tooltip="include"]
    "4" -> "5" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
    "6" -> "7" [dir=back tooltip="include"]
    "6" -> "8" [dir=back tooltip="include"]
}

Typedefs

typedef std::shared_ptr<EmpCylSL> EmpCylSLptr

Functions

void dlegendre_R(int lmax, double x, Eigen::MatrixXd &p, Eigen::MatrixXd &dp)
void legendre_R(int lmax, double x, Eigen::MatrixXd &p)
void sinecosine_R(int mmax, double phi, Eigen::VectorXd &c, Eigen::VectorXd &s)
file euler.H
#include <Eigen/Eigen>

Include dependency graph for euler.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/euler.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/euler.H" fillcolor="#BFBFBF"]
    "2" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "1" -> "2" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include euler.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/euler.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/euler.H" fillcolor="#BFBFBF"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Orient.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Orient.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "21" [dir=back tooltip="include"]
    "3" -> "25" [dir=back tooltip="include"]
    "3" -> "26" [dir=back tooltip="include"]
    "3" -> "27" [dir=back tooltip="include"]
    "3" -> "28" [dir=back tooltip="include"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "14" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
    "5" -> "7" [dir=back tooltip="include"]
    "5" -> "8" [dir=back tooltip="include"]
    "5" -> "9" [dir=back tooltip="include"]
    "5" -> "10" [dir=back tooltip="include"]
    "5" -> "11" [dir=back tooltip="include"]
    "5" -> "12" [dir=back tooltip="include"]
    "5" -> "13" [dir=back tooltip="include"]
    "21" -> "5" [dir=back tooltip="include"]
    "21" -> "22" [dir=back tooltip="include"]
    "21" -> "23" [dir=back tooltip="include"]
    "21" -> "14" [dir=back tooltip="include"]
    "21" -> "24" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "16" [dir=back tooltip="include"]
    "25" -> "25" [dir=back tooltip="include"]
    "17" -> "18" [dir=back tooltip="include"]
    "17" -> "19" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "14" -> "20" [dir=back tooltip="include"]
}

Functions

Eigen::Matrix3d return_euler(double PHI, double THETA, double PSI, int BODY)
Eigen::Matrix3d return_euler_slater(double PHI, double THETA, double PSI, int BODY)
file exp_thread.h
#include <pthread.h>

Include dependency graph for exp_thread.h:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exp_thread.h" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exp_thread.h" fillcolor="#BFBFBF"]
    "2" [label="pthread.h" tooltip="pthread.h"]
    "1" -> "2" [dir=forward tooltip="include"]
}

Functions

void exp_thread_fork(void *(*func)(void*), char *caller)
void kill_mutex(pthread_mutex_t *m, char *caller, char *name)
void make_mutex(pthread_mutex_t *m, char *caller, char *name)
file exp_thread.h
#include <pthread.h>

Include dependency graph for exp_thread.h:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/exp_thread.h" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/exp_thread.h" fillcolor="#BFBFBF"]
    "2" [label="pthread.h" tooltip="pthread.h"]
    "1" -> "2" [dir=forward tooltip="include"]
}

Functions

void exp_thread_fork(void *(*func)(void*), char *caller)
void kill_mutex(pthread_mutex_t *m, char *caller, char *name)
void make_mutex(pthread_mutex_t *m, char *caller, char *name)
file EXPException.H
#include <set>
#include <vector>
#include <string>
#include <sstream>
#include <libvars.H>

Include dependency graph for EXPException.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EXPException.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EXPException.H" fillcolor="#BFBFBF"]
    "6" [label="libvars.H" tooltip="libvars.H"]
    "8" [label="mpi.h" tooltip="mpi.h"]
    "7" [label="random" tooltip="random"]
    "2" [label="set" tooltip="set"]
    "5" [label="sstream" tooltip="sstream"]
    "4" [label="string" tooltip="string"]
    "3" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "6" -> "7" [dir=forward tooltip="include"]
    "6" -> "8" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include EXPException.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EXPException.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EXPException.H" fillcolor="#BFBFBF"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "27" [dir=back tooltip="include"]
    "1" -> "13" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "20" [dir=back tooltip="include"]
    "2" -> "24" [dir=back tooltip="include"]
    "2" -> "25" [dir=back tooltip="include"]
    "2" -> "26" [dir=back tooltip="include"]
    "2" -> "27" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "13" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "6" [dir=back tooltip="include"]
    "4" -> "7" [dir=back tooltip="include"]
    "4" -> "8" [dir=back tooltip="include"]
    "4" -> "9" [dir=back tooltip="include"]
    "4" -> "10" [dir=back tooltip="include"]
    "4" -> "11" [dir=back tooltip="include"]
    "4" -> "12" [dir=back tooltip="include"]
    "20" -> "4" [dir=back tooltip="include"]
    "20" -> "21" [dir=back tooltip="include"]
    "20" -> "22" [dir=back tooltip="include"]
    "20" -> "13" [dir=back tooltip="include"]
    "20" -> "23" [dir=back tooltip="include"]
    "24" -> "24" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "16" -> "18" [dir=back tooltip="include"]
    "13" -> "14" [dir=back tooltip="include"]
    "13" -> "19" [dir=back tooltip="include"]
}
file EXPini.H
#include <algorithm>
#include <typeinfo>
#include <iostream>
#include <iomanip>
#include <fstream>
#include <sstream>
#include <cstring>
#include <yaml-cpp/yaml.h>
#include <cxxopts.H>

Include dependency graph for EXPini.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EXPini.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EXPini.H" fillcolor="#BFBFBF"]
    "10" [label="cxxopts.H" tooltip="cxxopts.H"]
    "2" [label="algorithm" tooltip="algorithm"]
    "11" [label="cctype" tooltip="cctype"]
    "8" [label="cstring" tooltip="cstring"]
    "12" [label="exception" tooltip="exception"]
    "6" [label="fstream" tooltip="fstream"]
    "5" [label="iomanip" tooltip="iomanip"]
    "4" [label="iostream" tooltip="iostream"]
    "13" [label="limits" tooltip="limits"]
    "14" [label="list" tooltip="list"]
    "15" [label="map" tooltip="map"]
    "16" [label="memory" tooltip="memory"]
    "22" [label="regex" tooltip="regex"]
    "7" [label="sstream" tooltip="sstream"]
    "17" [label="string" tooltip="string"]
    "3" [label="typeinfo" tooltip="typeinfo"]
    "18" [label="unordered_map" tooltip="unordered_map"]
    "19" [label="unordered_set" tooltip="unordered_set"]
    "20" [label="utility" tooltip="utility"]
    "21" [label="vector" tooltip="vector"]
    "9" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "1" -> "10" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "8" [dir=forward tooltip="include"]
    "10" -> "12" [dir=forward tooltip="include"]
    "10" -> "4" [dir=forward tooltip="include"]
    "10" -> "13" [dir=forward tooltip="include"]
    "10" -> "14" [dir=forward tooltip="include"]
    "10" -> "15" [dir=forward tooltip="include"]
    "10" -> "16" [dir=forward tooltip="include"]
    "10" -> "7" [dir=forward tooltip="include"]
    "10" -> "17" [dir=forward tooltip="include"]
    "10" -> "18" [dir=forward tooltip="include"]
    "10" -> "19" [dir=forward tooltip="include"]
    "10" -> "20" [dir=forward tooltip="include"]
    "10" -> "21" [dir=forward tooltip="include"]
    "10" -> "2" [dir=forward tooltip="include"]
    "10" -> "22" [dir=forward tooltip="include"]
}

Functions

cxxopts::ParseResult LoadConfig(cxxopts::Options &options, const std::string &config)

Read the YAML parameter config file and load the cxxopts database with parameters

void SaveConfig(const cxxopts::ParseResult &vm, const cxxopts::Options &options, const std::string &config, const std::vector<std::string> groups = {""}, const std::vector<std::string> exclude = {"help", "template", "expert", "config"})

Saves the current command-line cxxopts database in YAML format for user configuration. For ease, the current convention is that all vector-values options will be stored as strings, and converted by the calling program to the correct value internally.

file EXPmath.H

This graph shows which files directly or indirectly include EXPmath.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EXPmath.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EXPmath.H" fillcolor="#BFBFBF"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCyl2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCyl2d.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/PotRZ.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/PotRZ.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QDHT.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QDHT.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/Bess.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/Bess.H"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "6" [dir=back tooltip="include"]
    "4" -> "8" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "10" [dir=back tooltip="include"]
    "1" -> "12" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "4" [dir=back tooltip="include"]
    "10" -> "11" [dir=back tooltip="include"]
    "6" -> "7" [dir=back tooltip="include"]
    "6" -> "5" [dir=back tooltip="include"]
    "8" -> "9" [dir=back tooltip="include"]
}
file exponential.H
#include <massmodel.H>

Include dependency graph for exponential.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "21" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "10" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "20" [label="QPDistF.H" tooltip="QPDistF.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exponential.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exponential.H" fillcolor="#BFBFBF"]
    "15" [label="gaussQ.H" tooltip="gaussQ.H"]
    "8" [label="interp.H" tooltip="interp.H"]
    "2" [label="massmodel.H" tooltip="massmodel.H"]
    "13" [label="orbit.H" tooltip="orbit.H"]
    "7" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "19" [label="cstdlib" tooltip="cstdlib"]
    "9" [label="deque" tooltip="deque"]
    "14" [label="functional" tooltip="functional"]
    "17" [label="iomanip" tooltip="iomanip"]
    "16" [label="iostream" tooltip="iostream"]
    "11" [label="map" tooltip="map"]
    "4" [label="memory" tooltip="memory"]
    "5" [label="random" tooltip="random"]
    "18" [label="sstream" tooltip="sstream"]
    "12" [label="string" tooltip="string"]
    "6" [label="tuple" tooltip="tuple"]
    "3" [label="vector" tooltip="vector"]
    "21" -> "2" [dir=forward tooltip="include"]
    "10" -> "3" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "12" [dir=forward tooltip="include"]
    "20" -> "17" [dir=forward tooltip="include"]
    "20" -> "12" [dir=forward tooltip="include"]
    "20" -> "11" [dir=forward tooltip="include"]
    "20" -> "2" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "13" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "17" [dir=forward tooltip="include"]
    "15" -> "18" [dir=forward tooltip="include"]
    "15" -> "19" [dir=forward tooltip="include"]
    "15" -> "12" [dir=forward tooltip="include"]
    "15" -> "3" [dir=forward tooltip="include"]
    "8" -> "7" [dir=forward tooltip="include"]
    "8" -> "3" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "10" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "2" -> "7" [dir=forward tooltip="include"]
    "2" -> "8" [dir=forward tooltip="include"]
    "2" -> "13" [dir=forward tooltip="include"]
    "2" -> "20" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "4" [dir=forward tooltip="include"]
    "13" -> "7" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include exponential.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exponential.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exponential.H" fillcolor="#BFBFBF"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
}
file exputils.H
#include <string>
#include <Eigen/Eigen>

Include dependency graph for exputils.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exputils.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exputils.H" fillcolor="#BFBFBF"]
    "3" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "2" [label="string" tooltip="string"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
}

Functions

std::tuple<bool, double, std::vector<double>> orthoCompute(const std::vector<Eigen::MatrixXd> &tests)
void orthoTest(const std::vector<Eigen::MatrixXd> &tests, const std::string &classname, const std::string &indexname)
file FileUtils.H
#include <string>

Include dependency graph for FileUtils.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/FileUtils.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/FileUtils.H" fillcolor="#BFBFBF"]
    "2" [label="string" tooltip="string"]
    "1" -> "2" [dir=forward tooltip="include"]
}

Functions

bool FileExists(const std::string &filename)
bool FileRename(const std::string &file1, const std::string &file2)
file FindOrb.H
#include <functional>

Include dependency graph for FindOrb.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/FindOrb.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/FindOrb.H" fillcolor="#BFBFBF"]
    "2" [label="functional" tooltip="functional"]
    "1" -> "2" [dir=forward tooltip="include"]
}
file fpetrap.h
#include <iostream>
#include <iomanip>
#include <cfenv>
#include <list>
#include <signal.h>

Include dependency graph for fpetrap.h:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/fpetrap.h" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/fpetrap.h" fillcolor="#BFBFBF"]
    "4" [label="cfenv" tooltip="cfenv"]
    "3" [label="iomanip" tooltip="iomanip"]
    "2" [label="iostream" tooltip="iostream"]
    "5" [label="list" tooltip="list"]
    "6" [label="signal.h" tooltip="signal.h"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
}

Functions

static void my_fpu_handler(int err)

Very lean error handler. Only good for setting a debugger breakpoint.

void set_fpu_handler(void)

Turns on exceptions for invalid, div by zero and overflow, other

bits default. This will only work for x86 architecture.

Variables

static int my_err

Global to hold error code.

Some FPE trapping stuff for debugging

static void (*oldhandler)(int)
file Func1d.H
file gadget.H

This graph shows which files directly or indirectly include gadget.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ParticleReader.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ParticleReader.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/gadget.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/gadget.H" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=back tooltip="include"]
}
file gaussQ.H
#include <iostream>
#include <iomanip>
#include <sstream>
#include <cstdlib>
#include <string>
#include <vector>

Include dependency graph for gaussQ.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/gaussQ.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/gaussQ.H" fillcolor="#BFBFBF"]
    "5" [label="cstdlib" tooltip="cstdlib"]
    "3" [label="iomanip" tooltip="iomanip"]
    "2" [label="iostream" tooltip="iostream"]
    "4" [label="sstream" tooltip="sstream"]
    "6" [label="string" tooltip="string"]
    "7" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include gaussQ.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskWithHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskWithHalo.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCyl2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCyl2d.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/GenPoly.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/GenPoly.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/HunterX.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/HunterX.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/OrthoFunction.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/OrthoFunction.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QPDistF.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QPDistF.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H"]
    "33" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exponential.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exponential.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/gaussQ.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/gaussQ.H" fillcolor="#BFBFBF"]
    "34" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hernquist_model.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hernquist_model.H"]
    "35" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hunter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hunter.H"]
    "36" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/isothermal.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/isothermal.H"]
    "37" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/king.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/king.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/massmodel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/massmodel.H"]
    "38" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/mestel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/mestel.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/orbit.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/orbit.H"]
    "39" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/plummer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/plummer.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H"]
    "40" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/toomre.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/toomre.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "41" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H"]
    "42" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "29" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H"]
    "30" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "43" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/externalShock.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/externalShock.H"]
    "31" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H"]
    "44" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddDisk.H"]
    "45" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddSpheres.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddSpheres.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H"]
    "48" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/EllipForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/EllipForce.H"]
    "49" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/EllipsoidForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/EllipsoidForce.H"]
    "32" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H"]
    "46" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/massmodel1d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/massmodel1d.H"]
    "47" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/MakeModel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/MakeModel.H"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "6" [dir=back tooltip="include"]
    "4" -> "8" [dir=back tooltip="include"]
    "11" -> "12" [dir=back tooltip="include"]
    "24" -> "22" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "4" [dir=back tooltip="include"]
    "10" -> "11" [dir=back tooltip="include"]
    "10" -> "13" [dir=back tooltip="include"]
    "10" -> "18" [dir=back tooltip="include"]
    "10" -> "12" [dir=back tooltip="include"]
    "10" -> "19" [dir=back tooltip="include"]
    "22" -> "23" [dir=back tooltip="include"]
    "27" -> "10" [dir=back tooltip="include"]
    "27" -> "28" [dir=back tooltip="include"]
    "27" -> "29" [dir=back tooltip="include"]
    "27" -> "30" [dir=back tooltip="include"]
    "27" -> "15" [dir=back tooltip="include"]
    "27" -> "31" [dir=back tooltip="include"]
    "27" -> "32" [dir=back tooltip="include"]
    "33" -> "9" [dir=back tooltip="include"]
    "33" -> "19" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "10" [dir=back tooltip="include"]
    "1" -> "20" [dir=back tooltip="include"]
    "1" -> "21" [dir=back tooltip="include"]
    "1" -> "8" [dir=back tooltip="include"]
    "1" -> "9" [dir=back tooltip="include"]
    "1" -> "12" [dir=back tooltip="include"]
    "1" -> "19" [dir=back tooltip="include"]
    "1" -> "48" [dir=back tooltip="include"]
    "1" -> "49" [dir=back tooltip="include"]
    "35" -> "26" [dir=back tooltip="include"]
    "23" -> "3" [dir=back tooltip="include"]
    "23" -> "4" [dir=back tooltip="include"]
    "23" -> "24" [dir=back tooltip="include"]
    "23" -> "25" [dir=back tooltip="include"]
    "23" -> "26" [dir=back tooltip="include"]
    "23" -> "22" [dir=back tooltip="include"]
    "23" -> "27" [dir=back tooltip="include"]
    "23" -> "33" [dir=back tooltip="include"]
    "23" -> "34" [dir=back tooltip="include"]
    "23" -> "35" [dir=back tooltip="include"]
    "23" -> "36" [dir=back tooltip="include"]
    "23" -> "37" [dir=back tooltip="include"]
    "23" -> "38" [dir=back tooltip="include"]
    "23" -> "39" [dir=back tooltip="include"]
    "23" -> "40" [dir=back tooltip="include"]
    "23" -> "41" [dir=back tooltip="include"]
    "23" -> "42" [dir=back tooltip="include"]
    "23" -> "43" [dir=back tooltip="include"]
    "23" -> "44" [dir=back tooltip="include"]
    "23" -> "45" [dir=back tooltip="include"]
    "23" -> "18" [dir=back tooltip="include"]
    "23" -> "9" [dir=back tooltip="include"]
    "23" -> "19" [dir=back tooltip="include"]
    "23" -> "46" [dir=back tooltip="include"]
    "23" -> "47" [dir=back tooltip="include"]
    "21" -> "22" [dir=back tooltip="include"]
    "21" -> "23" [dir=back tooltip="include"]
    "21" -> "43" [dir=back tooltip="include"]
    "13" -> "14" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "6" -> "7" [dir=back tooltip="include"]
    "6" -> "5" [dir=back tooltip="include"]
    "30" -> "15" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "15" -> "17" [dir=back tooltip="include"]
    "44" -> "9" [dir=back tooltip="include"]
    "44" -> "19" [dir=back tooltip="include"]
    "8" -> "9" [dir=back tooltip="include"]
    "32" -> "9" [dir=back tooltip="include"]
    "32" -> "19" [dir=back tooltip="include"]
}
file GenPoly.H
#include <cmath>
#include <massmodel.H>

Include dependency graph for GenPoly.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "22" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/GenPoly.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/GenPoly.H" fillcolor="#BFBFBF"]
    "11" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "21" [label="QPDistF.H" tooltip="QPDistF.H"]
    "16" [label="gaussQ.H" tooltip="gaussQ.H"]
    "9" [label="interp.H" tooltip="interp.H"]
    "3" [label="massmodel.H" tooltip="massmodel.H"]
    "14" [label="orbit.H" tooltip="orbit.H"]
    "8" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "2" [label="cmath" tooltip="cmath"]
    "20" [label="cstdlib" tooltip="cstdlib"]
    "10" [label="deque" tooltip="deque"]
    "15" [label="functional" tooltip="functional"]
    "18" [label="iomanip" tooltip="iomanip"]
    "17" [label="iostream" tooltip="iostream"]
    "12" [label="map" tooltip="map"]
    "5" [label="memory" tooltip="memory"]
    "6" [label="random" tooltip="random"]
    "19" [label="sstream" tooltip="sstream"]
    "13" [label="string" tooltip="string"]
    "7" [label="tuple" tooltip="tuple"]
    "4" [label="vector" tooltip="vector"]
    "22" -> "3" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "11" -> "4" [dir=forward tooltip="include"]
    "11" -> "12" [dir=forward tooltip="include"]
    "11" -> "13" [dir=forward tooltip="include"]
    "21" -> "18" [dir=forward tooltip="include"]
    "21" -> "13" [dir=forward tooltip="include"]
    "21" -> "12" [dir=forward tooltip="include"]
    "21" -> "3" [dir=forward tooltip="include"]
    "21" -> "22" [dir=forward tooltip="include"]
    "21" -> "14" [dir=forward tooltip="include"]
    "16" -> "17" [dir=forward tooltip="include"]
    "16" -> "18" [dir=forward tooltip="include"]
    "16" -> "19" [dir=forward tooltip="include"]
    "16" -> "20" [dir=forward tooltip="include"]
    "16" -> "13" [dir=forward tooltip="include"]
    "16" -> "4" [dir=forward tooltip="include"]
    "9" -> "8" [dir=forward tooltip="include"]
    "9" -> "4" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "11" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "5" [dir=forward tooltip="include"]
    "3" -> "6" [dir=forward tooltip="include"]
    "3" -> "7" [dir=forward tooltip="include"]
    "3" -> "8" [dir=forward tooltip="include"]
    "3" -> "9" [dir=forward tooltip="include"]
    "3" -> "14" [dir=forward tooltip="include"]
    "3" -> "21" [dir=forward tooltip="include"]
    "14" -> "15" [dir=forward tooltip="include"]
    "14" -> "5" [dir=forward tooltip="include"]
    "14" -> "8" [dir=forward tooltip="include"]
    "14" -> "16" [dir=forward tooltip="include"]
}
file gknots.h

Functions

void free_gknots(struct GAUSS*, int)
void get_gknots(struct GAUSS*, int)
file Hankel.H
#include <functional>
#include <algorithm>
#include <vector>
#include <cmath>
#include <boost/math/special_functions/bessel.hpp>
#include <boost/math/tools/minima.hpp>

Include dependency graph for Hankel.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Hankel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Hankel.H" fillcolor="#BFBFBF"]
    "3" [label="algorithm" tooltip="algorithm"]
    "6" [label="boost/math/special_functions/bessel.hpp" tooltip="boost/math/special_functions/bessel.hpp"]
    "7" [label="boost/math/tools/minima.hpp" tooltip="boost/math/tools/minima.hpp"]
    "5" [label="cmath" tooltip="cmath"]
    "2" [label="functional" tooltip="functional"]
    "4" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
}
file header.H
#include <iostream>
#include <iomanip>
#include <sstream>
#include <memory>
#include “localmpi.H

Include dependency graph for header.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/header.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/header.H" fillcolor="#BFBFBF"]
    "6" [label="localmpi.H" tooltip="localmpi.H"]
    "8" [label="fstream" tooltip="fstream"]
    "3" [label="iomanip" tooltip="iomanip"]
    "2" [label="iostream" tooltip="iostream"]
    "5" [label="memory" tooltip="memory"]
    "7" [label="mpi.h" tooltip="mpi.h"]
    "4" [label="sstream" tooltip="sstream"]
    "9" [label="string" tooltip="string"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "6" -> "7" [dir=forward tooltip="include"]
    "6" -> "2" [dir=forward tooltip="include"]
    "6" -> "8" [dir=forward tooltip="include"]
    "6" -> "3" [dir=forward tooltip="include"]
    "6" -> "9" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include header.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ParticleReader.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ParticleReader.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/header.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/header.H" fillcolor="#BFBFBF"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "29" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/PSP2.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/PSP2.H"]
    "30" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/PSP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/PSP.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
    "1" -> "29" [dir=back tooltip="include"]
    "1" -> "30" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "21" [dir=back tooltip="include"]
    "3" -> "25" [dir=back tooltip="include"]
    "3" -> "26" [dir=back tooltip="include"]
    "3" -> "27" [dir=back tooltip="include"]
    "3" -> "28" [dir=back tooltip="include"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "14" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
    "5" -> "7" [dir=back tooltip="include"]
    "5" -> "8" [dir=back tooltip="include"]
    "5" -> "9" [dir=back tooltip="include"]
    "5" -> "10" [dir=back tooltip="include"]
    "5" -> "11" [dir=back tooltip="include"]
    "5" -> "12" [dir=back tooltip="include"]
    "5" -> "13" [dir=back tooltip="include"]
    "21" -> "5" [dir=back tooltip="include"]
    "21" -> "22" [dir=back tooltip="include"]
    "21" -> "23" [dir=back tooltip="include"]
    "21" -> "14" [dir=back tooltip="include"]
    "21" -> "24" [dir=back tooltip="include"]
    "25" -> "25" [dir=back tooltip="include"]
    "17" -> "18" [dir=back tooltip="include"]
    "17" -> "19" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "14" -> "20" [dir=back tooltip="include"]
}
file hernquist_model.H
#include <cmath>
#include <massmodel.H>

Include dependency graph for hernquist_model.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "22" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "11" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "21" [label="QPDistF.H" tooltip="QPDistF.H"]
    "16" [label="gaussQ.H" tooltip="gaussQ.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hernquist_model.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hernquist_model.H" fillcolor="#BFBFBF"]
    "9" [label="interp.H" tooltip="interp.H"]
    "3" [label="massmodel.H" tooltip="massmodel.H"]
    "14" [label="orbit.H" tooltip="orbit.H"]
    "8" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "2" [label="cmath" tooltip="cmath"]
    "20" [label="cstdlib" tooltip="cstdlib"]
    "10" [label="deque" tooltip="deque"]
    "15" [label="functional" tooltip="functional"]
    "18" [label="iomanip" tooltip="iomanip"]
    "17" [label="iostream" tooltip="iostream"]
    "12" [label="map" tooltip="map"]
    "5" [label="memory" tooltip="memory"]
    "6" [label="random" tooltip="random"]
    "19" [label="sstream" tooltip="sstream"]
    "13" [label="string" tooltip="string"]
    "7" [label="tuple" tooltip="tuple"]
    "4" [label="vector" tooltip="vector"]
    "22" -> "3" [dir=forward tooltip="include"]
    "11" -> "4" [dir=forward tooltip="include"]
    "11" -> "12" [dir=forward tooltip="include"]
    "11" -> "13" [dir=forward tooltip="include"]
    "21" -> "18" [dir=forward tooltip="include"]
    "21" -> "13" [dir=forward tooltip="include"]
    "21" -> "12" [dir=forward tooltip="include"]
    "21" -> "3" [dir=forward tooltip="include"]
    "21" -> "22" [dir=forward tooltip="include"]
    "21" -> "14" [dir=forward tooltip="include"]
    "16" -> "17" [dir=forward tooltip="include"]
    "16" -> "18" [dir=forward tooltip="include"]
    "16" -> "19" [dir=forward tooltip="include"]
    "16" -> "20" [dir=forward tooltip="include"]
    "16" -> "13" [dir=forward tooltip="include"]
    "16" -> "4" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "9" -> "8" [dir=forward tooltip="include"]
    "9" -> "4" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "11" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "5" [dir=forward tooltip="include"]
    "3" -> "6" [dir=forward tooltip="include"]
    "3" -> "7" [dir=forward tooltip="include"]
    "3" -> "8" [dir=forward tooltip="include"]
    "3" -> "9" [dir=forward tooltip="include"]
    "3" -> "14" [dir=forward tooltip="include"]
    "3" -> "21" [dir=forward tooltip="include"]
    "14" -> "15" [dir=forward tooltip="include"]
    "14" -> "5" [dir=forward tooltip="include"]
    "14" -> "8" [dir=forward tooltip="include"]
    "14" -> "16" [dir=forward tooltip="include"]
}
file hunter.H
#include <massmodel.H>

Include dependency graph for hunter.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "21" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "10" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "20" [label="QPDistF.H" tooltip="QPDistF.H"]
    "15" [label="gaussQ.H" tooltip="gaussQ.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hunter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hunter.H" fillcolor="#BFBFBF"]
    "8" [label="interp.H" tooltip="interp.H"]
    "2" [label="massmodel.H" tooltip="massmodel.H"]
    "13" [label="orbit.H" tooltip="orbit.H"]
    "7" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "19" [label="cstdlib" tooltip="cstdlib"]
    "9" [label="deque" tooltip="deque"]
    "14" [label="functional" tooltip="functional"]
    "17" [label="iomanip" tooltip="iomanip"]
    "16" [label="iostream" tooltip="iostream"]
    "11" [label="map" tooltip="map"]
    "4" [label="memory" tooltip="memory"]
    "5" [label="random" tooltip="random"]
    "18" [label="sstream" tooltip="sstream"]
    "12" [label="string" tooltip="string"]
    "6" [label="tuple" tooltip="tuple"]
    "3" [label="vector" tooltip="vector"]
    "21" -> "2" [dir=forward tooltip="include"]
    "10" -> "3" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "12" [dir=forward tooltip="include"]
    "20" -> "17" [dir=forward tooltip="include"]
    "20" -> "12" [dir=forward tooltip="include"]
    "20" -> "11" [dir=forward tooltip="include"]
    "20" -> "2" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "13" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "17" [dir=forward tooltip="include"]
    "15" -> "18" [dir=forward tooltip="include"]
    "15" -> "19" [dir=forward tooltip="include"]
    "15" -> "12" [dir=forward tooltip="include"]
    "15" -> "3" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "8" -> "7" [dir=forward tooltip="include"]
    "8" -> "3" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "10" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "2" -> "7" [dir=forward tooltip="include"]
    "2" -> "8" [dir=forward tooltip="include"]
    "2" -> "13" [dir=forward tooltip="include"]
    "2" -> "20" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "4" [dir=forward tooltip="include"]
    "13" -> "7" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include hunter.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/HunterX.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/HunterX.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hunter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hunter.H" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=back tooltip="include"]
}
file HunterX.H
#include <massmodel.H>
#include <hunter.h>

Include dependency graph for HunterX.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "21" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/HunterX.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/HunterX.H" fillcolor="#BFBFBF"]
    "10" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "20" [label="QPDistF.H" tooltip="QPDistF.H"]
    "15" [label="gaussQ.H" tooltip="gaussQ.H"]
    "22" [label="hunter.h" tooltip="hunter.h"]
    "8" [label="interp.H" tooltip="interp.H"]
    "2" [label="massmodel.H" tooltip="massmodel.H"]
    "13" [label="orbit.H" tooltip="orbit.H"]
    "7" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "19" [label="cstdlib" tooltip="cstdlib"]
    "9" [label="deque" tooltip="deque"]
    "14" [label="functional" tooltip="functional"]
    "17" [label="iomanip" tooltip="iomanip"]
    "16" [label="iostream" tooltip="iostream"]
    "11" [label="map" tooltip="map"]
    "4" [label="memory" tooltip="memory"]
    "5" [label="random" tooltip="random"]
    "18" [label="sstream" tooltip="sstream"]
    "12" [label="string" tooltip="string"]
    "6" [label="tuple" tooltip="tuple"]
    "3" [label="vector" tooltip="vector"]
    "21" -> "2" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "22" [dir=forward tooltip="include"]
    "10" -> "3" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "12" [dir=forward tooltip="include"]
    "20" -> "17" [dir=forward tooltip="include"]
    "20" -> "12" [dir=forward tooltip="include"]
    "20" -> "11" [dir=forward tooltip="include"]
    "20" -> "2" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "13" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "17" [dir=forward tooltip="include"]
    "15" -> "18" [dir=forward tooltip="include"]
    "15" -> "19" [dir=forward tooltip="include"]
    "15" -> "12" [dir=forward tooltip="include"]
    "15" -> "3" [dir=forward tooltip="include"]
    "22" -> "2" [dir=forward tooltip="include"]
    "8" -> "7" [dir=forward tooltip="include"]
    "8" -> "3" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "10" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "2" -> "7" [dir=forward tooltip="include"]
    "2" -> "8" [dir=forward tooltip="include"]
    "2" -> "13" [dir=forward tooltip="include"]
    "2" -> "20" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "4" [dir=forward tooltip="include"]
    "13" -> "7" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
}
file InitContainer.H
#include <map>

Include dependency graph for InitContainer.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/InitContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/InitContainer.H" fillcolor="#BFBFBF"]
    "2" [label="map" tooltip="map"]
    "1" -> "2" [dir=forward tooltip="include"]
}

Functions

template<template<class, class, class...> class C, typename K, typename V, typename ...Args>
V &GetWithDef(C<K, V, Args...> &m, K const &key, const V &defval)

Non-invasive, assignable, lvalue return.

template<template<class, class, class...> class C, typename K, typename V, typename ...Args>
V GetWithDef(const C<K, V, Args...> &m, K const &key, const V &defval)

Non-invasive, constant rvalue return.

Wrapper template for STL containers for initializing value for new key.

GetWithDef returns a value and MapWithDef returns the container.

The Icont class derives a helper class using the STL container as a base class. This version seems the cleanest but may have slightly more overhead.

This version is updated for C++11 variadic arguments. Should work for generic associative containers including the optional comparator and allocator parameters.

file interp.H
#include <Eigen/Eigen>
#include <vector>
#include <deque>

Include dependency graph for interp.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/interp.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/interp.H" fillcolor="#BFBFBF"]
    "2" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "4" [label="deque" tooltip="deque"]
    "6" [label="map" tooltip="map"]
    "7" [label="string" tooltip="string"]
    "3" [label="vector" tooltip="vector"]
    "5" -> "3" [dir=forward tooltip="include"]
    "5" -> "6" [dir=forward tooltip="include"]
    "5" -> "7" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include interp.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskWithHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskWithHalo.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/GenPoly.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/GenPoly.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/HunterX.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/HunterX.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QPDistF.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QPDistF.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H"]
    "31" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exponential.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exponential.H"]
    "32" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hernquist_model.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hernquist_model.H"]
    "33" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hunter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hunter.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/interp.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/interp.H" fillcolor="#BFBFBF"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/isothermal.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/isothermal.H"]
    "34" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/king.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/king.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/massmodel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/massmodel.H"]
    "35" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/mestel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/mestel.H"]
    "36" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/plummer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/plummer.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H"]
    "37" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/toomre.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/toomre.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "38" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "45" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H"]
    "39" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "40" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/externalShock.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/externalShock.H"]
    "29" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H"]
    "41" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddDisk.H"]
    "42" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddSpheres.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddSpheres.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H"]
    "46" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/EllipForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/EllipForce.H"]
    "47" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/EllipsoidForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/EllipsoidForce.H"]
    "30" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H"]
    "43" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/massmodel1d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/massmodel1d.H"]
    "44" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/MakeModel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/MakeModel.H"]
    "15" -> "16" [dir=back tooltip="include"]
    "15" -> "17" [dir=back tooltip="include"]
    "15" -> "19" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "21" -> "22" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "5" [dir=back tooltip="include"]
    "2" -> "10" [dir=back tooltip="include"]
    "2" -> "4" [dir=back tooltip="include"]
    "2" -> "11" [dir=back tooltip="include"]
    "22" -> "13" [dir=back tooltip="include"]
    "25" -> "2" [dir=back tooltip="include"]
    "25" -> "26" [dir=back tooltip="include"]
    "25" -> "27" [dir=back tooltip="include"]
    "25" -> "28" [dir=back tooltip="include"]
    "25" -> "7" [dir=back tooltip="include"]
    "25" -> "29" [dir=back tooltip="include"]
    "25" -> "30" [dir=back tooltip="include"]
    "31" -> "20" [dir=back tooltip="include"]
    "31" -> "11" [dir=back tooltip="include"]
    "33" -> "24" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "12" [dir=back tooltip="include"]
    "1" -> "13" [dir=back tooltip="include"]
    "1" -> "45" [dir=back tooltip="include"]
    "1" -> "39" [dir=back tooltip="include"]
    "1" -> "10" [dir=back tooltip="include"]
    "1" -> "46" [dir=back tooltip="include"]
    "1" -> "47" [dir=back tooltip="include"]
    "13" -> "14" [dir=back tooltip="include"]
    "13" -> "15" [dir=back tooltip="include"]
    "13" -> "21" [dir=back tooltip="include"]
    "13" -> "23" [dir=back tooltip="include"]
    "13" -> "24" [dir=back tooltip="include"]
    "13" -> "22" [dir=back tooltip="include"]
    "13" -> "25" [dir=back tooltip="include"]
    "13" -> "31" [dir=back tooltip="include"]
    "13" -> "32" [dir=back tooltip="include"]
    "13" -> "33" [dir=back tooltip="include"]
    "13" -> "12" [dir=back tooltip="include"]
    "13" -> "34" [dir=back tooltip="include"]
    "13" -> "35" [dir=back tooltip="include"]
    "13" -> "36" [dir=back tooltip="include"]
    "13" -> "37" [dir=back tooltip="include"]
    "13" -> "38" [dir=back tooltip="include"]
    "13" -> "39" [dir=back tooltip="include"]
    "13" -> "40" [dir=back tooltip="include"]
    "13" -> "41" [dir=back tooltip="include"]
    "13" -> "42" [dir=back tooltip="include"]
    "13" -> "10" [dir=back tooltip="include"]
    "13" -> "20" [dir=back tooltip="include"]
    "13" -> "11" [dir=back tooltip="include"]
    "13" -> "43" [dir=back tooltip="include"]
    "13" -> "44" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
    "6" -> "7" [dir=back tooltip="include"]
    "17" -> "18" [dir=back tooltip="include"]
    "17" -> "16" [dir=back tooltip="include"]
    "28" -> "7" [dir=back tooltip="include"]
    "7" -> "8" [dir=back tooltip="include"]
    "7" -> "9" [dir=back tooltip="include"]
    "41" -> "20" [dir=back tooltip="include"]
    "41" -> "11" [dir=back tooltip="include"]
    "19" -> "20" [dir=back tooltip="include"]
    "30" -> "20" [dir=back tooltip="include"]
    "30" -> "11" [dir=back tooltip="include"]
}

Functions

template<class V>
double drv2(double x, const V &xtab, const V &ftab, int even = 0)
template<class V>
double odd2(double x, const V &xtab, const V &ftab, int even = 0)
void Spline(const Eigen::VectorXd &x, const Eigen::VectorXd &y, double yp1, double ypn, Eigen::VectorXd &y2)
void Splint1(const Eigen::VectorXd &xa, const Eigen::VectorXd &ya, const Eigen::VectorXd &y2a, double x, double &y, int even = 0)
void Splint2(const Eigen::VectorXd &xa, const Eigen::VectorXd &ya, const Eigen::VectorXd &y2a, double x, double &y, double &dy, int even = 0)
void Splint3(const Eigen::VectorXd &xa, const Eigen::VectorXd &ya, const Eigen::VectorXd &y2a, double x, double &y, double &dy, double &dyy, int even = 0)
double Splsum(const Eigen::VectorXd &x, const Eigen::VectorXd &y)
void Splsum(const Eigen::VectorXd &x, const Eigen::VectorXd &y, Eigen::VectorXd &z)
double Trapsum(const Eigen::VectorXd &x, const Eigen::VectorXd &y)
void Trapsum(const Eigen::VectorXd &x, const Eigen::VectorXd &y, Eigen::VectorXd &z)
template<class V>
int Vlocate(double x, const V &xtab)
template<class V>
int Vlocate_with_guard(double value, const V &vec)
file isothermal.H
#include <cmath>
#include <massmodel.H>
#include <interp.H>

Include dependency graph for isothermal.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "22" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "11" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "21" [label="QPDistF.H" tooltip="QPDistF.H"]
    "16" [label="gaussQ.H" tooltip="gaussQ.H"]
    "9" [label="interp.H" tooltip="interp.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/isothermal.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/isothermal.H" fillcolor="#BFBFBF"]
    "3" [label="massmodel.H" tooltip="massmodel.H"]
    "14" [label="orbit.H" tooltip="orbit.H"]
    "8" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "2" [label="cmath" tooltip="cmath"]
    "20" [label="cstdlib" tooltip="cstdlib"]
    "10" [label="deque" tooltip="deque"]
    "15" [label="functional" tooltip="functional"]
    "18" [label="iomanip" tooltip="iomanip"]
    "17" [label="iostream" tooltip="iostream"]
    "12" [label="map" tooltip="map"]
    "5" [label="memory" tooltip="memory"]
    "6" [label="random" tooltip="random"]
    "19" [label="sstream" tooltip="sstream"]
    "13" [label="string" tooltip="string"]
    "7" [label="tuple" tooltip="tuple"]
    "4" [label="vector" tooltip="vector"]
    "22" -> "3" [dir=forward tooltip="include"]
    "11" -> "4" [dir=forward tooltip="include"]
    "11" -> "12" [dir=forward tooltip="include"]
    "11" -> "13" [dir=forward tooltip="include"]
    "21" -> "18" [dir=forward tooltip="include"]
    "21" -> "13" [dir=forward tooltip="include"]
    "21" -> "12" [dir=forward tooltip="include"]
    "21" -> "3" [dir=forward tooltip="include"]
    "21" -> "22" [dir=forward tooltip="include"]
    "21" -> "14" [dir=forward tooltip="include"]
    "16" -> "17" [dir=forward tooltip="include"]
    "16" -> "18" [dir=forward tooltip="include"]
    "16" -> "19" [dir=forward tooltip="include"]
    "16" -> "20" [dir=forward tooltip="include"]
    "16" -> "13" [dir=forward tooltip="include"]
    "16" -> "4" [dir=forward tooltip="include"]
    "9" -> "8" [dir=forward tooltip="include"]
    "9" -> "4" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "11" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "5" [dir=forward tooltip="include"]
    "3" -> "6" [dir=forward tooltip="include"]
    "3" -> "7" [dir=forward tooltip="include"]
    "3" -> "8" [dir=forward tooltip="include"]
    "3" -> "9" [dir=forward tooltip="include"]
    "3" -> "14" [dir=forward tooltip="include"]
    "3" -> "21" [dir=forward tooltip="include"]
    "14" -> "15" [dir=forward tooltip="include"]
    "14" -> "5" [dir=forward tooltip="include"]
    "14" -> "8" [dir=forward tooltip="include"]
    "14" -> "16" [dir=forward tooltip="include"]
}
file Iterable.H
#include <iterator>
#include <cstddef>

Include dependency graph for Iterable.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Iterable.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Iterable.H" fillcolor="#BFBFBF"]
    "3" [label="cstddef" tooltip="cstddef"]
    "2" [label="iterator" tooltip="iterator"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
}
file kalnajs.H
file KDtree.H
#include <algorithm>
#include <random>
#include <vector>
#include <array>
#include <cmath>
#include <tuple>
#include <map>

Include dependency graph for KDtree.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/KDtree.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/KDtree.H" fillcolor="#BFBFBF"]
    "2" [label="algorithm" tooltip="algorithm"]
    "5" [label="array" tooltip="array"]
    "6" [label="cmath" tooltip="cmath"]
    "8" [label="map" tooltip="map"]
    "3" [label="random" tooltip="random"]
    "7" [label="tuple" tooltip="tuple"]
    "4" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
}
file king.H
#include <massmodel.H>

Include dependency graph for king.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "21" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "10" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "20" [label="QPDistF.H" tooltip="QPDistF.H"]
    "15" [label="gaussQ.H" tooltip="gaussQ.H"]
    "8" [label="interp.H" tooltip="interp.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/king.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/king.H" fillcolor="#BFBFBF"]
    "2" [label="massmodel.H" tooltip="massmodel.H"]
    "13" [label="orbit.H" tooltip="orbit.H"]
    "7" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "19" [label="cstdlib" tooltip="cstdlib"]
    "9" [label="deque" tooltip="deque"]
    "14" [label="functional" tooltip="functional"]
    "17" [label="iomanip" tooltip="iomanip"]
    "16" [label="iostream" tooltip="iostream"]
    "11" [label="map" tooltip="map"]
    "4" [label="memory" tooltip="memory"]
    "5" [label="random" tooltip="random"]
    "18" [label="sstream" tooltip="sstream"]
    "12" [label="string" tooltip="string"]
    "6" [label="tuple" tooltip="tuple"]
    "3" [label="vector" tooltip="vector"]
    "21" -> "2" [dir=forward tooltip="include"]
    "10" -> "3" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "12" [dir=forward tooltip="include"]
    "20" -> "17" [dir=forward tooltip="include"]
    "20" -> "12" [dir=forward tooltip="include"]
    "20" -> "11" [dir=forward tooltip="include"]
    "20" -> "2" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "13" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "17" [dir=forward tooltip="include"]
    "15" -> "18" [dir=forward tooltip="include"]
    "15" -> "19" [dir=forward tooltip="include"]
    "15" -> "12" [dir=forward tooltip="include"]
    "15" -> "3" [dir=forward tooltip="include"]
    "8" -> "7" [dir=forward tooltip="include"]
    "8" -> "3" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "10" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "2" -> "7" [dir=forward tooltip="include"]
    "2" -> "8" [dir=forward tooltip="include"]
    "2" -> "13" [dir=forward tooltip="include"]
    "2" -> "20" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "4" [dir=forward tooltip="include"]
    "13" -> "7" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
}
file libvars.H
#include <random>
#include <mpi.h>

Include dependency graph for libvars.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/libvars.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/libvars.H" fillcolor="#BFBFBF"]
    "3" [label="mpi.h" tooltip="mpi.h"]
    "2" [label="random" tooltip="random"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include libvars.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "30" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EXPException.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EXPException.H"]
    "29" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H"]
    "34" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/libvars.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/libvars.H" fillcolor="#BFBFBF"]
    "35" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "36" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H"]
    "37" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "41" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/global.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/global.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "38" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H"]
    "32" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H"]
    "40" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H"]
    "31" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H"]
    "33" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H"]
    "39" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H"]
    "30" -> "31" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "28" [dir=back tooltip="include"]
    "2" -> "14" [dir=back tooltip="include"]
    "29" -> "30" [dir=back tooltip="include"]
    "29" -> "15" [dir=back tooltip="include"]
    "29" -> "32" [dir=back tooltip="include"]
    "29" -> "31" [dir=back tooltip="include"]
    "29" -> "33" [dir=back tooltip="include"]
    "34" -> "29" [dir=back tooltip="include"]
    "34" -> "35" [dir=back tooltip="include"]
    "34" -> "36" [dir=back tooltip="include"]
    "34" -> "37" [dir=back tooltip="include"]
    "34" -> "17" [dir=back tooltip="include"]
    "34" -> "38" [dir=back tooltip="include"]
    "34" -> "39" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "29" [dir=back tooltip="include"]
    "1" -> "34" [dir=back tooltip="include"]
    "1" -> "41" [dir=back tooltip="include"]
    "1" -> "40" [dir=back tooltip="include"]
    "1" -> "33" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "21" [dir=back tooltip="include"]
    "3" -> "25" [dir=back tooltip="include"]
    "3" -> "26" [dir=back tooltip="include"]
    "3" -> "27" [dir=back tooltip="include"]
    "3" -> "28" [dir=back tooltip="include"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "14" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
    "5" -> "7" [dir=back tooltip="include"]
    "5" -> "8" [dir=back tooltip="include"]
    "5" -> "9" [dir=back tooltip="include"]
    "5" -> "10" [dir=back tooltip="include"]
    "5" -> "11" [dir=back tooltip="include"]
    "5" -> "12" [dir=back tooltip="include"]
    "5" -> "13" [dir=back tooltip="include"]
    "21" -> "5" [dir=back tooltip="include"]
    "21" -> "22" [dir=back tooltip="include"]
    "21" -> "23" [dir=back tooltip="include"]
    "21" -> "14" [dir=back tooltip="include"]
    "21" -> "24" [dir=back tooltip="include"]
    "25" -> "25" [dir=back tooltip="include"]
    "37" -> "17" [dir=back tooltip="include"]
    "17" -> "18" [dir=back tooltip="include"]
    "17" -> "19" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "14" -> "20" [dir=back tooltip="include"]
    "41" -> "3" [dir=back tooltip="include"]
    "41" -> "15" [dir=back tooltip="include"]
    "41" -> "14" [dir=back tooltip="include"]
    "39" -> "40" [dir=back tooltip="include"]
    "39" -> "33" [dir=back tooltip="include"]
}
file localmpi.H
#include <mpi.h>
#include <iostream>
#include <fstream>
#include <iomanip>
#include <string>

Include dependency graph for localmpi.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/localmpi.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/localmpi.H" fillcolor="#BFBFBF"]
    "4" [label="fstream" tooltip="fstream"]
    "5" [label="iomanip" tooltip="iomanip"]
    "3" [label="iostream" tooltip="iostream"]
    "2" [label="mpi.h" tooltip="mpi.h"]
    "6" [label="string" tooltip="string"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include localmpi.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCyl2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCyl2d.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ParticleReader.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ParticleReader.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/header.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/header.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/localmpi.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/localmpi.H" fillcolor="#BFBFBF"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H"]
    "29" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "30" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "41" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H"]
    "42" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "45" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "46" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "47" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "48" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "51" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ParticleFerry.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ParticleFerry.H"]
    "31" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H"]
    "43" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "40" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H"]
    "52" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/StatsMPI.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/StatsMPI.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "39" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "53" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/global.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/global.H"]
    "32" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "33" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "34" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "35" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "36" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "37" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "38" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "44" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "49" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/PSP2.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/PSP2.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H"]
    "54" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SParticle.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SParticle.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H"]
    "50" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/PSP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/PSP.H"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "5" [dir=back tooltip="include"]
    "3" -> "7" [dir=back tooltip="include"]
    "12" -> "13" [dir=back tooltip="include"]
    "9" -> "2" [dir=back tooltip="include"]
    "9" -> "3" [dir=back tooltip="include"]
    "11" -> "12" [dir=back tooltip="include"]
    "11" -> "14" [dir=back tooltip="include"]
    "11" -> "19" [dir=back tooltip="include"]
    "11" -> "13" [dir=back tooltip="include"]
    "11" -> "20" [dir=back tooltip="include"]
    "10" -> "11" [dir=back tooltip="include"]
    "10" -> "21" [dir=back tooltip="include"]
    "10" -> "22" [dir=back tooltip="include"]
    "10" -> "23" [dir=back tooltip="include"]
    "10" -> "16" [dir=back tooltip="include"]
    "10" -> "24" [dir=back tooltip="include"]
    "10" -> "25" [dir=back tooltip="include"]
    "26" -> "27" [dir=back tooltip="include"]
    "26" -> "28" [dir=back tooltip="include"]
    "26" -> "49" [dir=back tooltip="include"]
    "26" -> "50" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
    "1" -> "9" [dir=back tooltip="include"]
    "1" -> "10" [dir=back tooltip="include"]
    "1" -> "26" [dir=back tooltip="include"]
    "1" -> "28" [dir=back tooltip="include"]
    "1" -> "51" [dir=back tooltip="include"]
    "1" -> "52" [dir=back tooltip="include"]
    "1" -> "53" [dir=back tooltip="include"]
    "1" -> "24" [dir=back tooltip="include"]
    "1" -> "8" [dir=back tooltip="include"]
    "1" -> "20" [dir=back tooltip="include"]
    "1" -> "54" [dir=back tooltip="include"]
    "28" -> "29" [dir=back tooltip="include"]
    "28" -> "41" [dir=back tooltip="include"]
    "28" -> "45" [dir=back tooltip="include"]
    "28" -> "46" [dir=back tooltip="include"]
    "28" -> "47" [dir=back tooltip="include"]
    "28" -> "48" [dir=back tooltip="include"]
    "29" -> "30" [dir=back tooltip="include"]
    "29" -> "39" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "30" -> "31" [dir=back tooltip="include"]
    "30" -> "32" [dir=back tooltip="include"]
    "30" -> "33" [dir=back tooltip="include"]
    "30" -> "34" [dir=back tooltip="include"]
    "30" -> "35" [dir=back tooltip="include"]
    "30" -> "36" [dir=back tooltip="include"]
    "30" -> "37" [dir=back tooltip="include"]
    "30" -> "38" [dir=back tooltip="include"]
    "41" -> "30" [dir=back tooltip="include"]
    "41" -> "42" [dir=back tooltip="include"]
    "41" -> "43" [dir=back tooltip="include"]
    "41" -> "39" [dir=back tooltip="include"]
    "41" -> "44" [dir=back tooltip="include"]
    "45" -> "45" [dir=back tooltip="include"]
    "51" -> "28" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
    "5" -> "4" [dir=back tooltip="include"]
    "23" -> "16" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "16" -> "18" [dir=back tooltip="include"]
    "39" -> "14" [dir=back tooltip="include"]
    "39" -> "40" [dir=back tooltip="include"]
    "53" -> "28" [dir=back tooltip="include"]
    "53" -> "14" [dir=back tooltip="include"]
    "53" -> "39" [dir=back tooltip="include"]
    "7" -> "8" [dir=back tooltip="include"]
    "54" -> "8" [dir=back tooltip="include"]
    "54" -> "20" [dir=back tooltip="include"]
    "25" -> "8" [dir=back tooltip="include"]
    "25" -> "20" [dir=back tooltip="include"]
}

Functions

void local_init_mpi(int argc, char **argv)

Initialize MPI.

inline void mpi_report_location(const std::string &msg)

For MPI debugging.

Variables

MPI_Comm MPI_COMM_WORKER
std::ofstream mpi_debug
int myid
int numprocs
int proc_namelen
char processor_name[MPI_MAX_PROCESSOR_NAME]
MPI_Group worker_group
int workers
MPI_Group world_group
file massmodel.H
#include <vector>
#include <memory>
#include <random>
#include <tuple>
#include <Eigen/Eigen>
#include <interp.H>
#include <orbit.H>
#include <QPDistF.H>

Include dependency graph for massmodel.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "20" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "9" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "19" [label="QPDistF.H" tooltip="QPDistF.H"]
    "14" [label="gaussQ.H" tooltip="gaussQ.H"]
    "7" [label="interp.H" tooltip="interp.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/massmodel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/massmodel.H" fillcolor="#BFBFBF"]
    "12" [label="orbit.H" tooltip="orbit.H"]
    "6" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "18" [label="cstdlib" tooltip="cstdlib"]
    "8" [label="deque" tooltip="deque"]
    "13" [label="functional" tooltip="functional"]
    "16" [label="iomanip" tooltip="iomanip"]
    "15" [label="iostream" tooltip="iostream"]
    "10" [label="map" tooltip="map"]
    "3" [label="memory" tooltip="memory"]
    "4" [label="random" tooltip="random"]
    "17" [label="sstream" tooltip="sstream"]
    "11" [label="string" tooltip="string"]
    "5" [label="tuple" tooltip="tuple"]
    "2" [label="vector" tooltip="vector"]
    "20" -> "1" [dir=forward tooltip="include"]
    "9" -> "2" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "11" [dir=forward tooltip="include"]
    "19" -> "16" [dir=forward tooltip="include"]
    "19" -> "11" [dir=forward tooltip="include"]
    "19" -> "10" [dir=forward tooltip="include"]
    "19" -> "1" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "19" -> "12" [dir=forward tooltip="include"]
    "14" -> "15" [dir=forward tooltip="include"]
    "14" -> "16" [dir=forward tooltip="include"]
    "14" -> "17" [dir=forward tooltip="include"]
    "14" -> "18" [dir=forward tooltip="include"]
    "14" -> "11" [dir=forward tooltip="include"]
    "14" -> "2" [dir=forward tooltip="include"]
    "7" -> "6" [dir=forward tooltip="include"]
    "7" -> "2" [dir=forward tooltip="include"]
    "7" -> "8" [dir=forward tooltip="include"]
    "7" -> "9" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "12" [dir=forward tooltip="include"]
    "1" -> "19" [dir=forward tooltip="include"]
    "12" -> "13" [dir=forward tooltip="include"]
    "12" -> "3" [dir=forward tooltip="include"]
    "12" -> "6" [dir=forward tooltip="include"]
    "12" -> "14" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include massmodel.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskWithHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskWithHalo.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/GenPoly.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/GenPoly.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/HunterX.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/HunterX.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QPDistF.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QPDistF.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H"]
    "29" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exponential.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exponential.H"]
    "30" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hernquist_model.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hernquist_model.H"]
    "31" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hunter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hunter.H"]
    "32" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/isothermal.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/isothermal.H"]
    "33" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/king.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/king.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/massmodel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/massmodel.H" fillcolor="#BFBFBF"]
    "34" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/mestel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/mestel.H"]
    "35" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/plummer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/plummer.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H"]
    "36" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/toomre.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/toomre.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "37" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H"]
    "38" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "39" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/externalShock.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/externalShock.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H"]
    "40" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddDisk.H"]
    "41" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddSpheres.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddSpheres.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H"]
    "42" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/massmodel1d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/massmodel1d.H"]
    "43" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/MakeModel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/MakeModel.H"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "5" [dir=back tooltip="include"]
    "3" -> "7" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "9" -> "10" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "14" -> "17" [dir=back tooltip="include"]
    "14" -> "22" [dir=back tooltip="include"]
    "14" -> "16" [dir=back tooltip="include"]
    "14" -> "23" [dir=back tooltip="include"]
    "10" -> "1" [dir=back tooltip="include"]
    "13" -> "14" [dir=back tooltip="include"]
    "13" -> "24" [dir=back tooltip="include"]
    "13" -> "25" [dir=back tooltip="include"]
    "13" -> "26" [dir=back tooltip="include"]
    "13" -> "19" [dir=back tooltip="include"]
    "13" -> "27" [dir=back tooltip="include"]
    "13" -> "28" [dir=back tooltip="include"]
    "29" -> "8" [dir=back tooltip="include"]
    "29" -> "23" [dir=back tooltip="include"]
    "31" -> "12" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
    "1" -> "9" [dir=back tooltip="include"]
    "1" -> "11" [dir=back tooltip="include"]
    "1" -> "12" [dir=back tooltip="include"]
    "1" -> "10" [dir=back tooltip="include"]
    "1" -> "13" [dir=back tooltip="include"]
    "1" -> "29" [dir=back tooltip="include"]
    "1" -> "30" [dir=back tooltip="include"]
    "1" -> "31" [dir=back tooltip="include"]
    "1" -> "32" [dir=back tooltip="include"]
    "1" -> "33" [dir=back tooltip="include"]
    "1" -> "34" [dir=back tooltip="include"]
    "1" -> "35" [dir=back tooltip="include"]
    "1" -> "36" [dir=back tooltip="include"]
    "1" -> "37" [dir=back tooltip="include"]
    "1" -> "38" [dir=back tooltip="include"]
    "1" -> "39" [dir=back tooltip="include"]
    "1" -> "40" [dir=back tooltip="include"]
    "1" -> "41" [dir=back tooltip="include"]
    "1" -> "22" [dir=back tooltip="include"]
    "1" -> "8" [dir=back tooltip="include"]
    "1" -> "23" [dir=back tooltip="include"]
    "1" -> "42" [dir=back tooltip="include"]
    "1" -> "43" [dir=back tooltip="include"]
    "17" -> "18" [dir=back tooltip="include"]
    "18" -> "19" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
    "5" -> "4" [dir=back tooltip="include"]
    "26" -> "19" [dir=back tooltip="include"]
    "19" -> "20" [dir=back tooltip="include"]
    "19" -> "21" [dir=back tooltip="include"]
    "40" -> "8" [dir=back tooltip="include"]
    "40" -> "23" [dir=back tooltip="include"]
    "7" -> "8" [dir=back tooltip="include"]
    "28" -> "8" [dir=back tooltip="include"]
    "28" -> "23" [dir=back tooltip="include"]
}

Typedefs

typedef std::shared_ptr<AxiSymModel> AxiSymModPtr
typedef std::shared_ptr<EmbeddedDiskModel> EmbDiskModPtr
typedef std::shared_ptr<SphericalModelMulti> SphModMultPtr
typedef std::shared_ptr<SphericalModelTable> SphModTblPtr
file mestel.H
#include <massmodel.H>

Include dependency graph for mestel.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "21" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "10" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "20" [label="QPDistF.H" tooltip="QPDistF.H"]
    "15" [label="gaussQ.H" tooltip="gaussQ.H"]
    "8" [label="interp.H" tooltip="interp.H"]
    "2" [label="massmodel.H" tooltip="massmodel.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/mestel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/mestel.H" fillcolor="#BFBFBF"]
    "13" [label="orbit.H" tooltip="orbit.H"]
    "7" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "19" [label="cstdlib" tooltip="cstdlib"]
    "9" [label="deque" tooltip="deque"]
    "14" [label="functional" tooltip="functional"]
    "17" [label="iomanip" tooltip="iomanip"]
    "16" [label="iostream" tooltip="iostream"]
    "11" [label="map" tooltip="map"]
    "4" [label="memory" tooltip="memory"]
    "5" [label="random" tooltip="random"]
    "18" [label="sstream" tooltip="sstream"]
    "12" [label="string" tooltip="string"]
    "6" [label="tuple" tooltip="tuple"]
    "3" [label="vector" tooltip="vector"]
    "21" -> "2" [dir=forward tooltip="include"]
    "10" -> "3" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "12" [dir=forward tooltip="include"]
    "20" -> "17" [dir=forward tooltip="include"]
    "20" -> "12" [dir=forward tooltip="include"]
    "20" -> "11" [dir=forward tooltip="include"]
    "20" -> "2" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "13" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "17" [dir=forward tooltip="include"]
    "15" -> "18" [dir=forward tooltip="include"]
    "15" -> "19" [dir=forward tooltip="include"]
    "15" -> "12" [dir=forward tooltip="include"]
    "15" -> "3" [dir=forward tooltip="include"]
    "8" -> "7" [dir=forward tooltip="include"]
    "8" -> "3" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "10" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "2" -> "7" [dir=forward tooltip="include"]
    "2" -> "8" [dir=forward tooltip="include"]
    "2" -> "13" [dir=forward tooltip="include"]
    "2" -> "20" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "4" [dir=forward tooltip="include"]
    "13" -> "7" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
}
file model2d.H

Enums

enum Models2d

Values:

enumerator mestel
enumerator toomre
enumerator expon
enumerator kalnajs
enumerator hunter
enumerator hunterx

Variables

static string Model2dNames[] = {"Mestel", "Toomre", "Exponential", "Kalnajs", "Hunter", "HunterX"}
file model3d.H

Enums

enum Models3d

Values:

enumerator file
enumerator isothermal
enumerator sing_isothermal
enumerator low_sing_isothermal
enumerator hernquist_model
enumerator gen_polytrope
enumerator plummer

Variables

static std::string Model3dNames[] = {"file", "Isothermal", "SingIsothermal", "LowSingIsothermal", "Hernquist", "GeneralizedPolytrope", "PlummerSphere"}
file models.H
#include <Eigen/Eigen>

Include dependency graph for models.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/models.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/models.H" fillcolor="#BFBFBF"]
    "2" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "1" -> "2" [dir=forward tooltip="include"]
}
file MonotCubicInterpolator.H
#include <vector>
#include <map>
#include <string>

Include dependency graph for MonotCubicInterpolator.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/MonotCubicInterpolator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/MonotCubicInterpolator.H" fillcolor="#BFBFBF"]
    "3" [label="map" tooltip="map"]
    "4" [label="string" tooltip="string"]
    "2" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include MonotCubicInterpolator.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskWithHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskWithHalo.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/GenPoly.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/GenPoly.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/HunterX.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/HunterX.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/MonotCubicInterpolator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/MonotCubicInterpolator.H" fillcolor="#BFBFBF"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QPDistF.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QPDistF.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H"]
    "32" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exponential.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exponential.H"]
    "33" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hernquist_model.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hernquist_model.H"]
    "34" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hunter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hunter.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/interp.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/interp.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/isothermal.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/isothermal.H"]
    "35" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/king.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/king.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/massmodel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/massmodel.H"]
    "36" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/mestel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/mestel.H"]
    "37" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/plummer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/plummer.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H"]
    "38" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/toomre.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/toomre.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "39" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "46" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H"]
    "40" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H"]
    "29" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "41" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/externalShock.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/externalShock.H"]
    "30" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H"]
    "42" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddDisk.H"]
    "43" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddSpheres.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddSpheres.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H"]
    "47" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/EllipForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/EllipForce.H"]
    "48" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/EllipsoidForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/EllipsoidForce.H"]
    "31" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H"]
    "44" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/massmodel1d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/massmodel1d.H"]
    "45" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/MakeModel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/MakeModel.H"]
    "16" -> "17" [dir=back tooltip="include"]
    "16" -> "18" [dir=back tooltip="include"]
    "16" -> "20" [dir=back tooltip="include"]
    "4" -> "5" [dir=back tooltip="include"]
    "22" -> "23" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "6" [dir=back tooltip="include"]
    "3" -> "11" [dir=back tooltip="include"]
    "3" -> "5" [dir=back tooltip="include"]
    "3" -> "12" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "23" -> "14" [dir=back tooltip="include"]
    "26" -> "3" [dir=back tooltip="include"]
    "26" -> "27" [dir=back tooltip="include"]
    "26" -> "28" [dir=back tooltip="include"]
    "26" -> "29" [dir=back tooltip="include"]
    "26" -> "8" [dir=back tooltip="include"]
    "26" -> "30" [dir=back tooltip="include"]
    "26" -> "31" [dir=back tooltip="include"]
    "32" -> "21" [dir=back tooltip="include"]
    "32" -> "12" [dir=back tooltip="include"]
    "34" -> "25" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "13" [dir=back tooltip="include"]
    "2" -> "14" [dir=back tooltip="include"]
    "2" -> "46" [dir=back tooltip="include"]
    "2" -> "40" [dir=back tooltip="include"]
    "2" -> "11" [dir=back tooltip="include"]
    "2" -> "47" [dir=back tooltip="include"]
    "2" -> "48" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "14" -> "16" [dir=back tooltip="include"]
    "14" -> "22" [dir=back tooltip="include"]
    "14" -> "24" [dir=back tooltip="include"]
    "14" -> "25" [dir=back tooltip="include"]
    "14" -> "23" [dir=back tooltip="include"]
    "14" -> "26" [dir=back tooltip="include"]
    "14" -> "32" [dir=back tooltip="include"]
    "14" -> "33" [dir=back tooltip="include"]
    "14" -> "34" [dir=back tooltip="include"]
    "14" -> "13" [dir=back tooltip="include"]
    "14" -> "35" [dir=back tooltip="include"]
    "14" -> "36" [dir=back tooltip="include"]
    "14" -> "37" [dir=back tooltip="include"]
    "14" -> "38" [dir=back tooltip="include"]
    "14" -> "39" [dir=back tooltip="include"]
    "14" -> "40" [dir=back tooltip="include"]
    "14" -> "41" [dir=back tooltip="include"]
    "14" -> "42" [dir=back tooltip="include"]
    "14" -> "43" [dir=back tooltip="include"]
    "14" -> "11" [dir=back tooltip="include"]
    "14" -> "21" [dir=back tooltip="include"]
    "14" -> "12" [dir=back tooltip="include"]
    "14" -> "44" [dir=back tooltip="include"]
    "14" -> "45" [dir=back tooltip="include"]
    "6" -> "7" [dir=back tooltip="include"]
    "7" -> "8" [dir=back tooltip="include"]
    "18" -> "19" [dir=back tooltip="include"]
    "18" -> "17" [dir=back tooltip="include"]
    "29" -> "8" [dir=back tooltip="include"]
    "8" -> "9" [dir=back tooltip="include"]
    "8" -> "10" [dir=back tooltip="include"]
    "42" -> "21" [dir=back tooltip="include"]
    "42" -> "12" [dir=back tooltip="include"]
    "20" -> "21" [dir=back tooltip="include"]
    "31" -> "21" [dir=back tooltip="include"]
    "31" -> "12" [dir=back tooltip="include"]
}
file needle.H
file norminv.H
#include <cmath>

Include dependency graph for norminv.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/norminv.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/norminv.H" fillcolor="#BFBFBF"]
    "2" [label="cmath" tooltip="cmath"]
    "1" -> "2" [dir=forward tooltip="include"]
}

Defines

A1
A2
A3
A4
A5
A6
B1
B2
B3
B4
B5
C1
C2
C3
C4
C5
C6
D1
D2
D3
D4
P_HIGH
P_LOW

Functions

double norminv(double p)
file numerical.H
#include <functional>
#include <Eigen/Eigen>

Include dependency graph for numerical.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/numerical.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/numerical.H" fillcolor="#BFBFBF"]
    "3" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "2" [label="functional" tooltip="functional"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include numerical.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/numerical.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/numerical.H" fillcolor="#BFBFBF"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/phase.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/phase.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
    "1" -> "4" [dir=back tooltip="include"]
}

Defines

DOUBLE(X)
FLOAT(X)
MAX(X, Y)
MIN(X, Y)
Sign(X)
SQR(X)
TINY

Typedefs

using ode_derivs = std::function<void(double, Eigen::VectorXd&, Eigen::VectorXd&)>
using ode_integrator = std::function<void(Eigen::VectorXd&, Eigen::VectorXd&, int, double&, double, double, Eigen::VectorXd&, double&, double&, ode_derivs)>
using ode_rk = std::function<void(Eigen::VectorXd&, Eigen::VectorXd&, int, double, double, Eigen::VectorXd&, ode_derivs)>
using symp_derivs = std::function<void(double, Eigen::VectorXd&, Eigen::VectorXd&, Eigen::VectorXd&)>
using symp_integrator = std::function<void(Eigen::VectorXd&, Eigen::VectorXd&, Eigen::VectorXd&, Eigen::VectorXd&, double, double, symp_derivs)>

Functions

double brent(double, double, double, std::function<double(double)>, double, double&)
void bsstep(Eigen::VectorXd&, Eigen::VectorXd&, int, double&, double, double, Eigen::VectorXd&, double&, double&, ode_derivs)
void constant_step(Eigen::VectorXd&, Eigen::VectorXd&, int, double, ode_derivs, ode_rk)
void gauleg(double, double, Eigen::VectorXd&, Eigen::VectorXd&, int)
void integrate_ode(Eigen::VectorXd&, double, double, double&, double, int, ode_derivs, ode_integrator)
void locate(Eigen::VectorXd&, int, double, int*)
void mnbrak(Eigen::VectorXd&, Eigen::VectorXd&, Eigen::VectorXd&, Eigen::VectorXd&, Eigen::VectorXd&, Eigen::VectorXd&, std::function<double(double)>)
void onestep(Eigen::VectorXd&, double&, int, double&, double, ode_derivs, ode_integrator)
double poly(double, int, double*)
double qadapt(double, double, std::function<double(double)>, double)
double qadapt2d(double, double, double, double, std::function<double(double, double)>, double)
void rk2qc(Eigen::VectorXd&, Eigen::VectorXd&, int, double&, double, double, Eigen::VectorXd&, double&, double&, ode_derivs)
void rk4(Eigen::VectorXd&, Eigen::VectorXd&, int, double, double, Eigen::VectorXd&, ode_derivs)
void rkqc(Eigen::VectorXd&, Eigen::VectorXd&, int, double&, double, double, Eigen::VectorXd&, double&, double&, ode_derivs)
double rtbis(std::function<double(double)>, double, double, double)
double rtsafe(std::function<void(double, double&, double&)>, double, double, double)
void sia4(Eigen::VectorXd&, Eigen::VectorXd&, Eigen::VectorXd&, Eigen::VectorXd&, double, double, symp_derivs)
int zbrac(std::function<double(double)>, Eigen::VectorXd&, Eigen::VectorXd&)
double zbrent(std::function<double(double)>, double, double, double)

Variables

const double Pi = 3.141592653589793
file orbit.H
#include <functional>
#include <memory>
#include <Eigen/Eigen>
#include <gaussQ.H>

Include dependency graph for orbit.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="gaussQ.H" tooltip="gaussQ.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/orbit.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/orbit.H" fillcolor="#BFBFBF"]
    "4" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "9" [label="cstdlib" tooltip="cstdlib"]
    "2" [label="functional" tooltip="functional"]
    "7" [label="iomanip" tooltip="iomanip"]
    "6" [label="iostream" tooltip="iostream"]
    "3" [label="memory" tooltip="memory"]
    "8" [label="sstream" tooltip="sstream"]
    "10" [label="string" tooltip="string"]
    "11" [label="vector" tooltip="vector"]
    "5" -> "6" [dir=forward tooltip="include"]
    "5" -> "7" [dir=forward tooltip="include"]
    "5" -> "8" [dir=forward tooltip="include"]
    "5" -> "9" [dir=forward tooltip="include"]
    "5" -> "10" [dir=forward tooltip="include"]
    "5" -> "11" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include orbit.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskWithHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskWithHalo.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/GenPoly.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/GenPoly.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/HunterX.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/HunterX.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QPDistF.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QPDistF.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H"]
    "30" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exponential.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exponential.H"]
    "31" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hernquist_model.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hernquist_model.H"]
    "32" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hunter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hunter.H"]
    "33" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/isothermal.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/isothermal.H"]
    "34" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/king.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/king.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/massmodel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/massmodel.H"]
    "35" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/mestel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/mestel.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/orbit.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/orbit.H" fillcolor="#BFBFBF"]
    "36" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/plummer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/plummer.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H"]
    "37" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/toomre.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/toomre.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "38" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H"]
    "39" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "40" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/externalShock.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/externalShock.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H"]
    "41" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddDisk.H"]
    "42" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddSpheres.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddSpheres.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H"]
    "29" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H"]
    "43" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/massmodel1d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/massmodel1d.H"]
    "44" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/MakeModel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/MakeModel.H"]
    "5" -> "6" [dir=back tooltip="include"]
    "5" -> "7" [dir=back tooltip="include"]
    "5" -> "9" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "11" -> "2" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "15" -> "18" [dir=back tooltip="include"]
    "15" -> "23" [dir=back tooltip="include"]
    "15" -> "17" [dir=back tooltip="include"]
    "15" -> "24" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "14" -> "25" [dir=back tooltip="include"]
    "14" -> "26" [dir=back tooltip="include"]
    "14" -> "27" [dir=back tooltip="include"]
    "14" -> "20" [dir=back tooltip="include"]
    "14" -> "28" [dir=back tooltip="include"]
    "14" -> "29" [dir=back tooltip="include"]
    "30" -> "10" [dir=back tooltip="include"]
    "30" -> "24" [dir=back tooltip="include"]
    "32" -> "13" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "5" [dir=back tooltip="include"]
    "3" -> "11" [dir=back tooltip="include"]
    "3" -> "12" [dir=back tooltip="include"]
    "3" -> "13" [dir=back tooltip="include"]
    "3" -> "2" [dir=back tooltip="include"]
    "3" -> "14" [dir=back tooltip="include"]
    "3" -> "30" [dir=back tooltip="include"]
    "3" -> "31" [dir=back tooltip="include"]
    "3" -> "32" [dir=back tooltip="include"]
    "3" -> "33" [dir=back tooltip="include"]
    "3" -> "34" [dir=back tooltip="include"]
    "3" -> "35" [dir=back tooltip="include"]
    "3" -> "36" [dir=back tooltip="include"]
    "3" -> "37" [dir=back tooltip="include"]
    "3" -> "38" [dir=back tooltip="include"]
    "3" -> "39" [dir=back tooltip="include"]
    "3" -> "40" [dir=back tooltip="include"]
    "3" -> "41" [dir=back tooltip="include"]
    "3" -> "42" [dir=back tooltip="include"]
    "3" -> "23" [dir=back tooltip="include"]
    "3" -> "10" [dir=back tooltip="include"]
    "3" -> "24" [dir=back tooltip="include"]
    "3" -> "43" [dir=back tooltip="include"]
    "3" -> "44" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
    "1" -> "40" [dir=back tooltip="include"]
    "18" -> "19" [dir=back tooltip="include"]
    "19" -> "20" [dir=back tooltip="include"]
    "7" -> "8" [dir=back tooltip="include"]
    "7" -> "6" [dir=back tooltip="include"]
    "27" -> "20" [dir=back tooltip="include"]
    "20" -> "21" [dir=back tooltip="include"]
    "20" -> "22" [dir=back tooltip="include"]
    "41" -> "10" [dir=back tooltip="include"]
    "41" -> "24" [dir=back tooltip="include"]
    "9" -> "10" [dir=back tooltip="include"]
    "29" -> "10" [dir=back tooltip="include"]
    "29" -> "24" [dir=back tooltip="include"]
}
file OrthoFunction.H
#include <functional>
#include <memory>
#include <Eigen/Eigen>
#include <gaussQ.H>

Include dependency graph for OrthoFunction.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/OrthoFunction.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/OrthoFunction.H" fillcolor="#BFBFBF"]
    "5" [label="gaussQ.H" tooltip="gaussQ.H"]
    "4" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "9" [label="cstdlib" tooltip="cstdlib"]
    "2" [label="functional" tooltip="functional"]
    "7" [label="iomanip" tooltip="iomanip"]
    "6" [label="iostream" tooltip="iostream"]
    "3" [label="memory" tooltip="memory"]
    "8" [label="sstream" tooltip="sstream"]
    "10" [label="string" tooltip="string"]
    "11" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "5" -> "6" [dir=forward tooltip="include"]
    "5" -> "7" [dir=forward tooltip="include"]
    "5" -> "8" [dir=forward tooltip="include"]
    "5" -> "9" [dir=forward tooltip="include"]
    "5" -> "10" [dir=forward tooltip="include"]
    "5" -> "11" [dir=forward tooltip="include"]
}
file OrthoPoly.H
#include <cfloat>
#include <cmath>
#include <Eigen/Eigen>

Include dependency graph for OrthoPoly.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/OrthoPoly.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/OrthoPoly.H" fillcolor="#BFBFBF"]
    "4" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "2" [label="cfloat" tooltip="cfloat"]
    "3" [label="cmath" tooltip="cmath"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
}
file P2Quantile.H
#include <array>

Include dependency graph for P2Quantile.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/P2Quantile.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/P2Quantile.H" fillcolor="#BFBFBF"]
    "2" [label="array" tooltip="array"]
    "1" -> "2" [dir=forward tooltip="include"]
}
file parseVersionString.H
#include <vector>
#include <string>

Include dependency graph for parseVersionString.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/parseVersionString.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/parseVersionString.H" fillcolor="#BFBFBF"]
    "3" [label="string" tooltip="string"]
    "2" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
}

Functions

std::vector<int> parseVersionString(const std::string &version_str)
file Particle.H
#include <unordered_map>
#include <vector>
#include <memory>

Include dependency graph for Particle.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Particle.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Particle.H" fillcolor="#BFBFBF"]
    "4" [label="memory" tooltip="memory"]
    "2" [label="unordered_map" tooltip="unordered_map"]
    "3" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include Particle.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Particle.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Particle.H" fillcolor="#BFBFBF"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ParticleReader.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ParticleReader.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H"]
    "3" -> "4" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "5" [dir=back tooltip="include"]
    "2" -> "10" [dir=back tooltip="include"]
    "2" -> "4" [dir=back tooltip="include"]
    "2" -> "11" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "12" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
    "6" -> "7" [dir=back tooltip="include"]
    "7" -> "8" [dir=back tooltip="include"]
    "7" -> "9" [dir=back tooltip="include"]
}

Typedefs

typedef std::unordered_map<unsigned long, PartPtr> PartMap
typedef std::unordered_map<unsignedlong, PartPtr>::iterator PartMapItr
typedef std::shared_ptr<Particle> PartPtr
typedef std::pair<unsigned long, PartPtr> PMapType

Functions

std::ostream &operator<<(std::ostream &os, const PMapType &p)
file Particle.h
file ParticleReader.H
#include <unordered_map>
#include <stdexcept>
#include <algorithm>
#include <iostream>
#include <fstream>
#include <iomanip>
#include <vector>
#include <memory>
#include <string>
#include <cmath>
#include <list>
#include <mpi.h>
#include <config_exp.h>
#include <StringTok.H>
#include <header.H>
#include <Particle.H>
#include <gadget.H>
#include <tipsy.H>

Include dependency graph for ParticleReader.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "19" [label="Particle.H" tooltip="Particle.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ParticleReader.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ParticleReader.H" fillcolor="#BFBFBF"]
    "15" [label="StringTok.H" tooltip="StringTok.H"]
    "20" [label="gadget.H" tooltip="gadget.H"]
    "16" [label="header.H" tooltip="header.H"]
    "18" [label="localmpi.H" tooltip="localmpi.H"]
    "21" [label="tipsy.H" tooltip="tipsy.H"]
    "4" [label="algorithm" tooltip="algorithm"]
    "11" [label="cmath" tooltip="cmath"]
    "14" [label="config_exp.h" tooltip="config_exp.h"]
    "6" [label="fstream" tooltip="fstream"]
    "7" [label="iomanip" tooltip="iomanip"]
    "5" [label="iostream" tooltip="iostream"]
    "12" [label="list" tooltip="list"]
    "9" [label="memory" tooltip="memory"]
    "13" [label="mpi.h" tooltip="mpi.h"]
    "17" [label="sstream" tooltip="sstream"]
    "3" [label="stdexcept" tooltip="stdexcept"]
    "10" [label="string" tooltip="string"]
    "2" [label="unordered_map" tooltip="unordered_map"]
    "8" [label="vector" tooltip="vector"]
    "19" -> "2" [dir=forward tooltip="include"]
    "19" -> "8" [dir=forward tooltip="include"]
    "19" -> "9" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "1" -> "10" [dir=forward tooltip="include"]
    "1" -> "11" [dir=forward tooltip="include"]
    "1" -> "12" [dir=forward tooltip="include"]
    "1" -> "13" [dir=forward tooltip="include"]
    "1" -> "14" [dir=forward tooltip="include"]
    "1" -> "15" [dir=forward tooltip="include"]
    "1" -> "16" [dir=forward tooltip="include"]
    "1" -> "19" [dir=forward tooltip="include"]
    "1" -> "20" [dir=forward tooltip="include"]
    "1" -> "21" [dir=forward tooltip="include"]
    "16" -> "5" [dir=forward tooltip="include"]
    "16" -> "7" [dir=forward tooltip="include"]
    "16" -> "17" [dir=forward tooltip="include"]
    "16" -> "9" [dir=forward tooltip="include"]
    "16" -> "18" [dir=forward tooltip="include"]
    "18" -> "13" [dir=forward tooltip="include"]
    "18" -> "5" [dir=forward tooltip="include"]
    "18" -> "6" [dir=forward tooltip="include"]
    "18" -> "7" [dir=forward tooltip="include"]
    "18" -> "10" [dir=forward tooltip="include"]
}
file permutation.H
#include <algorithm>
#include <numeric>
#include <random>

Include dependency graph for permutation.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/permutation.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/permutation.H" fillcolor="#BFBFBF"]
    "2" [label="algorithm" tooltip="algorithm"]
    "3" [label="numeric" tooltip="numeric"]
    "4" [label="random" tooltip="random"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
}
file phase.H
#include <ostream>
#include <vector>
#include <Eigen/Eigen>
#include <numerical.H>

Include dependency graph for phase.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "5" [label="numerical.H" tooltip="numerical.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/phase.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/phase.H" fillcolor="#BFBFBF"]
    "4" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "6" [label="functional" tooltip="functional"]
    "2" [label="ostream" tooltip="ostream"]
    "3" [label="vector" tooltip="vector"]
    "5" -> "6" [dir=forward tooltip="include"]
    "5" -> "4" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
}

Typedefs

typedef Eigen::Vector3d (*force_func_ptr)(double, Eigen::Vector3d&, Eigen::Vector3d&)
typedef int (*freezing_function)(Phase&)
typedef double (*pot_func_ptr)(double, Eigen::Vector3d&)

Functions

double epicyclic_kappa(double)
void forward_interp(double, double, double, double, double, double, double, double&, double&)
double inverse_interp_zero(double, double, double, double, double, double)
void Newton(double, Eigen::VectorXd&, Eigen::VectorXd&)
double Oort_A(double)
double Oort_B(double)
double v_circ(double)
double vertical_kappa(double)
Eigen::Matrix3d z_Rotation(double)
file plummer.H
#include <cmath>
#include <massmodel.H>

Include dependency graph for plummer.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "22" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "11" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "21" [label="QPDistF.H" tooltip="QPDistF.H"]
    "16" [label="gaussQ.H" tooltip="gaussQ.H"]
    "9" [label="interp.H" tooltip="interp.H"]
    "3" [label="massmodel.H" tooltip="massmodel.H"]
    "14" [label="orbit.H" tooltip="orbit.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/plummer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/plummer.H" fillcolor="#BFBFBF"]
    "8" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "2" [label="cmath" tooltip="cmath"]
    "20" [label="cstdlib" tooltip="cstdlib"]
    "10" [label="deque" tooltip="deque"]
    "15" [label="functional" tooltip="functional"]
    "18" [label="iomanip" tooltip="iomanip"]
    "17" [label="iostream" tooltip="iostream"]
    "12" [label="map" tooltip="map"]
    "5" [label="memory" tooltip="memory"]
    "6" [label="random" tooltip="random"]
    "19" [label="sstream" tooltip="sstream"]
    "13" [label="string" tooltip="string"]
    "7" [label="tuple" tooltip="tuple"]
    "4" [label="vector" tooltip="vector"]
    "22" -> "3" [dir=forward tooltip="include"]
    "11" -> "4" [dir=forward tooltip="include"]
    "11" -> "12" [dir=forward tooltip="include"]
    "11" -> "13" [dir=forward tooltip="include"]
    "21" -> "18" [dir=forward tooltip="include"]
    "21" -> "13" [dir=forward tooltip="include"]
    "21" -> "12" [dir=forward tooltip="include"]
    "21" -> "3" [dir=forward tooltip="include"]
    "21" -> "22" [dir=forward tooltip="include"]
    "21" -> "14" [dir=forward tooltip="include"]
    "16" -> "17" [dir=forward tooltip="include"]
    "16" -> "18" [dir=forward tooltip="include"]
    "16" -> "19" [dir=forward tooltip="include"]
    "16" -> "20" [dir=forward tooltip="include"]
    "16" -> "13" [dir=forward tooltip="include"]
    "16" -> "4" [dir=forward tooltip="include"]
    "9" -> "8" [dir=forward tooltip="include"]
    "9" -> "4" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "11" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "5" [dir=forward tooltip="include"]
    "3" -> "6" [dir=forward tooltip="include"]
    "3" -> "7" [dir=forward tooltip="include"]
    "3" -> "8" [dir=forward tooltip="include"]
    "3" -> "9" [dir=forward tooltip="include"]
    "3" -> "14" [dir=forward tooltip="include"]
    "3" -> "21" [dir=forward tooltip="include"]
    "14" -> "15" [dir=forward tooltip="include"]
    "14" -> "5" [dir=forward tooltip="include"]
    "14" -> "8" [dir=forward tooltip="include"]
    "14" -> "16" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
}
file poly.H
#include <iostream>
#include <fstream>
#include <Eigen/Eigen>

Include dependency graph for poly.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/poly.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/poly.H" fillcolor="#BFBFBF"]
    "4" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "3" [label="fstream" tooltip="fstream"]
    "2" [label="iostream" tooltip="iostream"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include poly.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/cpoly.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/cpoly.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/poly.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/poly.H" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=back tooltip="include"]
}

Functions

void bomb_Poly(const char*)
void bomb_Poly_operation(const char*)
file PotRZ.H
#include <QDHT.H>
#include <cmath>

Include dependency graph for PotRZ.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "9" [label="EXPmath.H" tooltip="EXPmath.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/PotRZ.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/PotRZ.H" fillcolor="#BFBFBF"]
    "2" [label="QDHT.H" tooltip="QDHT.H"]
    "8" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "4" [label="algorithm" tooltip="algorithm"]
    "5" [label="chrono" tooltip="chrono"]
    "7" [label="cmath" tooltip="cmath"]
    "3" [label="functional" tooltip="functional"]
    "6" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "2" -> "7" [dir=forward tooltip="include"]
    "2" -> "8" [dir=forward tooltip="include"]
    "2" -> "9" [dir=forward tooltip="include"]
}
file Progress.H
#include <iostream>
#include <string>

Include dependency graph for Progress.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Progress.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Progress.H" fillcolor="#BFBFBF"]
    "2" [label="iostream" tooltip="iostream"]
    "3" [label="string" tooltip="string"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
}
file PseudoAccel.H
#include <deque>
#include <array>
#include <Eigen/Eigen>
#include <QuadLS.H>

Include dependency graph for PseudoAccel.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/PseudoAccel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/PseudoAccel.H" fillcolor="#BFBFBF"]
    "5" [label="QuadLS.H" tooltip="QuadLS.H"]
    "4" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "3" [label="array" tooltip="array"]
    "2" [label="deque" tooltip="deque"]
    "7" [label="iomanip" tooltip="iomanip"]
    "6" [label="iostream" tooltip="iostream"]
    "8" [label="tuple" tooltip="tuple"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "5" -> "6" [dir=forward tooltip="include"]
    "5" -> "7" [dir=forward tooltip="include"]
    "5" -> "8" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include PseudoAccel.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/PseudoAccel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/PseudoAccel.H" fillcolor="#BFBFBF"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Orient.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Orient.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "21" [dir=back tooltip="include"]
    "3" -> "25" [dir=back tooltip="include"]
    "3" -> "26" [dir=back tooltip="include"]
    "3" -> "27" [dir=back tooltip="include"]
    "3" -> "28" [dir=back tooltip="include"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "14" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
    "5" -> "7" [dir=back tooltip="include"]
    "5" -> "8" [dir=back tooltip="include"]
    "5" -> "9" [dir=back tooltip="include"]
    "5" -> "10" [dir=back tooltip="include"]
    "5" -> "11" [dir=back tooltip="include"]
    "5" -> "12" [dir=back tooltip="include"]
    "5" -> "13" [dir=back tooltip="include"]
    "21" -> "5" [dir=back tooltip="include"]
    "21" -> "22" [dir=back tooltip="include"]
    "21" -> "23" [dir=back tooltip="include"]
    "21" -> "14" [dir=back tooltip="include"]
    "21" -> "24" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "16" [dir=back tooltip="include"]
    "25" -> "25" [dir=back tooltip="include"]
    "17" -> "18" [dir=back tooltip="include"]
    "17" -> "19" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "14" -> "20" [dir=back tooltip="include"]
}
file QDHT.H
#include <functional>
#include <algorithm>
#include <chrono>
#include <vector>
#include <cmath>
#include <Eigen/Eigen>
#include <EXPmath.H>

Include dependency graph for QDHT.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "8" [label="EXPmath.H" tooltip="EXPmath.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QDHT.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QDHT.H" fillcolor="#BFBFBF"]
    "7" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "3" [label="algorithm" tooltip="algorithm"]
    "4" [label="chrono" tooltip="chrono"]
    "6" [label="cmath" tooltip="cmath"]
    "2" [label="functional" tooltip="functional"]
    "5" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include QDHT.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/PotRZ.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/PotRZ.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QDHT.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QDHT.H" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=back tooltip="include"]
}
file QPDistF.H
#include <iomanip>
#include <string>
#include <map>
#include <massmodel.H>
#include <DiskWithHalo.H>
#include <orbit.H>

Include dependency graph for QPDistF.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "20" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "13" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QPDistF.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QPDistF.H" fillcolor="#BFBFBF"]
    "16" [label="gaussQ.H" tooltip="gaussQ.H"]
    "11" [label="interp.H" tooltip="interp.H"]
    "5" [label="massmodel.H" tooltip="massmodel.H"]
    "14" [label="orbit.H" tooltip="orbit.H"]
    "10" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "19" [label="cstdlib" tooltip="cstdlib"]
    "12" [label="deque" tooltip="deque"]
    "15" [label="functional" tooltip="functional"]
    "2" [label="iomanip" tooltip="iomanip"]
    "17" [label="iostream" tooltip="iostream"]
    "4" [label="map" tooltip="map"]
    "7" [label="memory" tooltip="memory"]
    "8" [label="random" tooltip="random"]
    "18" [label="sstream" tooltip="sstream"]
    "3" [label="string" tooltip="string"]
    "9" [label="tuple" tooltip="tuple"]
    "6" [label="vector" tooltip="vector"]
    "20" -> "5" [dir=forward tooltip="include"]
    "13" -> "6" [dir=forward tooltip="include"]
    "13" -> "4" [dir=forward tooltip="include"]
    "13" -> "3" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "20" [dir=forward tooltip="include"]
    "1" -> "14" [dir=forward tooltip="include"]
    "16" -> "17" [dir=forward tooltip="include"]
    "16" -> "2" [dir=forward tooltip="include"]
    "16" -> "18" [dir=forward tooltip="include"]
    "16" -> "19" [dir=forward tooltip="include"]
    "16" -> "3" [dir=forward tooltip="include"]
    "16" -> "6" [dir=forward tooltip="include"]
    "11" -> "10" [dir=forward tooltip="include"]
    "11" -> "6" [dir=forward tooltip="include"]
    "11" -> "12" [dir=forward tooltip="include"]
    "11" -> "13" [dir=forward tooltip="include"]
    "5" -> "6" [dir=forward tooltip="include"]
    "5" -> "7" [dir=forward tooltip="include"]
    "5" -> "8" [dir=forward tooltip="include"]
    "5" -> "9" [dir=forward tooltip="include"]
    "5" -> "10" [dir=forward tooltip="include"]
    "5" -> "11" [dir=forward tooltip="include"]
    "5" -> "14" [dir=forward tooltip="include"]
    "5" -> "1" [dir=forward tooltip="include"]
    "14" -> "15" [dir=forward tooltip="include"]
    "14" -> "7" [dir=forward tooltip="include"]
    "14" -> "10" [dir=forward tooltip="include"]
    "14" -> "16" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include QPDistF.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCube.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BiorthCyl.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskWithHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskWithHalo.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/GenPoly.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/GenPoly.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/HunterX.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/HunterX.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QPDistF.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QPDistF.H" fillcolor="#BFBFBF"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H"]
    "29" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exponential.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/exponential.H"]
    "30" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hernquist_model.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hernquist_model.H"]
    "31" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hunter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/hunter.H"]
    "32" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/isothermal.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/isothermal.H"]
    "33" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/king.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/king.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/massmodel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/massmodel.H"]
    "34" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/mestel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/mestel.H"]
    "35" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/plummer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/plummer.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H"]
    "36" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/toomre.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/toomre.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "37" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H"]
    "38" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "39" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/externalShock.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/externalShock.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H"]
    "40" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddDisk.H"]
    "41" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddSpheres.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddSpheres.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H"]
    "42" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/massmodel1d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/massmodel1d.H"]
    "43" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/MakeModel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/MakeModel.H"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "6" [dir=back tooltip="include"]
    "4" -> "8" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "10" -> "1" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "14" -> "17" [dir=back tooltip="include"]
    "14" -> "22" [dir=back tooltip="include"]
    "14" -> "16" [dir=back tooltip="include"]
    "14" -> "23" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "13" -> "14" [dir=back tooltip="include"]
    "13" -> "24" [dir=back tooltip="include"]
    "13" -> "25" [dir=back tooltip="include"]
    "13" -> "26" [dir=back tooltip="include"]
    "13" -> "19" [dir=back tooltip="include"]
    "13" -> "27" [dir=back tooltip="include"]
    "13" -> "28" [dir=back tooltip="include"]
    "29" -> "9" [dir=back tooltip="include"]
    "29" -> "23" [dir=back tooltip="include"]
    "31" -> "12" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "4" [dir=back tooltip="include"]
    "2" -> "10" [dir=back tooltip="include"]
    "2" -> "11" [dir=back tooltip="include"]
    "2" -> "12" [dir=back tooltip="include"]
    "2" -> "1" [dir=back tooltip="include"]
    "2" -> "13" [dir=back tooltip="include"]
    "2" -> "29" [dir=back tooltip="include"]
    "2" -> "30" [dir=back tooltip="include"]
    "2" -> "31" [dir=back tooltip="include"]
    "2" -> "32" [dir=back tooltip="include"]
    "2" -> "33" [dir=back tooltip="include"]
    "2" -> "34" [dir=back tooltip="include"]
    "2" -> "35" [dir=back tooltip="include"]
    "2" -> "36" [dir=back tooltip="include"]
    "2" -> "37" [dir=back tooltip="include"]
    "2" -> "38" [dir=back tooltip="include"]
    "2" -> "39" [dir=back tooltip="include"]
    "2" -> "40" [dir=back tooltip="include"]
    "2" -> "41" [dir=back tooltip="include"]
    "2" -> "22" [dir=back tooltip="include"]
    "2" -> "9" [dir=back tooltip="include"]
    "2" -> "23" [dir=back tooltip="include"]
    "2" -> "42" [dir=back tooltip="include"]
    "2" -> "43" [dir=back tooltip="include"]
    "17" -> "18" [dir=back tooltip="include"]
    "18" -> "19" [dir=back tooltip="include"]
    "6" -> "7" [dir=back tooltip="include"]
    "6" -> "5" [dir=back tooltip="include"]
    "26" -> "19" [dir=back tooltip="include"]
    "19" -> "20" [dir=back tooltip="include"]
    "19" -> "21" [dir=back tooltip="include"]
    "40" -> "9" [dir=back tooltip="include"]
    "40" -> "23" [dir=back tooltip="include"]
    "8" -> "9" [dir=back tooltip="include"]
    "28" -> "9" [dir=back tooltip="include"]
    "28" -> "23" [dir=back tooltip="include"]
}
file QuadLS.H
#include <iostream>
#include <iomanip>
#include <tuple>

Include dependency graph for QuadLS.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QuadLS.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QuadLS.H" fillcolor="#BFBFBF"]
    "3" [label="iomanip" tooltip="iomanip"]
    "2" [label="iostream" tooltip="iostream"]
    "4" [label="tuple" tooltip="tuple"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include QuadLS.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/PseudoAccel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/PseudoAccel.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QuadLS.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/QuadLS.H" fillcolor="#BFBFBF"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Orient.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Orient.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "29" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "2" -> "3" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "22" [dir=back tooltip="include"]
    "4" -> "26" [dir=back tooltip="include"]
    "4" -> "27" [dir=back tooltip="include"]
    "4" -> "28" [dir=back tooltip="include"]
    "4" -> "29" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
    "5" -> "15" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "17" -> "18" [dir=back tooltip="include"]
    "6" -> "7" [dir=back tooltip="include"]
    "6" -> "8" [dir=back tooltip="include"]
    "6" -> "9" [dir=back tooltip="include"]
    "6" -> "10" [dir=back tooltip="include"]
    "6" -> "11" [dir=back tooltip="include"]
    "6" -> "12" [dir=back tooltip="include"]
    "6" -> "13" [dir=back tooltip="include"]
    "6" -> "14" [dir=back tooltip="include"]
    "22" -> "6" [dir=back tooltip="include"]
    "22" -> "23" [dir=back tooltip="include"]
    "22" -> "24" [dir=back tooltip="include"]
    "22" -> "15" [dir=back tooltip="include"]
    "22" -> "25" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "17" [dir=back tooltip="include"]
    "26" -> "26" [dir=back tooltip="include"]
    "18" -> "19" [dir=back tooltip="include"]
    "18" -> "20" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "15" -> "21" [dir=back tooltip="include"]
}
file RK4.H
#include <Eigen/Eigen>

Include dependency graph for RK4.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/RK4.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/RK4.H" fillcolor="#BFBFBF"]
    "2" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "1" -> "2" [dir=forward tooltip="include"]
}
file rotcurv.H

Functions

double epicyclic_kappa(double)
double omega_circ(double)
double Oort_A(double)
double Oort_B(double)
double v_circ(double)
double vertical_kappa(double)
file RunningTime.H
#include <deque>
#include <Timer.H>

Include dependency graph for RunningTime.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/RunningTime.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/RunningTime.H" fillcolor="#BFBFBF"]
    "3" [label="Timer.H" tooltip="Timer.H"]
    "6" [label="chrono" tooltip="chrono"]
    "5" [label="cstdlib" tooltip="cstdlib"]
    "2" [label="deque" tooltip="deque"]
    "4" [label="iostream" tooltip="iostream"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "5" [dir=forward tooltip="include"]
    "3" -> "6" [dir=forward tooltip="include"]
}
file SimAnn.H
#include <functional>
#include <iostream>
#include <iomanip>
#include <fstream>
#include <random>
#include <limits>
#include <cmath>

Include dependency graph for SimAnn.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SimAnn.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SimAnn.H" fillcolor="#BFBFBF"]
    "8" [label="cmath" tooltip="cmath"]
    "5" [label="fstream" tooltip="fstream"]
    "2" [label="functional" tooltip="functional"]
    "4" [label="iomanip" tooltip="iomanip"]
    "3" [label="iostream" tooltip="iostream"]
    "7" [label="limits" tooltip="limits"]
    "6" [label="random" tooltip="random"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
}

Defines

SIM_ANN_HPP_
file SLGridMP2.H
#include <math.h>
#include <iostream>
#include <fstream>
#include <string>
#include <mpi.h>
#include <localmpi.H>
#include <config_exp.h>
#include <massmodel.H>
#include <sltableMP2.H>
#include <yaml-cpp/yaml.h>
#include <libvars.H>

Include dependency graph for SLGridMP2.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "26" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "18" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "25" [label="QPDistF.H" tooltip="QPDistF.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H" fillcolor="#BFBFBF"]
    "22" [label="gaussQ.H" tooltip="gaussQ.H"]
    "16" [label="interp.H" tooltip="interp.H"]
    "29" [label="libvars.H" tooltip="libvars.H"]
    "7" [label="localmpi.H" tooltip="localmpi.H"]
    "10" [label="massmodel.H" tooltip="massmodel.H"]
    "20" [label="orbit.H" tooltip="orbit.H"]
    "27" [label="sltableMP2.H" tooltip="sltableMP2.H"]
    "15" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "9" [label="config_exp.h" tooltip="config_exp.h"]
    "24" [label="cstdlib" tooltip="cstdlib"]
    "17" [label="deque" tooltip="deque"]
    "4" [label="fstream" tooltip="fstream"]
    "21" [label="functional" tooltip="functional"]
    "8" [label="iomanip" tooltip="iomanip"]
    "3" [label="iostream" tooltip="iostream"]
    "19" [label="map" tooltip="map"]
    "2" [label="math.h" tooltip="math.h"]
    "12" [label="memory" tooltip="memory"]
    "6" [label="mpi.h" tooltip="mpi.h"]
    "13" [label="random" tooltip="random"]
    "23" [label="sstream" tooltip="sstream"]
    "5" [label="string" tooltip="string"]
    "14" [label="tuple" tooltip="tuple"]
    "11" [label="vector" tooltip="vector"]
    "28" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "26" -> "10" [dir=forward tooltip="include"]
    "18" -> "11" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "5" [dir=forward tooltip="include"]
    "25" -> "8" [dir=forward tooltip="include"]
    "25" -> "5" [dir=forward tooltip="include"]
    "25" -> "19" [dir=forward tooltip="include"]
    "25" -> "10" [dir=forward tooltip="include"]
    "25" -> "26" [dir=forward tooltip="include"]
    "25" -> "20" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "1" -> "10" [dir=forward tooltip="include"]
    "1" -> "27" [dir=forward tooltip="include"]
    "1" -> "28" [dir=forward tooltip="include"]
    "1" -> "29" [dir=forward tooltip="include"]
    "22" -> "3" [dir=forward tooltip="include"]
    "22" -> "8" [dir=forward tooltip="include"]
    "22" -> "23" [dir=forward tooltip="include"]
    "22" -> "24" [dir=forward tooltip="include"]
    "22" -> "5" [dir=forward tooltip="include"]
    "22" -> "11" [dir=forward tooltip="include"]
    "16" -> "15" [dir=forward tooltip="include"]
    "16" -> "11" [dir=forward tooltip="include"]
    "16" -> "17" [dir=forward tooltip="include"]
    "16" -> "18" [dir=forward tooltip="include"]
    "29" -> "13" [dir=forward tooltip="include"]
    "29" -> "6" [dir=forward tooltip="include"]
    "7" -> "6" [dir=forward tooltip="include"]
    "7" -> "3" [dir=forward tooltip="include"]
    "7" -> "4" [dir=forward tooltip="include"]
    "7" -> "8" [dir=forward tooltip="include"]
    "7" -> "5" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "12" [dir=forward tooltip="include"]
    "10" -> "13" [dir=forward tooltip="include"]
    "10" -> "14" [dir=forward tooltip="include"]
    "10" -> "15" [dir=forward tooltip="include"]
    "10" -> "16" [dir=forward tooltip="include"]
    "10" -> "20" [dir=forward tooltip="include"]
    "10" -> "25" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "12" [dir=forward tooltip="include"]
    "20" -> "15" [dir=forward tooltip="include"]
    "20" -> "22" [dir=forward tooltip="include"]
    "27" -> "15" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include SLGridMP2.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H" fillcolor="#BFBFBF"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H"]
    "3" -> "4" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "5" [dir=back tooltip="include"]
    "2" -> "10" [dir=back tooltip="include"]
    "2" -> "4" [dir=back tooltip="include"]
    "2" -> "11" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "12" [dir=back tooltip="include"]
    "1" -> "13" [dir=back tooltip="include"]
    "1" -> "14" [dir=back tooltip="include"]
    "1" -> "7" [dir=back tooltip="include"]
    "1" -> "15" [dir=back tooltip="include"]
    "1" -> "16" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
    "6" -> "7" [dir=back tooltip="include"]
    "14" -> "7" [dir=back tooltip="include"]
    "7" -> "8" [dir=back tooltip="include"]
    "7" -> "9" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "16" -> "11" [dir=back tooltip="include"]
}
file sltableMP2.H
#include <Eigen/Eigen>

Include dependency graph for sltableMP2.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sltableMP2.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sltableMP2.H" fillcolor="#BFBFBF"]
    "2" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "1" -> "2" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include sltableMP2.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/SLGridMP2.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sltableMP2.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sltableMP2.H" fillcolor="#BFBFBF"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H"]
    "4" -> "5" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "6" [dir=back tooltip="include"]
    "3" -> "11" [dir=back tooltip="include"]
    "3" -> "5" [dir=back tooltip="include"]
    "3" -> "12" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "13" [dir=back tooltip="include"]
    "2" -> "14" [dir=back tooltip="include"]
    "2" -> "15" [dir=back tooltip="include"]
    "2" -> "8" [dir=back tooltip="include"]
    "2" -> "16" [dir=back tooltip="include"]
    "2" -> "17" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "6" -> "7" [dir=back tooltip="include"]
    "7" -> "8" [dir=back tooltip="include"]
    "15" -> "8" [dir=back tooltip="include"]
    "8" -> "9" [dir=back tooltip="include"]
    "8" -> "10" [dir=back tooltip="include"]
    "17" -> "18" [dir=back tooltip="include"]
    "17" -> "12" [dir=back tooltip="include"]
}
file Species.H
#include <map>
#include <set>
#include <vector>

Include dependency graph for Species.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Species.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Species.H" fillcolor="#BFBFBF"]
    "2" [label="map" tooltip="map"]
    "3" [label="set" tooltip="set"]
    "4" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include Species.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Species.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Species.H" fillcolor="#BFBFBF"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "29" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/StatsMPI.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/StatsMPI.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/global.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/global.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "22" [dir=back tooltip="include"]
    "4" -> "26" [dir=back tooltip="include"]
    "4" -> "27" [dir=back tooltip="include"]
    "4" -> "28" [dir=back tooltip="include"]
    "4" -> "29" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
    "5" -> "15" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "17" -> "18" [dir=back tooltip="include"]
    "6" -> "7" [dir=back tooltip="include"]
    "6" -> "8" [dir=back tooltip="include"]
    "6" -> "9" [dir=back tooltip="include"]
    "6" -> "10" [dir=back tooltip="include"]
    "6" -> "11" [dir=back tooltip="include"]
    "6" -> "12" [dir=back tooltip="include"]
    "6" -> "13" [dir=back tooltip="include"]
    "6" -> "14" [dir=back tooltip="include"]
    "22" -> "6" [dir=back tooltip="include"]
    "22" -> "23" [dir=back tooltip="include"]
    "22" -> "24" [dir=back tooltip="include"]
    "22" -> "15" [dir=back tooltip="include"]
    "22" -> "25" [dir=back tooltip="include"]
    "26" -> "26" [dir=back tooltip="include"]
    "18" -> "19" [dir=back tooltip="include"]
    "18" -> "20" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "15" -> "21" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "16" [dir=back tooltip="include"]
    "3" -> "15" [dir=back tooltip="include"]
}

Typedefs

typedef std::map<speciesKey, sKeyDmap> sKey2Dmap
typedef std::map<speciesKey, sKeyUmap> sKey2Umap
typedef std::map<speciesKey, double> sKeyDmap
typedef std::pair<speciesKey, speciesKey> sKeyPair
typedef std::set<speciesKey> sKeySet
typedef std::map<speciesKey, unsigned> sKeyUmap
typedef std::map<speciesKey, std::vector<double>> sKeyvDmap
typedef std::pair<unsigned short, unsigned short> speciesKey

Typedefs for the species key.

file sphereSL.H
#include <cmath>
#include <iostream>
#include <fstream>
#include <string>
#include <numerical.H>
#include <biorth.H>
#include <SLGridMP2.H>

Include dependency graph for sphereSL.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "30" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "24" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "29" [label="QPDistF.H" tooltip="QPDistF.H"]
    "13" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
    "9" [label="biorth.H" tooltip="biorth.H"]
    "27" [label="gaussQ.H" tooltip="gaussQ.H"]
    "22" [label="interp.H" tooltip="interp.H"]
    "33" [label="libvars.H" tooltip="libvars.H"]
    "16" [label="localmpi.H" tooltip="localmpi.H"]
    "18" [label="massmodel.H" tooltip="massmodel.H"]
    "6" [label="numerical.H" tooltip="numerical.H"]
    "26" [label="orbit.H" tooltip="orbit.H"]
    "31" [label="sltableMP2.H" tooltip="sltableMP2.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/sphereSL.H" fillcolor="#BFBFBF"]
    "8" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "2" [label="cmath" tooltip="cmath"]
    "17" [label="config_exp.h" tooltip="config_exp.h"]
    "11" [label="cstdlib" tooltip="cstdlib"]
    "23" [label="deque" tooltip="deque"]
    "4" [label="fstream" tooltip="fstream"]
    "7" [label="functional" tooltip="functional"]
    "10" [label="iomanip" tooltip="iomanip"]
    "3" [label="iostream" tooltip="iostream"]
    "25" [label="map" tooltip="map"]
    "14" [label="math.h" tooltip="math.h"]
    "12" [label="memory" tooltip="memory"]
    "15" [label="mpi.h" tooltip="mpi.h"]
    "20" [label="random" tooltip="random"]
    "28" [label="sstream" tooltip="sstream"]
    "5" [label="string" tooltip="string"]
    "21" [label="tuple" tooltip="tuple"]
    "19" [label="vector" tooltip="vector"]
    "32" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "30" -> "18" [dir=forward tooltip="include"]
    "24" -> "19" [dir=forward tooltip="include"]
    "24" -> "25" [dir=forward tooltip="include"]
    "24" -> "5" [dir=forward tooltip="include"]
    "29" -> "10" [dir=forward tooltip="include"]
    "29" -> "5" [dir=forward tooltip="include"]
    "29" -> "25" [dir=forward tooltip="include"]
    "29" -> "18" [dir=forward tooltip="include"]
    "29" -> "30" [dir=forward tooltip="include"]
    "29" -> "26" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "3" [dir=forward tooltip="include"]
    "13" -> "4" [dir=forward tooltip="include"]
    "13" -> "5" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
    "13" -> "16" [dir=forward tooltip="include"]
    "13" -> "17" [dir=forward tooltip="include"]
    "13" -> "18" [dir=forward tooltip="include"]
    "13" -> "31" [dir=forward tooltip="include"]
    "13" -> "32" [dir=forward tooltip="include"]
    "13" -> "33" [dir=forward tooltip="include"]
    "9" -> "3" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "11" [dir=forward tooltip="include"]
    "9" -> "5" [dir=forward tooltip="include"]
    "9" -> "12" [dir=forward tooltip="include"]
    "9" -> "8" [dir=forward tooltip="include"]
    "27" -> "3" [dir=forward tooltip="include"]
    "27" -> "10" [dir=forward tooltip="include"]
    "27" -> "28" [dir=forward tooltip="include"]
    "27" -> "11" [dir=forward tooltip="include"]
    "27" -> "5" [dir=forward tooltip="include"]
    "27" -> "19" [dir=forward tooltip="include"]
    "22" -> "8" [dir=forward tooltip="include"]
    "22" -> "19" [dir=forward tooltip="include"]
    "22" -> "23" [dir=forward tooltip="include"]
    "22" -> "24" [dir=forward tooltip="include"]
    "33" -> "20" [dir=forward tooltip="include"]
    "33" -> "15" [dir=forward tooltip="include"]
    "16" -> "15" [dir=forward tooltip="include"]
    "16" -> "3" [dir=forward tooltip="include"]
    "16" -> "4" [dir=forward tooltip="include"]
    "16" -> "10" [dir=forward tooltip="include"]
    "16" -> "5" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "12" [dir=forward tooltip="include"]
    "18" -> "20" [dir=forward tooltip="include"]
    "18" -> "21" [dir=forward tooltip="include"]
    "18" -> "8" [dir=forward tooltip="include"]
    "18" -> "22" [dir=forward tooltip="include"]
    "18" -> "26" [dir=forward tooltip="include"]
    "18" -> "29" [dir=forward tooltip="include"]
    "6" -> "7" [dir=forward tooltip="include"]
    "6" -> "8" [dir=forward tooltip="include"]
    "26" -> "7" [dir=forward tooltip="include"]
    "26" -> "12" [dir=forward tooltip="include"]
    "26" -> "8" [dir=forward tooltip="include"]
    "26" -> "27" [dir=forward tooltip="include"]
    "31" -> "8" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "1" -> "13" [dir=forward tooltip="include"]
}
file Spline.H
#include <cstdlib>
#include <vector>
#include <cmath>

Include dependency graph for Spline.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Spline.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Spline.H" fillcolor="#BFBFBF"]
    "4" [label="cmath" tooltip="cmath"]
    "2" [label="cstdlib" tooltip="cstdlib"]
    "3" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
}

Functions

template<class T>
void Spline(const std::vector<T> &x, const std::vector<T> &y, T yp1, T ypn, std::vector<T> &y2)
template<class T>
void Splint1(const std::vector<T> &xa, const std::vector<T> &ya, const std::vector<T> &y2a, T x, T &y, int even = 0)
template<class T>
void Splint2(const std::vector<T> &xa, const std::vector<T> &ya, const std::vector<T> &y2a, T x, T &y, T &dy, int even = 0)
template<class T>
void Splint3(const std::vector<T> &xa, const std::vector<T> &ya, const std::vector<T> &y2a, T x, T &y, T &dy, T &ddy, int even = 0)
file staeckel.H
file StringTok.H

This graph shows which files directly or indirectly include StringTok.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ParticleReader.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ParticleReader.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/StringTok.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/StringTok.H" fillcolor="#BFBFBF"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/AxisymmetricBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/AxisymmetricBasis.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Basis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Basis.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Bessel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Bessel.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H"]
    "33" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H"]
    "34" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "43" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cube.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cube.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "35" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "37" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H"]
    "38" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "44" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/NoForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/NoForce.H"]
    "41" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCHKPTQ.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCHKPTQ.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutRelaxation.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutRelaxation.H"]
    "42" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Output.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Output.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutputContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutputContainer.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PotAccel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PotAccel.H"]
    "39" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "45" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SphericalBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SphericalBasis.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "29" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "30" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "31" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "32" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "36" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "40" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "46" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/PSP2.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/PSP2.H"]
    "47" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/PSP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/PSP.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
    "1" -> "16" [dir=back tooltip="include"]
    "1" -> "46" [dir=back tooltip="include"]
    "1" -> "47" [dir=back tooltip="include"]
    "18" -> "19" [dir=back tooltip="include"]
    "18" -> "20" [dir=back tooltip="include"]
    "18" -> "21" [dir=back tooltip="include"]
    "18" -> "15" [dir=back tooltip="include"]
    "18" -> "24" [dir=back tooltip="include"]
    "18" -> "27" [dir=back tooltip="include"]
    "18" -> "28" [dir=back tooltip="include"]
    "18" -> "29" [dir=back tooltip="include"]
    "18" -> "30" [dir=back tooltip="include"]
    "18" -> "31" [dir=back tooltip="include"]
    "18" -> "32" [dir=back tooltip="include"]
    "17" -> "18" [dir=back tooltip="include"]
    "17" -> "11" [dir=back tooltip="include"]
    "25" -> "12" [dir=back tooltip="include"]
    "33" -> "34" [dir=back tooltip="include"]
    "33" -> "37" [dir=back tooltip="include"]
    "33" -> "41" [dir=back tooltip="include"]
    "33" -> "5" [dir=back tooltip="include"]
    "33" -> "6" [dir=back tooltip="include"]
    "33" -> "42" [dir=back tooltip="include"]
    "34" -> "35" [dir=back tooltip="include"]
    "34" -> "9" [dir=back tooltip="include"]
    "10" -> "11" [dir=back tooltip="include"]
    "11" -> "12" [dir=back tooltip="include"]
    "35" -> "20" [dir=back tooltip="include"]
    "35" -> "27" [dir=back tooltip="include"]
    "35" -> "28" [dir=back tooltip="include"]
    "35" -> "29" [dir=back tooltip="include"]
    "35" -> "30" [dir=back tooltip="include"]
    "35" -> "31" [dir=back tooltip="include"]
    "35" -> "32" [dir=back tooltip="include"]
    "35" -> "36" [dir=back tooltip="include"]
    "37" -> "35" [dir=back tooltip="include"]
    "37" -> "38" [dir=back tooltip="include"]
    "37" -> "39" [dir=back tooltip="include"]
    "37" -> "9" [dir=back tooltip="include"]
    "37" -> "40" [dir=back tooltip="include"]
    "41" -> "41" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "5" [dir=back tooltip="include"]
    "3" -> "6" [dir=back tooltip="include"]
    "3" -> "7" [dir=back tooltip="include"]
    "3" -> "8" [dir=back tooltip="include"]
    "3" -> "9" [dir=back tooltip="include"]
    "21" -> "22" [dir=back tooltip="include"]
    "21" -> "23" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "16" -> "33" [dir=back tooltip="include"]
    "16" -> "43" [dir=back tooltip="include"]
    "16" -> "37" [dir=back tooltip="include"]
    "16" -> "44" [dir=back tooltip="include"]
    "16" -> "45" [dir=back tooltip="include"]
    "26" -> "12" [dir=back tooltip="include"]
    "24" -> "25" [dir=back tooltip="include"]
    "24" -> "26" [dir=back tooltip="include"]
    "12" -> "13" [dir=back tooltip="include"]
    "12" -> "14" [dir=back tooltip="include"]
    "9" -> "10" [dir=back tooltip="include"]
    "9" -> "15" [dir=back tooltip="include"]
}
file Sutils.H
#include <algorithm>
#include <sstream>
#include <string>
#include <vector>
#include <cctype>
#include <locale>

Include dependency graph for Sutils.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Sutils.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Sutils.H" fillcolor="#BFBFBF"]
    "2" [label="algorithm" tooltip="algorithm"]
    "6" [label="cctype" tooltip="cctype"]
    "7" [label="locale" tooltip="locale"]
    "3" [label="sstream" tooltip="sstream"]
    "4" [label="string" tooltip="string"]
    "5" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
}

Functions

static inline void ltrim(std::string &s)

String trim white-space from start (in place version)

static inline std::string ltrim_copy(std::string s)

String trim white space from start (new copy)

static inline void rtrim(std::string &s)

String trim white-space string from end (in place version)

static inline std::string rtrim_copy(std::string s)

String trim white space from end (new copy)

std::vector<std::string> str_split(const std::string &s, char delimiter)

Split string on a character delimiter.

std::string str_to_lower(const std::string &s)

Return a lower case copy.

std::string str_to_upper(const std::string &s)

Return an upper case copy.

static inline void trim(std::string &s)

String trim white-spacefrom both ends (in place)

static inline std::string trim_copy(std::string s)

String trim white space from both ends (new copy)

file Swap.H
file TableGrid.H
#include <sstream>
#include <vector>
#include <memory>
#include <map>
#include <ThreeDGrid.H>

Include dependency graph for TableGrid.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/TableGrid.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/TableGrid.H" fillcolor="#BFBFBF"]
    "6" [label="ThreeDGrid.H" tooltip="ThreeDGrid.H"]
    "5" [label="map" tooltip="map"]
    "4" [label="memory" tooltip="memory"]
    "2" [label="sstream" tooltip="sstream"]
    "3" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "6" -> "3" [dir=forward tooltip="include"]
    "6" -> "2" [dir=forward tooltip="include"]
    "6" -> "4" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include TableGrid.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DataGrid.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DataGrid.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/TableGrid.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/TableGrid.H" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=back tooltip="include"]
}

Typedefs

typedef std::shared_ptr<TableGrid> TableGridPtr
file TempFile.H
#include <filesystem>
#include <iostream>
#include <random>

Include dependency graph for TempFile.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/TempFile.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/TempFile.H" fillcolor="#BFBFBF"]
    "2" [label="filesystem" tooltip="filesystem"]
    "3" [label="iostream" tooltip="iostream"]
    "4" [label="random" tooltip="random"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
}

Functions

std::filesystem::path temp_file(const std::string &prefix, std::size_t length = 16)

Generate a unique file name with a given prefix and ‘length’ random characters. The routine will check for existence and attempt ‘max_try’ times to make unique name. Otherwise, it throws an exception reporting the last attempted file name. We use std::filesystem to obtain the path for temporary files. The value of max_try=1000 by default.

Examples:

auto path = temp_file(“my_prog”); // Uses the default length=16 auto path = temp_file(“my_prog”, 8); // User specfied length=8

file ThreeDGrid.H
#include <vector>
#include <sstream>
#include <memory>

Include dependency graph for ThreeDGrid.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ThreeDGrid.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ThreeDGrid.H" fillcolor="#BFBFBF"]
    "4" [label="memory" tooltip="memory"]
    "3" [label="sstream" tooltip="sstream"]
    "2" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include ThreeDGrid.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DataGrid.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DataGrid.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/TableGrid.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/TableGrid.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ThreeDGrid.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ThreeDGrid.H" fillcolor="#BFBFBF"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/VtkGrid.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/VtkGrid.H"]
    "2" -> "3" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "4" [dir=back tooltip="include"]
    "4" -> "3" [dir=back tooltip="include"]
}

Typedefs

typedef std::shared_ptr<ThreeDGrid> ThreeDGridPtr
file Timer.H
#include <iostream>
#include <cstdlib>
#include <chrono>

Include dependency graph for Timer.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Timer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Timer.H" fillcolor="#BFBFBF"]
    "4" [label="chrono" tooltip="chrono"]
    "3" [label="cstdlib" tooltip="cstdlib"]
    "2" [label="iostream" tooltip="iostream"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include Timer.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BarrierWrapper.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/BarrierWrapper.H"]
    "31" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DiskModels.H"]
    "30" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCylSL.H"]
    "35" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/RunningTime.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/RunningTime.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Timer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/Timer.H" fillcolor="#BFBFBF"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "37" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCHKPTQ.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCHKPTQ.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "38" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutRelaxation.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutRelaxation.H"]
    "29" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "36" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Output.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Output.H"]
    "39" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutputContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutputContainer.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/global.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/global.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "33" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H"]
    "32" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H"]
    "34" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H"]
    "2" -> "3" [dir=back tooltip="include"]
    "31" -> "32" [dir=back tooltip="include"]
    "30" -> "31" [dir=back tooltip="include"]
    "30" -> "16" [dir=back tooltip="include"]
    "30" -> "33" [dir=back tooltip="include"]
    "30" -> "32" [dir=back tooltip="include"]
    "30" -> "34" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "30" [dir=back tooltip="include"]
    "1" -> "35" [dir=back tooltip="include"]
    "1" -> "4" [dir=back tooltip="include"]
    "1" -> "5" [dir=back tooltip="include"]
    "1" -> "36" [dir=back tooltip="include"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "22" [dir=back tooltip="include"]
    "4" -> "26" [dir=back tooltip="include"]
    "4" -> "27" [dir=back tooltip="include"]
    "4" -> "28" [dir=back tooltip="include"]
    "4" -> "29" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
    "5" -> "15" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "17" -> "18" [dir=back tooltip="include"]
    "6" -> "7" [dir=back tooltip="include"]
    "6" -> "8" [dir=back tooltip="include"]
    "6" -> "9" [dir=back tooltip="include"]
    "6" -> "10" [dir=back tooltip="include"]
    "6" -> "11" [dir=back tooltip="include"]
    "6" -> "12" [dir=back tooltip="include"]
    "6" -> "13" [dir=back tooltip="include"]
    "6" -> "14" [dir=back tooltip="include"]
    "22" -> "6" [dir=back tooltip="include"]
    "22" -> "23" [dir=back tooltip="include"]
    "22" -> "24" [dir=back tooltip="include"]
    "22" -> "15" [dir=back tooltip="include"]
    "22" -> "25" [dir=back tooltip="include"]
    "26" -> "26" [dir=back tooltip="include"]
    "36" -> "37" [dir=back tooltip="include"]
    "36" -> "27" [dir=back tooltip="include"]
    "36" -> "28" [dir=back tooltip="include"]
    "36" -> "38" [dir=back tooltip="include"]
    "36" -> "39" [dir=back tooltip="include"]
    "36" -> "15" [dir=back tooltip="include"]
    "18" -> "19" [dir=back tooltip="include"]
    "18" -> "20" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "15" -> "21" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "16" [dir=back tooltip="include"]
    "3" -> "15" [dir=back tooltip="include"]
}
file tipsy.H

This graph shows which files directly or indirectly include tipsy.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ParticleReader.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ParticleReader.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/tipsy.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/tipsy.H" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=back tooltip="include"]
}
file toomre.H
#include <massmodel.H>

Include dependency graph for toomre.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "21" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "10" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "20" [label="QPDistF.H" tooltip="QPDistF.H"]
    "15" [label="gaussQ.H" tooltip="gaussQ.H"]
    "8" [label="interp.H" tooltip="interp.H"]
    "2" [label="massmodel.H" tooltip="massmodel.H"]
    "13" [label="orbit.H" tooltip="orbit.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/toomre.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/toomre.H" fillcolor="#BFBFBF"]
    "7" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "19" [label="cstdlib" tooltip="cstdlib"]
    "9" [label="deque" tooltip="deque"]
    "14" [label="functional" tooltip="functional"]
    "17" [label="iomanip" tooltip="iomanip"]
    "16" [label="iostream" tooltip="iostream"]
    "11" [label="map" tooltip="map"]
    "4" [label="memory" tooltip="memory"]
    "5" [label="random" tooltip="random"]
    "18" [label="sstream" tooltip="sstream"]
    "12" [label="string" tooltip="string"]
    "6" [label="tuple" tooltip="tuple"]
    "3" [label="vector" tooltip="vector"]
    "21" -> "2" [dir=forward tooltip="include"]
    "10" -> "3" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "12" [dir=forward tooltip="include"]
    "20" -> "17" [dir=forward tooltip="include"]
    "20" -> "12" [dir=forward tooltip="include"]
    "20" -> "11" [dir=forward tooltip="include"]
    "20" -> "2" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "13" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "17" [dir=forward tooltip="include"]
    "15" -> "18" [dir=forward tooltip="include"]
    "15" -> "19" [dir=forward tooltip="include"]
    "15" -> "12" [dir=forward tooltip="include"]
    "15" -> "3" [dir=forward tooltip="include"]
    "8" -> "7" [dir=forward tooltip="include"]
    "8" -> "3" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "10" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "2" -> "7" [dir=forward tooltip="include"]
    "2" -> "8" [dir=forward tooltip="include"]
    "2" -> "13" [dir=forward tooltip="include"]
    "2" -> "20" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "4" [dir=forward tooltip="include"]
    "13" -> "7" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
}
file TransformFFT.H
#include <complex>
#include <vector>
#include <Eigen/Dense>
#include <fftw3.h>

Include dependency graph for TransformFFT.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/TransformFFT.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/TransformFFT.H" fillcolor="#BFBFBF"]
    "4" [label="Eigen/Dense" tooltip="Eigen/Dense"]
    "2" [label="complex" tooltip="complex"]
    "5" [label="fftw3.h" tooltip="fftw3.h"]
    "3" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
}
file VtkGrid.H
#include <algorithm>
#include <fstream>
#include <sstream>
#include <vector>
#include <memory>
#include <limits>
#include <map>
#include <ThreeDGrid.H>

Include dependency graph for VtkGrid.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "9" [label="ThreeDGrid.H" tooltip="ThreeDGrid.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/VtkGrid.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/VtkGrid.H" fillcolor="#BFBFBF"]
    "2" [label="algorithm" tooltip="algorithm"]
    "3" [label="fstream" tooltip="fstream"]
    "7" [label="limits" tooltip="limits"]
    "8" [label="map" tooltip="map"]
    "6" [label="memory" tooltip="memory"]
    "4" [label="sstream" tooltip="sstream"]
    "5" [label="vector" tooltip="vector"]
    "9" -> "5" [dir=forward tooltip="include"]
    "9" -> "4" [dir=forward tooltip="include"]
    "9" -> "6" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include VtkGrid.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DataGrid.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/DataGrid.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/VtkGrid.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/VtkGrid.H" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=back tooltip="include"]
}

Typedefs

typedef std::shared_ptr<VtkGrid> VtkGridPtr
file VtkPCA.H
#include <sstream>
#include <memory>
#include <Eigen/Eigen>
#include <vtkSmartPointer.h>
#include <vtkDoubleArray.h>
#include <vtkFloatArray.h>
#include <vtkIntArray.h>
#include <vtkUnsignedCharArray.h>
#include <vtkStructuredPoints.h>
#include <vtkRectilinearGrid.h>
#include <vtkPoints.h>
#include <vtkPointData.h>
#include <vtkXMLRectilinearGridWriter.h>
#include <vtkLookupTable.h>
#include <vtkVersion.h>

Include dependency graph for VtkPCA.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/VtkPCA.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/VtkPCA.H" fillcolor="#BFBFBF"]
    "4" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "3" [label="memory" tooltip="memory"]
    "2" [label="sstream" tooltip="sstream"]
    "6" [label="vtkDoubleArray.h" tooltip="vtkDoubleArray.h"]
    "7" [label="vtkFloatArray.h" tooltip="vtkFloatArray.h"]
    "8" [label="vtkIntArray.h" tooltip="vtkIntArray.h"]
    "15" [label="vtkLookupTable.h" tooltip="vtkLookupTable.h"]
    "13" [label="vtkPointData.h" tooltip="vtkPointData.h"]
    "12" [label="vtkPoints.h" tooltip="vtkPoints.h"]
    "11" [label="vtkRectilinearGrid.h" tooltip="vtkRectilinearGrid.h"]
    "5" [label="vtkSmartPointer.h" tooltip="vtkSmartPointer.h"]
    "10" [label="vtkStructuredPoints.h" tooltip="vtkStructuredPoints.h"]
    "9" [label="vtkUnsignedCharArray.h" tooltip="vtkUnsignedCharArray.h"]
    "16" [label="vtkVersion.h" tooltip="vtkVersion.h"]
    "14" [label="vtkXMLRectilinearGridWriter.h" tooltip="vtkXMLRectilinearGridWriter.h"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "1" -> "10" [dir=forward tooltip="include"]
    "1" -> "11" [dir=forward tooltip="include"]
    "1" -> "12" [dir=forward tooltip="include"]
    "1" -> "13" [dir=forward tooltip="include"]
    "1" -> "14" [dir=forward tooltip="include"]
    "1" -> "15" [dir=forward tooltip="include"]
    "1" -> "16" [dir=forward tooltip="include"]
}

Typedefs

using vtkFloatArrayP = vtkSmartPointer<vtkFloatArray>
typedef std::shared_ptr<VtkPCA> VtkPCAptr
using vtkRectilinearGridP = vtkSmartPointer<vtkRectilinearGrid>
using vtkRectilinearGridWriterP = vtkSmartPointer<vtkXMLRectilinearGridWriter>
file writePVD.H
#include <iostream>
#include <iomanip>
#include <fstream>
#include <vector>
#include <string>

Include dependency graph for writePVD.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/writePVD.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/writePVD.H" fillcolor="#BFBFBF"]
    "4" [label="fstream" tooltip="fstream"]
    "3" [label="iomanip" tooltip="iomanip"]
    "2" [label="iostream" tooltip="iostream"]
    "6" [label="string" tooltip="string"]
    "5" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
}

Functions

void writePVD(const std::string &filename, const std::vector<double> &times, const std::vector<std::string> &files)
file YamlCheck.H
#include <string>
#include <set>
#include <yaml-cpp/yaml.h>

Include dependency graph for YamlCheck.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/YamlCheck.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/YamlCheck.H" fillcolor="#BFBFBF"]
    "3" [label="set" tooltip="set"]
    "2" [label="string" tooltip="string"]
    "4" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include YamlCheck.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/YamlCheck.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/YamlCheck.H" fillcolor="#BFBFBF"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/AxisymmetricBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/AxisymmetricBasis.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Basis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Basis.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Bessel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Bessel.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "38" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cube.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cube.H"]
    "29" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "30" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H"]
    "31" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "39" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/NoForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/NoForce.H"]
    "34" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "35" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "36" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "37" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PotAccel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PotAccel.H"]
    "32" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "40" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SphericalBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SphericalBasis.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "33" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "6" [dir=back tooltip="include"]
    "4" -> "7" [dir=back tooltip="include"]
    "4" -> "10" [dir=back tooltip="include"]
    "4" -> "11" [dir=back tooltip="include"]
    "4" -> "17" [dir=back tooltip="include"]
    "4" -> "18" [dir=back tooltip="include"]
    "4" -> "19" [dir=back tooltip="include"]
    "4" -> "20" [dir=back tooltip="include"]
    "4" -> "21" [dir=back tooltip="include"]
    "4" -> "22" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "23" [dir=back tooltip="include"]
    "12" -> "13" [dir=back tooltip="include"]
    "24" -> "25" [dir=back tooltip="include"]
    "24" -> "30" [dir=back tooltip="include"]
    "24" -> "34" [dir=back tooltip="include"]
    "24" -> "35" [dir=back tooltip="include"]
    "24" -> "36" [dir=back tooltip="include"]
    "24" -> "37" [dir=back tooltip="include"]
    "25" -> "26" [dir=back tooltip="include"]
    "25" -> "28" [dir=back tooltip="include"]
    "29" -> "23" [dir=back tooltip="include"]
    "23" -> "13" [dir=back tooltip="include"]
    "26" -> "6" [dir=back tooltip="include"]
    "26" -> "17" [dir=back tooltip="include"]
    "26" -> "18" [dir=back tooltip="include"]
    "26" -> "19" [dir=back tooltip="include"]
    "26" -> "20" [dir=back tooltip="include"]
    "26" -> "21" [dir=back tooltip="include"]
    "26" -> "22" [dir=back tooltip="include"]
    "26" -> "27" [dir=back tooltip="include"]
    "30" -> "26" [dir=back tooltip="include"]
    "30" -> "31" [dir=back tooltip="include"]
    "30" -> "32" [dir=back tooltip="include"]
    "30" -> "28" [dir=back tooltip="include"]
    "30" -> "33" [dir=back tooltip="include"]
    "34" -> "34" [dir=back tooltip="include"]
    "7" -> "8" [dir=back tooltip="include"]
    "7" -> "9" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "24" [dir=back tooltip="include"]
    "2" -> "38" [dir=back tooltip="include"]
    "2" -> "30" [dir=back tooltip="include"]
    "2" -> "39" [dir=back tooltip="include"]
    "2" -> "40" [dir=back tooltip="include"]
    "16" -> "13" [dir=back tooltip="include"]
    "11" -> "12" [dir=back tooltip="include"]
    "11" -> "16" [dir=back tooltip="include"]
    "13" -> "14" [dir=back tooltip="include"]
    "13" -> "15" [dir=back tooltip="include"]
    "28" -> "29" [dir=back tooltip="include"]
    "28" -> "10" [dir=back tooltip="include"]
}

Functions

std::set<std::string> YamlCheck(const YAML::Node &node, const std::set<std::string> &valid)

Check for unmatched configuration keys in a YAML::node

Returns an std::vector of unmatched keys which is empty if all keys are matched

file YamlConfig.H
#include <typeinfo>
#include <iostream>
#include <iomanip>
#include <fstream>
#include <sstream>
#include <cstring>
#include <yaml-cpp/yaml.h>
#include <cxxopts.H>

Include dependency graph for YamlConfig.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/YamlConfig.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/YamlConfig.H" fillcolor="#BFBFBF"]
    "9" [label="cxxopts.H" tooltip="cxxopts.H"]
    "21" [label="algorithm" tooltip="algorithm"]
    "10" [label="cctype" tooltip="cctype"]
    "7" [label="cstring" tooltip="cstring"]
    "11" [label="exception" tooltip="exception"]
    "5" [label="fstream" tooltip="fstream"]
    "4" [label="iomanip" tooltip="iomanip"]
    "3" [label="iostream" tooltip="iostream"]
    "12" [label="limits" tooltip="limits"]
    "13" [label="list" tooltip="list"]
    "14" [label="map" tooltip="map"]
    "15" [label="memory" tooltip="memory"]
    "22" [label="regex" tooltip="regex"]
    "6" [label="sstream" tooltip="sstream"]
    "16" [label="string" tooltip="string"]
    "2" [label="typeinfo" tooltip="typeinfo"]
    "17" [label="unordered_map" tooltip="unordered_map"]
    "18" [label="unordered_set" tooltip="unordered_set"]
    "19" [label="utility" tooltip="utility"]
    "20" [label="vector" tooltip="vector"]
    "8" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "7" [dir=forward tooltip="include"]
    "9" -> "11" [dir=forward tooltip="include"]
    "9" -> "3" [dir=forward tooltip="include"]
    "9" -> "12" [dir=forward tooltip="include"]
    "9" -> "13" [dir=forward tooltip="include"]
    "9" -> "14" [dir=forward tooltip="include"]
    "9" -> "15" [dir=forward tooltip="include"]
    "9" -> "6" [dir=forward tooltip="include"]
    "9" -> "16" [dir=forward tooltip="include"]
    "9" -> "17" [dir=forward tooltip="include"]
    "9" -> "18" [dir=forward tooltip="include"]
    "9" -> "19" [dir=forward tooltip="include"]
    "9" -> "20" [dir=forward tooltip="include"]
    "9" -> "21" [dir=forward tooltip="include"]
    "9" -> "22" [dir=forward tooltip="include"]
}

Functions

cxxopts::ParseResult LoadConfig(cxxopts::Options &options, const std::string &config)

Read the YAML parameter config file and load the cxxopts database with parameters

void SaveConfig(const cxxopts::ParseResult &vm, const cxxopts::Options &options, const std::string &config, const std::vector<std::string> groups = {""}, const std::vector<std::string> exclude = {"help", "template", "expert", "config"})

Saves the current command-line cxxopts database in YAML format for user configuration. For ease, the current convention is that all vector-values options will be stored as strings, and converted by the calling program to the correct value internally.

file ZBrent.H
#include <math.h>
#include <functional>
#include <iostream>
#include <iomanip>
#include <vector>

Include dependency graph for ZBrent.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ZBrent.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/ZBrent.H" fillcolor="#BFBFBF"]
    "3" [label="functional" tooltip="functional"]
    "5" [label="iomanip" tooltip="iomanip"]
    "4" [label="iostream" tooltip="iostream"]
    "2" [label="math.h" tooltip="math.h"]
    "6" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
}

Enums

enum ZBrentReturn

Values:

enumerator Good
enumerator Bracket
enumerator Iteration
file AxisymmetricBasis.H
#include <Basis.H>
#include <Eigen/Eigen>

Include dependency graph for AxisymmetricBasis.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "12" [label="StringTok.H" tooltip="StringTok.H"]
    "13" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/AxisymmetricBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/AxisymmetricBasis.H" fillcolor="#BFBFBF"]
    "2" [label="Basis.H" tooltip="Basis.H"]
    "3" [label="PotAccel.H" tooltip="PotAccel.H"]
    "16" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "11" [label="Particle.H" tooltip="Particle.H"]
    "6" [label="chrono" tooltip="chrono"]
    "15" [label="config_exp.h" tooltip="config_exp.h"]
    "4" [label="cstdlib" tooltip="cstdlib"]
    "7" [label="list" tooltip="list"]
    "8" [label="map" tooltip="map"]
    "9" [label="memory" tooltip="memory"]
    "14" [label="set" tooltip="set"]
    "5" [label="string" tooltip="string"]
    "10" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "13" -> "5" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "10" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "16" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "16" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "5" [dir=forward tooltip="include"]
    "3" -> "6" [dir=forward tooltip="include"]
    "3" -> "7" [dir=forward tooltip="include"]
    "3" -> "8" [dir=forward tooltip="include"]
    "3" -> "9" [dir=forward tooltip="include"]
    "3" -> "10" [dir=forward tooltip="include"]
    "3" -> "11" [dir=forward tooltip="include"]
    "3" -> "12" [dir=forward tooltip="include"]
    "3" -> "13" [dir=forward tooltip="include"]
    "3" -> "15" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include AxisymmetricBasis.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/AxisymmetricBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/AxisymmetricBasis.H" fillcolor="#BFBFBF"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Bessel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Bessel.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SphericalBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SphericalBasis.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
    "1" -> "4" [dir=back tooltip="include"]
    "1" -> "7" [dir=back tooltip="include"]
    "1" -> "8" [dir=back tooltip="include"]
    "1" -> "14" [dir=back tooltip="include"]
    "1" -> "15" [dir=back tooltip="include"]
    "1" -> "16" [dir=back tooltip="include"]
    "1" -> "17" [dir=back tooltip="include"]
    "1" -> "18" [dir=back tooltip="include"]
    "1" -> "19" [dir=back tooltip="include"]
    "9" -> "10" [dir=back tooltip="include"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "6" [dir=back tooltip="include"]
    "13" -> "10" [dir=back tooltip="include"]
    "8" -> "9" [dir=back tooltip="include"]
    "8" -> "13" [dir=back tooltip="include"]
    "10" -> "11" [dir=back tooltip="include"]
    "10" -> "12" [dir=back tooltip="include"]
}
file Basis.H
#include <PotAccel.H>
#include <Eigen/Eigen>

Include dependency graph for Basis.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "11" [label="StringTok.H" tooltip="StringTok.H"]
    "12" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Basis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Basis.H" fillcolor="#BFBFBF"]
    "2" [label="PotAccel.H" tooltip="PotAccel.H"]
    "15" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "10" [label="Particle.H" tooltip="Particle.H"]
    "5" [label="chrono" tooltip="chrono"]
    "14" [label="config_exp.h" tooltip="config_exp.h"]
    "3" [label="cstdlib" tooltip="cstdlib"]
    "6" [label="list" tooltip="list"]
    "7" [label="map" tooltip="map"]
    "8" [label="memory" tooltip="memory"]
    "13" [label="set" tooltip="set"]
    "4" [label="string" tooltip="string"]
    "9" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "12" -> "4" [dir=forward tooltip="include"]
    "12" -> "13" [dir=forward tooltip="include"]
    "12" -> "9" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "15" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "2" -> "7" [dir=forward tooltip="include"]
    "2" -> "8" [dir=forward tooltip="include"]
    "2" -> "9" [dir=forward tooltip="include"]
    "2" -> "10" [dir=forward tooltip="include"]
    "2" -> "11" [dir=forward tooltip="include"]
    "2" -> "12" [dir=forward tooltip="include"]
    "2" -> "14" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include Basis.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/AxisymmetricBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/AxisymmetricBasis.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Basis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Basis.H" fillcolor="#BFBFBF"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Bessel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Bessel.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SphericalBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SphericalBasis.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "4" [dir=back tooltip="include"]
    "2" -> "5" [dir=back tooltip="include"]
    "2" -> "8" [dir=back tooltip="include"]
    "2" -> "9" [dir=back tooltip="include"]
    "2" -> "15" [dir=back tooltip="include"]
    "2" -> "16" [dir=back tooltip="include"]
    "2" -> "17" [dir=back tooltip="include"]
    "2" -> "18" [dir=back tooltip="include"]
    "2" -> "19" [dir=back tooltip="include"]
    "2" -> "20" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "21" [dir=back tooltip="include"]
    "10" -> "11" [dir=back tooltip="include"]
    "21" -> "11" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
    "5" -> "7" [dir=back tooltip="include"]
    "14" -> "11" [dir=back tooltip="include"]
    "9" -> "10" [dir=back tooltip="include"]
    "9" -> "14" [dir=back tooltip="include"]
    "11" -> "12" [dir=back tooltip="include"]
    "11" -> "13" [dir=back tooltip="include"]
}
file Bessel.H
#include <assert.h>
#include <SphericalBasis.H>

Include dependency graph for Bessel.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "18" [label="StringTok.H" tooltip="StringTok.H"]
    "19" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "9" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
    "10" [label="Basis.H" tooltip="Basis.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Bessel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Bessel.H" fillcolor="#BFBFBF"]
    "23" [label="NVTX.H" tooltip="NVTX.H"]
    "11" [label="PotAccel.H" tooltip="PotAccel.H"]
    "3" [label="SphericalBasis.H" tooltip="SphericalBasis.H"]
    "24" [label="CoefContainer.H" tooltip="CoefContainer.H"]
    "22" [label="Coefficients.H" tooltip="Coefficients.H"]
    "21" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "17" [label="Particle.H" tooltip="Particle.H"]
    "2" [label="assert.h" tooltip="assert.h"]
    "13" [label="chrono" tooltip="chrono"]
    "20" [label="config_exp.h" tooltip="config_exp.h"]
    "12" [label="cstdlib" tooltip="cstdlib"]
    "14" [label="list" tooltip="list"]
    "15" [label="map" tooltip="map"]
    "4" [label="memory" tooltip="memory"]
    "5" [label="random" tooltip="random"]
    "8" [label="set" tooltip="set"]
    "7" [label="string" tooltip="string"]
    "6" [label="vector" tooltip="vector"]
    "16" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "19" -> "7" [dir=forward tooltip="include"]
    "19" -> "8" [dir=forward tooltip="include"]
    "19" -> "16" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "21" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "21" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "23" -> "4" [dir=forward tooltip="include"]
    "23" -> "20" [dir=forward tooltip="include"]
    "11" -> "12" [dir=forward tooltip="include"]
    "11" -> "7" [dir=forward tooltip="include"]
    "11" -> "13" [dir=forward tooltip="include"]
    "11" -> "14" [dir=forward tooltip="include"]
    "11" -> "15" [dir=forward tooltip="include"]
    "11" -> "4" [dir=forward tooltip="include"]
    "11" -> "16" [dir=forward tooltip="include"]
    "11" -> "17" [dir=forward tooltip="include"]
    "11" -> "18" [dir=forward tooltip="include"]
    "11" -> "19" [dir=forward tooltip="include"]
    "11" -> "20" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "5" [dir=forward tooltip="include"]
    "3" -> "6" [dir=forward tooltip="include"]
    "3" -> "7" [dir=forward tooltip="include"]
    "3" -> "8" [dir=forward tooltip="include"]
    "3" -> "9" [dir=forward tooltip="include"]
    "3" -> "22" [dir=forward tooltip="include"]
    "3" -> "20" [dir=forward tooltip="include"]
    "3" -> "23" [dir=forward tooltip="include"]
    "3" -> "24" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include Bessel.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Bessel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Bessel.H" fillcolor="#BFBFBF"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "4" [dir=back tooltip="include"]
}

Functions

Eigen::VectorXd sbessjz(int n, int m)
file BN.H
#include <iostream>
#include <iomanip>
#include <vector>
#include <cmath>

Include dependency graph for BN.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/BN.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/BN.H" fillcolor="#BFBFBF"]
    "5" [label="cmath" tooltip="cmath"]
    "3" [label="iomanip" tooltip="iomanip"]
    "2" [label="iostream" tooltip="iostream"]
    "4" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
}
file CBDisk.H
#include <memory>
#include <map>
#include <PolarBasis.H>

Include dependency graph for CBDisk.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "24" [label="BiorthCyl.H" tooltip="BiorthCyl.H"]
    "41" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "50" [label="EXPmath.H" tooltip="EXPmath.H"]
    "46" [label="EmpCyl2d.H" tooltip="EmpCyl2d.H"]
    "35" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "40" [label="QPDistF.H" tooltip="QPDistF.H"]
    "17" [label="StringTok.H" tooltip="StringTok.H"]
    "18" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "38" [label="gaussQ.H" tooltip="gaussQ.H"]
    "33" [label="interp.H" tooltip="interp.H"]
    "29" [label="localmpi.H" tooltip="localmpi.H"]
    "31" [label="massmodel.H" tooltip="massmodel.H"]
    "36" [label="orbit.H" tooltip="orbit.H"]
    "9" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
    "10" [label="Basis.H" tooltip="Basis.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H" fillcolor="#BFBFBF"]
    "22" [label="NVTX.H" tooltip="NVTX.H"]
    "4" [label="PolarBasis.H" tooltip="PolarBasis.H"]
    "11" [label="PotAccel.H" tooltip="PotAccel.H"]
    "23" [label="CoefContainer.H" tooltip="CoefContainer.H"]
    "21" [label="Coefficients.H" tooltip="Coefficients.H"]
    "20" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "49" [label="Eigen/Eigenvalues" tooltip="Eigen/Eigenvalues"]
    "16" [label="Particle.H" tooltip="Particle.H"]
    "47" [label="algorithm" tooltip="algorithm"]
    "48" [label="array" tooltip="array"]
    "13" [label="chrono" tooltip="chrono"]
    "27" [label="cmath" tooltip="cmath"]
    "19" [label="config_exp.h" tooltip="config_exp.h"]
    "12" [label="cstdlib" tooltip="cstdlib"]
    "34" [label="deque" tooltip="deque"]
    "26" [label="fstream" tooltip="fstream"]
    "37" [label="functional" tooltip="functional"]
    "45" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
    "43" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
    "44" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
    "42" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
    "52" [label="highfive/eigen.hpp" tooltip="highfive/eigen.hpp"]
    "51" [label="highfive/highfive.hpp" tooltip="highfive/highfive.hpp"]
    "30" [label="iomanip" tooltip="iomanip"]
    "25" [label="iostream" tooltip="iostream"]
    "14" [label="list" tooltip="list"]
    "3" [label="map" tooltip="map"]
    "2" [label="memory" tooltip="memory"]
    "28" [label="mpi.h" tooltip="mpi.h"]
    "5" [label="random" tooltip="random"]
    "8" [label="set" tooltip="set"]
    "39" [label="sstream" tooltip="sstream"]
    "7" [label="string" tooltip="string"]
    "32" [label="tuple" tooltip="tuple"]
    "6" [label="vector" tooltip="vector"]
    "15" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "24" -> "25" [dir=forward tooltip="include"]
    "24" -> "26" [dir=forward tooltip="include"]
    "24" -> "7" [dir=forward tooltip="include"]
    "24" -> "27" [dir=forward tooltip="include"]
    "24" -> "20" [dir=forward tooltip="include"]
    "24" -> "28" [dir=forward tooltip="include"]
    "24" -> "29" [dir=forward tooltip="include"]
    "24" -> "19" [dir=forward tooltip="include"]
    "24" -> "31" [dir=forward tooltip="include"]
    "24" -> "15" [dir=forward tooltip="include"]
    "24" -> "42" [dir=forward tooltip="include"]
    "24" -> "43" [dir=forward tooltip="include"]
    "24" -> "44" [dir=forward tooltip="include"]
    "24" -> "45" [dir=forward tooltip="include"]
    "24" -> "46" [dir=forward tooltip="include"]
    "41" -> "31" [dir=forward tooltip="include"]
    "46" -> "47" [dir=forward tooltip="include"]
    "46" -> "2" [dir=forward tooltip="include"]
    "46" -> "7" [dir=forward tooltip="include"]
    "46" -> "6" [dir=forward tooltip="include"]
    "46" -> "48" [dir=forward tooltip="include"]
    "46" -> "32" [dir=forward tooltip="include"]
    "46" -> "20" [dir=forward tooltip="include"]
    "46" -> "49" [dir=forward tooltip="include"]
    "46" -> "15" [dir=forward tooltip="include"]
    "46" -> "19" [dir=forward tooltip="include"]
    "46" -> "38" [dir=forward tooltip="include"]
    "46" -> "50" [dir=forward tooltip="include"]
    "46" -> "29" [dir=forward tooltip="include"]
    "46" -> "51" [dir=forward tooltip="include"]
    "46" -> "52" [dir=forward tooltip="include"]
    "35" -> "6" [dir=forward tooltip="include"]
    "35" -> "3" [dir=forward tooltip="include"]
    "35" -> "7" [dir=forward tooltip="include"]
    "40" -> "30" [dir=forward tooltip="include"]
    "40" -> "7" [dir=forward tooltip="include"]
    "40" -> "3" [dir=forward tooltip="include"]
    "40" -> "31" [dir=forward tooltip="include"]
    "40" -> "41" [dir=forward tooltip="include"]
    "40" -> "36" [dir=forward tooltip="include"]
    "18" -> "7" [dir=forward tooltip="include"]
    "18" -> "8" [dir=forward tooltip="include"]
    "18" -> "15" [dir=forward tooltip="include"]
    "38" -> "25" [dir=forward tooltip="include"]
    "38" -> "30" [dir=forward tooltip="include"]
    "38" -> "39" [dir=forward tooltip="include"]
    "38" -> "12" [dir=forward tooltip="include"]
    "38" -> "7" [dir=forward tooltip="include"]
    "38" -> "6" [dir=forward tooltip="include"]
    "33" -> "20" [dir=forward tooltip="include"]
    "33" -> "6" [dir=forward tooltip="include"]
    "33" -> "34" [dir=forward tooltip="include"]
    "33" -> "35" [dir=forward tooltip="include"]
    "29" -> "28" [dir=forward tooltip="include"]
    "29" -> "25" [dir=forward tooltip="include"]
    "29" -> "26" [dir=forward tooltip="include"]
    "29" -> "30" [dir=forward tooltip="include"]
    "29" -> "7" [dir=forward tooltip="include"]
    "31" -> "6" [dir=forward tooltip="include"]
    "31" -> "2" [dir=forward tooltip="include"]
    "31" -> "5" [dir=forward tooltip="include"]
    "31" -> "32" [dir=forward tooltip="include"]
    "31" -> "20" [dir=forward tooltip="include"]
    "31" -> "33" [dir=forward tooltip="include"]
    "31" -> "36" [dir=forward tooltip="include"]
    "31" -> "40" [dir=forward tooltip="include"]
    "36" -> "37" [dir=forward tooltip="include"]
    "36" -> "2" [dir=forward tooltip="include"]
    "36" -> "20" [dir=forward tooltip="include"]
    "36" -> "38" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "20" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "20" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "22" -> "2" [dir=forward tooltip="include"]
    "22" -> "19" [dir=forward tooltip="include"]
    "4" -> "2" [dir=forward tooltip="include"]
    "4" -> "5" [dir=forward tooltip="include"]
    "4" -> "6" [dir=forward tooltip="include"]
    "4" -> "7" [dir=forward tooltip="include"]
    "4" -> "8" [dir=forward tooltip="include"]
    "4" -> "9" [dir=forward tooltip="include"]
    "4" -> "21" [dir=forward tooltip="include"]
    "4" -> "19" [dir=forward tooltip="include"]
    "4" -> "22" [dir=forward tooltip="include"]
    "4" -> "23" [dir=forward tooltip="include"]
    "4" -> "24" [dir=forward tooltip="include"]
    "11" -> "12" [dir=forward tooltip="include"]
    "11" -> "7" [dir=forward tooltip="include"]
    "11" -> "13" [dir=forward tooltip="include"]
    "11" -> "14" [dir=forward tooltip="include"]
    "11" -> "3" [dir=forward tooltip="include"]
    "11" -> "2" [dir=forward tooltip="include"]
    "11" -> "15" [dir=forward tooltip="include"]
    "11" -> "16" [dir=forward tooltip="include"]
    "11" -> "17" [dir=forward tooltip="include"]
    "11" -> "18" [dir=forward tooltip="include"]
    "11" -> "19" [dir=forward tooltip="include"]
}
file chkTimer.H
#include <time.h>
#include <cmath>
#include <iostream>
#include <fstream>
#include <iomanip>

Include dependency graph for chkTimer.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/chkTimer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/chkTimer.H" fillcolor="#BFBFBF"]
    "3" [label="cmath" tooltip="cmath"]
    "5" [label="fstream" tooltip="fstream"]
    "6" [label="iomanip" tooltip="iomanip"]
    "4" [label="iostream" tooltip="iostream"]
    "2" [label="time.h" tooltip="time.h"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include chkTimer.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/chkTimer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/chkTimer.H" fillcolor="#BFBFBF"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/global.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/global.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "21" [dir=back tooltip="include"]
    "3" -> "25" [dir=back tooltip="include"]
    "3" -> "26" [dir=back tooltip="include"]
    "3" -> "27" [dir=back tooltip="include"]
    "3" -> "28" [dir=back tooltip="include"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "14" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
    "5" -> "7" [dir=back tooltip="include"]
    "5" -> "8" [dir=back tooltip="include"]
    "5" -> "9" [dir=back tooltip="include"]
    "5" -> "10" [dir=back tooltip="include"]
    "5" -> "11" [dir=back tooltip="include"]
    "5" -> "12" [dir=back tooltip="include"]
    "5" -> "13" [dir=back tooltip="include"]
    "21" -> "5" [dir=back tooltip="include"]
    "21" -> "22" [dir=back tooltip="include"]
    "21" -> "23" [dir=back tooltip="include"]
    "21" -> "14" [dir=back tooltip="include"]
    "21" -> "24" [dir=back tooltip="include"]
    "25" -> "25" [dir=back tooltip="include"]
    "17" -> "18" [dir=back tooltip="include"]
    "17" -> "19" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "14" -> "20" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "15" [dir=back tooltip="include"]
    "2" -> "14" [dir=back tooltip="include"]
}
file Component.H
#include <mpi.h>
#include <utility>
#include <yaml-cpp/yaml.h>
#include <EXPException.H>
#include <global.H>
#include <Orient.H>
#include <header.H>
#include <localmpi.H>
#include <ParticleFerry.H>
#include <CenterFile.H>
#include <PotAccel.H>
#include <Circular.H>
#include <Timer.H>
#include <config_exp.h>

Include dependency graph for Component.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "23" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "43" [label="CenterFile.H" tooltip="CenterFile.H"]
    "47" [label="Circular.H" tooltip="Circular.H"]
    "5" [label="EXPException.H" tooltip="EXPException.H"]
    "36" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "38" [label="QuadLS.H" tooltip="QuadLS.H"]
    "29" [label="Species.H" tooltip="Species.H"]
    "45" [label="StringTok.H" tooltip="StringTok.H"]
    "25" [label="Timer.H" tooltip="Timer.H"]
    "46" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "33" [label="euler.H" tooltip="euler.H"]
    "41" [label="header.H" tooltip="header.H"]
    "10" [label="libvars.H" tooltip="libvars.H"]
    "28" [label="localmpi.H" tooltip="localmpi.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" fillcolor="#BFBFBF"]
    "30" [label="Orient.H" tooltip="Orient.H"]
    "42" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "44" [label="PotAccel.H" tooltip="PotAccel.H"]
    "17" [label="chkTimer.H" tooltip="chkTimer.H"]
    "16" [label="coef.H" tooltip="coef.H"]
    "12" [label="global.H" tooltip="global.H"]
    "34" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "35" [label="Particle.H" tooltip="Particle.H"]
    "32" [label="algorithm" tooltip="algorithm"]
    "37" [label="array" tooltip="array"]
    "27" [label="chrono" tooltip="chrono"]
    "19" [label="cmath" tooltip="cmath"]
    "40" [label="config_exp.h" tooltip="config_exp.h"]
    "26" [label="cstdlib" tooltip="cstdlib"]
    "31" [label="deque" tooltip="deque"]
    "21" [label="fstream" tooltip="fstream"]
    "22" [label="iomanip" tooltip="iomanip"]
    "20" [label="iostream" tooltip="iostream"]
    "15" [label="list" tooltip="list"]
    "24" [label="map" tooltip="map"]
    "14" [label="memory" tooltip="memory"]
    "2" [label="mpi.h" tooltip="mpi.h"]
    "13" [label="pthread.h" tooltip="pthread.h"]
    "11" [label="random" tooltip="random"]
    "6" [label="set" tooltip="set"]
    "9" [label="sstream" tooltip="sstream"]
    "8" [label="string" tooltip="string"]
    "18" [label="time.h" tooltip="time.h"]
    "39" [label="tuple" tooltip="tuple"]
    "3" [label="utility" tooltip="utility"]
    "7" [label="vector" tooltip="vector"]
    "4" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "23" -> "20" [dir=forward tooltip="include"]
    "23" -> "22" [dir=forward tooltip="include"]
    "23" -> "7" [dir=forward tooltip="include"]
    "23" -> "8" [dir=forward tooltip="include"]
    "23" -> "15" [dir=forward tooltip="include"]
    "23" -> "24" [dir=forward tooltip="include"]
    "23" -> "6" [dir=forward tooltip="include"]
    "23" -> "14" [dir=forward tooltip="include"]
    "23" -> "25" [dir=forward tooltip="include"]
    "23" -> "2" [dir=forward tooltip="include"]
    "43" -> "21" [dir=forward tooltip="include"]
    "43" -> "7" [dir=forward tooltip="include"]
    "43" -> "37" [dir=forward tooltip="include"]
    "43" -> "4" [dir=forward tooltip="include"]
    "47" -> "7" [dir=forward tooltip="include"]
    "5" -> "6" [dir=forward tooltip="include"]
    "5" -> "7" [dir=forward tooltip="include"]
    "5" -> "8" [dir=forward tooltip="include"]
    "5" -> "9" [dir=forward tooltip="include"]
    "5" -> "10" [dir=forward tooltip="include"]
    "36" -> "31" [dir=forward tooltip="include"]
    "36" -> "37" [dir=forward tooltip="include"]
    "36" -> "34" [dir=forward tooltip="include"]
    "36" -> "38" [dir=forward tooltip="include"]
    "38" -> "20" [dir=forward tooltip="include"]
    "38" -> "22" [dir=forward tooltip="include"]
    "38" -> "39" [dir=forward tooltip="include"]
    "29" -> "24" [dir=forward tooltip="include"]
    "29" -> "6" [dir=forward tooltip="include"]
    "29" -> "7" [dir=forward tooltip="include"]
    "25" -> "20" [dir=forward tooltip="include"]
    "25" -> "26" [dir=forward tooltip="include"]
    "25" -> "27" [dir=forward tooltip="include"]
    "46" -> "8" [dir=forward tooltip="include"]
    "46" -> "6" [dir=forward tooltip="include"]
    "46" -> "4" [dir=forward tooltip="include"]
    "33" -> "34" [dir=forward tooltip="include"]
    "41" -> "20" [dir=forward tooltip="include"]
    "41" -> "22" [dir=forward tooltip="include"]
    "41" -> "9" [dir=forward tooltip="include"]
    "41" -> "14" [dir=forward tooltip="include"]
    "41" -> "28" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "2" [dir=forward tooltip="include"]
    "28" -> "2" [dir=forward tooltip="include"]
    "28" -> "20" [dir=forward tooltip="include"]
    "28" -> "21" [dir=forward tooltip="include"]
    "28" -> "22" [dir=forward tooltip="include"]
    "28" -> "8" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "12" [dir=forward tooltip="include"]
    "1" -> "30" [dir=forward tooltip="include"]
    "1" -> "41" [dir=forward tooltip="include"]
    "1" -> "28" [dir=forward tooltip="include"]
    "1" -> "42" [dir=forward tooltip="include"]
    "1" -> "43" [dir=forward tooltip="include"]
    "1" -> "44" [dir=forward tooltip="include"]
    "1" -> "47" [dir=forward tooltip="include"]
    "1" -> "25" [dir=forward tooltip="include"]
    "1" -> "40" [dir=forward tooltip="include"]
    "30" -> "7" [dir=forward tooltip="include"]
    "30" -> "6" [dir=forward tooltip="include"]
    "30" -> "31" [dir=forward tooltip="include"]
    "30" -> "32" [dir=forward tooltip="include"]
    "30" -> "33" [dir=forward tooltip="include"]
    "30" -> "35" [dir=forward tooltip="include"]
    "30" -> "36" [dir=forward tooltip="include"]
    "30" -> "40" [dir=forward tooltip="include"]
    "42" -> "7" [dir=forward tooltip="include"]
    "42" -> "14" [dir=forward tooltip="include"]
    "42" -> "28" [dir=forward tooltip="include"]
    "42" -> "35" [dir=forward tooltip="include"]
    "44" -> "26" [dir=forward tooltip="include"]
    "44" -> "8" [dir=forward tooltip="include"]
    "44" -> "27" [dir=forward tooltip="include"]
    "44" -> "15" [dir=forward tooltip="include"]
    "44" -> "24" [dir=forward tooltip="include"]
    "44" -> "14" [dir=forward tooltip="include"]
    "44" -> "4" [dir=forward tooltip="include"]
    "44" -> "35" [dir=forward tooltip="include"]
    "44" -> "45" [dir=forward tooltip="include"]
    "44" -> "46" [dir=forward tooltip="include"]
    "44" -> "40" [dir=forward tooltip="include"]
    "17" -> "18" [dir=forward tooltip="include"]
    "17" -> "19" [dir=forward tooltip="include"]
    "17" -> "20" [dir=forward tooltip="include"]
    "17" -> "21" [dir=forward tooltip="include"]
    "17" -> "22" [dir=forward tooltip="include"]
    "12" -> "13" [dir=forward tooltip="include"]
    "12" -> "2" [dir=forward tooltip="include"]
    "12" -> "7" [dir=forward tooltip="include"]
    "12" -> "8" [dir=forward tooltip="include"]
    "12" -> "14" [dir=forward tooltip="include"]
    "12" -> "11" [dir=forward tooltip="include"]
    "12" -> "15" [dir=forward tooltip="include"]
    "12" -> "16" [dir=forward tooltip="include"]
    "12" -> "17" [dir=forward tooltip="include"]
    "12" -> "23" [dir=forward tooltip="include"]
    "12" -> "4" [dir=forward tooltip="include"]
    "12" -> "28" [dir=forward tooltip="include"]
    "12" -> "10" [dir=forward tooltip="include"]
    "12" -> "29" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include Component.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" fillcolor="#BFBFBF"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "19" [dir=back tooltip="include"]
    "1" -> "23" [dir=back tooltip="include"]
    "1" -> "24" [dir=back tooltip="include"]
    "1" -> "25" [dir=back tooltip="include"]
    "1" -> "26" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "12" [dir=back tooltip="include"]
    "13" -> "14" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "5" [dir=back tooltip="include"]
    "3" -> "6" [dir=back tooltip="include"]
    "3" -> "7" [dir=back tooltip="include"]
    "3" -> "8" [dir=back tooltip="include"]
    "3" -> "9" [dir=back tooltip="include"]
    "3" -> "10" [dir=back tooltip="include"]
    "3" -> "11" [dir=back tooltip="include"]
    "19" -> "3" [dir=back tooltip="include"]
    "19" -> "20" [dir=back tooltip="include"]
    "19" -> "21" [dir=back tooltip="include"]
    "19" -> "12" [dir=back tooltip="include"]
    "19" -> "22" [dir=back tooltip="include"]
    "23" -> "23" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "15" -> "17" [dir=back tooltip="include"]
    "12" -> "13" [dir=back tooltip="include"]
    "12" -> "18" [dir=back tooltip="include"]
}
file ComponentContainer.H
#include <list>
#include <Component.H>
#include <Timer.H>

Include dependency graph for ComponentContainer.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "24" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "44" [label="CenterFile.H" tooltip="CenterFile.H"]
    "48" [label="Circular.H" tooltip="Circular.H"]
    "7" [label="EXPException.H" tooltip="EXPException.H"]
    "37" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "39" [label="QuadLS.H" tooltip="QuadLS.H"]
    "30" [label="Species.H" tooltip="Species.H"]
    "46" [label="StringTok.H" tooltip="StringTok.H"]
    "26" [label="Timer.H" tooltip="Timer.H"]
    "47" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "34" [label="euler.H" tooltip="euler.H"]
    "42" [label="header.H" tooltip="header.H"]
    "12" [label="libvars.H" tooltip="libvars.H"]
    "29" [label="localmpi.H" tooltip="localmpi.H"]
    "3" [label="Component.H" tooltip="Component.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" fillcolor="#BFBFBF"]
    "31" [label="Orient.H" tooltip="Orient.H"]
    "43" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "45" [label="PotAccel.H" tooltip="PotAccel.H"]
    "18" [label="chkTimer.H" tooltip="chkTimer.H"]
    "17" [label="coef.H" tooltip="coef.H"]
    "14" [label="global.H" tooltip="global.H"]
    "35" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "36" [label="Particle.H" tooltip="Particle.H"]
    "33" [label="algorithm" tooltip="algorithm"]
    "38" [label="array" tooltip="array"]
    "28" [label="chrono" tooltip="chrono"]
    "20" [label="cmath" tooltip="cmath"]
    "41" [label="config_exp.h" tooltip="config_exp.h"]
    "27" [label="cstdlib" tooltip="cstdlib"]
    "32" [label="deque" tooltip="deque"]
    "22" [label="fstream" tooltip="fstream"]
    "23" [label="iomanip" tooltip="iomanip"]
    "21" [label="iostream" tooltip="iostream"]
    "2" [label="list" tooltip="list"]
    "25" [label="map" tooltip="map"]
    "16" [label="memory" tooltip="memory"]
    "4" [label="mpi.h" tooltip="mpi.h"]
    "15" [label="pthread.h" tooltip="pthread.h"]
    "13" [label="random" tooltip="random"]
    "8" [label="set" tooltip="set"]
    "11" [label="sstream" tooltip="sstream"]
    "10" [label="string" tooltip="string"]
    "19" [label="time.h" tooltip="time.h"]
    "40" [label="tuple" tooltip="tuple"]
    "5" [label="utility" tooltip="utility"]
    "9" [label="vector" tooltip="vector"]
    "6" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "24" -> "21" [dir=forward tooltip="include"]
    "24" -> "23" [dir=forward tooltip="include"]
    "24" -> "9" [dir=forward tooltip="include"]
    "24" -> "10" [dir=forward tooltip="include"]
    "24" -> "2" [dir=forward tooltip="include"]
    "24" -> "25" [dir=forward tooltip="include"]
    "24" -> "8" [dir=forward tooltip="include"]
    "24" -> "16" [dir=forward tooltip="include"]
    "24" -> "26" [dir=forward tooltip="include"]
    "24" -> "4" [dir=forward tooltip="include"]
    "44" -> "22" [dir=forward tooltip="include"]
    "44" -> "9" [dir=forward tooltip="include"]
    "44" -> "38" [dir=forward tooltip="include"]
    "44" -> "6" [dir=forward tooltip="include"]
    "48" -> "9" [dir=forward tooltip="include"]
    "7" -> "8" [dir=forward tooltip="include"]
    "7" -> "9" [dir=forward tooltip="include"]
    "7" -> "10" [dir=forward tooltip="include"]
    "7" -> "11" [dir=forward tooltip="include"]
    "7" -> "12" [dir=forward tooltip="include"]
    "37" -> "32" [dir=forward tooltip="include"]
    "37" -> "38" [dir=forward tooltip="include"]
    "37" -> "35" [dir=forward tooltip="include"]
    "37" -> "39" [dir=forward tooltip="include"]
    "39" -> "21" [dir=forward tooltip="include"]
    "39" -> "23" [dir=forward tooltip="include"]
    "39" -> "40" [dir=forward tooltip="include"]
    "30" -> "25" [dir=forward tooltip="include"]
    "30" -> "8" [dir=forward tooltip="include"]
    "30" -> "9" [dir=forward tooltip="include"]
    "26" -> "21" [dir=forward tooltip="include"]
    "26" -> "27" [dir=forward tooltip="include"]
    "26" -> "28" [dir=forward tooltip="include"]
    "47" -> "10" [dir=forward tooltip="include"]
    "47" -> "8" [dir=forward tooltip="include"]
    "47" -> "6" [dir=forward tooltip="include"]
    "34" -> "35" [dir=forward tooltip="include"]
    "42" -> "21" [dir=forward tooltip="include"]
    "42" -> "23" [dir=forward tooltip="include"]
    "42" -> "11" [dir=forward tooltip="include"]
    "42" -> "16" [dir=forward tooltip="include"]
    "42" -> "29" [dir=forward tooltip="include"]
    "12" -> "13" [dir=forward tooltip="include"]
    "12" -> "4" [dir=forward tooltip="include"]
    "29" -> "4" [dir=forward tooltip="include"]
    "29" -> "21" [dir=forward tooltip="include"]
    "29" -> "22" [dir=forward tooltip="include"]
    "29" -> "23" [dir=forward tooltip="include"]
    "29" -> "10" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "5" [dir=forward tooltip="include"]
    "3" -> "6" [dir=forward tooltip="include"]
    "3" -> "7" [dir=forward tooltip="include"]
    "3" -> "14" [dir=forward tooltip="include"]
    "3" -> "31" [dir=forward tooltip="include"]
    "3" -> "42" [dir=forward tooltip="include"]
    "3" -> "29" [dir=forward tooltip="include"]
    "3" -> "43" [dir=forward tooltip="include"]
    "3" -> "44" [dir=forward tooltip="include"]
    "3" -> "45" [dir=forward tooltip="include"]
    "3" -> "48" [dir=forward tooltip="include"]
    "3" -> "26" [dir=forward tooltip="include"]
    "3" -> "41" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "26" [dir=forward tooltip="include"]
    "31" -> "9" [dir=forward tooltip="include"]
    "31" -> "8" [dir=forward tooltip="include"]
    "31" -> "32" [dir=forward tooltip="include"]
    "31" -> "33" [dir=forward tooltip="include"]
    "31" -> "34" [dir=forward tooltip="include"]
    "31" -> "36" [dir=forward tooltip="include"]
    "31" -> "37" [dir=forward tooltip="include"]
    "31" -> "41" [dir=forward tooltip="include"]
    "43" -> "9" [dir=forward tooltip="include"]
    "43" -> "16" [dir=forward tooltip="include"]
    "43" -> "29" [dir=forward tooltip="include"]
    "43" -> "36" [dir=forward tooltip="include"]
    "45" -> "27" [dir=forward tooltip="include"]
    "45" -> "10" [dir=forward tooltip="include"]
    "45" -> "28" [dir=forward tooltip="include"]
    "45" -> "2" [dir=forward tooltip="include"]
    "45" -> "25" [dir=forward tooltip="include"]
    "45" -> "16" [dir=forward tooltip="include"]
    "45" -> "6" [dir=forward tooltip="include"]
    "45" -> "36" [dir=forward tooltip="include"]
    "45" -> "46" [dir=forward tooltip="include"]
    "45" -> "47" [dir=forward tooltip="include"]
    "45" -> "41" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "20" [dir=forward tooltip="include"]
    "18" -> "21" [dir=forward tooltip="include"]
    "18" -> "22" [dir=forward tooltip="include"]
    "18" -> "23" [dir=forward tooltip="include"]
    "14" -> "15" [dir=forward tooltip="include"]
    "14" -> "4" [dir=forward tooltip="include"]
    "14" -> "9" [dir=forward tooltip="include"]
    "14" -> "10" [dir=forward tooltip="include"]
    "14" -> "16" [dir=forward tooltip="include"]
    "14" -> "13" [dir=forward tooltip="include"]
    "14" -> "2" [dir=forward tooltip="include"]
    "14" -> "17" [dir=forward tooltip="include"]
    "14" -> "18" [dir=forward tooltip="include"]
    "14" -> "24" [dir=forward tooltip="include"]
    "14" -> "6" [dir=forward tooltip="include"]
    "14" -> "29" [dir=forward tooltip="include"]
    "14" -> "12" [dir=forward tooltip="include"]
    "14" -> "30" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include ComponentContainer.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" fillcolor="#BFBFBF"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "11" [dir=back tooltip="include"]
    "12" -> "13" [dir=back tooltip="include"]
    "13" -> "14" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "4" [dir=back tooltip="include"]
    "2" -> "5" [dir=back tooltip="include"]
    "2" -> "6" [dir=back tooltip="include"]
    "2" -> "7" [dir=back tooltip="include"]
    "2" -> "8" [dir=back tooltip="include"]
    "2" -> "9" [dir=back tooltip="include"]
    "2" -> "10" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "14" -> "16" [dir=back tooltip="include"]
    "11" -> "12" [dir=back tooltip="include"]
    "11" -> "17" [dir=back tooltip="include"]
}
file Cube.H
#include <complex>
#include <vector>
#include <string>
#include <set>
#include <Eigen/Eigen>
#include <unsupported/Eigen/CXX11/Tensor>
#include <Coefficients.H>
#include <PotAccel.H>

Include dependency graph for Cube.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "17" [label="StringTok.H" tooltip="StringTok.H"]
    "18" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cube.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cube.H" fillcolor="#BFBFBF"]
    "9" [label="PotAccel.H" tooltip="PotAccel.H"]
    "8" [label="Coefficients.H" tooltip="Coefficients.H"]
    "6" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "16" [label="Particle.H" tooltip="Particle.H"]
    "11" [label="chrono" tooltip="chrono"]
    "2" [label="complex" tooltip="complex"]
    "19" [label="config_exp.h" tooltip="config_exp.h"]
    "10" [label="cstdlib" tooltip="cstdlib"]
    "12" [label="list" tooltip="list"]
    "13" [label="map" tooltip="map"]
    "14" [label="memory" tooltip="memory"]
    "5" [label="set" tooltip="set"]
    "4" [label="string" tooltip="string"]
    "7" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
    "3" [label="vector" tooltip="vector"]
    "15" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "18" -> "4" [dir=forward tooltip="include"]
    "18" -> "5" [dir=forward tooltip="include"]
    "18" -> "15" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "4" [dir=forward tooltip="include"]
    "9" -> "11" [dir=forward tooltip="include"]
    "9" -> "12" [dir=forward tooltip="include"]
    "9" -> "13" [dir=forward tooltip="include"]
    "9" -> "14" [dir=forward tooltip="include"]
    "9" -> "15" [dir=forward tooltip="include"]
    "9" -> "16" [dir=forward tooltip="include"]
    "9" -> "17" [dir=forward tooltip="include"]
    "9" -> "18" [dir=forward tooltip="include"]
    "9" -> "19" [dir=forward tooltip="include"]
}
file CylEXP.H
#include <global.H>
#include <expand.H>
#include <EmpCylSL.H>

Include dependency graph for CylEXP.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "17" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "49" [label="CenterFile.H" tooltip="CenterFile.H"]
    "53" [label="Circular.H" tooltip="Circular.H"]
    "68" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "37" [label="EXPException.H" tooltip="EXPException.H"]
    "56" [label="EmpCylSL.H" tooltip="EmpCylSL.H"]
    "60" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "61" [label="Particle.H" tooltip="Particle.H"]
    "43" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "67" [label="QPDistF.H" tooltip="QPDistF.H"]
    "45" [label="QuadLS.H" tooltip="QuadLS.H"]
    "63" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
    "26" [label="Species.H" tooltip="Species.H"]
    "51" [label="StringTok.H" tooltip="StringTok.H"]
    "20" [label="Timer.H" tooltip="Timer.H"]
    "52" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "70" [label="coef.H" tooltip="coef.H"]
    "41" [label="euler.H" tooltip="euler.H"]
    "58" [label="gaussQ.H" tooltip="gaussQ.H"]
    "47" [label="header.H" tooltip="header.H"]
    "59" [label="interp.H" tooltip="interp.H"]
    "25" [label="libvars.H" tooltip="libvars.H"]
    "24" [label="localmpi.H" tooltip="localmpi.H"]
    "65" [label="massmodel.H" tooltip="massmodel.H"]
    "66" [label="orbit.H" tooltip="orbit.H"]
    "69" [label="sltableMP2.H" tooltip="sltableMP2.H"]
    "35" [label="Component.H" tooltip="Component.H"]
    "34" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" fillcolor="#BFBFBF"]
    "54" [label="ExternalForce.H" tooltip="ExternalForce.H"]
    "38" [label="Orient.H" tooltip="Orient.H"]
    "55" [label="Output.H" tooltip="Output.H"]
    "48" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "50" [label="PotAccel.H" tooltip="PotAccel.H"]
    "11" [label="chkTimer.H" tooltip="chkTimer.H"]
    "10" [label="coef.H" tooltip="coef.H"]
    "27" [label="expand.H" tooltip="expand.H"]
    "2" [label="global.H" tooltip="global.H"]
    "33" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "42" [label="Particle.H" tooltip="Particle.H"]
    "40" [label="algorithm" tooltip="algorithm"]
    "44" [label="array" tooltip="array"]
    "22" [label="chrono" tooltip="chrono"]
    "13" [label="cmath" tooltip="cmath"]
    "28" [label="config_exp.h" tooltip="config_exp.h"]
    "21" [label="cstdlib" tooltip="cstdlib"]
    "30" [label="cstring" tooltip="cstring"]
    "39" [label="deque" tooltip="deque"]
    "15" [label="fstream" tooltip="fstream"]
    "57" [label="functional" tooltip="functional"]
    "16" [label="iomanip" tooltip="iomanip"]
    "14" [label="iostream" tooltip="iostream"]
    "32" [label="limits" tooltip="limits"]
    "9" [label="list" tooltip="list"]
    "18" [label="map" tooltip="map"]
    "64" [label="math.h" tooltip="math.h"]
    "7" [label="memory" tooltip="memory"]
    "4" [label="mpi.h" tooltip="mpi.h"]
    "3" [label="pthread.h" tooltip="pthread.h"]
    "8" [label="random" tooltip="random"]
    "19" [label="set" tooltip="set"]
    "31" [label="sstream" tooltip="sstream"]
    "29" [label="stdexcept" tooltip="stdexcept"]
    "6" [label="string" tooltip="string"]
    "12" [label="time.h" tooltip="time.h"]
    "46" [label="tuple" tooltip="tuple"]
    "62" [label="unordered_map" tooltip="unordered_map"]
    "36" [label="utility" tooltip="utility"]
    "5" [label="vector" tooltip="vector"]
    "23" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "17" -> "14" [dir=forward tooltip="include"]
    "17" -> "16" [dir=forward tooltip="include"]
    "17" -> "5" [dir=forward tooltip="include"]
    "17" -> "6" [dir=forward tooltip="include"]
    "17" -> "9" [dir=forward tooltip="include"]
    "17" -> "18" [dir=forward tooltip="include"]
    "17" -> "19" [dir=forward tooltip="include"]
    "17" -> "7" [dir=forward tooltip="include"]
    "17" -> "20" [dir=forward tooltip="include"]
    "17" -> "4" [dir=forward tooltip="include"]
    "49" -> "15" [dir=forward tooltip="include"]
    "49" -> "5" [dir=forward tooltip="include"]
    "49" -> "44" [dir=forward tooltip="include"]
    "49" -> "23" [dir=forward tooltip="include"]
    "53" -> "5" [dir=forward tooltip="include"]
    "68" -> "65" [dir=forward tooltip="include"]
    "37" -> "19" [dir=forward tooltip="include"]
    "37" -> "5" [dir=forward tooltip="include"]
    "37" -> "6" [dir=forward tooltip="include"]
    "37" -> "31" [dir=forward tooltip="include"]
    "37" -> "25" [dir=forward tooltip="include"]
    "56" -> "57" [dir=forward tooltip="include"]
    "56" -> "5" [dir=forward tooltip="include"]
    "56" -> "7" [dir=forward tooltip="include"]
    "56" -> "32" [dir=forward tooltip="include"]
    "56" -> "13" [dir=forward tooltip="include"]
    "56" -> "33" [dir=forward tooltip="include"]
    "56" -> "58" [dir=forward tooltip="include"]
    "56" -> "59" [dir=forward tooltip="include"]
    "56" -> "20" [dir=forward tooltip="include"]
    "56" -> "61" [dir=forward tooltip="include"]
    "56" -> "63" [dir=forward tooltip="include"]
    "56" -> "70" [dir=forward tooltip="include"]
    "56" -> "25" [dir=forward tooltip="include"]
    "60" -> "5" [dir=forward tooltip="include"]
    "60" -> "18" [dir=forward tooltip="include"]
    "60" -> "6" [dir=forward tooltip="include"]
    "61" -> "62" [dir=forward tooltip="include"]
    "61" -> "5" [dir=forward tooltip="include"]
    "61" -> "7" [dir=forward tooltip="include"]
    "43" -> "39" [dir=forward tooltip="include"]
    "43" -> "44" [dir=forward tooltip="include"]
    "43" -> "33" [dir=forward tooltip="include"]
    "43" -> "45" [dir=forward tooltip="include"]
    "67" -> "16" [dir=forward tooltip="include"]
    "67" -> "6" [dir=forward tooltip="include"]
    "67" -> "18" [dir=forward tooltip="include"]
    "67" -> "65" [dir=forward tooltip="include"]
    "67" -> "68" [dir=forward tooltip="include"]
    "67" -> "66" [dir=forward tooltip="include"]
    "45" -> "14" [dir=forward tooltip="include"]
    "45" -> "16" [dir=forward tooltip="include"]
    "45" -> "46" [dir=forward tooltip="include"]
    "63" -> "64" [dir=forward tooltip="include"]
    "63" -> "14" [dir=forward tooltip="include"]
    "63" -> "15" [dir=forward tooltip="include"]
    "63" -> "6" [dir=forward tooltip="include"]
    "63" -> "4" [dir=forward tooltip="include"]
    "63" -> "24" [dir=forward tooltip="include"]
    "63" -> "28" [dir=forward tooltip="include"]
    "63" -> "65" [dir=forward tooltip="include"]
    "63" -> "69" [dir=forward tooltip="include"]
    "63" -> "23" [dir=forward tooltip="include"]
    "63" -> "25" [dir=forward tooltip="include"]
    "26" -> "18" [dir=forward tooltip="include"]
    "26" -> "19" [dir=forward tooltip="include"]
    "26" -> "5" [dir=forward tooltip="include"]
    "20" -> "14" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "22" [dir=forward tooltip="include"]
    "52" -> "6" [dir=forward tooltip="include"]
    "52" -> "19" [dir=forward tooltip="include"]
    "52" -> "23" [dir=forward tooltip="include"]
    "41" -> "33" [dir=forward tooltip="include"]
    "58" -> "14" [dir=forward tooltip="include"]
    "58" -> "16" [dir=forward tooltip="include"]
    "58" -> "31" [dir=forward tooltip="include"]
    "58" -> "21" [dir=forward tooltip="include"]
    "58" -> "6" [dir=forward tooltip="include"]
    "58" -> "5" [dir=forward tooltip="include"]
    "47" -> "14" [dir=forward tooltip="include"]
    "47" -> "16" [dir=forward tooltip="include"]
    "47" -> "31" [dir=forward tooltip="include"]
    "47" -> "7" [dir=forward tooltip="include"]
    "47" -> "24" [dir=forward tooltip="include"]
    "59" -> "33" [dir=forward tooltip="include"]
    "59" -> "5" [dir=forward tooltip="include"]
    "59" -> "39" [dir=forward tooltip="include"]
    "59" -> "60" [dir=forward tooltip="include"]
    "25" -> "8" [dir=forward tooltip="include"]
    "25" -> "4" [dir=forward tooltip="include"]
    "24" -> "4" [dir=forward tooltip="include"]
    "24" -> "14" [dir=forward tooltip="include"]
    "24" -> "15" [dir=forward tooltip="include"]
    "24" -> "16" [dir=forward tooltip="include"]
    "24" -> "6" [dir=forward tooltip="include"]
    "65" -> "5" [dir=forward tooltip="include"]
    "65" -> "7" [dir=forward tooltip="include"]
    "65" -> "8" [dir=forward tooltip="include"]
    "65" -> "46" [dir=forward tooltip="include"]
    "65" -> "33" [dir=forward tooltip="include"]
    "65" -> "59" [dir=forward tooltip="include"]
    "65" -> "66" [dir=forward tooltip="include"]
    "65" -> "67" [dir=forward tooltip="include"]
    "66" -> "57" [dir=forward tooltip="include"]
    "66" -> "7" [dir=forward tooltip="include"]
    "66" -> "33" [dir=forward tooltip="include"]
    "66" -> "58" [dir=forward tooltip="include"]
    "69" -> "33" [dir=forward tooltip="include"]
    "35" -> "4" [dir=forward tooltip="include"]
    "35" -> "36" [dir=forward tooltip="include"]
    "35" -> "23" [dir=forward tooltip="include"]
    "35" -> "37" [dir=forward tooltip="include"]
    "35" -> "2" [dir=forward tooltip="include"]
    "35" -> "38" [dir=forward tooltip="include"]
    "35" -> "47" [dir=forward tooltip="include"]
    "35" -> "24" [dir=forward tooltip="include"]
    "35" -> "48" [dir=forward tooltip="include"]
    "35" -> "49" [dir=forward tooltip="include"]
    "35" -> "50" [dir=forward tooltip="include"]
    "35" -> "53" [dir=forward tooltip="include"]
    "35" -> "20" [dir=forward tooltip="include"]
    "35" -> "28" [dir=forward tooltip="include"]
    "34" -> "9" [dir=forward tooltip="include"]
    "34" -> "35" [dir=forward tooltip="include"]
    "34" -> "20" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "27" [dir=forward tooltip="include"]
    "1" -> "56" [dir=forward tooltip="include"]
    "54" -> "50" [dir=forward tooltip="include"]
    "54" -> "35" [dir=forward tooltip="include"]
    "38" -> "5" [dir=forward tooltip="include"]
    "38" -> "19" [dir=forward tooltip="include"]
    "38" -> "39" [dir=forward tooltip="include"]
    "38" -> "40" [dir=forward tooltip="include"]
    "38" -> "41" [dir=forward tooltip="include"]
    "38" -> "42" [dir=forward tooltip="include"]
    "38" -> "43" [dir=forward tooltip="include"]
    "38" -> "28" [dir=forward tooltip="include"]
    "55" -> "6" [dir=forward tooltip="include"]
    "55" -> "5" [dir=forward tooltip="include"]
    "55" -> "36" [dir=forward tooltip="include"]
    "55" -> "19" [dir=forward tooltip="include"]
    "55" -> "51" [dir=forward tooltip="include"]
    "55" -> "20" [dir=forward tooltip="include"]
    "48" -> "5" [dir=forward tooltip="include"]
    "48" -> "7" [dir=forward tooltip="include"]
    "48" -> "24" [dir=forward tooltip="include"]
    "48" -> "42" [dir=forward tooltip="include"]
    "50" -> "21" [dir=forward tooltip="include"]
    "50" -> "6" [dir=forward tooltip="include"]
    "50" -> "22" [dir=forward tooltip="include"]
    "50" -> "9" [dir=forward tooltip="include"]
    "50" -> "18" [dir=forward tooltip="include"]
    "50" -> "7" [dir=forward tooltip="include"]
    "50" -> "23" [dir=forward tooltip="include"]
    "50" -> "42" [dir=forward tooltip="include"]
    "50" -> "51" [dir=forward tooltip="include"]
    "50" -> "52" [dir=forward tooltip="include"]
    "50" -> "28" [dir=forward tooltip="include"]
    "11" -> "12" [dir=forward tooltip="include"]
    "11" -> "13" [dir=forward tooltip="include"]
    "11" -> "14" [dir=forward tooltip="include"]
    "11" -> "15" [dir=forward tooltip="include"]
    "11" -> "16" [dir=forward tooltip="include"]
    "27" -> "28" [dir=forward tooltip="include"]
    "27" -> "4" [dir=forward tooltip="include"]
    "27" -> "3" [dir=forward tooltip="include"]
    "27" -> "29" [dir=forward tooltip="include"]
    "27" -> "21" [dir=forward tooltip="include"]
    "27" -> "13" [dir=forward tooltip="include"]
    "27" -> "30" [dir=forward tooltip="include"]
    "27" -> "14" [dir=forward tooltip="include"]
    "27" -> "15" [dir=forward tooltip="include"]
    "27" -> "31" [dir=forward tooltip="include"]
    "27" -> "16" [dir=forward tooltip="include"]
    "27" -> "5" [dir=forward tooltip="include"]
    "27" -> "6" [dir=forward tooltip="include"]
    "27" -> "32" [dir=forward tooltip="include"]
    "27" -> "33" [dir=forward tooltip="include"]
    "27" -> "34" [dir=forward tooltip="include"]
    "27" -> "54" [dir=forward tooltip="include"]
    "27" -> "55" [dir=forward tooltip="include"]
    "27" -> "23" [dir=forward tooltip="include"]
    "27" -> "2" [dir=forward tooltip="include"]
    "27" -> "37" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "2" -> "7" [dir=forward tooltip="include"]
    "2" -> "8" [dir=forward tooltip="include"]
    "2" -> "9" [dir=forward tooltip="include"]
    "2" -> "10" [dir=forward tooltip="include"]
    "2" -> "11" [dir=forward tooltip="include"]
    "2" -> "17" [dir=forward tooltip="include"]
    "2" -> "23" [dir=forward tooltip="include"]
    "2" -> "24" [dir=forward tooltip="include"]
    "2" -> "25" [dir=forward tooltip="include"]
    "2" -> "26" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include CylEXP.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" fillcolor="#BFBFBF"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "5" [dir=back tooltip="include"]
}
file Cylinder.H
#include <memory>
#include <Orient.H>
#include <Basis.H>
#include <CylEXP.H>
#include <Coefficients.H>
#include <config_exp.h>
#include <CoefContainer.H>

Include dependency graph for Cylinder.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "38" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "54" [label="CenterFile.H" tooltip="CenterFile.H"]
    "55" [label="Circular.H" tooltip="Circular.H"]
    "70" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "51" [label="EXPException.H" tooltip="EXPException.H"]
    "58" [label="EmpCylSL.H" tooltip="EmpCylSL.H"]
    "62" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "63" [label="Particle.H" tooltip="Particle.H"]
    "11" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "69" [label="QPDistF.H" tooltip="QPDistF.H"]
    "13" [label="QuadLS.H" tooltip="QuadLS.H"]
    "65" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
    "42" [label="Species.H" tooltip="Species.H"]
    "26" [label="StringTok.H" tooltip="StringTok.H"]
    "39" [label="Timer.H" tooltip="Timer.H"]
    "27" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "72" [label="coef.H" tooltip="coef.H"]
    "8" [label="euler.H" tooltip="euler.H"]
    "60" [label="gaussQ.H" tooltip="gaussQ.H"]
    "52" [label="header.H" tooltip="header.H"]
    "61" [label="interp.H" tooltip="interp.H"]
    "41" [label="libvars.H" tooltip="libvars.H"]
    "40" [label="localmpi.H" tooltip="localmpi.H"]
    "67" [label="massmodel.H" tooltip="massmodel.H"]
    "68" [label="orbit.H" tooltip="orbit.H"]
    "71" [label="sltableMP2.H" tooltip="sltableMP2.H"]
    "18" [label="Basis.H" tooltip="Basis.H"]
    "49" [label="Component.H" tooltip="Component.H"]
    "48" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
    "28" [label="CylEXP.H" tooltip="CylEXP.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" fillcolor="#BFBFBF"]
    "56" [label="ExternalForce.H" tooltip="ExternalForce.H"]
    "3" [label="Orient.H" tooltip="Orient.H"]
    "57" [label="Output.H" tooltip="Output.H"]
    "53" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "19" [label="PotAccel.H" tooltip="PotAccel.H"]
    "34" [label="chkTimer.H" tooltip="chkTimer.H"]
    "33" [label="coef.H" tooltip="coef.H"]
    "43" [label="expand.H" tooltip="expand.H"]
    "29" [label="global.H" tooltip="global.H"]
    "74" [label="CoefContainer.H" tooltip="CoefContainer.H"]
    "73" [label="Coefficients.H" tooltip="Coefficients.H"]
    "9" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "10" [label="Particle.H" tooltip="Particle.H"]
    "7" [label="algorithm" tooltip="algorithm"]
    "12" [label="array" tooltip="array"]
    "22" [label="chrono" tooltip="chrono"]
    "36" [label="cmath" tooltip="cmath"]
    "17" [label="config_exp.h" tooltip="config_exp.h"]
    "20" [label="cstdlib" tooltip="cstdlib"]
    "45" [label="cstring" tooltip="cstring"]
    "6" [label="deque" tooltip="deque"]
    "37" [label="fstream" tooltip="fstream"]
    "59" [label="functional" tooltip="functional"]
    "15" [label="iomanip" tooltip="iomanip"]
    "14" [label="iostream" tooltip="iostream"]
    "47" [label="limits" tooltip="limits"]
    "23" [label="list" tooltip="list"]
    "24" [label="map" tooltip="map"]
    "66" [label="math.h" tooltip="math.h"]
    "2" [label="memory" tooltip="memory"]
    "31" [label="mpi.h" tooltip="mpi.h"]
    "30" [label="pthread.h" tooltip="pthread.h"]
    "32" [label="random" tooltip="random"]
    "5" [label="set" tooltip="set"]
    "46" [label="sstream" tooltip="sstream"]
    "44" [label="stdexcept" tooltip="stdexcept"]
    "21" [label="string" tooltip="string"]
    "35" [label="time.h" tooltip="time.h"]
    "16" [label="tuple" tooltip="tuple"]
    "64" [label="unordered_map" tooltip="unordered_map"]
    "50" [label="utility" tooltip="utility"]
    "4" [label="vector" tooltip="vector"]
    "25" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "38" -> "14" [dir=forward tooltip="include"]
    "38" -> "15" [dir=forward tooltip="include"]
    "38" -> "4" [dir=forward tooltip="include"]
    "38" -> "21" [dir=forward tooltip="include"]
    "38" -> "23" [dir=forward tooltip="include"]
    "38" -> "24" [dir=forward tooltip="include"]
    "38" -> "5" [dir=forward tooltip="include"]
    "38" -> "2" [dir=forward tooltip="include"]
    "38" -> "39" [dir=forward tooltip="include"]
    "38" -> "31" [dir=forward tooltip="include"]
    "54" -> "37" [dir=forward tooltip="include"]
    "54" -> "4" [dir=forward tooltip="include"]
    "54" -> "12" [dir=forward tooltip="include"]
    "54" -> "25" [dir=forward tooltip="include"]
    "55" -> "4" [dir=forward tooltip="include"]
    "70" -> "67" [dir=forward tooltip="include"]
    "51" -> "5" [dir=forward tooltip="include"]
    "51" -> "4" [dir=forward tooltip="include"]
    "51" -> "21" [dir=forward tooltip="include"]
    "51" -> "46" [dir=forward tooltip="include"]
    "51" -> "41" [dir=forward tooltip="include"]
    "58" -> "59" [dir=forward tooltip="include"]
    "58" -> "4" [dir=forward tooltip="include"]
    "58" -> "2" [dir=forward tooltip="include"]
    "58" -> "47" [dir=forward tooltip="include"]
    "58" -> "36" [dir=forward tooltip="include"]
    "58" -> "9" [dir=forward tooltip="include"]
    "58" -> "60" [dir=forward tooltip="include"]
    "58" -> "61" [dir=forward tooltip="include"]
    "58" -> "39" [dir=forward tooltip="include"]
    "58" -> "63" [dir=forward tooltip="include"]
    "58" -> "65" [dir=forward tooltip="include"]
    "58" -> "72" [dir=forward tooltip="include"]
    "58" -> "41" [dir=forward tooltip="include"]
    "62" -> "4" [dir=forward tooltip="include"]
    "62" -> "24" [dir=forward tooltip="include"]
    "62" -> "21" [dir=forward tooltip="include"]
    "63" -> "64" [dir=forward tooltip="include"]
    "63" -> "4" [dir=forward tooltip="include"]
    "63" -> "2" [dir=forward tooltip="include"]
    "11" -> "6" [dir=forward tooltip="include"]
    "11" -> "12" [dir=forward tooltip="include"]
    "11" -> "9" [dir=forward tooltip="include"]
    "11" -> "13" [dir=forward tooltip="include"]
    "69" -> "15" [dir=forward tooltip="include"]
    "69" -> "21" [dir=forward tooltip="include"]
    "69" -> "24" [dir=forward tooltip="include"]
    "69" -> "67" [dir=forward tooltip="include"]
    "69" -> "70" [dir=forward tooltip="include"]
    "69" -> "68" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
    "13" -> "16" [dir=forward tooltip="include"]
    "65" -> "66" [dir=forward tooltip="include"]
    "65" -> "14" [dir=forward tooltip="include"]
    "65" -> "37" [dir=forward tooltip="include"]
    "65" -> "21" [dir=forward tooltip="include"]
    "65" -> "31" [dir=forward tooltip="include"]
    "65" -> "40" [dir=forward tooltip="include"]
    "65" -> "17" [dir=forward tooltip="include"]
    "65" -> "67" [dir=forward tooltip="include"]
    "65" -> "71" [dir=forward tooltip="include"]
    "65" -> "25" [dir=forward tooltip="include"]
    "65" -> "41" [dir=forward tooltip="include"]
    "42" -> "24" [dir=forward tooltip="include"]
    "42" -> "5" [dir=forward tooltip="include"]
    "42" -> "4" [dir=forward tooltip="include"]
    "39" -> "14" [dir=forward tooltip="include"]
    "39" -> "20" [dir=forward tooltip="include"]
    "39" -> "22" [dir=forward tooltip="include"]
    "27" -> "21" [dir=forward tooltip="include"]
    "27" -> "5" [dir=forward tooltip="include"]
    "27" -> "25" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "60" -> "14" [dir=forward tooltip="include"]
    "60" -> "15" [dir=forward tooltip="include"]
    "60" -> "46" [dir=forward tooltip="include"]
    "60" -> "20" [dir=forward tooltip="include"]
    "60" -> "21" [dir=forward tooltip="include"]
    "60" -> "4" [dir=forward tooltip="include"]
    "52" -> "14" [dir=forward tooltip="include"]
    "52" -> "15" [dir=forward tooltip="include"]
    "52" -> "46" [dir=forward tooltip="include"]
    "52" -> "2" [dir=forward tooltip="include"]
    "52" -> "40" [dir=forward tooltip="include"]
    "61" -> "9" [dir=forward tooltip="include"]
    "61" -> "4" [dir=forward tooltip="include"]
    "61" -> "6" [dir=forward tooltip="include"]
    "61" -> "62" [dir=forward tooltip="include"]
    "41" -> "32" [dir=forward tooltip="include"]
    "41" -> "31" [dir=forward tooltip="include"]
    "40" -> "31" [dir=forward tooltip="include"]
    "40" -> "14" [dir=forward tooltip="include"]
    "40" -> "37" [dir=forward tooltip="include"]
    "40" -> "15" [dir=forward tooltip="include"]
    "40" -> "21" [dir=forward tooltip="include"]
    "67" -> "4" [dir=forward tooltip="include"]
    "67" -> "2" [dir=forward tooltip="include"]
    "67" -> "32" [dir=forward tooltip="include"]
    "67" -> "16" [dir=forward tooltip="include"]
    "67" -> "9" [dir=forward tooltip="include"]
    "67" -> "61" [dir=forward tooltip="include"]
    "67" -> "68" [dir=forward tooltip="include"]
    "67" -> "69" [dir=forward tooltip="include"]
    "68" -> "59" [dir=forward tooltip="include"]
    "68" -> "2" [dir=forward tooltip="include"]
    "68" -> "9" [dir=forward tooltip="include"]
    "68" -> "60" [dir=forward tooltip="include"]
    "71" -> "9" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "9" [dir=forward tooltip="include"]
    "49" -> "31" [dir=forward tooltip="include"]
    "49" -> "50" [dir=forward tooltip="include"]
    "49" -> "25" [dir=forward tooltip="include"]
    "49" -> "51" [dir=forward tooltip="include"]
    "49" -> "29" [dir=forward tooltip="include"]
    "49" -> "3" [dir=forward tooltip="include"]
    "49" -> "52" [dir=forward tooltip="include"]
    "49" -> "40" [dir=forward tooltip="include"]
    "49" -> "53" [dir=forward tooltip="include"]
    "49" -> "54" [dir=forward tooltip="include"]
    "49" -> "19" [dir=forward tooltip="include"]
    "49" -> "55" [dir=forward tooltip="include"]
    "49" -> "39" [dir=forward tooltip="include"]
    "49" -> "17" [dir=forward tooltip="include"]
    "48" -> "23" [dir=forward tooltip="include"]
    "48" -> "49" [dir=forward tooltip="include"]
    "48" -> "39" [dir=forward tooltip="include"]
    "28" -> "29" [dir=forward tooltip="include"]
    "28" -> "43" [dir=forward tooltip="include"]
    "28" -> "58" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "18" [dir=forward tooltip="include"]
    "1" -> "28" [dir=forward tooltip="include"]
    "1" -> "73" [dir=forward tooltip="include"]
    "1" -> "17" [dir=forward tooltip="include"]
    "1" -> "74" [dir=forward tooltip="include"]
    "56" -> "19" [dir=forward tooltip="include"]
    "56" -> "49" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "5" [dir=forward tooltip="include"]
    "3" -> "6" [dir=forward tooltip="include"]
    "3" -> "7" [dir=forward tooltip="include"]
    "3" -> "8" [dir=forward tooltip="include"]
    "3" -> "10" [dir=forward tooltip="include"]
    "3" -> "11" [dir=forward tooltip="include"]
    "3" -> "17" [dir=forward tooltip="include"]
    "57" -> "21" [dir=forward tooltip="include"]
    "57" -> "4" [dir=forward tooltip="include"]
    "57" -> "50" [dir=forward tooltip="include"]
    "57" -> "5" [dir=forward tooltip="include"]
    "57" -> "26" [dir=forward tooltip="include"]
    "57" -> "39" [dir=forward tooltip="include"]
    "53" -> "4" [dir=forward tooltip="include"]
    "53" -> "2" [dir=forward tooltip="include"]
    "53" -> "40" [dir=forward tooltip="include"]
    "53" -> "10" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "19" -> "21" [dir=forward tooltip="include"]
    "19" -> "22" [dir=forward tooltip="include"]
    "19" -> "23" [dir=forward tooltip="include"]
    "19" -> "24" [dir=forward tooltip="include"]
    "19" -> "2" [dir=forward tooltip="include"]
    "19" -> "25" [dir=forward tooltip="include"]
    "19" -> "10" [dir=forward tooltip="include"]
    "19" -> "26" [dir=forward tooltip="include"]
    "19" -> "27" [dir=forward tooltip="include"]
    "19" -> "17" [dir=forward tooltip="include"]
    "34" -> "35" [dir=forward tooltip="include"]
    "34" -> "36" [dir=forward tooltip="include"]
    "34" -> "14" [dir=forward tooltip="include"]
    "34" -> "37" [dir=forward tooltip="include"]
    "34" -> "15" [dir=forward tooltip="include"]
    "43" -> "17" [dir=forward tooltip="include"]
    "43" -> "31" [dir=forward tooltip="include"]
    "43" -> "30" [dir=forward tooltip="include"]
    "43" -> "44" [dir=forward tooltip="include"]
    "43" -> "20" [dir=forward tooltip="include"]
    "43" -> "36" [dir=forward tooltip="include"]
    "43" -> "45" [dir=forward tooltip="include"]
    "43" -> "14" [dir=forward tooltip="include"]
    "43" -> "37" [dir=forward tooltip="include"]
    "43" -> "46" [dir=forward tooltip="include"]
    "43" -> "15" [dir=forward tooltip="include"]
    "43" -> "4" [dir=forward tooltip="include"]
    "43" -> "21" [dir=forward tooltip="include"]
    "43" -> "47" [dir=forward tooltip="include"]
    "43" -> "9" [dir=forward tooltip="include"]
    "43" -> "48" [dir=forward tooltip="include"]
    "43" -> "56" [dir=forward tooltip="include"]
    "43" -> "57" [dir=forward tooltip="include"]
    "43" -> "25" [dir=forward tooltip="include"]
    "43" -> "29" [dir=forward tooltip="include"]
    "43" -> "51" [dir=forward tooltip="include"]
    "29" -> "30" [dir=forward tooltip="include"]
    "29" -> "31" [dir=forward tooltip="include"]
    "29" -> "4" [dir=forward tooltip="include"]
    "29" -> "21" [dir=forward tooltip="include"]
    "29" -> "2" [dir=forward tooltip="include"]
    "29" -> "32" [dir=forward tooltip="include"]
    "29" -> "23" [dir=forward tooltip="include"]
    "29" -> "33" [dir=forward tooltip="include"]
    "29" -> "34" [dir=forward tooltip="include"]
    "29" -> "38" [dir=forward tooltip="include"]
    "29" -> "25" [dir=forward tooltip="include"]
    "29" -> "40" [dir=forward tooltip="include"]
    "29" -> "41" [dir=forward tooltip="include"]
    "29" -> "42" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include Cylinder.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" fillcolor="#BFBFBF"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "4" [dir=back tooltip="include"]
}
file Direct.H
#include <utility>
#include <memory>
#include <vector>
#include <string>
#include <set>
#include <GravKernel.H>
#include <massmodel.H>

Include dependency graph for Direct.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "34" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "26" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "33" [label="QPDistF.H" tooltip="QPDistF.H"]
    "16" [label="StringTok.H" tooltip="StringTok.H"]
    "17" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "29" [label="gaussQ.H" tooltip="gaussQ.H"]
    "24" [label="interp.H" tooltip="interp.H"]
    "21" [label="massmodel.H" tooltip="massmodel.H"]
    "27" [label="orbit.H" tooltip="orbit.H"]
    "7" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
    "8" [label="Basis.H" tooltip="Basis.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H" fillcolor="#BFBFBF"]
    "20" [label="GravKernel.H" tooltip="GravKernel.H"]
    "9" [label="PotAccel.H" tooltip="PotAccel.H"]
    "19" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "15" [label="Particle.H" tooltip="Particle.H"]
    "11" [label="chrono" tooltip="chrono"]
    "18" [label="config_exp.h" tooltip="config_exp.h"]
    "10" [label="cstdlib" tooltip="cstdlib"]
    "25" [label="deque" tooltip="deque"]
    "28" [label="functional" tooltip="functional"]
    "31" [label="iomanip" tooltip="iomanip"]
    "30" [label="iostream" tooltip="iostream"]
    "12" [label="list" tooltip="list"]
    "13" [label="map" tooltip="map"]
    "3" [label="memory" tooltip="memory"]
    "22" [label="random" tooltip="random"]
    "6" [label="set" tooltip="set"]
    "32" [label="sstream" tooltip="sstream"]
    "5" [label="string" tooltip="string"]
    "23" [label="tuple" tooltip="tuple"]
    "2" [label="utility" tooltip="utility"]
    "4" [label="vector" tooltip="vector"]
    "14" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "34" -> "21" [dir=forward tooltip="include"]
    "26" -> "4" [dir=forward tooltip="include"]
    "26" -> "13" [dir=forward tooltip="include"]
    "26" -> "5" [dir=forward tooltip="include"]
    "33" -> "31" [dir=forward tooltip="include"]
    "33" -> "5" [dir=forward tooltip="include"]
    "33" -> "13" [dir=forward tooltip="include"]
    "33" -> "21" [dir=forward tooltip="include"]
    "33" -> "34" [dir=forward tooltip="include"]
    "33" -> "27" [dir=forward tooltip="include"]
    "17" -> "5" [dir=forward tooltip="include"]
    "17" -> "6" [dir=forward tooltip="include"]
    "17" -> "14" [dir=forward tooltip="include"]
    "29" -> "30" [dir=forward tooltip="include"]
    "29" -> "31" [dir=forward tooltip="include"]
    "29" -> "32" [dir=forward tooltip="include"]
    "29" -> "10" [dir=forward tooltip="include"]
    "29" -> "5" [dir=forward tooltip="include"]
    "29" -> "4" [dir=forward tooltip="include"]
    "24" -> "19" [dir=forward tooltip="include"]
    "24" -> "4" [dir=forward tooltip="include"]
    "24" -> "25" [dir=forward tooltip="include"]
    "24" -> "26" [dir=forward tooltip="include"]
    "21" -> "4" [dir=forward tooltip="include"]
    "21" -> "3" [dir=forward tooltip="include"]
    "21" -> "22" [dir=forward tooltip="include"]
    "21" -> "23" [dir=forward tooltip="include"]
    "21" -> "19" [dir=forward tooltip="include"]
    "21" -> "24" [dir=forward tooltip="include"]
    "21" -> "27" [dir=forward tooltip="include"]
    "21" -> "33" [dir=forward tooltip="include"]
    "27" -> "28" [dir=forward tooltip="include"]
    "27" -> "3" [dir=forward tooltip="include"]
    "27" -> "19" [dir=forward tooltip="include"]
    "27" -> "29" [dir=forward tooltip="include"]
    "7" -> "8" [dir=forward tooltip="include"]
    "7" -> "19" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "19" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "20" [dir=forward tooltip="include"]
    "1" -> "21" [dir=forward tooltip="include"]
    "20" -> "2" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "5" [dir=forward tooltip="include"]
    "9" -> "11" [dir=forward tooltip="include"]
    "9" -> "12" [dir=forward tooltip="include"]
    "9" -> "13" [dir=forward tooltip="include"]
    "9" -> "3" [dir=forward tooltip="include"]
    "9" -> "14" [dir=forward tooltip="include"]
    "9" -> "15" [dir=forward tooltip="include"]
    "9" -> "16" [dir=forward tooltip="include"]
    "9" -> "17" [dir=forward tooltip="include"]
    "9" -> "18" [dir=forward tooltip="include"]
}
file EJcom.H
#include <TwoCenter.H>

Include dependency graph for EJcom.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "62" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "75" [label="CenterFile.H" tooltip="CenterFile.H"]
    "76" [label="Circular.H" tooltip="Circular.H"]
    "28" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "72" [label="EXPException.H" tooltip="EXPException.H"]
    "79" [label="EmpCylSL.H" tooltip="EmpCylSL.H"]
    "20" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "80" [label="Particle.H" tooltip="Particle.H"]
    "52" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "27" [label="QPDistF.H" tooltip="QPDistF.H"]
    "54" [label="QuadLS.H" tooltip="QuadLS.H"]
    "3" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
    "64" [label="Species.H" tooltip="Species.H"]
    "41" [label="StringTok.H" tooltip="StringTok.H"]
    "63" [label="Timer.H" tooltip="Timer.H"]
    "42" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "82" [label="coef.H" tooltip="coef.H"]
    "51" [label="euler.H" tooltip="euler.H"]
    "24" [label="gaussQ.H" tooltip="gaussQ.H"]
    "73" [label="header.H" tooltip="header.H"]
    "18" [label="interp.H" tooltip="interp.H"]
    "31" [label="libvars.H" tooltip="libvars.H"]
    "9" [label="localmpi.H" tooltip="localmpi.H"]
    "12" [label="massmodel.H" tooltip="massmodel.H"]
    "22" [label="orbit.H" tooltip="orbit.H"]
    "29" [label="sltableMP2.H" tooltip="sltableMP2.H"]
    "35" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
    "36" [label="Basis.H" tooltip="Basis.H"]
    "46" [label="Bessel.H" tooltip="Bessel.H"]
    "70" [label="Component.H" tooltip="Component.H"]
    "69" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
    "55" [label="CylEXP.H" tooltip="CylEXP.H"]
    "48" [label="Cylinder.H" tooltip="Cylinder.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" fillcolor="#BFBFBF"]
    "77" [label="ExternalForce.H" tooltip="ExternalForce.H"]
    "44" [label="NVTX.H" tooltip="NVTX.H"]
    "49" [label="Orient.H" tooltip="Orient.H"]
    "78" [label="Output.H" tooltip="Output.H"]
    "74" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "37" [label="PotAccel.H" tooltip="PotAccel.H"]
    "32" [label="Sphere.H" tooltip="Sphere.H"]
    "33" [label="SphericalBasis.H" tooltip="SphericalBasis.H"]
    "2" [label="TwoCenter.H" tooltip="TwoCenter.H"]
    "59" [label="chkTimer.H" tooltip="chkTimer.H"]
    "58" [label="coef.H" tooltip="coef.H"]
    "65" [label="expand.H" tooltip="expand.H"]
    "56" [label="global.H" tooltip="global.H"]
    "45" [label="CoefContainer.H" tooltip="CoefContainer.H"]
    "43" [label="Coefficients.H" tooltip="Coefficients.H"]
    "17" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "40" [label="Particle.H" tooltip="Particle.H"]
    "50" [label="algorithm" tooltip="algorithm"]
    "53" [label="array" tooltip="array"]
    "47" [label="assert.h" tooltip="assert.h"]
    "38" [label="chrono" tooltip="chrono"]
    "61" [label="cmath" tooltip="cmath"]
    "11" [label="config_exp.h" tooltip="config_exp.h"]
    "26" [label="cstdlib" tooltip="cstdlib"]
    "67" [label="cstring" tooltip="cstring"]
    "19" [label="deque" tooltip="deque"]
    "6" [label="fstream" tooltip="fstream"]
    "23" [label="functional" tooltip="functional"]
    "10" [label="iomanip" tooltip="iomanip"]
    "5" [label="iostream" tooltip="iostream"]
    "68" [label="limits" tooltip="limits"]
    "39" [label="list" tooltip="list"]
    "21" [label="map" tooltip="map"]
    "4" [label="math.h" tooltip="math.h"]
    "14" [label="memory" tooltip="memory"]
    "8" [label="mpi.h" tooltip="mpi.h"]
    "57" [label="pthread.h" tooltip="pthread.h"]
    "15" [label="random" tooltip="random"]
    "34" [label="set" tooltip="set"]
    "25" [label="sstream" tooltip="sstream"]
    "66" [label="stdexcept" tooltip="stdexcept"]
    "7" [label="string" tooltip="string"]
    "60" [label="time.h" tooltip="time.h"]
    "16" [label="tuple" tooltip="tuple"]
    "81" [label="unordered_map" tooltip="unordered_map"]
    "71" [label="utility" tooltip="utility"]
    "13" [label="vector" tooltip="vector"]
    "30" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "62" -> "5" [dir=forward tooltip="include"]
    "62" -> "10" [dir=forward tooltip="include"]
    "62" -> "13" [dir=forward tooltip="include"]
    "62" -> "7" [dir=forward tooltip="include"]
    "62" -> "39" [dir=forward tooltip="include"]
    "62" -> "21" [dir=forward tooltip="include"]
    "62" -> "34" [dir=forward tooltip="include"]
    "62" -> "14" [dir=forward tooltip="include"]
    "62" -> "63" [dir=forward tooltip="include"]
    "62" -> "8" [dir=forward tooltip="include"]
    "75" -> "6" [dir=forward tooltip="include"]
    "75" -> "13" [dir=forward tooltip="include"]
    "75" -> "53" [dir=forward tooltip="include"]
    "75" -> "30" [dir=forward tooltip="include"]
    "76" -> "13" [dir=forward tooltip="include"]
    "28" -> "12" [dir=forward tooltip="include"]
    "72" -> "34" [dir=forward tooltip="include"]
    "72" -> "13" [dir=forward tooltip="include"]
    "72" -> "7" [dir=forward tooltip="include"]
    "72" -> "25" [dir=forward tooltip="include"]
    "72" -> "31" [dir=forward tooltip="include"]
    "79" -> "23" [dir=forward tooltip="include"]
    "79" -> "13" [dir=forward tooltip="include"]
    "79" -> "14" [dir=forward tooltip="include"]
    "79" -> "68" [dir=forward tooltip="include"]
    "79" -> "61" [dir=forward tooltip="include"]
    "79" -> "17" [dir=forward tooltip="include"]
    "79" -> "24" [dir=forward tooltip="include"]
    "79" -> "18" [dir=forward tooltip="include"]
    "79" -> "63" [dir=forward tooltip="include"]
    "79" -> "80" [dir=forward tooltip="include"]
    "79" -> "3" [dir=forward tooltip="include"]
    "79" -> "82" [dir=forward tooltip="include"]
    "79" -> "31" [dir=forward tooltip="include"]
    "20" -> "13" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "7" [dir=forward tooltip="include"]
    "80" -> "81" [dir=forward tooltip="include"]
    "80" -> "13" [dir=forward tooltip="include"]
    "80" -> "14" [dir=forward tooltip="include"]
    "52" -> "19" [dir=forward tooltip="include"]
    "52" -> "53" [dir=forward tooltip="include"]
    "52" -> "17" [dir=forward tooltip="include"]
    "52" -> "54" [dir=forward tooltip="include"]
    "27" -> "10" [dir=forward tooltip="include"]
    "27" -> "7" [dir=forward tooltip="include"]
    "27" -> "21" [dir=forward tooltip="include"]
    "27" -> "12" [dir=forward tooltip="include"]
    "27" -> "28" [dir=forward tooltip="include"]
    "27" -> "22" [dir=forward tooltip="include"]
    "54" -> "5" [dir=forward tooltip="include"]
    "54" -> "10" [dir=forward tooltip="include"]
    "54" -> "16" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "5" [dir=forward tooltip="include"]
    "3" -> "6" [dir=forward tooltip="include"]
    "3" -> "7" [dir=forward tooltip="include"]
    "3" -> "8" [dir=forward tooltip="include"]
    "3" -> "9" [dir=forward tooltip="include"]
    "3" -> "11" [dir=forward tooltip="include"]
    "3" -> "12" [dir=forward tooltip="include"]
    "3" -> "29" [dir=forward tooltip="include"]
    "3" -> "30" [dir=forward tooltip="include"]
    "3" -> "31" [dir=forward tooltip="include"]
    "64" -> "21" [dir=forward tooltip="include"]
    "64" -> "34" [dir=forward tooltip="include"]
    "64" -> "13" [dir=forward tooltip="include"]
    "63" -> "5" [dir=forward tooltip="include"]
    "63" -> "26" [dir=forward tooltip="include"]
    "63" -> "38" [dir=forward tooltip="include"]
    "42" -> "7" [dir=forward tooltip="include"]
    "42" -> "34" [dir=forward tooltip="include"]
    "42" -> "30" [dir=forward tooltip="include"]
    "51" -> "17" [dir=forward tooltip="include"]
    "24" -> "5" [dir=forward tooltip="include"]
    "24" -> "10" [dir=forward tooltip="include"]
    "24" -> "25" [dir=forward tooltip="include"]
    "24" -> "26" [dir=forward tooltip="include"]
    "24" -> "7" [dir=forward tooltip="include"]
    "24" -> "13" [dir=forward tooltip="include"]
    "73" -> "5" [dir=forward tooltip="include"]
    "73" -> "10" [dir=forward tooltip="include"]
    "73" -> "25" [dir=forward tooltip="include"]
    "73" -> "14" [dir=forward tooltip="include"]
    "73" -> "9" [dir=forward tooltip="include"]
    "18" -> "17" [dir=forward tooltip="include"]
    "18" -> "13" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "20" [dir=forward tooltip="include"]
    "31" -> "15" [dir=forward tooltip="include"]
    "31" -> "8" [dir=forward tooltip="include"]
    "9" -> "8" [dir=forward tooltip="include"]
    "9" -> "5" [dir=forward tooltip="include"]
    "9" -> "6" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "7" [dir=forward tooltip="include"]
    "12" -> "13" [dir=forward tooltip="include"]
    "12" -> "14" [dir=forward tooltip="include"]
    "12" -> "15" [dir=forward tooltip="include"]
    "12" -> "16" [dir=forward tooltip="include"]
    "12" -> "17" [dir=forward tooltip="include"]
    "12" -> "18" [dir=forward tooltip="include"]
    "12" -> "22" [dir=forward tooltip="include"]
    "12" -> "27" [dir=forward tooltip="include"]
    "22" -> "23" [dir=forward tooltip="include"]
    "22" -> "14" [dir=forward tooltip="include"]
    "22" -> "17" [dir=forward tooltip="include"]
    "22" -> "24" [dir=forward tooltip="include"]
    "29" -> "17" [dir=forward tooltip="include"]
    "35" -> "36" [dir=forward tooltip="include"]
    "35" -> "17" [dir=forward tooltip="include"]
    "36" -> "37" [dir=forward tooltip="include"]
    "36" -> "17" [dir=forward tooltip="include"]
    "46" -> "47" [dir=forward tooltip="include"]
    "46" -> "33" [dir=forward tooltip="include"]
    "70" -> "8" [dir=forward tooltip="include"]
    "70" -> "71" [dir=forward tooltip="include"]
    "70" -> "30" [dir=forward tooltip="include"]
    "70" -> "72" [dir=forward tooltip="include"]
    "70" -> "56" [dir=forward tooltip="include"]
    "70" -> "49" [dir=forward tooltip="include"]
    "70" -> "73" [dir=forward tooltip="include"]
    "70" -> "9" [dir=forward tooltip="include"]
    "70" -> "74" [dir=forward tooltip="include"]
    "70" -> "75" [dir=forward tooltip="include"]
    "70" -> "37" [dir=forward tooltip="include"]
    "70" -> "76" [dir=forward tooltip="include"]
    "70" -> "63" [dir=forward tooltip="include"]
    "70" -> "11" [dir=forward tooltip="include"]
    "69" -> "39" [dir=forward tooltip="include"]
    "69" -> "70" [dir=forward tooltip="include"]
    "69" -> "63" [dir=forward tooltip="include"]
    "55" -> "56" [dir=forward tooltip="include"]
    "55" -> "65" [dir=forward tooltip="include"]
    "55" -> "79" [dir=forward tooltip="include"]
    "48" -> "14" [dir=forward tooltip="include"]
    "48" -> "49" [dir=forward tooltip="include"]
    "48" -> "36" [dir=forward tooltip="include"]
    "48" -> "55" [dir=forward tooltip="include"]
    "48" -> "43" [dir=forward tooltip="include"]
    "48" -> "11" [dir=forward tooltip="include"]
    "48" -> "45" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "77" -> "37" [dir=forward tooltip="include"]
    "77" -> "70" [dir=forward tooltip="include"]
    "44" -> "14" [dir=forward tooltip="include"]
    "44" -> "11" [dir=forward tooltip="include"]
    "49" -> "13" [dir=forward tooltip="include"]
    "49" -> "34" [dir=forward tooltip="include"]
    "49" -> "19" [dir=forward tooltip="include"]
    "49" -> "50" [dir=forward tooltip="include"]
    "49" -> "51" [dir=forward tooltip="include"]
    "49" -> "40" [dir=forward tooltip="include"]
    "49" -> "52" [dir=forward tooltip="include"]
    "49" -> "11" [dir=forward tooltip="include"]
    "78" -> "7" [dir=forward tooltip="include"]
    "78" -> "13" [dir=forward tooltip="include"]
    "78" -> "71" [dir=forward tooltip="include"]
    "78" -> "34" [dir=forward tooltip="include"]
    "78" -> "41" [dir=forward tooltip="include"]
    "78" -> "63" [dir=forward tooltip="include"]
    "74" -> "13" [dir=forward tooltip="include"]
    "74" -> "14" [dir=forward tooltip="include"]
    "74" -> "9" [dir=forward tooltip="include"]
    "74" -> "40" [dir=forward tooltip="include"]
    "37" -> "26" [dir=forward tooltip="include"]
    "37" -> "7" [dir=forward tooltip="include"]
    "37" -> "38" [dir=forward tooltip="include"]
    "37" -> "39" [dir=forward tooltip="include"]
    "37" -> "21" [dir=forward tooltip="include"]
    "37" -> "14" [dir=forward tooltip="include"]
    "37" -> "30" [dir=forward tooltip="include"]
    "37" -> "40" [dir=forward tooltip="include"]
    "37" -> "41" [dir=forward tooltip="include"]
    "37" -> "42" [dir=forward tooltip="include"]
    "37" -> "11" [dir=forward tooltip="include"]
    "32" -> "14" [dir=forward tooltip="include"]
    "32" -> "21" [dir=forward tooltip="include"]
    "32" -> "3" [dir=forward tooltip="include"]
    "32" -> "33" [dir=forward tooltip="include"]
    "33" -> "14" [dir=forward tooltip="include"]
    "33" -> "15" [dir=forward tooltip="include"]
    "33" -> "13" [dir=forward tooltip="include"]
    "33" -> "7" [dir=forward tooltip="include"]
    "33" -> "34" [dir=forward tooltip="include"]
    "33" -> "35" [dir=forward tooltip="include"]
    "33" -> "43" [dir=forward tooltip="include"]
    "33" -> "11" [dir=forward tooltip="include"]
    "33" -> "44" [dir=forward tooltip="include"]
    "33" -> "45" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "32" [dir=forward tooltip="include"]
    "2" -> "46" [dir=forward tooltip="include"]
    "2" -> "48" [dir=forward tooltip="include"]
    "59" -> "60" [dir=forward tooltip="include"]
    "59" -> "61" [dir=forward tooltip="include"]
    "59" -> "5" [dir=forward tooltip="include"]
    "59" -> "6" [dir=forward tooltip="include"]
    "59" -> "10" [dir=forward tooltip="include"]
    "65" -> "11" [dir=forward tooltip="include"]
    "65" -> "8" [dir=forward tooltip="include"]
    "65" -> "57" [dir=forward tooltip="include"]
    "65" -> "66" [dir=forward tooltip="include"]
    "65" -> "26" [dir=forward tooltip="include"]
    "65" -> "61" [dir=forward tooltip="include"]
    "65" -> "67" [dir=forward tooltip="include"]
    "65" -> "5" [dir=forward tooltip="include"]
    "65" -> "6" [dir=forward tooltip="include"]
    "65" -> "25" [dir=forward tooltip="include"]
    "65" -> "10" [dir=forward tooltip="include"]
    "65" -> "13" [dir=forward tooltip="include"]
    "65" -> "7" [dir=forward tooltip="include"]
    "65" -> "68" [dir=forward tooltip="include"]
    "65" -> "17" [dir=forward tooltip="include"]
    "65" -> "69" [dir=forward tooltip="include"]
    "65" -> "77" [dir=forward tooltip="include"]
    "65" -> "78" [dir=forward tooltip="include"]
    "65" -> "30" [dir=forward tooltip="include"]
    "65" -> "56" [dir=forward tooltip="include"]
    "65" -> "72" [dir=forward tooltip="include"]
    "56" -> "57" [dir=forward tooltip="include"]
    "56" -> "8" [dir=forward tooltip="include"]
    "56" -> "13" [dir=forward tooltip="include"]
    "56" -> "7" [dir=forward tooltip="include"]
    "56" -> "14" [dir=forward tooltip="include"]
    "56" -> "15" [dir=forward tooltip="include"]
    "56" -> "39" [dir=forward tooltip="include"]
    "56" -> "58" [dir=forward tooltip="include"]
    "56" -> "59" [dir=forward tooltip="include"]
    "56" -> "62" [dir=forward tooltip="include"]
    "56" -> "30" [dir=forward tooltip="include"]
    "56" -> "9" [dir=forward tooltip="include"]
    "56" -> "31" [dir=forward tooltip="include"]
    "56" -> "64" [dir=forward tooltip="include"]
}
file EnumBitset.H
#include <bitset>
#include <type_traits>

Include dependency graph for EnumBitset.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EnumBitset.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EnumBitset.H" fillcolor="#BFBFBF"]
    "2" [label="bitset" tooltip="bitset"]
    "3" [label="type_traits" tooltip="type_traits"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
}
file expand.H
#include <config_exp.h>
#include <mpi.h>
#include <pthread.h>
#include <stdexcept>
#include <cstdlib>
#include <cmath>
#include <cstring>
#include <iostream>
#include <fstream>
#include <sstream>
#include <iomanip>
#include <vector>
#include <string>
#include <limits>
#include <Eigen/Eigen>
#include <ExternalForce.H>
#include <Output.H>
#include <yaml-cpp/yaml.h>
#include <global.H>
#include <EXPException.H>

Include dependency graph for expand.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "31" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "48" [label="CenterFile.H" tooltip="CenterFile.H"]
    "52" [label="Circular.H" tooltip="Circular.H"]
    "22" [label="EXPException.H" tooltip="EXPException.H"]
    "42" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "44" [label="QuadLS.H" tooltip="QuadLS.H"]
    "36" [label="Species.H" tooltip="Species.H"]
    "50" [label="StringTok.H" tooltip="StringTok.H"]
    "33" [label="Timer.H" tooltip="Timer.H"]
    "51" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "40" [label="euler.H" tooltip="euler.H"]
    "46" [label="header.H" tooltip="header.H"]
    "24" [label="libvars.H" tooltip="libvars.H"]
    "35" [label="localmpi.H" tooltip="localmpi.H"]
    "19" [label="Component.H" tooltip="Component.H"]
    "17" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
    "53" [label="ExternalForce.H" tooltip="ExternalForce.H"]
    "37" [label="Orient.H" tooltip="Orient.H"]
    "54" [label="Output.H" tooltip="Output.H"]
    "47" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "49" [label="PotAccel.H" tooltip="PotAccel.H"]
    "29" [label="chkTimer.H" tooltip="chkTimer.H"]
    "28" [label="coef.H" tooltip="coef.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" fillcolor="#BFBFBF"]
    "26" [label="global.H" tooltip="global.H"]
    "16" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "41" [label="Particle.H" tooltip="Particle.H"]
    "39" [label="algorithm" tooltip="algorithm"]
    "43" [label="array" tooltip="array"]
    "34" [label="chrono" tooltip="chrono"]
    "7" [label="cmath" tooltip="cmath"]
    "2" [label="config_exp.h" tooltip="config_exp.h"]
    "6" [label="cstdlib" tooltip="cstdlib"]
    "8" [label="cstring" tooltip="cstring"]
    "38" [label="deque" tooltip="deque"]
    "10" [label="fstream" tooltip="fstream"]
    "12" [label="iomanip" tooltip="iomanip"]
    "9" [label="iostream" tooltip="iostream"]
    "15" [label="limits" tooltip="limits"]
    "18" [label="list" tooltip="list"]
    "32" [label="map" tooltip="map"]
    "27" [label="memory" tooltip="memory"]
    "3" [label="mpi.h" tooltip="mpi.h"]
    "4" [label="pthread.h" tooltip="pthread.h"]
    "25" [label="random" tooltip="random"]
    "23" [label="set" tooltip="set"]
    "11" [label="sstream" tooltip="sstream"]
    "5" [label="stdexcept" tooltip="stdexcept"]
    "14" [label="string" tooltip="string"]
    "30" [label="time.h" tooltip="time.h"]
    "45" [label="tuple" tooltip="tuple"]
    "20" [label="utility" tooltip="utility"]
    "13" [label="vector" tooltip="vector"]
    "21" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "31" -> "9" [dir=forward tooltip="include"]
    "31" -> "12" [dir=forward tooltip="include"]
    "31" -> "13" [dir=forward tooltip="include"]
    "31" -> "14" [dir=forward tooltip="include"]
    "31" -> "18" [dir=forward tooltip="include"]
    "31" -> "32" [dir=forward tooltip="include"]
    "31" -> "23" [dir=forward tooltip="include"]
    "31" -> "27" [dir=forward tooltip="include"]
    "31" -> "33" [dir=forward tooltip="include"]
    "31" -> "3" [dir=forward tooltip="include"]
    "48" -> "10" [dir=forward tooltip="include"]
    "48" -> "13" [dir=forward tooltip="include"]
    "48" -> "43" [dir=forward tooltip="include"]
    "48" -> "21" [dir=forward tooltip="include"]
    "52" -> "13" [dir=forward tooltip="include"]
    "22" -> "23" [dir=forward tooltip="include"]
    "22" -> "13" [dir=forward tooltip="include"]
    "22" -> "14" [dir=forward tooltip="include"]
    "22" -> "11" [dir=forward tooltip="include"]
    "22" -> "24" [dir=forward tooltip="include"]
    "42" -> "38" [dir=forward tooltip="include"]
    "42" -> "43" [dir=forward tooltip="include"]
    "42" -> "16" [dir=forward tooltip="include"]
    "42" -> "44" [dir=forward tooltip="include"]
    "44" -> "9" [dir=forward tooltip="include"]
    "44" -> "12" [dir=forward tooltip="include"]
    "44" -> "45" [dir=forward tooltip="include"]
    "36" -> "32" [dir=forward tooltip="include"]
    "36" -> "23" [dir=forward tooltip="include"]
    "36" -> "13" [dir=forward tooltip="include"]
    "33" -> "9" [dir=forward tooltip="include"]
    "33" -> "6" [dir=forward tooltip="include"]
    "33" -> "34" [dir=forward tooltip="include"]
    "51" -> "14" [dir=forward tooltip="include"]
    "51" -> "23" [dir=forward tooltip="include"]
    "51" -> "21" [dir=forward tooltip="include"]
    "40" -> "16" [dir=forward tooltip="include"]
    "46" -> "9" [dir=forward tooltip="include"]
    "46" -> "12" [dir=forward tooltip="include"]
    "46" -> "11" [dir=forward tooltip="include"]
    "46" -> "27" [dir=forward tooltip="include"]
    "46" -> "35" [dir=forward tooltip="include"]
    "24" -> "25" [dir=forward tooltip="include"]
    "24" -> "3" [dir=forward tooltip="include"]
    "35" -> "3" [dir=forward tooltip="include"]
    "35" -> "9" [dir=forward tooltip="include"]
    "35" -> "10" [dir=forward tooltip="include"]
    "35" -> "12" [dir=forward tooltip="include"]
    "35" -> "14" [dir=forward tooltip="include"]
    "19" -> "3" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "19" -> "21" [dir=forward tooltip="include"]
    "19" -> "22" [dir=forward tooltip="include"]
    "19" -> "26" [dir=forward tooltip="include"]
    "19" -> "37" [dir=forward tooltip="include"]
    "19" -> "46" [dir=forward tooltip="include"]
    "19" -> "35" [dir=forward tooltip="include"]
    "19" -> "47" [dir=forward tooltip="include"]
    "19" -> "48" [dir=forward tooltip="include"]
    "19" -> "49" [dir=forward tooltip="include"]
    "19" -> "52" [dir=forward tooltip="include"]
    "19" -> "33" [dir=forward tooltip="include"]
    "19" -> "2" [dir=forward tooltip="include"]
    "17" -> "18" [dir=forward tooltip="include"]
    "17" -> "19" [dir=forward tooltip="include"]
    "17" -> "33" [dir=forward tooltip="include"]
    "53" -> "49" [dir=forward tooltip="include"]
    "53" -> "19" [dir=forward tooltip="include"]
    "37" -> "13" [dir=forward tooltip="include"]
    "37" -> "23" [dir=forward tooltip="include"]
    "37" -> "38" [dir=forward tooltip="include"]
    "37" -> "39" [dir=forward tooltip="include"]
    "37" -> "40" [dir=forward tooltip="include"]
    "37" -> "41" [dir=forward tooltip="include"]
    "37" -> "42" [dir=forward tooltip="include"]
    "37" -> "2" [dir=forward tooltip="include"]
    "54" -> "14" [dir=forward tooltip="include"]
    "54" -> "13" [dir=forward tooltip="include"]
    "54" -> "20" [dir=forward tooltip="include"]
    "54" -> "23" [dir=forward tooltip="include"]
    "54" -> "50" [dir=forward tooltip="include"]
    "54" -> "33" [dir=forward tooltip="include"]
    "47" -> "13" [dir=forward tooltip="include"]
    "47" -> "27" [dir=forward tooltip="include"]
    "47" -> "35" [dir=forward tooltip="include"]
    "47" -> "41" [dir=forward tooltip="include"]
    "49" -> "6" [dir=forward tooltip="include"]
    "49" -> "14" [dir=forward tooltip="include"]
    "49" -> "34" [dir=forward tooltip="include"]
    "49" -> "18" [dir=forward tooltip="include"]
    "49" -> "32" [dir=forward tooltip="include"]
    "49" -> "27" [dir=forward tooltip="include"]
    "49" -> "21" [dir=forward tooltip="include"]
    "49" -> "41" [dir=forward tooltip="include"]
    "49" -> "50" [dir=forward tooltip="include"]
    "49" -> "51" [dir=forward tooltip="include"]
    "49" -> "2" [dir=forward tooltip="include"]
    "29" -> "30" [dir=forward tooltip="include"]
    "29" -> "7" [dir=forward tooltip="include"]
    "29" -> "9" [dir=forward tooltip="include"]
    "29" -> "10" [dir=forward tooltip="include"]
    "29" -> "12" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "1" -> "10" [dir=forward tooltip="include"]
    "1" -> "11" [dir=forward tooltip="include"]
    "1" -> "12" [dir=forward tooltip="include"]
    "1" -> "13" [dir=forward tooltip="include"]
    "1" -> "14" [dir=forward tooltip="include"]
    "1" -> "15" [dir=forward tooltip="include"]
    "1" -> "16" [dir=forward tooltip="include"]
    "1" -> "17" [dir=forward tooltip="include"]
    "1" -> "53" [dir=forward tooltip="include"]
    "1" -> "54" [dir=forward tooltip="include"]
    "1" -> "21" [dir=forward tooltip="include"]
    "1" -> "26" [dir=forward tooltip="include"]
    "1" -> "22" [dir=forward tooltip="include"]
    "26" -> "4" [dir=forward tooltip="include"]
    "26" -> "3" [dir=forward tooltip="include"]
    "26" -> "13" [dir=forward tooltip="include"]
    "26" -> "14" [dir=forward tooltip="include"]
    "26" -> "27" [dir=forward tooltip="include"]
    "26" -> "25" [dir=forward tooltip="include"]
    "26" -> "18" [dir=forward tooltip="include"]
    "26" -> "28" [dir=forward tooltip="include"]
    "26" -> "29" [dir=forward tooltip="include"]
    "26" -> "31" [dir=forward tooltip="include"]
    "26" -> "21" [dir=forward tooltip="include"]
    "26" -> "35" [dir=forward tooltip="include"]
    "26" -> "24" [dir=forward tooltip="include"]
    "26" -> "36" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include expand.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" fillcolor="#BFBFBF"]
    "2" -> "3" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "6" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "7" [dir=back tooltip="include"]
}

Defines

BSD_SOURCE
MAX(A, B)
MIN(A, B)

Functions

void adjust_multistep_level()
inline double atof(string &s)
inline int atoi(string &s)
inline bool atol(string &s)
void begin_run(void)
void create_tipsy(void)
double densi(double rr, int l, int n)
double dgammln()
void do_output_init(void)
double dplgndr(int l, int m, double x)
void exp_mpi_error_handler(MPI_Comm *communicator, int *error_code, ...)
double factrl(int n)
double get_dens(double r, int l, double *coef)
void get_potacc(double r, int l, double *coef, double *p, double *dp)
void get_ultra(int nmax, double l, double x, Eigen::VectorXd &p)
void incr_com_position(double dt)
void incr_com_velocity(double dt)
void incr_position(double dt, int mlevel = 0)
void incr_velocity(double dt, int mlevel = 0)
void init_velocity(void)
void initialize_cuda(void)
void initialize_multistep()
void locate()
void make_grid(double rmin, double rmax, int lmax, int nmax)
void mpi_gdb_print_trace(int sig)
void mpi_gdb_wait_trace(int sig)
void mpi_print_trace(const string &routine, const string &msg, const char *file, int line)
double MPL_read_timer(int reset)
void MPL_reset_timer(void)
void MPL_start_timer(void)
void MPL_stop_timer(void)
void parallel_distribute_coefficients(void)
void parallel_gather_coefficients(void)
double plgndr(int, int, double)
double potli(double rr, int l, int n)
void print_trace(std::ostream &out, const char *file, int line)
void recompute_processor_rates(void)
void redistribute_particles(void)
void set_fpu_gdb_handler(void)
void set_fpu_invalid_handler(void)
void set_fpu_trace_handler(void)
void set_global_com(void)
void setup_distribution(void)
void signal_handler_dump(int sig)
void signal_handler_stop(int sig)
void sync_eval_multistep()
void test_mpi(void)
string trimComment(const string)
string trimLeft(const string)
string trimRight(const string)
void write_parm(void)
double zbrent()

Variables

static const double DSMALL = 1.0e-16
static const int mdtDim = 7
file ExternalCollection.H
#include <map>
#include <ExternalForce.H>

Include dependency graph for ExternalCollection.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "26" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "45" [label="CenterFile.H" tooltip="CenterFile.H"]
    "49" [label="Circular.H" tooltip="Circular.H"]
    "9" [label="EXPException.H" tooltip="EXPException.H"]
    "38" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "40" [label="QuadLS.H" tooltip="QuadLS.H"]
    "31" [label="Species.H" tooltip="Species.H"]
    "47" [label="StringTok.H" tooltip="StringTok.H"]
    "27" [label="Timer.H" tooltip="Timer.H"]
    "48" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "35" [label="euler.H" tooltip="euler.H"]
    "43" [label="header.H" tooltip="header.H"]
    "14" [label="libvars.H" tooltip="libvars.H"]
    "30" [label="localmpi.H" tooltip="localmpi.H"]
    "5" [label="Component.H" tooltip="Component.H"]
    "3" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" fillcolor="#BFBFBF"]
    "50" [label="ExternalForce.H" tooltip="ExternalForce.H"]
    "32" [label="Orient.H" tooltip="Orient.H"]
    "44" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "46" [label="PotAccel.H" tooltip="PotAccel.H"]
    "20" [label="chkTimer.H" tooltip="chkTimer.H"]
    "19" [label="coef.H" tooltip="coef.H"]
    "16" [label="global.H" tooltip="global.H"]
    "36" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "37" [label="Particle.H" tooltip="Particle.H"]
    "34" [label="algorithm" tooltip="algorithm"]
    "39" [label="array" tooltip="array"]
    "29" [label="chrono" tooltip="chrono"]
    "22" [label="cmath" tooltip="cmath"]
    "42" [label="config_exp.h" tooltip="config_exp.h"]
    "28" [label="cstdlib" tooltip="cstdlib"]
    "33" [label="deque" tooltip="deque"]
    "24" [label="fstream" tooltip="fstream"]
    "25" [label="iomanip" tooltip="iomanip"]
    "23" [label="iostream" tooltip="iostream"]
    "4" [label="list" tooltip="list"]
    "2" [label="map" tooltip="map"]
    "18" [label="memory" tooltip="memory"]
    "6" [label="mpi.h" tooltip="mpi.h"]
    "17" [label="pthread.h" tooltip="pthread.h"]
    "15" [label="random" tooltip="random"]
    "10" [label="set" tooltip="set"]
    "13" [label="sstream" tooltip="sstream"]
    "12" [label="string" tooltip="string"]
    "21" [label="time.h" tooltip="time.h"]
    "41" [label="tuple" tooltip="tuple"]
    "7" [label="utility" tooltip="utility"]
    "11" [label="vector" tooltip="vector"]
    "8" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "26" -> "23" [dir=forward tooltip="include"]
    "26" -> "25" [dir=forward tooltip="include"]
    "26" -> "11" [dir=forward tooltip="include"]
    "26" -> "12" [dir=forward tooltip="include"]
    "26" -> "4" [dir=forward tooltip="include"]
    "26" -> "2" [dir=forward tooltip="include"]
    "26" -> "10" [dir=forward tooltip="include"]
    "26" -> "18" [dir=forward tooltip="include"]
    "26" -> "27" [dir=forward tooltip="include"]
    "26" -> "6" [dir=forward tooltip="include"]
    "45" -> "24" [dir=forward tooltip="include"]
    "45" -> "11" [dir=forward tooltip="include"]
    "45" -> "39" [dir=forward tooltip="include"]
    "45" -> "8" [dir=forward tooltip="include"]
    "49" -> "11" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "11" [dir=forward tooltip="include"]
    "9" -> "12" [dir=forward tooltip="include"]
    "9" -> "13" [dir=forward tooltip="include"]
    "9" -> "14" [dir=forward tooltip="include"]
    "38" -> "33" [dir=forward tooltip="include"]
    "38" -> "39" [dir=forward tooltip="include"]
    "38" -> "36" [dir=forward tooltip="include"]
    "38" -> "40" [dir=forward tooltip="include"]
    "40" -> "23" [dir=forward tooltip="include"]
    "40" -> "25" [dir=forward tooltip="include"]
    "40" -> "41" [dir=forward tooltip="include"]
    "31" -> "2" [dir=forward tooltip="include"]
    "31" -> "10" [dir=forward tooltip="include"]
    "31" -> "11" [dir=forward tooltip="include"]
    "27" -> "23" [dir=forward tooltip="include"]
    "27" -> "28" [dir=forward tooltip="include"]
    "27" -> "29" [dir=forward tooltip="include"]
    "48" -> "12" [dir=forward tooltip="include"]
    "48" -> "10" [dir=forward tooltip="include"]
    "48" -> "8" [dir=forward tooltip="include"]
    "35" -> "36" [dir=forward tooltip="include"]
    "43" -> "23" [dir=forward tooltip="include"]
    "43" -> "25" [dir=forward tooltip="include"]
    "43" -> "13" [dir=forward tooltip="include"]
    "43" -> "18" [dir=forward tooltip="include"]
    "43" -> "30" [dir=forward tooltip="include"]
    "14" -> "15" [dir=forward tooltip="include"]
    "14" -> "6" [dir=forward tooltip="include"]
    "30" -> "6" [dir=forward tooltip="include"]
    "30" -> "23" [dir=forward tooltip="include"]
    "30" -> "24" [dir=forward tooltip="include"]
    "30" -> "25" [dir=forward tooltip="include"]
    "30" -> "12" [dir=forward tooltip="include"]
    "5" -> "6" [dir=forward tooltip="include"]
    "5" -> "7" [dir=forward tooltip="include"]
    "5" -> "8" [dir=forward tooltip="include"]
    "5" -> "9" [dir=forward tooltip="include"]
    "5" -> "16" [dir=forward tooltip="include"]
    "5" -> "32" [dir=forward tooltip="include"]
    "5" -> "43" [dir=forward tooltip="include"]
    "5" -> "30" [dir=forward tooltip="include"]
    "5" -> "44" [dir=forward tooltip="include"]
    "5" -> "45" [dir=forward tooltip="include"]
    "5" -> "46" [dir=forward tooltip="include"]
    "5" -> "49" [dir=forward tooltip="include"]
    "5" -> "27" [dir=forward tooltip="include"]
    "5" -> "42" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "5" [dir=forward tooltip="include"]
    "3" -> "27" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "50" [dir=forward tooltip="include"]
    "50" -> "46" [dir=forward tooltip="include"]
    "50" -> "5" [dir=forward tooltip="include"]
    "32" -> "11" [dir=forward tooltip="include"]
    "32" -> "10" [dir=forward tooltip="include"]
    "32" -> "33" [dir=forward tooltip="include"]
    "32" -> "34" [dir=forward tooltip="include"]
    "32" -> "35" [dir=forward tooltip="include"]
    "32" -> "37" [dir=forward tooltip="include"]
    "32" -> "38" [dir=forward tooltip="include"]
    "32" -> "42" [dir=forward tooltip="include"]
    "44" -> "11" [dir=forward tooltip="include"]
    "44" -> "18" [dir=forward tooltip="include"]
    "44" -> "30" [dir=forward tooltip="include"]
    "44" -> "37" [dir=forward tooltip="include"]
    "46" -> "28" [dir=forward tooltip="include"]
    "46" -> "12" [dir=forward tooltip="include"]
    "46" -> "29" [dir=forward tooltip="include"]
    "46" -> "4" [dir=forward tooltip="include"]
    "46" -> "2" [dir=forward tooltip="include"]
    "46" -> "18" [dir=forward tooltip="include"]
    "46" -> "8" [dir=forward tooltip="include"]
    "46" -> "37" [dir=forward tooltip="include"]
    "46" -> "47" [dir=forward tooltip="include"]
    "46" -> "48" [dir=forward tooltip="include"]
    "46" -> "42" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "22" [dir=forward tooltip="include"]
    "20" -> "23" [dir=forward tooltip="include"]
    "20" -> "24" [dir=forward tooltip="include"]
    "20" -> "25" [dir=forward tooltip="include"]
    "16" -> "17" [dir=forward tooltip="include"]
    "16" -> "6" [dir=forward tooltip="include"]
    "16" -> "11" [dir=forward tooltip="include"]
    "16" -> "12" [dir=forward tooltip="include"]
    "16" -> "18" [dir=forward tooltip="include"]
    "16" -> "15" [dir=forward tooltip="include"]
    "16" -> "4" [dir=forward tooltip="include"]
    "16" -> "19" [dir=forward tooltip="include"]
    "16" -> "20" [dir=forward tooltip="include"]
    "16" -> "26" [dir=forward tooltip="include"]
    "16" -> "8" [dir=forward tooltip="include"]
    "16" -> "30" [dir=forward tooltip="include"]
    "16" -> "14" [dir=forward tooltip="include"]
    "16" -> "31" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include ExternalCollection.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" fillcolor="#BFBFBF"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
    "1" -> "4" [dir=back tooltip="include"]
    "1" -> "5" [dir=back tooltip="include"]
    "1" -> "6" [dir=back tooltip="include"]
    "1" -> "7" [dir=back tooltip="include"]
    "1" -> "8" [dir=back tooltip="include"]
    "1" -> "9" [dir=back tooltip="include"]
}

Variables

map<string, maker_t*, less<string>> factory

factory for dynamically loaded forces

map<string, maker_t*, less<string>>::iterator fitr
file ExternalForce.H
#include <PotAccel.H>
#include <Component.H>

Include dependency graph for ExternalForce.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "32" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "47" [label="CenterFile.H" tooltip="CenterFile.H"]
    "48" [label="Circular.H" tooltip="Circular.H"]
    "18" [label="EXPException.H" tooltip="EXPException.H"]
    "41" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "43" [label="QuadLS.H" tooltip="QuadLS.H"]
    "35" [label="Species.H" tooltip="Species.H"]
    "11" [label="StringTok.H" tooltip="StringTok.H"]
    "33" [label="Timer.H" tooltip="Timer.H"]
    "12" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "39" [label="euler.H" tooltip="euler.H"]
    "45" [label="header.H" tooltip="header.H"]
    "21" [label="libvars.H" tooltip="libvars.H"]
    "34" [label="localmpi.H" tooltip="localmpi.H"]
    "15" [label="Component.H" tooltip="Component.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" fillcolor="#BFBFBF"]
    "36" [label="Orient.H" tooltip="Orient.H"]
    "46" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "2" [label="PotAccel.H" tooltip="PotAccel.H"]
    "26" [label="chkTimer.H" tooltip="chkTimer.H"]
    "25" [label="coef.H" tooltip="coef.H"]
    "23" [label="global.H" tooltip="global.H"]
    "40" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "10" [label="Particle.H" tooltip="Particle.H"]
    "38" [label="algorithm" tooltip="algorithm"]
    "42" [label="array" tooltip="array"]
    "5" [label="chrono" tooltip="chrono"]
    "28" [label="cmath" tooltip="cmath"]
    "14" [label="config_exp.h" tooltip="config_exp.h"]
    "3" [label="cstdlib" tooltip="cstdlib"]
    "37" [label="deque" tooltip="deque"]
    "30" [label="fstream" tooltip="fstream"]
    "31" [label="iomanip" tooltip="iomanip"]
    "29" [label="iostream" tooltip="iostream"]
    "6" [label="list" tooltip="list"]
    "7" [label="map" tooltip="map"]
    "8" [label="memory" tooltip="memory"]
    "16" [label="mpi.h" tooltip="mpi.h"]
    "24" [label="pthread.h" tooltip="pthread.h"]
    "22" [label="random" tooltip="random"]
    "13" [label="set" tooltip="set"]
    "20" [label="sstream" tooltip="sstream"]
    "4" [label="string" tooltip="string"]
    "27" [label="time.h" tooltip="time.h"]
    "44" [label="tuple" tooltip="tuple"]
    "17" [label="utility" tooltip="utility"]
    "19" [label="vector" tooltip="vector"]
    "9" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "32" -> "29" [dir=forward tooltip="include"]
    "32" -> "31" [dir=forward tooltip="include"]
    "32" -> "19" [dir=forward tooltip="include"]
    "32" -> "4" [dir=forward tooltip="include"]
    "32" -> "6" [dir=forward tooltip="include"]
    "32" -> "7" [dir=forward tooltip="include"]
    "32" -> "13" [dir=forward tooltip="include"]
    "32" -> "8" [dir=forward tooltip="include"]
    "32" -> "33" [dir=forward tooltip="include"]
    "32" -> "16" [dir=forward tooltip="include"]
    "47" -> "30" [dir=forward tooltip="include"]
    "47" -> "19" [dir=forward tooltip="include"]
    "47" -> "42" [dir=forward tooltip="include"]
    "47" -> "9" [dir=forward tooltip="include"]
    "48" -> "19" [dir=forward tooltip="include"]
    "18" -> "13" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "4" [dir=forward tooltip="include"]
    "18" -> "20" [dir=forward tooltip="include"]
    "18" -> "21" [dir=forward tooltip="include"]
    "41" -> "37" [dir=forward tooltip="include"]
    "41" -> "42" [dir=forward tooltip="include"]
    "41" -> "40" [dir=forward tooltip="include"]
    "41" -> "43" [dir=forward tooltip="include"]
    "43" -> "29" [dir=forward tooltip="include"]
    "43" -> "31" [dir=forward tooltip="include"]
    "43" -> "44" [dir=forward tooltip="include"]
    "35" -> "7" [dir=forward tooltip="include"]
    "35" -> "13" [dir=forward tooltip="include"]
    "35" -> "19" [dir=forward tooltip="include"]
    "33" -> "29" [dir=forward tooltip="include"]
    "33" -> "3" [dir=forward tooltip="include"]
    "33" -> "5" [dir=forward tooltip="include"]
    "12" -> "4" [dir=forward tooltip="include"]
    "12" -> "13" [dir=forward tooltip="include"]
    "12" -> "9" [dir=forward tooltip="include"]
    "39" -> "40" [dir=forward tooltip="include"]
    "45" -> "29" [dir=forward tooltip="include"]
    "45" -> "31" [dir=forward tooltip="include"]
    "45" -> "20" [dir=forward tooltip="include"]
    "45" -> "8" [dir=forward tooltip="include"]
    "45" -> "34" [dir=forward tooltip="include"]
    "21" -> "22" [dir=forward tooltip="include"]
    "21" -> "16" [dir=forward tooltip="include"]
    "34" -> "16" [dir=forward tooltip="include"]
    "34" -> "29" [dir=forward tooltip="include"]
    "34" -> "30" [dir=forward tooltip="include"]
    "34" -> "31" [dir=forward tooltip="include"]
    "34" -> "4" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "17" [dir=forward tooltip="include"]
    "15" -> "9" [dir=forward tooltip="include"]
    "15" -> "18" [dir=forward tooltip="include"]
    "15" -> "23" [dir=forward tooltip="include"]
    "15" -> "36" [dir=forward tooltip="include"]
    "15" -> "45" [dir=forward tooltip="include"]
    "15" -> "34" [dir=forward tooltip="include"]
    "15" -> "46" [dir=forward tooltip="include"]
    "15" -> "47" [dir=forward tooltip="include"]
    "15" -> "2" [dir=forward tooltip="include"]
    "15" -> "48" [dir=forward tooltip="include"]
    "15" -> "33" [dir=forward tooltip="include"]
    "15" -> "14" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "15" [dir=forward tooltip="include"]
    "36" -> "19" [dir=forward tooltip="include"]
    "36" -> "13" [dir=forward tooltip="include"]
    "36" -> "37" [dir=forward tooltip="include"]
    "36" -> "38" [dir=forward tooltip="include"]
    "36" -> "39" [dir=forward tooltip="include"]
    "36" -> "10" [dir=forward tooltip="include"]
    "36" -> "41" [dir=forward tooltip="include"]
    "36" -> "14" [dir=forward tooltip="include"]
    "46" -> "19" [dir=forward tooltip="include"]
    "46" -> "8" [dir=forward tooltip="include"]
    "46" -> "34" [dir=forward tooltip="include"]
    "46" -> "10" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "2" -> "7" [dir=forward tooltip="include"]
    "2" -> "8" [dir=forward tooltip="include"]
    "2" -> "9" [dir=forward tooltip="include"]
    "2" -> "10" [dir=forward tooltip="include"]
    "2" -> "11" [dir=forward tooltip="include"]
    "2" -> "12" [dir=forward tooltip="include"]
    "2" -> "14" [dir=forward tooltip="include"]
    "26" -> "27" [dir=forward tooltip="include"]
    "26" -> "28" [dir=forward tooltip="include"]
    "26" -> "29" [dir=forward tooltip="include"]
    "26" -> "30" [dir=forward tooltip="include"]
    "26" -> "31" [dir=forward tooltip="include"]
    "23" -> "24" [dir=forward tooltip="include"]
    "23" -> "16" [dir=forward tooltip="include"]
    "23" -> "19" [dir=forward tooltip="include"]
    "23" -> "4" [dir=forward tooltip="include"]
    "23" -> "8" [dir=forward tooltip="include"]
    "23" -> "22" [dir=forward tooltip="include"]
    "23" -> "6" [dir=forward tooltip="include"]
    "23" -> "25" [dir=forward tooltip="include"]
    "23" -> "26" [dir=forward tooltip="include"]
    "23" -> "32" [dir=forward tooltip="include"]
    "23" -> "9" [dir=forward tooltip="include"]
    "23" -> "34" [dir=forward tooltip="include"]
    "23" -> "21" [dir=forward tooltip="include"]
    "23" -> "35" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include ExternalForce.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" fillcolor="#BFBFBF"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "14" -> "15" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "4" [dir=back tooltip="include"]
    "2" -> "5" [dir=back tooltip="include"]
    "2" -> "6" [dir=back tooltip="include"]
    "2" -> "7" [dir=back tooltip="include"]
    "2" -> "8" [dir=back tooltip="include"]
    "2" -> "9" [dir=back tooltip="include"]
    "2" -> "10" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "11" [dir=back tooltip="include"]
    "1" -> "12" [dir=back tooltip="include"]
    "1" -> "13" [dir=back tooltip="include"]
    "1" -> "20" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "16" -> "18" [dir=back tooltip="include"]
    "13" -> "14" [dir=back tooltip="include"]
    "13" -> "19" [dir=back tooltip="include"]
}

Typedefs

typedef ExternalForce *maker_t(const YAML::Node&)
file externalShock.H
#include <orbit.H>
#include <massmodel.H>

Include dependency graph for externalShock.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "21" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "18" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "20" [label="QPDistF.H" tooltip="QPDistF.H"]
    "6" [label="gaussQ.H" tooltip="gaussQ.H"]
    "16" [label="interp.H" tooltip="interp.H"]
    "13" [label="massmodel.H" tooltip="massmodel.H"]
    "2" [label="orbit.H" tooltip="orbit.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/externalShock.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/externalShock.H" fillcolor="#BFBFBF"]
    "5" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "10" [label="cstdlib" tooltip="cstdlib"]
    "17" [label="deque" tooltip="deque"]
    "3" [label="functional" tooltip="functional"]
    "8" [label="iomanip" tooltip="iomanip"]
    "7" [label="iostream" tooltip="iostream"]
    "19" [label="map" tooltip="map"]
    "4" [label="memory" tooltip="memory"]
    "14" [label="random" tooltip="random"]
    "9" [label="sstream" tooltip="sstream"]
    "11" [label="string" tooltip="string"]
    "15" [label="tuple" tooltip="tuple"]
    "12" [label="vector" tooltip="vector"]
    "21" -> "13" [dir=forward tooltip="include"]
    "18" -> "12" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "11" [dir=forward tooltip="include"]
    "20" -> "8" [dir=forward tooltip="include"]
    "20" -> "11" [dir=forward tooltip="include"]
    "20" -> "19" [dir=forward tooltip="include"]
    "20" -> "13" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "2" [dir=forward tooltip="include"]
    "6" -> "7" [dir=forward tooltip="include"]
    "6" -> "8" [dir=forward tooltip="include"]
    "6" -> "9" [dir=forward tooltip="include"]
    "6" -> "10" [dir=forward tooltip="include"]
    "6" -> "11" [dir=forward tooltip="include"]
    "6" -> "12" [dir=forward tooltip="include"]
    "16" -> "5" [dir=forward tooltip="include"]
    "16" -> "12" [dir=forward tooltip="include"]
    "16" -> "17" [dir=forward tooltip="include"]
    "16" -> "18" [dir=forward tooltip="include"]
    "13" -> "12" [dir=forward tooltip="include"]
    "13" -> "4" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
    "13" -> "5" [dir=forward tooltip="include"]
    "13" -> "16" [dir=forward tooltip="include"]
    "13" -> "2" [dir=forward tooltip="include"]
    "13" -> "20" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "13" [dir=forward tooltip="include"]
}
file FlatDisk.H
#include <memory>
#include <map>
#include <BiorthCyl.H>
#include <PolarBasis.H>

Include dependency graph for FlatDisk.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="BiorthCyl.H" tooltip="BiorthCyl.H"]
    "27" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "37" [label="EXPmath.H" tooltip="EXPmath.H"]
    "33" [label="EmpCyl2d.H" tooltip="EmpCyl2d.H"]
    "20" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "26" [label="QPDistF.H" tooltip="QPDistF.H"]
    "48" [label="StringTok.H" tooltip="StringTok.H"]
    "49" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "23" [label="gaussQ.H" tooltip="gaussQ.H"]
    "18" [label="interp.H" tooltip="interp.H"]
    "11" [label="localmpi.H" tooltip="localmpi.H"]
    "14" [label="massmodel.H" tooltip="massmodel.H"]
    "21" [label="orbit.H" tooltip="orbit.H"]
    "42" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
    "43" [label="Basis.H" tooltip="Basis.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H" fillcolor="#BFBFBF"]
    "51" [label="NVTX.H" tooltip="NVTX.H"]
    "40" [label="PolarBasis.H" tooltip="PolarBasis.H"]
    "44" [label="PotAccel.H" tooltip="PotAccel.H"]
    "52" [label="CoefContainer.H" tooltip="CoefContainer.H"]
    "50" [label="Coefficients.H" tooltip="Coefficients.H"]
    "9" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "36" [label="Eigen/Eigenvalues" tooltip="Eigen/Eigenvalues"]
    "47" [label="Particle.H" tooltip="Particle.H"]
    "34" [label="algorithm" tooltip="algorithm"]
    "35" [label="array" tooltip="array"]
    "45" [label="chrono" tooltip="chrono"]
    "8" [label="cmath" tooltip="cmath"]
    "13" [label="config_exp.h" tooltip="config_exp.h"]
    "25" [label="cstdlib" tooltip="cstdlib"]
    "19" [label="deque" tooltip="deque"]
    "6" [label="fstream" tooltip="fstream"]
    "22" [label="functional" tooltip="functional"]
    "32" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
    "30" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
    "31" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
    "29" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
    "39" [label="highfive/eigen.hpp" tooltip="highfive/eigen.hpp"]
    "38" [label="highfive/highfive.hpp" tooltip="highfive/highfive.hpp"]
    "12" [label="iomanip" tooltip="iomanip"]
    "5" [label="iostream" tooltip="iostream"]
    "46" [label="list" tooltip="list"]
    "3" [label="map" tooltip="map"]
    "2" [label="memory" tooltip="memory"]
    "10" [label="mpi.h" tooltip="mpi.h"]
    "16" [label="random" tooltip="random"]
    "41" [label="set" tooltip="set"]
    "24" [label="sstream" tooltip="sstream"]
    "7" [label="string" tooltip="string"]
    "17" [label="tuple" tooltip="tuple"]
    "15" [label="vector" tooltip="vector"]
    "28" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "4" -> "5" [dir=forward tooltip="include"]
    "4" -> "6" [dir=forward tooltip="include"]
    "4" -> "7" [dir=forward tooltip="include"]
    "4" -> "8" [dir=forward tooltip="include"]
    "4" -> "9" [dir=forward tooltip="include"]
    "4" -> "10" [dir=forward tooltip="include"]
    "4" -> "11" [dir=forward tooltip="include"]
    "4" -> "13" [dir=forward tooltip="include"]
    "4" -> "14" [dir=forward tooltip="include"]
    "4" -> "28" [dir=forward tooltip="include"]
    "4" -> "29" [dir=forward tooltip="include"]
    "4" -> "30" [dir=forward tooltip="include"]
    "4" -> "31" [dir=forward tooltip="include"]
    "4" -> "32" [dir=forward tooltip="include"]
    "4" -> "33" [dir=forward tooltip="include"]
    "27" -> "14" [dir=forward tooltip="include"]
    "33" -> "34" [dir=forward tooltip="include"]
    "33" -> "2" [dir=forward tooltip="include"]
    "33" -> "7" [dir=forward tooltip="include"]
    "33" -> "15" [dir=forward tooltip="include"]
    "33" -> "35" [dir=forward tooltip="include"]
    "33" -> "17" [dir=forward tooltip="include"]
    "33" -> "9" [dir=forward tooltip="include"]
    "33" -> "36" [dir=forward tooltip="include"]
    "33" -> "28" [dir=forward tooltip="include"]
    "33" -> "13" [dir=forward tooltip="include"]
    "33" -> "23" [dir=forward tooltip="include"]
    "33" -> "37" [dir=forward tooltip="include"]
    "33" -> "11" [dir=forward tooltip="include"]
    "33" -> "38" [dir=forward tooltip="include"]
    "33" -> "39" [dir=forward tooltip="include"]
    "20" -> "15" [dir=forward tooltip="include"]
    "20" -> "3" [dir=forward tooltip="include"]
    "20" -> "7" [dir=forward tooltip="include"]
    "26" -> "12" [dir=forward tooltip="include"]
    "26" -> "7" [dir=forward tooltip="include"]
    "26" -> "3" [dir=forward tooltip="include"]
    "26" -> "14" [dir=forward tooltip="include"]
    "26" -> "27" [dir=forward tooltip="include"]
    "26" -> "21" [dir=forward tooltip="include"]
    "49" -> "7" [dir=forward tooltip="include"]
    "49" -> "41" [dir=forward tooltip="include"]
    "49" -> "28" [dir=forward tooltip="include"]
    "23" -> "5" [dir=forward tooltip="include"]
    "23" -> "12" [dir=forward tooltip="include"]
    "23" -> "24" [dir=forward tooltip="include"]
    "23" -> "25" [dir=forward tooltip="include"]
    "23" -> "7" [dir=forward tooltip="include"]
    "23" -> "15" [dir=forward tooltip="include"]
    "18" -> "9" [dir=forward tooltip="include"]
    "18" -> "15" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "20" [dir=forward tooltip="include"]
    "11" -> "10" [dir=forward tooltip="include"]
    "11" -> "5" [dir=forward tooltip="include"]
    "11" -> "6" [dir=forward tooltip="include"]
    "11" -> "12" [dir=forward tooltip="include"]
    "11" -> "7" [dir=forward tooltip="include"]
    "14" -> "15" [dir=forward tooltip="include"]
    "14" -> "2" [dir=forward tooltip="include"]
    "14" -> "16" [dir=forward tooltip="include"]
    "14" -> "17" [dir=forward tooltip="include"]
    "14" -> "9" [dir=forward tooltip="include"]
    "14" -> "18" [dir=forward tooltip="include"]
    "14" -> "21" [dir=forward tooltip="include"]
    "14" -> "26" [dir=forward tooltip="include"]
    "21" -> "22" [dir=forward tooltip="include"]
    "21" -> "2" [dir=forward tooltip="include"]
    "21" -> "9" [dir=forward tooltip="include"]
    "21" -> "23" [dir=forward tooltip="include"]
    "42" -> "43" [dir=forward tooltip="include"]
    "42" -> "9" [dir=forward tooltip="include"]
    "43" -> "44" [dir=forward tooltip="include"]
    "43" -> "9" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "40" [dir=forward tooltip="include"]
    "51" -> "2" [dir=forward tooltip="include"]
    "51" -> "13" [dir=forward tooltip="include"]
    "40" -> "2" [dir=forward tooltip="include"]
    "40" -> "16" [dir=forward tooltip="include"]
    "40" -> "15" [dir=forward tooltip="include"]
    "40" -> "7" [dir=forward tooltip="include"]
    "40" -> "41" [dir=forward tooltip="include"]
    "40" -> "42" [dir=forward tooltip="include"]
    "40" -> "50" [dir=forward tooltip="include"]
    "40" -> "13" [dir=forward tooltip="include"]
    "40" -> "51" [dir=forward tooltip="include"]
    "40" -> "52" [dir=forward tooltip="include"]
    "40" -> "4" [dir=forward tooltip="include"]
    "44" -> "25" [dir=forward tooltip="include"]
    "44" -> "7" [dir=forward tooltip="include"]
    "44" -> "45" [dir=forward tooltip="include"]
    "44" -> "46" [dir=forward tooltip="include"]
    "44" -> "3" [dir=forward tooltip="include"]
    "44" -> "2" [dir=forward tooltip="include"]
    "44" -> "28" [dir=forward tooltip="include"]
    "44" -> "47" [dir=forward tooltip="include"]
    "44" -> "48" [dir=forward tooltip="include"]
    "44" -> "49" [dir=forward tooltip="include"]
    "44" -> "13" [dir=forward tooltip="include"]
}

Typedefs

typedef std::shared_ptr<BiorthCyl> CylPtr
file generateRelaxation.H
file global.H
#include <pthread.h>
#include <mpi.h>
#include <vector>
#include <string>
#include <memory>
#include <random>
#include <list>
#include <coef.H>
#include <chkTimer.H>
#include <BarrierWrapper.H>
#include <yaml-cpp/yaml.h>
#include <localmpi.H>
#include <libvars.H>
#include “Species.H

Include dependency graph for global.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "16" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "25" [label="Species.H" tooltip="Species.H"]
    "19" [label="Timer.H" tooltip="Timer.H"]
    "24" [label="libvars.H" tooltip="libvars.H"]
    "23" [label="localmpi.H" tooltip="localmpi.H"]
    "10" [label="chkTimer.H" tooltip="chkTimer.H"]
    "9" [label="coef.H" tooltip="coef.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/global.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/global.H" fillcolor="#BFBFBF"]
    "21" [label="chrono" tooltip="chrono"]
    "12" [label="cmath" tooltip="cmath"]
    "20" [label="cstdlib" tooltip="cstdlib"]
    "14" [label="fstream" tooltip="fstream"]
    "15" [label="iomanip" tooltip="iomanip"]
    "13" [label="iostream" tooltip="iostream"]
    "8" [label="list" tooltip="list"]
    "17" [label="map" tooltip="map"]
    "6" [label="memory" tooltip="memory"]
    "3" [label="mpi.h" tooltip="mpi.h"]
    "2" [label="pthread.h" tooltip="pthread.h"]
    "7" [label="random" tooltip="random"]
    "18" [label="set" tooltip="set"]
    "5" [label="string" tooltip="string"]
    "11" [label="time.h" tooltip="time.h"]
    "4" [label="vector" tooltip="vector"]
    "22" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "16" -> "13" [dir=forward tooltip="include"]
    "16" -> "15" [dir=forward tooltip="include"]
    "16" -> "4" [dir=forward tooltip="include"]
    "16" -> "5" [dir=forward tooltip="include"]
    "16" -> "8" [dir=forward tooltip="include"]
    "16" -> "17" [dir=forward tooltip="include"]
    "16" -> "18" [dir=forward tooltip="include"]
    "16" -> "6" [dir=forward tooltip="include"]
    "16" -> "19" [dir=forward tooltip="include"]
    "16" -> "3" [dir=forward tooltip="include"]
    "25" -> "17" [dir=forward tooltip="include"]
    "25" -> "18" [dir=forward tooltip="include"]
    "25" -> "4" [dir=forward tooltip="include"]
    "19" -> "13" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "19" -> "21" [dir=forward tooltip="include"]
    "24" -> "7" [dir=forward tooltip="include"]
    "24" -> "3" [dir=forward tooltip="include"]
    "23" -> "3" [dir=forward tooltip="include"]
    "23" -> "13" [dir=forward tooltip="include"]
    "23" -> "14" [dir=forward tooltip="include"]
    "23" -> "15" [dir=forward tooltip="include"]
    "23" -> "5" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "12" [dir=forward tooltip="include"]
    "10" -> "13" [dir=forward tooltip="include"]
    "10" -> "14" [dir=forward tooltip="include"]
    "10" -> "15" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "1" -> "10" [dir=forward tooltip="include"]
    "1" -> "16" [dir=forward tooltip="include"]
    "1" -> "22" [dir=forward tooltip="include"]
    "1" -> "23" [dir=forward tooltip="include"]
    "1" -> "24" [dir=forward tooltip="include"]
    "1" -> "25" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include global.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/global.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/global.H" fillcolor="#BFBFBF"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "20" [dir=back tooltip="include"]
    "2" -> "24" [dir=back tooltip="include"]
    "2" -> "25" [dir=back tooltip="include"]
    "2" -> "26" [dir=back tooltip="include"]
    "2" -> "27" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "13" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "6" [dir=back tooltip="include"]
    "4" -> "7" [dir=back tooltip="include"]
    "4" -> "8" [dir=back tooltip="include"]
    "4" -> "9" [dir=back tooltip="include"]
    "4" -> "10" [dir=back tooltip="include"]
    "4" -> "11" [dir=back tooltip="include"]
    "4" -> "12" [dir=back tooltip="include"]
    "20" -> "4" [dir=back tooltip="include"]
    "20" -> "21" [dir=back tooltip="include"]
    "20" -> "22" [dir=back tooltip="include"]
    "20" -> "13" [dir=back tooltip="include"]
    "20" -> "23" [dir=back tooltip="include"]
    "24" -> "24" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "16" -> "18" [dir=back tooltip="include"]
    "13" -> "14" [dir=back tooltip="include"]
    "13" -> "19" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "14" [dir=back tooltip="include"]
    "1" -> "13" [dir=back tooltip="include"]
}

Global variables.

These variables can be changed/specified in the [global] stanza of the inputfile

Coefficient header on each output dump

BarrierWrapper *barrier

Barrier instance for debugging.

bool barrier_check

Turn on Barrier check debugging.

bool barrier_debug

Turn on Barrier check debugging.

bool barrier_extra

Turn on Barrier extra debugging.

bool barrier_label

Barrier label checking.

bool barrier_light

Barrier label light weight method.

bool barrier_quiet

Do not report good barrier condtion if true.

CheckpointTimer chktimer

Checkpoint timer.

struct CylCoefHeader coefheadercyl

Cylindrical header type.

struct SphCoefHeader coefheadersph

Spherical header.

ComponentContainer *comp
bool cuda_prof

For toggling CUDA profiling.

bool debug_wait

Endless loop for setting gdb breakpoints.

ExternalCollection *external
string lastPS

Last PS file name.

string lastPSQ
string lastPSR
bool leapfrog_cuda

Can we leave phase space on GPUs or do we need to copy back to host?

bool main_wait
MPI_Datatype MPI_EXP_KEYTYPE

MPI datatype for pHOT key.

OutputContainer *output

One output routine container per simulation.

YAML::Node parse

Parameter database.

unsigned int random_seed

Mersenne random number generator provided by Boost.Random. This could be changed to another if needed.

string restart_cmd

Restart command on successful completion but early termination according to the checkpoint timer

int rlimit_val

Default memory limit value in GB. If value is set to zero, use the system default. If value is less than zero, attempt to set memory to unlimited.

double runtime

Total alloted runtime (runtime < 0 turns off timer)

bool use_cuda

Set to false to suppress cuda computation.

Variables

bool all_couples

Toggle interactions “on” or “off” by default. If interactions are “on” (the default), interactions listed in the ‘Interaction’ list be turned “off”. Alternatively, if interactions are “off”, interactions listed in the ‘Interaction’ list be turned “on”.

int centerlevl

Lowest level for centering recomputation (default: multistep/2)

double dbthresh

Load balancing threshold (larger difference initiates balancing)

vector<vector<int>> dstepL

Multistep interpolation array.

vector<vector<int>> dstepN
double dtime

Time step.

unsigned char dump_signal

Phase space dump on next step

This flag is set by signalling the root process with SIGHUP

int dump_signal0
double dynfracA

Acceleration coefficient (default: 0.03)

double dynfracD

Drift coefficient (default: 1000.0)

double dynfracP

Escape time scale coefficient (default: 0.05)

double dynfracS

Fraction of dynamical time for determining multistep level.

Scale coefficient (default: 1.00)

double dynfracV

Velocity coefficient (default: 0.01)

bool eqmotion

Toggle phase space advance (e.g. for use with externally supplied mapping). On by default.

bool fpe_trace

Install error handler for fpe backtrace.

bool fpe_trap

Install error handler for fpe debugging.

bool fpe_wait

Install error handler for fpe wait.

double *gcom

Global center of mass.

double *gcov

Global center of velocity.

bool gdb_trace

Use gdb or native trace handling.

bool global_cov

Resets total center of velocity to zero if true.

string homedir

Home directory for configuration files, etc.

bool ignore_info

Suppress parsing of info fields on restart; use config specified parameters instead

string infile

Input file (for restart)

bool initializing

True when initializing before first time step.

int is_init

Used to flag separate behavior on inintialization (unused)

string ldlibdir

Directory to look for loadable modules.

vector<vector<bool>> mactive

Multistep level flag: levels currently synchronized.

double max_mindt

Maximum fraction of particles that request a smaller than minimum timestep.

unsigned maxlev

Multistep sublevel info used for nbody.

int mdrft

Current point in multistepping for drift step.

vector<int> mfirst

Lowest synchronized level at a step.

vector<int> mintvl

Multistep time step spacing.

MPI_Comm MPI_COMM_WORKER

Internally defined worker communicator.

bool mpi_wait

Install error handler for MPI debugging.

int mstep

Current point in multistepping for velocity step.

int Mstep

Maximum number of multistep steps.

double mtot

Total mass in simulation (used by Orient and log diagnostics)

std::map<std::string, std::vector<int>> nameMap

List of host names and ranks.

int nbalance

Number of steps between load balancing (use 0 for none)

int ngpus

Number of gpu devices per node.

int NICE

Process priority set to NICE value.

int nreport

Number of steps between particle number reports (use 0 for none)

int nsteps

Maximum number of steps to execute.

string parmfile

Parameter dump file.

unsigned PFbufsz

Particle ferry buffer size.

vector<thrd_pass_posvel> posvel_data

Multithreding data structures for incr_position and incr_velocity.

vector<pthread_t> posvel_thrd

Threads for incr_position and incr_velocity.

int psdump

Last phase space dump step.

unsigned char quit_signal

Quit now

This flag is set by checkpoint itmer

string ratefile

Initial processor rate file.

bool restart

Global set on restart (to used by initializers and user modules)

unsigned shiftlevl

Constrain level changes per step (default: 0 means no constraint)

std::vector<int> siblingList

List of sibling ranks.

bool step_timing

Step timing.

unsigned char stop_signal

Stop on next step

This flag is set by signalling the root process with SIGTERM

int stop_signal0

Implementation variables for handlers

int this_step

Current Nbody step id.

double tnow

Times for each phase-space time slice (for Leap-Frog)

bool traceback

Enable traceback on exceptions.

bool use_cwd

Use Node 0’s home dir for the working dir on all nodes.

int VERBOSE

Output logging level.

file global_key_set.H

Variables

const std::set<std::string> global_valid_keys
file GravKernel.H
#include <utility>

Include dependency graph for GravKernel.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/GravKernel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/GravKernel.H" fillcolor="#BFBFBF"]
    "2" [label="utility" tooltip="utility"]
    "1" -> "2" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include GravKernel.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/GravKernel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/GravKernel.H" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=back tooltip="include"]
}
file HaloBulge.H
#include <string>
#include <vector>
#include <set>
#include <ExternalForce.H>

Include dependency graph for HaloBulge.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "33" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "48" [label="CenterFile.H" tooltip="CenterFile.H"]
    "49" [label="Circular.H" tooltip="Circular.H"]
    "20" [label="EXPException.H" tooltip="EXPException.H"]
    "42" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "44" [label="QuadLS.H" tooltip="QuadLS.H"]
    "36" [label="Species.H" tooltip="Species.H"]
    "14" [label="StringTok.H" tooltip="StringTok.H"]
    "34" [label="Timer.H" tooltip="Timer.H"]
    "15" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "40" [label="euler.H" tooltip="euler.H"]
    "46" [label="header.H" tooltip="header.H"]
    "22" [label="libvars.H" tooltip="libvars.H"]
    "35" [label="localmpi.H" tooltip="localmpi.H"]
    "17" [label="Component.H" tooltip="Component.H"]
    "5" [label="ExternalForce.H" tooltip="ExternalForce.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" fillcolor="#BFBFBF"]
    "37" [label="Orient.H" tooltip="Orient.H"]
    "47" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "6" [label="PotAccel.H" tooltip="PotAccel.H"]
    "27" [label="chkTimer.H" tooltip="chkTimer.H"]
    "26" [label="coef.H" tooltip="coef.H"]
    "24" [label="global.H" tooltip="global.H"]
    "41" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "13" [label="Particle.H" tooltip="Particle.H"]
    "39" [label="algorithm" tooltip="algorithm"]
    "43" [label="array" tooltip="array"]
    "8" [label="chrono" tooltip="chrono"]
    "29" [label="cmath" tooltip="cmath"]
    "16" [label="config_exp.h" tooltip="config_exp.h"]
    "7" [label="cstdlib" tooltip="cstdlib"]
    "38" [label="deque" tooltip="deque"]
    "31" [label="fstream" tooltip="fstream"]
    "32" [label="iomanip" tooltip="iomanip"]
    "30" [label="iostream" tooltip="iostream"]
    "9" [label="list" tooltip="list"]
    "10" [label="map" tooltip="map"]
    "11" [label="memory" tooltip="memory"]
    "18" [label="mpi.h" tooltip="mpi.h"]
    "25" [label="pthread.h" tooltip="pthread.h"]
    "23" [label="random" tooltip="random"]
    "4" [label="set" tooltip="set"]
    "21" [label="sstream" tooltip="sstream"]
    "2" [label="string" tooltip="string"]
    "28" [label="time.h" tooltip="time.h"]
    "45" [label="tuple" tooltip="tuple"]
    "19" [label="utility" tooltip="utility"]
    "3" [label="vector" tooltip="vector"]
    "12" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "33" -> "30" [dir=forward tooltip="include"]
    "33" -> "32" [dir=forward tooltip="include"]
    "33" -> "3" [dir=forward tooltip="include"]
    "33" -> "2" [dir=forward tooltip="include"]
    "33" -> "9" [dir=forward tooltip="include"]
    "33" -> "10" [dir=forward tooltip="include"]
    "33" -> "4" [dir=forward tooltip="include"]
    "33" -> "11" [dir=forward tooltip="include"]
    "33" -> "34" [dir=forward tooltip="include"]
    "33" -> "18" [dir=forward tooltip="include"]
    "48" -> "31" [dir=forward tooltip="include"]
    "48" -> "3" [dir=forward tooltip="include"]
    "48" -> "43" [dir=forward tooltip="include"]
    "48" -> "12" [dir=forward tooltip="include"]
    "49" -> "3" [dir=forward tooltip="include"]
    "20" -> "4" [dir=forward tooltip="include"]
    "20" -> "3" [dir=forward tooltip="include"]
    "20" -> "2" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "22" [dir=forward tooltip="include"]
    "42" -> "38" [dir=forward tooltip="include"]
    "42" -> "43" [dir=forward tooltip="include"]
    "42" -> "41" [dir=forward tooltip="include"]
    "42" -> "44" [dir=forward tooltip="include"]
    "44" -> "30" [dir=forward tooltip="include"]
    "44" -> "32" [dir=forward tooltip="include"]
    "44" -> "45" [dir=forward tooltip="include"]
    "36" -> "10" [dir=forward tooltip="include"]
    "36" -> "4" [dir=forward tooltip="include"]
    "36" -> "3" [dir=forward tooltip="include"]
    "34" -> "30" [dir=forward tooltip="include"]
    "34" -> "7" [dir=forward tooltip="include"]
    "34" -> "8" [dir=forward tooltip="include"]
    "15" -> "2" [dir=forward tooltip="include"]
    "15" -> "4" [dir=forward tooltip="include"]
    "15" -> "12" [dir=forward tooltip="include"]
    "40" -> "41" [dir=forward tooltip="include"]
    "46" -> "30" [dir=forward tooltip="include"]
    "46" -> "32" [dir=forward tooltip="include"]
    "46" -> "21" [dir=forward tooltip="include"]
    "46" -> "11" [dir=forward tooltip="include"]
    "46" -> "35" [dir=forward tooltip="include"]
    "22" -> "23" [dir=forward tooltip="include"]
    "22" -> "18" [dir=forward tooltip="include"]
    "35" -> "18" [dir=forward tooltip="include"]
    "35" -> "30" [dir=forward tooltip="include"]
    "35" -> "31" [dir=forward tooltip="include"]
    "35" -> "32" [dir=forward tooltip="include"]
    "35" -> "2" [dir=forward tooltip="include"]
    "17" -> "18" [dir=forward tooltip="include"]
    "17" -> "19" [dir=forward tooltip="include"]
    "17" -> "12" [dir=forward tooltip="include"]
    "17" -> "20" [dir=forward tooltip="include"]
    "17" -> "24" [dir=forward tooltip="include"]
    "17" -> "37" [dir=forward tooltip="include"]
    "17" -> "46" [dir=forward tooltip="include"]
    "17" -> "35" [dir=forward tooltip="include"]
    "17" -> "47" [dir=forward tooltip="include"]
    "17" -> "48" [dir=forward tooltip="include"]
    "17" -> "6" [dir=forward tooltip="include"]
    "17" -> "49" [dir=forward tooltip="include"]
    "17" -> "34" [dir=forward tooltip="include"]
    "17" -> "16" [dir=forward tooltip="include"]
    "5" -> "6" [dir=forward tooltip="include"]
    "5" -> "17" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "37" -> "3" [dir=forward tooltip="include"]
    "37" -> "4" [dir=forward tooltip="include"]
    "37" -> "38" [dir=forward tooltip="include"]
    "37" -> "39" [dir=forward tooltip="include"]
    "37" -> "40" [dir=forward tooltip="include"]
    "37" -> "13" [dir=forward tooltip="include"]
    "37" -> "42" [dir=forward tooltip="include"]
    "37" -> "16" [dir=forward tooltip="include"]
    "47" -> "3" [dir=forward tooltip="include"]
    "47" -> "11" [dir=forward tooltip="include"]
    "47" -> "35" [dir=forward tooltip="include"]
    "47" -> "13" [dir=forward tooltip="include"]
    "6" -> "7" [dir=forward tooltip="include"]
    "6" -> "2" [dir=forward tooltip="include"]
    "6" -> "8" [dir=forward tooltip="include"]
    "6" -> "9" [dir=forward tooltip="include"]
    "6" -> "10" [dir=forward tooltip="include"]
    "6" -> "11" [dir=forward tooltip="include"]
    "6" -> "12" [dir=forward tooltip="include"]
    "6" -> "13" [dir=forward tooltip="include"]
    "6" -> "14" [dir=forward tooltip="include"]
    "6" -> "15" [dir=forward tooltip="include"]
    "6" -> "16" [dir=forward tooltip="include"]
    "27" -> "28" [dir=forward tooltip="include"]
    "27" -> "29" [dir=forward tooltip="include"]
    "27" -> "30" [dir=forward tooltip="include"]
    "27" -> "31" [dir=forward tooltip="include"]
    "27" -> "32" [dir=forward tooltip="include"]
    "24" -> "25" [dir=forward tooltip="include"]
    "24" -> "18" [dir=forward tooltip="include"]
    "24" -> "3" [dir=forward tooltip="include"]
    "24" -> "2" [dir=forward tooltip="include"]
    "24" -> "11" [dir=forward tooltip="include"]
    "24" -> "23" [dir=forward tooltip="include"]
    "24" -> "9" [dir=forward tooltip="include"]
    "24" -> "26" [dir=forward tooltip="include"]
    "24" -> "27" [dir=forward tooltip="include"]
    "24" -> "33" [dir=forward tooltip="include"]
    "24" -> "12" [dir=forward tooltip="include"]
    "24" -> "35" [dir=forward tooltip="include"]
    "24" -> "22" [dir=forward tooltip="include"]
    "24" -> "36" [dir=forward tooltip="include"]
}
file MixtureBasis.H
#include <TwoCenter.H>

Include dependency graph for MixtureBasis.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "62" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "75" [label="CenterFile.H" tooltip="CenterFile.H"]
    "76" [label="Circular.H" tooltip="Circular.H"]
    "28" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "72" [label="EXPException.H" tooltip="EXPException.H"]
    "79" [label="EmpCylSL.H" tooltip="EmpCylSL.H"]
    "20" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "80" [label="Particle.H" tooltip="Particle.H"]
    "52" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "27" [label="QPDistF.H" tooltip="QPDistF.H"]
    "54" [label="QuadLS.H" tooltip="QuadLS.H"]
    "3" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
    "64" [label="Species.H" tooltip="Species.H"]
    "41" [label="StringTok.H" tooltip="StringTok.H"]
    "63" [label="Timer.H" tooltip="Timer.H"]
    "42" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "82" [label="coef.H" tooltip="coef.H"]
    "51" [label="euler.H" tooltip="euler.H"]
    "24" [label="gaussQ.H" tooltip="gaussQ.H"]
    "73" [label="header.H" tooltip="header.H"]
    "18" [label="interp.H" tooltip="interp.H"]
    "31" [label="libvars.H" tooltip="libvars.H"]
    "9" [label="localmpi.H" tooltip="localmpi.H"]
    "12" [label="massmodel.H" tooltip="massmodel.H"]
    "22" [label="orbit.H" tooltip="orbit.H"]
    "29" [label="sltableMP2.H" tooltip="sltableMP2.H"]
    "35" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
    "36" [label="Basis.H" tooltip="Basis.H"]
    "46" [label="Bessel.H" tooltip="Bessel.H"]
    "70" [label="Component.H" tooltip="Component.H"]
    "69" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
    "55" [label="CylEXP.H" tooltip="CylEXP.H"]
    "48" [label="Cylinder.H" tooltip="Cylinder.H"]
    "77" [label="ExternalForce.H" tooltip="ExternalForce.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" fillcolor="#BFBFBF"]
    "44" [label="NVTX.H" tooltip="NVTX.H"]
    "49" [label="Orient.H" tooltip="Orient.H"]
    "78" [label="Output.H" tooltip="Output.H"]
    "74" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "37" [label="PotAccel.H" tooltip="PotAccel.H"]
    "32" [label="Sphere.H" tooltip="Sphere.H"]
    "33" [label="SphericalBasis.H" tooltip="SphericalBasis.H"]
    "2" [label="TwoCenter.H" tooltip="TwoCenter.H"]
    "59" [label="chkTimer.H" tooltip="chkTimer.H"]
    "58" [label="coef.H" tooltip="coef.H"]
    "65" [label="expand.H" tooltip="expand.H"]
    "56" [label="global.H" tooltip="global.H"]
    "45" [label="CoefContainer.H" tooltip="CoefContainer.H"]
    "43" [label="Coefficients.H" tooltip="Coefficients.H"]
    "17" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "40" [label="Particle.H" tooltip="Particle.H"]
    "50" [label="algorithm" tooltip="algorithm"]
    "53" [label="array" tooltip="array"]
    "47" [label="assert.h" tooltip="assert.h"]
    "38" [label="chrono" tooltip="chrono"]
    "61" [label="cmath" tooltip="cmath"]
    "11" [label="config_exp.h" tooltip="config_exp.h"]
    "26" [label="cstdlib" tooltip="cstdlib"]
    "67" [label="cstring" tooltip="cstring"]
    "19" [label="deque" tooltip="deque"]
    "6" [label="fstream" tooltip="fstream"]
    "23" [label="functional" tooltip="functional"]
    "10" [label="iomanip" tooltip="iomanip"]
    "5" [label="iostream" tooltip="iostream"]
    "68" [label="limits" tooltip="limits"]
    "39" [label="list" tooltip="list"]
    "21" [label="map" tooltip="map"]
    "4" [label="math.h" tooltip="math.h"]
    "14" [label="memory" tooltip="memory"]
    "8" [label="mpi.h" tooltip="mpi.h"]
    "57" [label="pthread.h" tooltip="pthread.h"]
    "15" [label="random" tooltip="random"]
    "34" [label="set" tooltip="set"]
    "25" [label="sstream" tooltip="sstream"]
    "66" [label="stdexcept" tooltip="stdexcept"]
    "7" [label="string" tooltip="string"]
    "60" [label="time.h" tooltip="time.h"]
    "16" [label="tuple" tooltip="tuple"]
    "81" [label="unordered_map" tooltip="unordered_map"]
    "71" [label="utility" tooltip="utility"]
    "13" [label="vector" tooltip="vector"]
    "30" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "62" -> "5" [dir=forward tooltip="include"]
    "62" -> "10" [dir=forward tooltip="include"]
    "62" -> "13" [dir=forward tooltip="include"]
    "62" -> "7" [dir=forward tooltip="include"]
    "62" -> "39" [dir=forward tooltip="include"]
    "62" -> "21" [dir=forward tooltip="include"]
    "62" -> "34" [dir=forward tooltip="include"]
    "62" -> "14" [dir=forward tooltip="include"]
    "62" -> "63" [dir=forward tooltip="include"]
    "62" -> "8" [dir=forward tooltip="include"]
    "75" -> "6" [dir=forward tooltip="include"]
    "75" -> "13" [dir=forward tooltip="include"]
    "75" -> "53" [dir=forward tooltip="include"]
    "75" -> "30" [dir=forward tooltip="include"]
    "76" -> "13" [dir=forward tooltip="include"]
    "28" -> "12" [dir=forward tooltip="include"]
    "72" -> "34" [dir=forward tooltip="include"]
    "72" -> "13" [dir=forward tooltip="include"]
    "72" -> "7" [dir=forward tooltip="include"]
    "72" -> "25" [dir=forward tooltip="include"]
    "72" -> "31" [dir=forward tooltip="include"]
    "79" -> "23" [dir=forward tooltip="include"]
    "79" -> "13" [dir=forward tooltip="include"]
    "79" -> "14" [dir=forward tooltip="include"]
    "79" -> "68" [dir=forward tooltip="include"]
    "79" -> "61" [dir=forward tooltip="include"]
    "79" -> "17" [dir=forward tooltip="include"]
    "79" -> "24" [dir=forward tooltip="include"]
    "79" -> "18" [dir=forward tooltip="include"]
    "79" -> "63" [dir=forward tooltip="include"]
    "79" -> "80" [dir=forward tooltip="include"]
    "79" -> "3" [dir=forward tooltip="include"]
    "79" -> "82" [dir=forward tooltip="include"]
    "79" -> "31" [dir=forward tooltip="include"]
    "20" -> "13" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "7" [dir=forward tooltip="include"]
    "80" -> "81" [dir=forward tooltip="include"]
    "80" -> "13" [dir=forward tooltip="include"]
    "80" -> "14" [dir=forward tooltip="include"]
    "52" -> "19" [dir=forward tooltip="include"]
    "52" -> "53" [dir=forward tooltip="include"]
    "52" -> "17" [dir=forward tooltip="include"]
    "52" -> "54" [dir=forward tooltip="include"]
    "27" -> "10" [dir=forward tooltip="include"]
    "27" -> "7" [dir=forward tooltip="include"]
    "27" -> "21" [dir=forward tooltip="include"]
    "27" -> "12" [dir=forward tooltip="include"]
    "27" -> "28" [dir=forward tooltip="include"]
    "27" -> "22" [dir=forward tooltip="include"]
    "54" -> "5" [dir=forward tooltip="include"]
    "54" -> "10" [dir=forward tooltip="include"]
    "54" -> "16" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "5" [dir=forward tooltip="include"]
    "3" -> "6" [dir=forward tooltip="include"]
    "3" -> "7" [dir=forward tooltip="include"]
    "3" -> "8" [dir=forward tooltip="include"]
    "3" -> "9" [dir=forward tooltip="include"]
    "3" -> "11" [dir=forward tooltip="include"]
    "3" -> "12" [dir=forward tooltip="include"]
    "3" -> "29" [dir=forward tooltip="include"]
    "3" -> "30" [dir=forward tooltip="include"]
    "3" -> "31" [dir=forward tooltip="include"]
    "64" -> "21" [dir=forward tooltip="include"]
    "64" -> "34" [dir=forward tooltip="include"]
    "64" -> "13" [dir=forward tooltip="include"]
    "63" -> "5" [dir=forward tooltip="include"]
    "63" -> "26" [dir=forward tooltip="include"]
    "63" -> "38" [dir=forward tooltip="include"]
    "42" -> "7" [dir=forward tooltip="include"]
    "42" -> "34" [dir=forward tooltip="include"]
    "42" -> "30" [dir=forward tooltip="include"]
    "51" -> "17" [dir=forward tooltip="include"]
    "24" -> "5" [dir=forward tooltip="include"]
    "24" -> "10" [dir=forward tooltip="include"]
    "24" -> "25" [dir=forward tooltip="include"]
    "24" -> "26" [dir=forward tooltip="include"]
    "24" -> "7" [dir=forward tooltip="include"]
    "24" -> "13" [dir=forward tooltip="include"]
    "73" -> "5" [dir=forward tooltip="include"]
    "73" -> "10" [dir=forward tooltip="include"]
    "73" -> "25" [dir=forward tooltip="include"]
    "73" -> "14" [dir=forward tooltip="include"]
    "73" -> "9" [dir=forward tooltip="include"]
    "18" -> "17" [dir=forward tooltip="include"]
    "18" -> "13" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "20" [dir=forward tooltip="include"]
    "31" -> "15" [dir=forward tooltip="include"]
    "31" -> "8" [dir=forward tooltip="include"]
    "9" -> "8" [dir=forward tooltip="include"]
    "9" -> "5" [dir=forward tooltip="include"]
    "9" -> "6" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "7" [dir=forward tooltip="include"]
    "12" -> "13" [dir=forward tooltip="include"]
    "12" -> "14" [dir=forward tooltip="include"]
    "12" -> "15" [dir=forward tooltip="include"]
    "12" -> "16" [dir=forward tooltip="include"]
    "12" -> "17" [dir=forward tooltip="include"]
    "12" -> "18" [dir=forward tooltip="include"]
    "12" -> "22" [dir=forward tooltip="include"]
    "12" -> "27" [dir=forward tooltip="include"]
    "22" -> "23" [dir=forward tooltip="include"]
    "22" -> "14" [dir=forward tooltip="include"]
    "22" -> "17" [dir=forward tooltip="include"]
    "22" -> "24" [dir=forward tooltip="include"]
    "29" -> "17" [dir=forward tooltip="include"]
    "35" -> "36" [dir=forward tooltip="include"]
    "35" -> "17" [dir=forward tooltip="include"]
    "36" -> "37" [dir=forward tooltip="include"]
    "36" -> "17" [dir=forward tooltip="include"]
    "46" -> "47" [dir=forward tooltip="include"]
    "46" -> "33" [dir=forward tooltip="include"]
    "70" -> "8" [dir=forward tooltip="include"]
    "70" -> "71" [dir=forward tooltip="include"]
    "70" -> "30" [dir=forward tooltip="include"]
    "70" -> "72" [dir=forward tooltip="include"]
    "70" -> "56" [dir=forward tooltip="include"]
    "70" -> "49" [dir=forward tooltip="include"]
    "70" -> "73" [dir=forward tooltip="include"]
    "70" -> "9" [dir=forward tooltip="include"]
    "70" -> "74" [dir=forward tooltip="include"]
    "70" -> "75" [dir=forward tooltip="include"]
    "70" -> "37" [dir=forward tooltip="include"]
    "70" -> "76" [dir=forward tooltip="include"]
    "70" -> "63" [dir=forward tooltip="include"]
    "70" -> "11" [dir=forward tooltip="include"]
    "69" -> "39" [dir=forward tooltip="include"]
    "69" -> "70" [dir=forward tooltip="include"]
    "69" -> "63" [dir=forward tooltip="include"]
    "55" -> "56" [dir=forward tooltip="include"]
    "55" -> "65" [dir=forward tooltip="include"]
    "55" -> "79" [dir=forward tooltip="include"]
    "48" -> "14" [dir=forward tooltip="include"]
    "48" -> "49" [dir=forward tooltip="include"]
    "48" -> "36" [dir=forward tooltip="include"]
    "48" -> "55" [dir=forward tooltip="include"]
    "48" -> "43" [dir=forward tooltip="include"]
    "48" -> "11" [dir=forward tooltip="include"]
    "48" -> "45" [dir=forward tooltip="include"]
    "77" -> "37" [dir=forward tooltip="include"]
    "77" -> "70" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "44" -> "14" [dir=forward tooltip="include"]
    "44" -> "11" [dir=forward tooltip="include"]
    "49" -> "13" [dir=forward tooltip="include"]
    "49" -> "34" [dir=forward tooltip="include"]
    "49" -> "19" [dir=forward tooltip="include"]
    "49" -> "50" [dir=forward tooltip="include"]
    "49" -> "51" [dir=forward tooltip="include"]
    "49" -> "40" [dir=forward tooltip="include"]
    "49" -> "52" [dir=forward tooltip="include"]
    "49" -> "11" [dir=forward tooltip="include"]
    "78" -> "7" [dir=forward tooltip="include"]
    "78" -> "13" [dir=forward tooltip="include"]
    "78" -> "71" [dir=forward tooltip="include"]
    "78" -> "34" [dir=forward tooltip="include"]
    "78" -> "41" [dir=forward tooltip="include"]
    "78" -> "63" [dir=forward tooltip="include"]
    "74" -> "13" [dir=forward tooltip="include"]
    "74" -> "14" [dir=forward tooltip="include"]
    "74" -> "9" [dir=forward tooltip="include"]
    "74" -> "40" [dir=forward tooltip="include"]
    "37" -> "26" [dir=forward tooltip="include"]
    "37" -> "7" [dir=forward tooltip="include"]
    "37" -> "38" [dir=forward tooltip="include"]
    "37" -> "39" [dir=forward tooltip="include"]
    "37" -> "21" [dir=forward tooltip="include"]
    "37" -> "14" [dir=forward tooltip="include"]
    "37" -> "30" [dir=forward tooltip="include"]
    "37" -> "40" [dir=forward tooltip="include"]
    "37" -> "41" [dir=forward tooltip="include"]
    "37" -> "42" [dir=forward tooltip="include"]
    "37" -> "11" [dir=forward tooltip="include"]
    "32" -> "14" [dir=forward tooltip="include"]
    "32" -> "21" [dir=forward tooltip="include"]
    "32" -> "3" [dir=forward tooltip="include"]
    "32" -> "33" [dir=forward tooltip="include"]
    "33" -> "14" [dir=forward tooltip="include"]
    "33" -> "15" [dir=forward tooltip="include"]
    "33" -> "13" [dir=forward tooltip="include"]
    "33" -> "7" [dir=forward tooltip="include"]
    "33" -> "34" [dir=forward tooltip="include"]
    "33" -> "35" [dir=forward tooltip="include"]
    "33" -> "43" [dir=forward tooltip="include"]
    "33" -> "11" [dir=forward tooltip="include"]
    "33" -> "44" [dir=forward tooltip="include"]
    "33" -> "45" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "32" [dir=forward tooltip="include"]
    "2" -> "46" [dir=forward tooltip="include"]
    "2" -> "48" [dir=forward tooltip="include"]
    "59" -> "60" [dir=forward tooltip="include"]
    "59" -> "61" [dir=forward tooltip="include"]
    "59" -> "5" [dir=forward tooltip="include"]
    "59" -> "6" [dir=forward tooltip="include"]
    "59" -> "10" [dir=forward tooltip="include"]
    "65" -> "11" [dir=forward tooltip="include"]
    "65" -> "8" [dir=forward tooltip="include"]
    "65" -> "57" [dir=forward tooltip="include"]
    "65" -> "66" [dir=forward tooltip="include"]
    "65" -> "26" [dir=forward tooltip="include"]
    "65" -> "61" [dir=forward tooltip="include"]
    "65" -> "67" [dir=forward tooltip="include"]
    "65" -> "5" [dir=forward tooltip="include"]
    "65" -> "6" [dir=forward tooltip="include"]
    "65" -> "25" [dir=forward tooltip="include"]
    "65" -> "10" [dir=forward tooltip="include"]
    "65" -> "13" [dir=forward tooltip="include"]
    "65" -> "7" [dir=forward tooltip="include"]
    "65" -> "68" [dir=forward tooltip="include"]
    "65" -> "17" [dir=forward tooltip="include"]
    "65" -> "69" [dir=forward tooltip="include"]
    "65" -> "77" [dir=forward tooltip="include"]
    "65" -> "78" [dir=forward tooltip="include"]
    "65" -> "30" [dir=forward tooltip="include"]
    "65" -> "56" [dir=forward tooltip="include"]
    "65" -> "72" [dir=forward tooltip="include"]
    "56" -> "57" [dir=forward tooltip="include"]
    "56" -> "8" [dir=forward tooltip="include"]
    "56" -> "13" [dir=forward tooltip="include"]
    "56" -> "7" [dir=forward tooltip="include"]
    "56" -> "14" [dir=forward tooltip="include"]
    "56" -> "15" [dir=forward tooltip="include"]
    "56" -> "39" [dir=forward tooltip="include"]
    "56" -> "58" [dir=forward tooltip="include"]
    "56" -> "59" [dir=forward tooltip="include"]
    "56" -> "62" [dir=forward tooltip="include"]
    "56" -> "30" [dir=forward tooltip="include"]
    "56" -> "9" [dir=forward tooltip="include"]
    "56" -> "31" [dir=forward tooltip="include"]
    "56" -> "64" [dir=forward tooltip="include"]
}

Defines

CALL_MEMBER_FN(object, ptrToMember)
file NoForce.H
#include <string>
#include <PotAccel.H>

Include dependency graph for NoForce.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "11" [label="StringTok.H" tooltip="StringTok.H"]
    "12" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/NoForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/NoForce.H" fillcolor="#BFBFBF"]
    "3" [label="PotAccel.H" tooltip="PotAccel.H"]
    "10" [label="Particle.H" tooltip="Particle.H"]
    "5" [label="chrono" tooltip="chrono"]
    "14" [label="config_exp.h" tooltip="config_exp.h"]
    "4" [label="cstdlib" tooltip="cstdlib"]
    "6" [label="list" tooltip="list"]
    "7" [label="map" tooltip="map"]
    "8" [label="memory" tooltip="memory"]
    "13" [label="set" tooltip="set"]
    "2" [label="string" tooltip="string"]
    "9" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "12" -> "2" [dir=forward tooltip="include"]
    "12" -> "13" [dir=forward tooltip="include"]
    "12" -> "9" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "2" [dir=forward tooltip="include"]
    "3" -> "5" [dir=forward tooltip="include"]
    "3" -> "6" [dir=forward tooltip="include"]
    "3" -> "7" [dir=forward tooltip="include"]
    "3" -> "8" [dir=forward tooltip="include"]
    "3" -> "9" [dir=forward tooltip="include"]
    "3" -> "10" [dir=forward tooltip="include"]
    "3" -> "11" [dir=forward tooltip="include"]
    "3" -> "12" [dir=forward tooltip="include"]
    "3" -> "14" [dir=forward tooltip="include"]
}
file NVTX.H
#include <memory>
#include <config_exp.h>

Include dependency graph for NVTX.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/NVTX.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/NVTX.H" fillcolor="#BFBFBF"]
    "3" [label="config_exp.h" tooltip="config_exp.h"]
    "2" [label="memory" tooltip="memory"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include NVTX.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Bessel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Bessel.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/NVTX.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/NVTX.H" fillcolor="#BFBFBF"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SphericalBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SphericalBasis.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "6" -> "7" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "5" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "4" [dir=back tooltip="include"]
    "10" -> "7" [dir=back tooltip="include"]
    "5" -> "6" [dir=back tooltip="include"]
    "5" -> "10" [dir=back tooltip="include"]
    "7" -> "8" [dir=back tooltip="include"]
    "7" -> "9" [dir=back tooltip="include"]
}

Typedefs

typedef std::shared_ptr<nvTracer> nvTracerPtr
file OrbTrace.H
#include <OrbTrace.H>

Include dependency graph for OrbTrace.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OrbTrace.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OrbTrace.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include OrbTrace.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OrbTrace.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OrbTrace.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=back tooltip="include"]
}
file Orient.H
#include <vector>
#include <set>
#include <deque>
#include <algorithm>
#include <euler.H>
#include <Particle.H>
#include <PseudoAccel.H>
#include <config_exp.h>

Include dependency graph for Orient.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "9" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "11" [label="QuadLS.H" tooltip="QuadLS.H"]
    "6" [label="euler.H" tooltip="euler.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Orient.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Orient.H" fillcolor="#BFBFBF"]
    "7" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "8" [label="Particle.H" tooltip="Particle.H"]
    "5" [label="algorithm" tooltip="algorithm"]
    "10" [label="array" tooltip="array"]
    "15" [label="config_exp.h" tooltip="config_exp.h"]
    "4" [label="deque" tooltip="deque"]
    "13" [label="iomanip" tooltip="iomanip"]
    "12" [label="iostream" tooltip="iostream"]
    "3" [label="set" tooltip="set"]
    "14" [label="tuple" tooltip="tuple"]
    "2" [label="vector" tooltip="vector"]
    "9" -> "4" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "7" [dir=forward tooltip="include"]
    "9" -> "11" [dir=forward tooltip="include"]
    "11" -> "12" [dir=forward tooltip="include"]
    "11" -> "13" [dir=forward tooltip="include"]
    "11" -> "14" [dir=forward tooltip="include"]
    "6" -> "7" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "1" -> "15" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include Orient.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Orient.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Orient.H" fillcolor="#BFBFBF"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "20" [dir=back tooltip="include"]
    "2" -> "24" [dir=back tooltip="include"]
    "2" -> "25" [dir=back tooltip="include"]
    "2" -> "26" [dir=back tooltip="include"]
    "2" -> "27" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "13" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "6" [dir=back tooltip="include"]
    "4" -> "7" [dir=back tooltip="include"]
    "4" -> "8" [dir=back tooltip="include"]
    "4" -> "9" [dir=back tooltip="include"]
    "4" -> "10" [dir=back tooltip="include"]
    "4" -> "11" [dir=back tooltip="include"]
    "4" -> "12" [dir=back tooltip="include"]
    "20" -> "4" [dir=back tooltip="include"]
    "20" -> "21" [dir=back tooltip="include"]
    "20" -> "22" [dir=back tooltip="include"]
    "20" -> "13" [dir=back tooltip="include"]
    "20" -> "23" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "15" [dir=back tooltip="include"]
    "24" -> "24" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "16" -> "18" [dir=back tooltip="include"]
    "13" -> "14" [dir=back tooltip="include"]
    "13" -> "19" [dir=back tooltip="include"]
}

Variables

bool use_cuda
file OutAscii.H
#include <Component.H>
#include <OutAscii.H>

Include dependency graph for OutAscii.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "24" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "44" [label="CenterFile.H" tooltip="CenterFile.H"]
    "48" [label="Circular.H" tooltip="Circular.H"]
    "6" [label="EXPException.H" tooltip="EXPException.H"]
    "37" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "39" [label="QuadLS.H" tooltip="QuadLS.H"]
    "30" [label="Species.H" tooltip="Species.H"]
    "46" [label="StringTok.H" tooltip="StringTok.H"]
    "26" [label="Timer.H" tooltip="Timer.H"]
    "47" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "34" [label="euler.H" tooltip="euler.H"]
    "42" [label="header.H" tooltip="header.H"]
    "11" [label="libvars.H" tooltip="libvars.H"]
    "29" [label="localmpi.H" tooltip="localmpi.H"]
    "2" [label="Component.H" tooltip="Component.H"]
    "31" [label="Orient.H" tooltip="Orient.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" fillcolor="#BFBFBF"]
    "43" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "45" [label="PotAccel.H" tooltip="PotAccel.H"]
    "18" [label="chkTimer.H" tooltip="chkTimer.H"]
    "17" [label="coef.H" tooltip="coef.H"]
    "13" [label="global.H" tooltip="global.H"]
    "35" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "36" [label="Particle.H" tooltip="Particle.H"]
    "33" [label="algorithm" tooltip="algorithm"]
    "38" [label="array" tooltip="array"]
    "28" [label="chrono" tooltip="chrono"]
    "20" [label="cmath" tooltip="cmath"]
    "41" [label="config_exp.h" tooltip="config_exp.h"]
    "27" [label="cstdlib" tooltip="cstdlib"]
    "32" [label="deque" tooltip="deque"]
    "22" [label="fstream" tooltip="fstream"]
    "23" [label="iomanip" tooltip="iomanip"]
    "21" [label="iostream" tooltip="iostream"]
    "16" [label="list" tooltip="list"]
    "25" [label="map" tooltip="map"]
    "15" [label="memory" tooltip="memory"]
    "3" [label="mpi.h" tooltip="mpi.h"]
    "14" [label="pthread.h" tooltip="pthread.h"]
    "12" [label="random" tooltip="random"]
    "7" [label="set" tooltip="set"]
    "10" [label="sstream" tooltip="sstream"]
    "9" [label="string" tooltip="string"]
    "19" [label="time.h" tooltip="time.h"]
    "40" [label="tuple" tooltip="tuple"]
    "4" [label="utility" tooltip="utility"]
    "8" [label="vector" tooltip="vector"]
    "5" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "24" -> "21" [dir=forward tooltip="include"]
    "24" -> "23" [dir=forward tooltip="include"]
    "24" -> "8" [dir=forward tooltip="include"]
    "24" -> "9" [dir=forward tooltip="include"]
    "24" -> "16" [dir=forward tooltip="include"]
    "24" -> "25" [dir=forward tooltip="include"]
    "24" -> "7" [dir=forward tooltip="include"]
    "24" -> "15" [dir=forward tooltip="include"]
    "24" -> "26" [dir=forward tooltip="include"]
    "24" -> "3" [dir=forward tooltip="include"]
    "44" -> "22" [dir=forward tooltip="include"]
    "44" -> "8" [dir=forward tooltip="include"]
    "44" -> "38" [dir=forward tooltip="include"]
    "44" -> "5" [dir=forward tooltip="include"]
    "48" -> "8" [dir=forward tooltip="include"]
    "6" -> "7" [dir=forward tooltip="include"]
    "6" -> "8" [dir=forward tooltip="include"]
    "6" -> "9" [dir=forward tooltip="include"]
    "6" -> "10" [dir=forward tooltip="include"]
    "6" -> "11" [dir=forward tooltip="include"]
    "37" -> "32" [dir=forward tooltip="include"]
    "37" -> "38" [dir=forward tooltip="include"]
    "37" -> "35" [dir=forward tooltip="include"]
    "37" -> "39" [dir=forward tooltip="include"]
    "39" -> "21" [dir=forward tooltip="include"]
    "39" -> "23" [dir=forward tooltip="include"]
    "39" -> "40" [dir=forward tooltip="include"]
    "30" -> "25" [dir=forward tooltip="include"]
    "30" -> "7" [dir=forward tooltip="include"]
    "30" -> "8" [dir=forward tooltip="include"]
    "26" -> "21" [dir=forward tooltip="include"]
    "26" -> "27" [dir=forward tooltip="include"]
    "26" -> "28" [dir=forward tooltip="include"]
    "47" -> "9" [dir=forward tooltip="include"]
    "47" -> "7" [dir=forward tooltip="include"]
    "47" -> "5" [dir=forward tooltip="include"]
    "34" -> "35" [dir=forward tooltip="include"]
    "42" -> "21" [dir=forward tooltip="include"]
    "42" -> "23" [dir=forward tooltip="include"]
    "42" -> "10" [dir=forward tooltip="include"]
    "42" -> "15" [dir=forward tooltip="include"]
    "42" -> "29" [dir=forward tooltip="include"]
    "11" -> "12" [dir=forward tooltip="include"]
    "11" -> "3" [dir=forward tooltip="include"]
    "29" -> "3" [dir=forward tooltip="include"]
    "29" -> "21" [dir=forward tooltip="include"]
    "29" -> "22" [dir=forward tooltip="include"]
    "29" -> "23" [dir=forward tooltip="include"]
    "29" -> "9" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "2" -> "13" [dir=forward tooltip="include"]
    "2" -> "31" [dir=forward tooltip="include"]
    "2" -> "42" [dir=forward tooltip="include"]
    "2" -> "29" [dir=forward tooltip="include"]
    "2" -> "43" [dir=forward tooltip="include"]
    "2" -> "44" [dir=forward tooltip="include"]
    "2" -> "45" [dir=forward tooltip="include"]
    "2" -> "48" [dir=forward tooltip="include"]
    "2" -> "26" [dir=forward tooltip="include"]
    "2" -> "41" [dir=forward tooltip="include"]
    "31" -> "8" [dir=forward tooltip="include"]
    "31" -> "7" [dir=forward tooltip="include"]
    "31" -> "32" [dir=forward tooltip="include"]
    "31" -> "33" [dir=forward tooltip="include"]
    "31" -> "34" [dir=forward tooltip="include"]
    "31" -> "36" [dir=forward tooltip="include"]
    "31" -> "37" [dir=forward tooltip="include"]
    "31" -> "41" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "1" [dir=forward tooltip="include"]
    "43" -> "8" [dir=forward tooltip="include"]
    "43" -> "15" [dir=forward tooltip="include"]
    "43" -> "29" [dir=forward tooltip="include"]
    "43" -> "36" [dir=forward tooltip="include"]
    "45" -> "27" [dir=forward tooltip="include"]
    "45" -> "9" [dir=forward tooltip="include"]
    "45" -> "28" [dir=forward tooltip="include"]
    "45" -> "16" [dir=forward tooltip="include"]
    "45" -> "25" [dir=forward tooltip="include"]
    "45" -> "15" [dir=forward tooltip="include"]
    "45" -> "5" [dir=forward tooltip="include"]
    "45" -> "36" [dir=forward tooltip="include"]
    "45" -> "46" [dir=forward tooltip="include"]
    "45" -> "47" [dir=forward tooltip="include"]
    "45" -> "41" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "20" [dir=forward tooltip="include"]
    "18" -> "21" [dir=forward tooltip="include"]
    "18" -> "22" [dir=forward tooltip="include"]
    "18" -> "23" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "3" [dir=forward tooltip="include"]
    "13" -> "8" [dir=forward tooltip="include"]
    "13" -> "9" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
    "13" -> "12" [dir=forward tooltip="include"]
    "13" -> "16" [dir=forward tooltip="include"]
    "13" -> "17" [dir=forward tooltip="include"]
    "13" -> "18" [dir=forward tooltip="include"]
    "13" -> "24" [dir=forward tooltip="include"]
    "13" -> "5" [dir=forward tooltip="include"]
    "13" -> "29" [dir=forward tooltip="include"]
    "13" -> "11" [dir=forward tooltip="include"]
    "13" -> "30" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include OutAscii.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=back tooltip="include"]
}
file OutCalbr.H
#include <Output.H>
#include <Component.H>

Include dependency graph for OutCalbr.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "29" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "46" [label="CenterFile.H" tooltip="CenterFile.H"]
    "49" [label="Circular.H" tooltip="Circular.H"]
    "15" [label="EXPException.H" tooltip="EXPException.H"]
    "39" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "41" [label="QuadLS.H" tooltip="QuadLS.H"]
    "32" [label="Species.H" tooltip="Species.H"]
    "7" [label="StringTok.H" tooltip="StringTok.H"]
    "8" [label="Timer.H" tooltip="Timer.H"]
    "48" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "36" [label="euler.H" tooltip="euler.H"]
    "44" [label="header.H" tooltip="header.H"]
    "17" [label="libvars.H" tooltip="libvars.H"]
    "31" [label="localmpi.H" tooltip="localmpi.H"]
    "12" [label="Component.H" tooltip="Component.H"]
    "33" [label="Orient.H" tooltip="Orient.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" fillcolor="#BFBFBF"]
    "2" [label="Output.H" tooltip="Output.H"]
    "45" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "47" [label="PotAccel.H" tooltip="PotAccel.H"]
    "24" [label="chkTimer.H" tooltip="chkTimer.H"]
    "23" [label="coef.H" tooltip="coef.H"]
    "19" [label="global.H" tooltip="global.H"]
    "37" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "38" [label="Particle.H" tooltip="Particle.H"]
    "35" [label="algorithm" tooltip="algorithm"]
    "40" [label="array" tooltip="array"]
    "11" [label="chrono" tooltip="chrono"]
    "26" [label="cmath" tooltip="cmath"]
    "43" [label="config_exp.h" tooltip="config_exp.h"]
    "10" [label="cstdlib" tooltip="cstdlib"]
    "34" [label="deque" tooltip="deque"]
    "27" [label="fstream" tooltip="fstream"]
    "28" [label="iomanip" tooltip="iomanip"]
    "9" [label="iostream" tooltip="iostream"]
    "22" [label="list" tooltip="list"]
    "30" [label="map" tooltip="map"]
    "21" [label="memory" tooltip="memory"]
    "13" [label="mpi.h" tooltip="mpi.h"]
    "20" [label="pthread.h" tooltip="pthread.h"]
    "18" [label="random" tooltip="random"]
    "6" [label="set" tooltip="set"]
    "16" [label="sstream" tooltip="sstream"]
    "3" [label="string" tooltip="string"]
    "25" [label="time.h" tooltip="time.h"]
    "42" [label="tuple" tooltip="tuple"]
    "5" [label="utility" tooltip="utility"]
    "4" [label="vector" tooltip="vector"]
    "14" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "29" -> "9" [dir=forward tooltip="include"]
    "29" -> "28" [dir=forward tooltip="include"]
    "29" -> "4" [dir=forward tooltip="include"]
    "29" -> "3" [dir=forward tooltip="include"]
    "29" -> "22" [dir=forward tooltip="include"]
    "29" -> "30" [dir=forward tooltip="include"]
    "29" -> "6" [dir=forward tooltip="include"]
    "29" -> "21" [dir=forward tooltip="include"]
    "29" -> "8" [dir=forward tooltip="include"]
    "29" -> "13" [dir=forward tooltip="include"]
    "46" -> "27" [dir=forward tooltip="include"]
    "46" -> "4" [dir=forward tooltip="include"]
    "46" -> "40" [dir=forward tooltip="include"]
    "46" -> "14" [dir=forward tooltip="include"]
    "49" -> "4" [dir=forward tooltip="include"]
    "15" -> "6" [dir=forward tooltip="include"]
    "15" -> "4" [dir=forward tooltip="include"]
    "15" -> "3" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "17" [dir=forward tooltip="include"]
    "39" -> "34" [dir=forward tooltip="include"]
    "39" -> "40" [dir=forward tooltip="include"]
    "39" -> "37" [dir=forward tooltip="include"]
    "39" -> "41" [dir=forward tooltip="include"]
    "41" -> "9" [dir=forward tooltip="include"]
    "41" -> "28" [dir=forward tooltip="include"]
    "41" -> "42" [dir=forward tooltip="include"]
    "32" -> "30" [dir=forward tooltip="include"]
    "32" -> "6" [dir=forward tooltip="include"]
    "32" -> "4" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "10" [dir=forward tooltip="include"]
    "8" -> "11" [dir=forward tooltip="include"]
    "48" -> "3" [dir=forward tooltip="include"]
    "48" -> "6" [dir=forward tooltip="include"]
    "48" -> "14" [dir=forward tooltip="include"]
    "36" -> "37" [dir=forward tooltip="include"]
    "44" -> "9" [dir=forward tooltip="include"]
    "44" -> "28" [dir=forward tooltip="include"]
    "44" -> "16" [dir=forward tooltip="include"]
    "44" -> "21" [dir=forward tooltip="include"]
    "44" -> "31" [dir=forward tooltip="include"]
    "17" -> "18" [dir=forward tooltip="include"]
    "17" -> "13" [dir=forward tooltip="include"]
    "31" -> "13" [dir=forward tooltip="include"]
    "31" -> "9" [dir=forward tooltip="include"]
    "31" -> "27" [dir=forward tooltip="include"]
    "31" -> "28" [dir=forward tooltip="include"]
    "31" -> "3" [dir=forward tooltip="include"]
    "12" -> "13" [dir=forward tooltip="include"]
    "12" -> "5" [dir=forward tooltip="include"]
    "12" -> "14" [dir=forward tooltip="include"]
    "12" -> "15" [dir=forward tooltip="include"]
    "12" -> "19" [dir=forward tooltip="include"]
    "12" -> "33" [dir=forward tooltip="include"]
    "12" -> "44" [dir=forward tooltip="include"]
    "12" -> "31" [dir=forward tooltip="include"]
    "12" -> "45" [dir=forward tooltip="include"]
    "12" -> "46" [dir=forward tooltip="include"]
    "12" -> "47" [dir=forward tooltip="include"]
    "12" -> "49" [dir=forward tooltip="include"]
    "12" -> "8" [dir=forward tooltip="include"]
    "12" -> "43" [dir=forward tooltip="include"]
    "33" -> "4" [dir=forward tooltip="include"]
    "33" -> "6" [dir=forward tooltip="include"]
    "33" -> "34" [dir=forward tooltip="include"]
    "33" -> "35" [dir=forward tooltip="include"]
    "33" -> "36" [dir=forward tooltip="include"]
    "33" -> "38" [dir=forward tooltip="include"]
    "33" -> "39" [dir=forward tooltip="include"]
    "33" -> "43" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "12" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "2" -> "7" [dir=forward tooltip="include"]
    "2" -> "8" [dir=forward tooltip="include"]
    "45" -> "4" [dir=forward tooltip="include"]
    "45" -> "21" [dir=forward tooltip="include"]
    "45" -> "31" [dir=forward tooltip="include"]
    "45" -> "38" [dir=forward tooltip="include"]
    "47" -> "10" [dir=forward tooltip="include"]
    "47" -> "3" [dir=forward tooltip="include"]
    "47" -> "11" [dir=forward tooltip="include"]
    "47" -> "22" [dir=forward tooltip="include"]
    "47" -> "30" [dir=forward tooltip="include"]
    "47" -> "21" [dir=forward tooltip="include"]
    "47" -> "14" [dir=forward tooltip="include"]
    "47" -> "38" [dir=forward tooltip="include"]
    "47" -> "7" [dir=forward tooltip="include"]
    "47" -> "48" [dir=forward tooltip="include"]
    "47" -> "43" [dir=forward tooltip="include"]
    "24" -> "25" [dir=forward tooltip="include"]
    "24" -> "26" [dir=forward tooltip="include"]
    "24" -> "9" [dir=forward tooltip="include"]
    "24" -> "27" [dir=forward tooltip="include"]
    "24" -> "28" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "19" -> "13" [dir=forward tooltip="include"]
    "19" -> "4" [dir=forward tooltip="include"]
    "19" -> "3" [dir=forward tooltip="include"]
    "19" -> "21" [dir=forward tooltip="include"]
    "19" -> "18" [dir=forward tooltip="include"]
    "19" -> "22" [dir=forward tooltip="include"]
    "19" -> "23" [dir=forward tooltip="include"]
    "19" -> "24" [dir=forward tooltip="include"]
    "19" -> "29" [dir=forward tooltip="include"]
    "19" -> "14" [dir=forward tooltip="include"]
    "19" -> "31" [dir=forward tooltip="include"]
    "19" -> "17" [dir=forward tooltip="include"]
    "19" -> "32" [dir=forward tooltip="include"]
}
file OutCHKPT.H
#include <OutCHKPT.H>

Include dependency graph for OutCHKPT.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCHKPT.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCHKPT.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include OutCHKPT.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCHKPT.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCHKPT.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=back tooltip="include"]
}
file OutCHKPTQ.H
#include <Output.H>

Include dependency graph for OutCHKPTQ.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "7" [label="StringTok.H" tooltip="StringTok.H"]
    "8" [label="Timer.H" tooltip="Timer.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCHKPTQ.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCHKPTQ.H" fillcolor="#BFBFBF"]
    "2" [label="Output.H" tooltip="Output.H"]
    "11" [label="chrono" tooltip="chrono"]
    "10" [label="cstdlib" tooltip="cstdlib"]
    "9" [label="iostream" tooltip="iostream"]
    "6" [label="set" tooltip="set"]
    "3" [label="string" tooltip="string"]
    "5" [label="utility" tooltip="utility"]
    "4" [label="vector" tooltip="vector"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "10" [dir=forward tooltip="include"]
    "8" -> "11" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "2" -> "7" [dir=forward tooltip="include"]
    "2" -> "8" [dir=forward tooltip="include"]
}
file OutCoef.H
#include <OutCoef.H>

Include dependency graph for OutCoef.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCoef.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCoef.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include OutCoef.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCoef.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCoef.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=back tooltip="include"]
}
file OutDiag.H
#include <OutDiag.H>

Include dependency graph for OutDiag.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutDiag.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutDiag.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include OutDiag.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutDiag.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutDiag.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=back tooltip="include"]
}
file OutFrac.H
#include <Output.H>
#include <Component.H>

Include dependency graph for OutFrac.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "29" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "46" [label="CenterFile.H" tooltip="CenterFile.H"]
    "49" [label="Circular.H" tooltip="Circular.H"]
    "15" [label="EXPException.H" tooltip="EXPException.H"]
    "39" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "41" [label="QuadLS.H" tooltip="QuadLS.H"]
    "32" [label="Species.H" tooltip="Species.H"]
    "7" [label="StringTok.H" tooltip="StringTok.H"]
    "8" [label="Timer.H" tooltip="Timer.H"]
    "48" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "36" [label="euler.H" tooltip="euler.H"]
    "44" [label="header.H" tooltip="header.H"]
    "17" [label="libvars.H" tooltip="libvars.H"]
    "31" [label="localmpi.H" tooltip="localmpi.H"]
    "12" [label="Component.H" tooltip="Component.H"]
    "33" [label="Orient.H" tooltip="Orient.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" fillcolor="#BFBFBF"]
    "2" [label="Output.H" tooltip="Output.H"]
    "45" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "47" [label="PotAccel.H" tooltip="PotAccel.H"]
    "24" [label="chkTimer.H" tooltip="chkTimer.H"]
    "23" [label="coef.H" tooltip="coef.H"]
    "19" [label="global.H" tooltip="global.H"]
    "37" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "38" [label="Particle.H" tooltip="Particle.H"]
    "35" [label="algorithm" tooltip="algorithm"]
    "40" [label="array" tooltip="array"]
    "11" [label="chrono" tooltip="chrono"]
    "26" [label="cmath" tooltip="cmath"]
    "43" [label="config_exp.h" tooltip="config_exp.h"]
    "10" [label="cstdlib" tooltip="cstdlib"]
    "34" [label="deque" tooltip="deque"]
    "27" [label="fstream" tooltip="fstream"]
    "28" [label="iomanip" tooltip="iomanip"]
    "9" [label="iostream" tooltip="iostream"]
    "22" [label="list" tooltip="list"]
    "30" [label="map" tooltip="map"]
    "21" [label="memory" tooltip="memory"]
    "13" [label="mpi.h" tooltip="mpi.h"]
    "20" [label="pthread.h" tooltip="pthread.h"]
    "18" [label="random" tooltip="random"]
    "6" [label="set" tooltip="set"]
    "16" [label="sstream" tooltip="sstream"]
    "3" [label="string" tooltip="string"]
    "25" [label="time.h" tooltip="time.h"]
    "42" [label="tuple" tooltip="tuple"]
    "5" [label="utility" tooltip="utility"]
    "4" [label="vector" tooltip="vector"]
    "14" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "29" -> "9" [dir=forward tooltip="include"]
    "29" -> "28" [dir=forward tooltip="include"]
    "29" -> "4" [dir=forward tooltip="include"]
    "29" -> "3" [dir=forward tooltip="include"]
    "29" -> "22" [dir=forward tooltip="include"]
    "29" -> "30" [dir=forward tooltip="include"]
    "29" -> "6" [dir=forward tooltip="include"]
    "29" -> "21" [dir=forward tooltip="include"]
    "29" -> "8" [dir=forward tooltip="include"]
    "29" -> "13" [dir=forward tooltip="include"]
    "46" -> "27" [dir=forward tooltip="include"]
    "46" -> "4" [dir=forward tooltip="include"]
    "46" -> "40" [dir=forward tooltip="include"]
    "46" -> "14" [dir=forward tooltip="include"]
    "49" -> "4" [dir=forward tooltip="include"]
    "15" -> "6" [dir=forward tooltip="include"]
    "15" -> "4" [dir=forward tooltip="include"]
    "15" -> "3" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "17" [dir=forward tooltip="include"]
    "39" -> "34" [dir=forward tooltip="include"]
    "39" -> "40" [dir=forward tooltip="include"]
    "39" -> "37" [dir=forward tooltip="include"]
    "39" -> "41" [dir=forward tooltip="include"]
    "41" -> "9" [dir=forward tooltip="include"]
    "41" -> "28" [dir=forward tooltip="include"]
    "41" -> "42" [dir=forward tooltip="include"]
    "32" -> "30" [dir=forward tooltip="include"]
    "32" -> "6" [dir=forward tooltip="include"]
    "32" -> "4" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "10" [dir=forward tooltip="include"]
    "8" -> "11" [dir=forward tooltip="include"]
    "48" -> "3" [dir=forward tooltip="include"]
    "48" -> "6" [dir=forward tooltip="include"]
    "48" -> "14" [dir=forward tooltip="include"]
    "36" -> "37" [dir=forward tooltip="include"]
    "44" -> "9" [dir=forward tooltip="include"]
    "44" -> "28" [dir=forward tooltip="include"]
    "44" -> "16" [dir=forward tooltip="include"]
    "44" -> "21" [dir=forward tooltip="include"]
    "44" -> "31" [dir=forward tooltip="include"]
    "17" -> "18" [dir=forward tooltip="include"]
    "17" -> "13" [dir=forward tooltip="include"]
    "31" -> "13" [dir=forward tooltip="include"]
    "31" -> "9" [dir=forward tooltip="include"]
    "31" -> "27" [dir=forward tooltip="include"]
    "31" -> "28" [dir=forward tooltip="include"]
    "31" -> "3" [dir=forward tooltip="include"]
    "12" -> "13" [dir=forward tooltip="include"]
    "12" -> "5" [dir=forward tooltip="include"]
    "12" -> "14" [dir=forward tooltip="include"]
    "12" -> "15" [dir=forward tooltip="include"]
    "12" -> "19" [dir=forward tooltip="include"]
    "12" -> "33" [dir=forward tooltip="include"]
    "12" -> "44" [dir=forward tooltip="include"]
    "12" -> "31" [dir=forward tooltip="include"]
    "12" -> "45" [dir=forward tooltip="include"]
    "12" -> "46" [dir=forward tooltip="include"]
    "12" -> "47" [dir=forward tooltip="include"]
    "12" -> "49" [dir=forward tooltip="include"]
    "12" -> "8" [dir=forward tooltip="include"]
    "12" -> "43" [dir=forward tooltip="include"]
    "33" -> "4" [dir=forward tooltip="include"]
    "33" -> "6" [dir=forward tooltip="include"]
    "33" -> "34" [dir=forward tooltip="include"]
    "33" -> "35" [dir=forward tooltip="include"]
    "33" -> "36" [dir=forward tooltip="include"]
    "33" -> "38" [dir=forward tooltip="include"]
    "33" -> "39" [dir=forward tooltip="include"]
    "33" -> "43" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "12" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "2" -> "7" [dir=forward tooltip="include"]
    "2" -> "8" [dir=forward tooltip="include"]
    "45" -> "4" [dir=forward tooltip="include"]
    "45" -> "21" [dir=forward tooltip="include"]
    "45" -> "31" [dir=forward tooltip="include"]
    "45" -> "38" [dir=forward tooltip="include"]
    "47" -> "10" [dir=forward tooltip="include"]
    "47" -> "3" [dir=forward tooltip="include"]
    "47" -> "11" [dir=forward tooltip="include"]
    "47" -> "22" [dir=forward tooltip="include"]
    "47" -> "30" [dir=forward tooltip="include"]
    "47" -> "21" [dir=forward tooltip="include"]
    "47" -> "14" [dir=forward tooltip="include"]
    "47" -> "38" [dir=forward tooltip="include"]
    "47" -> "7" [dir=forward tooltip="include"]
    "47" -> "48" [dir=forward tooltip="include"]
    "47" -> "43" [dir=forward tooltip="include"]
    "24" -> "25" [dir=forward tooltip="include"]
    "24" -> "26" [dir=forward tooltip="include"]
    "24" -> "9" [dir=forward tooltip="include"]
    "24" -> "27" [dir=forward tooltip="include"]
    "24" -> "28" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "19" -> "13" [dir=forward tooltip="include"]
    "19" -> "4" [dir=forward tooltip="include"]
    "19" -> "3" [dir=forward tooltip="include"]
    "19" -> "21" [dir=forward tooltip="include"]
    "19" -> "18" [dir=forward tooltip="include"]
    "19" -> "22" [dir=forward tooltip="include"]
    "19" -> "23" [dir=forward tooltip="include"]
    "19" -> "24" [dir=forward tooltip="include"]
    "19" -> "29" [dir=forward tooltip="include"]
    "19" -> "14" [dir=forward tooltip="include"]
    "19" -> "31" [dir=forward tooltip="include"]
    "19" -> "17" [dir=forward tooltip="include"]
    "19" -> "32" [dir=forward tooltip="include"]
}
file OutLog.H
#include <OutLog.H>

Include dependency graph for OutLog.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutLog.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutLog.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include OutLog.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutLog.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutLog.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=back tooltip="include"]
}
file OutMulti.H
#include <OutMulti.H>

Include dependency graph for OutMulti.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutMulti.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutMulti.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include OutMulti.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutMulti.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutMulti.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=back tooltip="include"]
}
file OutPS.H
#include <OutPS.H>

Include dependency graph for OutPS.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutPS.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutPS.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include OutPS.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutPS.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutPS.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=back tooltip="include"]
}
file OutPSN.H
#include <OutPSN.H>

Include dependency graph for OutPSN.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutPSN.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutPSN.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include OutPSN.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutPSN.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutPSN.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=back tooltip="include"]
}
file OutPSP.H
#include <OutPSP.H>

Include dependency graph for OutPSP.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutPSP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutPSP.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include OutPSP.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutPSP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutPSP.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=back tooltip="include"]
}
file OutPSQ.H
#include <OutPSQ.H>

Include dependency graph for OutPSQ.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutPSQ.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutPSQ.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include OutPSQ.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutPSQ.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutPSQ.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=back tooltip="include"]
}
file OutPSR.H
#include <OutPSR.H>

Include dependency graph for OutPSR.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutPSR.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutPSR.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include OutPSR.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutPSR.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutPSR.H" fillcolor="#BFBFBF"]
    "1" -> "1" [dir=back tooltip="include"]
}
file Output.H
#include <string>
#include <vector>
#include <utility>
#include <set>
#include <StringTok.H>
#include <Timer.H>

Include dependency graph for Output.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "6" [label="StringTok.H" tooltip="StringTok.H"]
    "7" [label="Timer.H" tooltip="Timer.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Output.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Output.H" fillcolor="#BFBFBF"]
    "10" [label="chrono" tooltip="chrono"]
    "9" [label="cstdlib" tooltip="cstdlib"]
    "8" [label="iostream" tooltip="iostream"]
    "5" [label="set" tooltip="set"]
    "2" [label="string" tooltip="string"]
    "4" [label="utility" tooltip="utility"]
    "3" [label="vector" tooltip="vector"]
    "7" -> "8" [dir=forward tooltip="include"]
    "7" -> "9" [dir=forward tooltip="include"]
    "7" -> "10" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include Output.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCHKPTQ.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCHKPTQ.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutRelaxation.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutRelaxation.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Output.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Output.H" fillcolor="#BFBFBF"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutputContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutputContainer.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "8" -> "9" [dir=back tooltip="include"]
    "9" -> "10" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
    "1" -> "4" [dir=back tooltip="include"]
    "1" -> "5" [dir=back tooltip="include"]
    "1" -> "6" [dir=back tooltip="include"]
    "1" -> "7" [dir=back tooltip="include"]
    "10" -> "11" [dir=back tooltip="include"]
    "10" -> "12" [dir=back tooltip="include"]
    "7" -> "8" [dir=back tooltip="include"]
    "7" -> "13" [dir=back tooltip="include"]
}
file OutputContainer.H
#include <thread>
#include <list>
#include <Output.H>

Include dependency graph for OutputContainer.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "9" [label="StringTok.H" tooltip="StringTok.H"]
    "10" [label="Timer.H" tooltip="Timer.H"]
    "4" [label="Output.H" tooltip="Output.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutputContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutputContainer.H" fillcolor="#BFBFBF"]
    "13" [label="chrono" tooltip="chrono"]
    "12" [label="cstdlib" tooltip="cstdlib"]
    "11" [label="iostream" tooltip="iostream"]
    "3" [label="list" tooltip="list"]
    "8" [label="set" tooltip="set"]
    "5" [label="string" tooltip="string"]
    "2" [label="thread" tooltip="thread"]
    "7" [label="utility" tooltip="utility"]
    "6" [label="vector" tooltip="vector"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "12" [dir=forward tooltip="include"]
    "10" -> "13" [dir=forward tooltip="include"]
    "4" -> "5" [dir=forward tooltip="include"]
    "4" -> "6" [dir=forward tooltip="include"]
    "4" -> "7" [dir=forward tooltip="include"]
    "4" -> "8" [dir=forward tooltip="include"]
    "4" -> "9" [dir=forward tooltip="include"]
    "4" -> "10" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
}
file OutRelaxation.H
#include <Output.H>

Include dependency graph for OutRelaxation.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "7" [label="StringTok.H" tooltip="StringTok.H"]
    "8" [label="Timer.H" tooltip="Timer.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutRelaxation.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutRelaxation.H" fillcolor="#BFBFBF"]
    "2" [label="Output.H" tooltip="Output.H"]
    "11" [label="chrono" tooltip="chrono"]
    "10" [label="cstdlib" tooltip="cstdlib"]
    "9" [label="iostream" tooltip="iostream"]
    "6" [label="set" tooltip="set"]
    "3" [label="string" tooltip="string"]
    "5" [label="utility" tooltip="utility"]
    "4" [label="vector" tooltip="vector"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "10" [dir=forward tooltip="include"]
    "8" -> "11" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "2" -> "7" [dir=forward tooltip="include"]
    "2" -> "8" [dir=forward tooltip="include"]
}
file OutVel.H
#include <functional>
#include <string>
#include <vector>
#include <Eigen/Eigen>
#include <unsupported/Eigen/CXX11/Tensor>
#include <highfive/H5File.hpp>
#include <highfive/H5DataSet.hpp>
#include <highfive/H5DataSpace.hpp>
#include <highfive/H5Attribute.hpp>
#include <interp.H>
#include <Component.H>
#include <EXPException.H>
#include <Coefficients.H>
#include <FieldBasis.H>

Include dependency graph for OutVel.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "35" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "52" [label="CenterFile.H" tooltip="CenterFile.H"]
    "56" [label="Circular.H" tooltip="Circular.H"]
    "19" [label="EXPException.H" tooltip="EXPException.H"]
    "13" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "45" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "47" [label="QuadLS.H" tooltip="QuadLS.H"]
    "40" [label="Species.H" tooltip="Species.H"]
    "54" [label="StringTok.H" tooltip="StringTok.H"]
    "36" [label="Timer.H" tooltip="Timer.H"]
    "55" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "43" [label="euler.H" tooltip="euler.H"]
    "50" [label="header.H" tooltip="header.H"]
    "11" [label="interp.H" tooltip="interp.H"]
    "22" [label="libvars.H" tooltip="libvars.H"]
    "39" [label="localmpi.H" tooltip="localmpi.H"]
    "15" [label="Component.H" tooltip="Component.H"]
    "41" [label="Orient.H" tooltip="Orient.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" fillcolor="#BFBFBF"]
    "51" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "53" [label="PotAccel.H" tooltip="PotAccel.H"]
    "29" [label="chkTimer.H" tooltip="chkTimer.H"]
    "28" [label="coef.H" tooltip="coef.H"]
    "24" [label="global.H" tooltip="global.H"]
    "57" [label="Coefficients.H" tooltip="Coefficients.H"]
    "5" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "58" [label="FieldBasis.H" tooltip="FieldBasis.H"]
    "44" [label="Particle.H" tooltip="Particle.H"]
    "42" [label="algorithm" tooltip="algorithm"]
    "46" [label="array" tooltip="array"]
    "38" [label="chrono" tooltip="chrono"]
    "31" [label="cmath" tooltip="cmath"]
    "49" [label="config_exp.h" tooltip="config_exp.h"]
    "37" [label="cstdlib" tooltip="cstdlib"]
    "12" [label="deque" tooltip="deque"]
    "33" [label="fstream" tooltip="fstream"]
    "2" [label="functional" tooltip="functional"]
    "10" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
    "8" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
    "9" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
    "7" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
    "34" [label="iomanip" tooltip="iomanip"]
    "32" [label="iostream" tooltip="iostream"]
    "27" [label="list" tooltip="list"]
    "14" [label="map" tooltip="map"]
    "26" [label="memory" tooltip="memory"]
    "16" [label="mpi.h" tooltip="mpi.h"]
    "25" [label="pthread.h" tooltip="pthread.h"]
    "23" [label="random" tooltip="random"]
    "20" [label="set" tooltip="set"]
    "21" [label="sstream" tooltip="sstream"]
    "3" [label="string" tooltip="string"]
    "30" [label="time.h" tooltip="time.h"]
    "48" [label="tuple" tooltip="tuple"]
    "6" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
    "17" [label="utility" tooltip="utility"]
    "4" [label="vector" tooltip="vector"]
    "18" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "35" -> "32" [dir=forward tooltip="include"]
    "35" -> "34" [dir=forward tooltip="include"]
    "35" -> "4" [dir=forward tooltip="include"]
    "35" -> "3" [dir=forward tooltip="include"]
    "35" -> "27" [dir=forward tooltip="include"]
    "35" -> "14" [dir=forward tooltip="include"]
    "35" -> "20" [dir=forward tooltip="include"]
    "35" -> "26" [dir=forward tooltip="include"]
    "35" -> "36" [dir=forward tooltip="include"]
    "35" -> "16" [dir=forward tooltip="include"]
    "52" -> "33" [dir=forward tooltip="include"]
    "52" -> "4" [dir=forward tooltip="include"]
    "52" -> "46" [dir=forward tooltip="include"]
    "52" -> "18" [dir=forward tooltip="include"]
    "56" -> "4" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "19" -> "4" [dir=forward tooltip="include"]
    "19" -> "3" [dir=forward tooltip="include"]
    "19" -> "21" [dir=forward tooltip="include"]
    "19" -> "22" [dir=forward tooltip="include"]
    "13" -> "4" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "3" [dir=forward tooltip="include"]
    "45" -> "12" [dir=forward tooltip="include"]
    "45" -> "46" [dir=forward tooltip="include"]
    "45" -> "5" [dir=forward tooltip="include"]
    "45" -> "47" [dir=forward tooltip="include"]
    "47" -> "32" [dir=forward tooltip="include"]
    "47" -> "34" [dir=forward tooltip="include"]
    "47" -> "48" [dir=forward tooltip="include"]
    "40" -> "14" [dir=forward tooltip="include"]
    "40" -> "20" [dir=forward tooltip="include"]
    "40" -> "4" [dir=forward tooltip="include"]
    "36" -> "32" [dir=forward tooltip="include"]
    "36" -> "37" [dir=forward tooltip="include"]
    "36" -> "38" [dir=forward tooltip="include"]
    "55" -> "3" [dir=forward tooltip="include"]
    "55" -> "20" [dir=forward tooltip="include"]
    "55" -> "18" [dir=forward tooltip="include"]
    "43" -> "5" [dir=forward tooltip="include"]
    "50" -> "32" [dir=forward tooltip="include"]
    "50" -> "34" [dir=forward tooltip="include"]
    "50" -> "21" [dir=forward tooltip="include"]
    "50" -> "26" [dir=forward tooltip="include"]
    "50" -> "39" [dir=forward tooltip="include"]
    "11" -> "5" [dir=forward tooltip="include"]
    "11" -> "4" [dir=forward tooltip="include"]
    "11" -> "12" [dir=forward tooltip="include"]
    "11" -> "13" [dir=forward tooltip="include"]
    "22" -> "23" [dir=forward tooltip="include"]
    "22" -> "16" [dir=forward tooltip="include"]
    "39" -> "16" [dir=forward tooltip="include"]
    "39" -> "32" [dir=forward tooltip="include"]
    "39" -> "33" [dir=forward tooltip="include"]
    "39" -> "34" [dir=forward tooltip="include"]
    "39" -> "3" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "17" [dir=forward tooltip="include"]
    "15" -> "18" [dir=forward tooltip="include"]
    "15" -> "19" [dir=forward tooltip="include"]
    "15" -> "24" [dir=forward tooltip="include"]
    "15" -> "41" [dir=forward tooltip="include"]
    "15" -> "50" [dir=forward tooltip="include"]
    "15" -> "39" [dir=forward tooltip="include"]
    "15" -> "51" [dir=forward tooltip="include"]
    "15" -> "52" [dir=forward tooltip="include"]
    "15" -> "53" [dir=forward tooltip="include"]
    "15" -> "56" [dir=forward tooltip="include"]
    "15" -> "36" [dir=forward tooltip="include"]
    "15" -> "49" [dir=forward tooltip="include"]
    "41" -> "4" [dir=forward tooltip="include"]
    "41" -> "20" [dir=forward tooltip="include"]
    "41" -> "12" [dir=forward tooltip="include"]
    "41" -> "42" [dir=forward tooltip="include"]
    "41" -> "43" [dir=forward tooltip="include"]
    "41" -> "44" [dir=forward tooltip="include"]
    "41" -> "45" [dir=forward tooltip="include"]
    "41" -> "49" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "1" -> "10" [dir=forward tooltip="include"]
    "1" -> "11" [dir=forward tooltip="include"]
    "1" -> "15" [dir=forward tooltip="include"]
    "1" -> "19" [dir=forward tooltip="include"]
    "1" -> "57" [dir=forward tooltip="include"]
    "1" -> "58" [dir=forward tooltip="include"]
    "51" -> "4" [dir=forward tooltip="include"]
    "51" -> "26" [dir=forward tooltip="include"]
    "51" -> "39" [dir=forward tooltip="include"]
    "51" -> "44" [dir=forward tooltip="include"]
    "53" -> "37" [dir=forward tooltip="include"]
    "53" -> "3" [dir=forward tooltip="include"]
    "53" -> "38" [dir=forward tooltip="include"]
    "53" -> "27" [dir=forward tooltip="include"]
    "53" -> "14" [dir=forward tooltip="include"]
    "53" -> "26" [dir=forward tooltip="include"]
    "53" -> "18" [dir=forward tooltip="include"]
    "53" -> "44" [dir=forward tooltip="include"]
    "53" -> "54" [dir=forward tooltip="include"]
    "53" -> "55" [dir=forward tooltip="include"]
    "53" -> "49" [dir=forward tooltip="include"]
    "29" -> "30" [dir=forward tooltip="include"]
    "29" -> "31" [dir=forward tooltip="include"]
    "29" -> "32" [dir=forward tooltip="include"]
    "29" -> "33" [dir=forward tooltip="include"]
    "29" -> "34" [dir=forward tooltip="include"]
    "24" -> "25" [dir=forward tooltip="include"]
    "24" -> "16" [dir=forward tooltip="include"]
    "24" -> "4" [dir=forward tooltip="include"]
    "24" -> "3" [dir=forward tooltip="include"]
    "24" -> "26" [dir=forward tooltip="include"]
    "24" -> "23" [dir=forward tooltip="include"]
    "24" -> "27" [dir=forward tooltip="include"]
    "24" -> "28" [dir=forward tooltip="include"]
    "24" -> "29" [dir=forward tooltip="include"]
    "24" -> "35" [dir=forward tooltip="include"]
    "24" -> "18" [dir=forward tooltip="include"]
    "24" -> "39" [dir=forward tooltip="include"]
    "24" -> "22" [dir=forward tooltip="include"]
    "24" -> "40" [dir=forward tooltip="include"]
}
file ParticleFerry.H
#include <vector>
#include <memory>
#include “localmpi.H
#include “Particle.H”

Include dependency graph for ParticleFerry.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "4" [label="localmpi.H" tooltip="localmpi.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ParticleFerry.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ParticleFerry.H" fillcolor="#BFBFBF"]
    "10" [label="Particle.H" tooltip="Particle.H"]
    "7" [label="fstream" tooltip="fstream"]
    "8" [label="iomanip" tooltip="iomanip"]
    "6" [label="iostream" tooltip="iostream"]
    "3" [label="memory" tooltip="memory"]
    "5" [label="mpi.h" tooltip="mpi.h"]
    "9" [label="string" tooltip="string"]
    "2" [label="vector" tooltip="vector"]
    "4" -> "5" [dir=forward tooltip="include"]
    "4" -> "6" [dir=forward tooltip="include"]
    "4" -> "7" [dir=forward tooltip="include"]
    "4" -> "8" [dir=forward tooltip="include"]
    "4" -> "9" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "10" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include ParticleFerry.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ParticleFerry.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ParticleFerry.H" fillcolor="#BFBFBF"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "20" [dir=back tooltip="include"]
    "2" -> "24" [dir=back tooltip="include"]
    "2" -> "25" [dir=back tooltip="include"]
    "2" -> "26" [dir=back tooltip="include"]
    "2" -> "27" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "13" [dir=back tooltip="include"]
    "14" -> "15" [dir=back tooltip="include"]
    "15" -> "16" [dir=back tooltip="include"]
    "4" -> "5" [dir=back tooltip="include"]
    "4" -> "6" [dir=back tooltip="include"]
    "4" -> "7" [dir=back tooltip="include"]
    "4" -> "8" [dir=back tooltip="include"]
    "4" -> "9" [dir=back tooltip="include"]
    "4" -> "10" [dir=back tooltip="include"]
    "4" -> "11" [dir=back tooltip="include"]
    "4" -> "12" [dir=back tooltip="include"]
    "20" -> "4" [dir=back tooltip="include"]
    "20" -> "21" [dir=back tooltip="include"]
    "20" -> "22" [dir=back tooltip="include"]
    "20" -> "13" [dir=back tooltip="include"]
    "20" -> "23" [dir=back tooltip="include"]
    "24" -> "24" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "16" -> "17" [dir=back tooltip="include"]
    "16" -> "18" [dir=back tooltip="include"]
    "13" -> "14" [dir=back tooltip="include"]
    "13" -> "19" [dir=back tooltip="include"]
}

Typedefs

typedef std::shared_ptr<ParticleFerry> ParticleFerryPtr
file PeriodicBC.H
#include <random>
#include <Particle.H>

Include dependency graph for PeriodicBC.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "37" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "51" [label="CenterFile.H" tooltip="CenterFile.H"]
    "52" [label="Circular.H" tooltip="Circular.H"]
    "24" [label="EXPException.H" tooltip="EXPException.H"]
    "45" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "47" [label="QuadLS.H" tooltip="QuadLS.H"]
    "40" [label="Species.H" tooltip="Species.H"]
    "14" [label="StringTok.H" tooltip="StringTok.H"]
    "38" [label="Timer.H" tooltip="Timer.H"]
    "15" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "44" [label="euler.H" tooltip="euler.H"]
    "49" [label="header.H" tooltip="header.H"]
    "27" [label="libvars.H" tooltip="libvars.H"]
    "39" [label="localmpi.H" tooltip="localmpi.H"]
    "4" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
    "5" [label="Basis.H" tooltip="Basis.H"]
    "21" [label="Component.H" tooltip="Component.H"]
    "20" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
    "19" [label="ExternalCollection.H" tooltip="ExternalCollection.H"]
    "53" [label="ExternalForce.H" tooltip="ExternalForce.H"]
    "41" [label="Orient.H" tooltip="Orient.H"]
    "50" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" fillcolor="#BFBFBF"]
    "6" [label="PotAccel.H" tooltip="PotAccel.H"]
    "31" [label="chkTimer.H" tooltip="chkTimer.H"]
    "30" [label="coef.H" tooltip="coef.H"]
    "28" [label="global.H" tooltip="global.H"]
    "18" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "3" [label="Particle.H" tooltip="Particle.H"]
    "43" [label="algorithm" tooltip="algorithm"]
    "46" [label="array" tooltip="array"]
    "9" [label="chrono" tooltip="chrono"]
    "33" [label="cmath" tooltip="cmath"]
    "17" [label="config_exp.h" tooltip="config_exp.h"]
    "7" [label="cstdlib" tooltip="cstdlib"]
    "42" [label="deque" tooltip="deque"]
    "35" [label="fstream" tooltip="fstream"]
    "36" [label="iomanip" tooltip="iomanip"]
    "34" [label="iostream" tooltip="iostream"]
    "10" [label="list" tooltip="list"]
    "11" [label="map" tooltip="map"]
    "12" [label="memory" tooltip="memory"]
    "22" [label="mpi.h" tooltip="mpi.h"]
    "29" [label="pthread.h" tooltip="pthread.h"]
    "2" [label="random" tooltip="random"]
    "16" [label="set" tooltip="set"]
    "26" [label="sstream" tooltip="sstream"]
    "8" [label="string" tooltip="string"]
    "32" [label="time.h" tooltip="time.h"]
    "48" [label="tuple" tooltip="tuple"]
    "23" [label="utility" tooltip="utility"]
    "25" [label="vector" tooltip="vector"]
    "13" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "37" -> "34" [dir=forward tooltip="include"]
    "37" -> "36" [dir=forward tooltip="include"]
    "37" -> "25" [dir=forward tooltip="include"]
    "37" -> "8" [dir=forward tooltip="include"]
    "37" -> "10" [dir=forward tooltip="include"]
    "37" -> "11" [dir=forward tooltip="include"]
    "37" -> "16" [dir=forward tooltip="include"]
    "37" -> "12" [dir=forward tooltip="include"]
    "37" -> "38" [dir=forward tooltip="include"]
    "37" -> "22" [dir=forward tooltip="include"]
    "51" -> "35" [dir=forward tooltip="include"]
    "51" -> "25" [dir=forward tooltip="include"]
    "51" -> "46" [dir=forward tooltip="include"]
    "51" -> "13" [dir=forward tooltip="include"]
    "52" -> "25" [dir=forward tooltip="include"]
    "24" -> "16" [dir=forward tooltip="include"]
    "24" -> "25" [dir=forward tooltip="include"]
    "24" -> "8" [dir=forward tooltip="include"]
    "24" -> "26" [dir=forward tooltip="include"]
    "24" -> "27" [dir=forward tooltip="include"]
    "45" -> "42" [dir=forward tooltip="include"]
    "45" -> "46" [dir=forward tooltip="include"]
    "45" -> "18" [dir=forward tooltip="include"]
    "45" -> "47" [dir=forward tooltip="include"]
    "47" -> "34" [dir=forward tooltip="include"]
    "47" -> "36" [dir=forward tooltip="include"]
    "47" -> "48" [dir=forward tooltip="include"]
    "40" -> "11" [dir=forward tooltip="include"]
    "40" -> "16" [dir=forward tooltip="include"]
    "40" -> "25" [dir=forward tooltip="include"]
    "38" -> "34" [dir=forward tooltip="include"]
    "38" -> "7" [dir=forward tooltip="include"]
    "38" -> "9" [dir=forward tooltip="include"]
    "15" -> "8" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "13" [dir=forward tooltip="include"]
    "44" -> "18" [dir=forward tooltip="include"]
    "49" -> "34" [dir=forward tooltip="include"]
    "49" -> "36" [dir=forward tooltip="include"]
    "49" -> "26" [dir=forward tooltip="include"]
    "49" -> "12" [dir=forward tooltip="include"]
    "49" -> "39" [dir=forward tooltip="include"]
    "27" -> "2" [dir=forward tooltip="include"]
    "27" -> "22" [dir=forward tooltip="include"]
    "39" -> "22" [dir=forward tooltip="include"]
    "39" -> "34" [dir=forward tooltip="include"]
    "39" -> "35" [dir=forward tooltip="include"]
    "39" -> "36" [dir=forward tooltip="include"]
    "39" -> "8" [dir=forward tooltip="include"]
    "4" -> "5" [dir=forward tooltip="include"]
    "4" -> "18" [dir=forward tooltip="include"]
    "5" -> "6" [dir=forward tooltip="include"]
    "5" -> "18" [dir=forward tooltip="include"]
    "21" -> "22" [dir=forward tooltip="include"]
    "21" -> "23" [dir=forward tooltip="include"]
    "21" -> "13" [dir=forward tooltip="include"]
    "21" -> "24" [dir=forward tooltip="include"]
    "21" -> "28" [dir=forward tooltip="include"]
    "21" -> "41" [dir=forward tooltip="include"]
    "21" -> "49" [dir=forward tooltip="include"]
    "21" -> "39" [dir=forward tooltip="include"]
    "21" -> "50" [dir=forward tooltip="include"]
    "21" -> "51" [dir=forward tooltip="include"]
    "21" -> "6" [dir=forward tooltip="include"]
    "21" -> "52" [dir=forward tooltip="include"]
    "21" -> "38" [dir=forward tooltip="include"]
    "21" -> "17" [dir=forward tooltip="include"]
    "20" -> "10" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "38" [dir=forward tooltip="include"]
    "19" -> "11" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "19" -> "53" [dir=forward tooltip="include"]
    "53" -> "6" [dir=forward tooltip="include"]
    "53" -> "21" [dir=forward tooltip="include"]
    "41" -> "25" [dir=forward tooltip="include"]
    "41" -> "16" [dir=forward tooltip="include"]
    "41" -> "42" [dir=forward tooltip="include"]
    "41" -> "43" [dir=forward tooltip="include"]
    "41" -> "44" [dir=forward tooltip="include"]
    "41" -> "3" [dir=forward tooltip="include"]
    "41" -> "45" [dir=forward tooltip="include"]
    "41" -> "17" [dir=forward tooltip="include"]
    "50" -> "25" [dir=forward tooltip="include"]
    "50" -> "12" [dir=forward tooltip="include"]
    "50" -> "39" [dir=forward tooltip="include"]
    "50" -> "3" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "19" [dir=forward tooltip="include"]
    "6" -> "7" [dir=forward tooltip="include"]
    "6" -> "8" [dir=forward tooltip="include"]
    "6" -> "9" [dir=forward tooltip="include"]
    "6" -> "10" [dir=forward tooltip="include"]
    "6" -> "11" [dir=forward tooltip="include"]
    "6" -> "12" [dir=forward tooltip="include"]
    "6" -> "13" [dir=forward tooltip="include"]
    "6" -> "3" [dir=forward tooltip="include"]
    "6" -> "14" [dir=forward tooltip="include"]
    "6" -> "15" [dir=forward tooltip="include"]
    "6" -> "17" [dir=forward tooltip="include"]
    "31" -> "32" [dir=forward tooltip="include"]
    "31" -> "33" [dir=forward tooltip="include"]
    "31" -> "34" [dir=forward tooltip="include"]
    "31" -> "35" [dir=forward tooltip="include"]
    "31" -> "36" [dir=forward tooltip="include"]
    "28" -> "29" [dir=forward tooltip="include"]
    "28" -> "22" [dir=forward tooltip="include"]
    "28" -> "25" [dir=forward tooltip="include"]
    "28" -> "8" [dir=forward tooltip="include"]
    "28" -> "12" [dir=forward tooltip="include"]
    "28" -> "2" [dir=forward tooltip="include"]
    "28" -> "10" [dir=forward tooltip="include"]
    "28" -> "30" [dir=forward tooltip="include"]
    "28" -> "31" [dir=forward tooltip="include"]
    "28" -> "37" [dir=forward tooltip="include"]
    "28" -> "13" [dir=forward tooltip="include"]
    "28" -> "39" [dir=forward tooltip="include"]
    "28" -> "27" [dir=forward tooltip="include"]
    "28" -> "40" [dir=forward tooltip="include"]
}
file PolarBasis.H
#include <memory>
#include <random>
#include <vector>
#include <string>
#include <set>
#include <Coefficients.H>
#include <config_exp.h>
#include <NVTX.H>
#include <CoefContainer.H>
#include <BiorthCyl.H>

Include dependency graph for PolarBasis.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "23" [label="BiorthCyl.H" tooltip="BiorthCyl.H"]
    "40" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "49" [label="EXPmath.H" tooltip="EXPmath.H"]
    "45" [label="EmpCyl2d.H" tooltip="EmpCyl2d.H"]
    "34" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "39" [label="QPDistF.H" tooltip="QPDistF.H"]
    "16" [label="StringTok.H" tooltip="StringTok.H"]
    "17" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "37" [label="gaussQ.H" tooltip="gaussQ.H"]
    "32" [label="interp.H" tooltip="interp.H"]
    "28" [label="localmpi.H" tooltip="localmpi.H"]
    "30" [label="massmodel.H" tooltip="massmodel.H"]
    "35" [label="orbit.H" tooltip="orbit.H"]
    "7" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
    "8" [label="Basis.H" tooltip="Basis.H"]
    "21" [label="NVTX.H" tooltip="NVTX.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" fillcolor="#BFBFBF"]
    "9" [label="PotAccel.H" tooltip="PotAccel.H"]
    "22" [label="CoefContainer.H" tooltip="CoefContainer.H"]
    "20" [label="Coefficients.H" tooltip="Coefficients.H"]
    "19" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "48" [label="Eigen/Eigenvalues" tooltip="Eigen/Eigenvalues"]
    "15" [label="Particle.H" tooltip="Particle.H"]
    "46" [label="algorithm" tooltip="algorithm"]
    "47" [label="array" tooltip="array"]
    "11" [label="chrono" tooltip="chrono"]
    "26" [label="cmath" tooltip="cmath"]
    "18" [label="config_exp.h" tooltip="config_exp.h"]
    "10" [label="cstdlib" tooltip="cstdlib"]
    "33" [label="deque" tooltip="deque"]
    "25" [label="fstream" tooltip="fstream"]
    "36" [label="functional" tooltip="functional"]
    "44" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
    "42" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
    "43" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
    "41" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
    "51" [label="highfive/eigen.hpp" tooltip="highfive/eigen.hpp"]
    "50" [label="highfive/highfive.hpp" tooltip="highfive/highfive.hpp"]
    "29" [label="iomanip" tooltip="iomanip"]
    "24" [label="iostream" tooltip="iostream"]
    "12" [label="list" tooltip="list"]
    "13" [label="map" tooltip="map"]
    "2" [label="memory" tooltip="memory"]
    "27" [label="mpi.h" tooltip="mpi.h"]
    "3" [label="random" tooltip="random"]
    "6" [label="set" tooltip="set"]
    "38" [label="sstream" tooltip="sstream"]
    "5" [label="string" tooltip="string"]
    "31" [label="tuple" tooltip="tuple"]
    "4" [label="vector" tooltip="vector"]
    "14" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "23" -> "24" [dir=forward tooltip="include"]
    "23" -> "25" [dir=forward tooltip="include"]
    "23" -> "5" [dir=forward tooltip="include"]
    "23" -> "26" [dir=forward tooltip="include"]
    "23" -> "19" [dir=forward tooltip="include"]
    "23" -> "27" [dir=forward tooltip="include"]
    "23" -> "28" [dir=forward tooltip="include"]
    "23" -> "18" [dir=forward tooltip="include"]
    "23" -> "30" [dir=forward tooltip="include"]
    "23" -> "14" [dir=forward tooltip="include"]
    "23" -> "41" [dir=forward tooltip="include"]
    "23" -> "42" [dir=forward tooltip="include"]
    "23" -> "43" [dir=forward tooltip="include"]
    "23" -> "44" [dir=forward tooltip="include"]
    "23" -> "45" [dir=forward tooltip="include"]
    "40" -> "30" [dir=forward tooltip="include"]
    "45" -> "46" [dir=forward tooltip="include"]
    "45" -> "2" [dir=forward tooltip="include"]
    "45" -> "5" [dir=forward tooltip="include"]
    "45" -> "4" [dir=forward tooltip="include"]
    "45" -> "47" [dir=forward tooltip="include"]
    "45" -> "31" [dir=forward tooltip="include"]
    "45" -> "19" [dir=forward tooltip="include"]
    "45" -> "48" [dir=forward tooltip="include"]
    "45" -> "14" [dir=forward tooltip="include"]
    "45" -> "18" [dir=forward tooltip="include"]
    "45" -> "37" [dir=forward tooltip="include"]
    "45" -> "49" [dir=forward tooltip="include"]
    "45" -> "28" [dir=forward tooltip="include"]
    "45" -> "50" [dir=forward tooltip="include"]
    "45" -> "51" [dir=forward tooltip="include"]
    "34" -> "4" [dir=forward tooltip="include"]
    "34" -> "13" [dir=forward tooltip="include"]
    "34" -> "5" [dir=forward tooltip="include"]
    "39" -> "29" [dir=forward tooltip="include"]
    "39" -> "5" [dir=forward tooltip="include"]
    "39" -> "13" [dir=forward tooltip="include"]
    "39" -> "30" [dir=forward tooltip="include"]
    "39" -> "40" [dir=forward tooltip="include"]
    "39" -> "35" [dir=forward tooltip="include"]
    "17" -> "5" [dir=forward tooltip="include"]
    "17" -> "6" [dir=forward tooltip="include"]
    "17" -> "14" [dir=forward tooltip="include"]
    "37" -> "24" [dir=forward tooltip="include"]
    "37" -> "29" [dir=forward tooltip="include"]
    "37" -> "38" [dir=forward tooltip="include"]
    "37" -> "10" [dir=forward tooltip="include"]
    "37" -> "5" [dir=forward tooltip="include"]
    "37" -> "4" [dir=forward tooltip="include"]
    "32" -> "19" [dir=forward tooltip="include"]
    "32" -> "4" [dir=forward tooltip="include"]
    "32" -> "33" [dir=forward tooltip="include"]
    "32" -> "34" [dir=forward tooltip="include"]
    "28" -> "27" [dir=forward tooltip="include"]
    "28" -> "24" [dir=forward tooltip="include"]
    "28" -> "25" [dir=forward tooltip="include"]
    "28" -> "29" [dir=forward tooltip="include"]
    "28" -> "5" [dir=forward tooltip="include"]
    "30" -> "4" [dir=forward tooltip="include"]
    "30" -> "2" [dir=forward tooltip="include"]
    "30" -> "3" [dir=forward tooltip="include"]
    "30" -> "31" [dir=forward tooltip="include"]
    "30" -> "19" [dir=forward tooltip="include"]
    "30" -> "32" [dir=forward tooltip="include"]
    "30" -> "35" [dir=forward tooltip="include"]
    "30" -> "39" [dir=forward tooltip="include"]
    "35" -> "36" [dir=forward tooltip="include"]
    "35" -> "2" [dir=forward tooltip="include"]
    "35" -> "19" [dir=forward tooltip="include"]
    "35" -> "37" [dir=forward tooltip="include"]
    "7" -> "8" [dir=forward tooltip="include"]
    "7" -> "19" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "19" [dir=forward tooltip="include"]
    "21" -> "2" [dir=forward tooltip="include"]
    "21" -> "18" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "20" [dir=forward tooltip="include"]
    "1" -> "18" [dir=forward tooltip="include"]
    "1" -> "21" [dir=forward tooltip="include"]
    "1" -> "22" [dir=forward tooltip="include"]
    "1" -> "23" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "5" [dir=forward tooltip="include"]
    "9" -> "11" [dir=forward tooltip="include"]
    "9" -> "12" [dir=forward tooltip="include"]
    "9" -> "13" [dir=forward tooltip="include"]
    "9" -> "2" [dir=forward tooltip="include"]
    "9" -> "14" [dir=forward tooltip="include"]
    "9" -> "15" [dir=forward tooltip="include"]
    "9" -> "16" [dir=forward tooltip="include"]
    "9" -> "17" [dir=forward tooltip="include"]
    "9" -> "18" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include PolarBasis.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
}
file PotAccel.H
#include <cstdlib>
#include <string>
#include <chrono>
#include <list>
#include <map>
#include <memory>
#include <yaml-cpp/yaml.h>
#include <Particle.H>
#include <StringTok.H>
#include <YamlCheck.H>
#include <config_exp.h>

Include dependency graph for PotAccel.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "10" [label="StringTok.H" tooltip="StringTok.H"]
    "11" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PotAccel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PotAccel.H" fillcolor="#BFBFBF"]
    "9" [label="Particle.H" tooltip="Particle.H"]
    "4" [label="chrono" tooltip="chrono"]
    "13" [label="config_exp.h" tooltip="config_exp.h"]
    "2" [label="cstdlib" tooltip="cstdlib"]
    "5" [label="list" tooltip="list"]
    "6" [label="map" tooltip="map"]
    "7" [label="memory" tooltip="memory"]
    "12" [label="set" tooltip="set"]
    "3" [label="string" tooltip="string"]
    "8" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "11" -> "3" [dir=forward tooltip="include"]
    "11" -> "12" [dir=forward tooltip="include"]
    "11" -> "8" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "1" -> "10" [dir=forward tooltip="include"]
    "1" -> "11" [dir=forward tooltip="include"]
    "1" -> "13" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include PotAccel.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/AxisymmetricBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/AxisymmetricBasis.H"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Basis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Basis.H"]
    "11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Bessel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Bessel.H"]
    "7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CBDisk.H"]
    "23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Component.H"]
    "24" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ComponentContainer.H"]
    "37" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cube.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cube.H"]
    "28" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/CylEXP.H"]
    "22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Direct.H"]
    "13" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
    "29" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalForce.H"]
    "8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H"]
    "30" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/HaloBulge.H"]
    "14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "38" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/NoForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/NoForce.H"]
    "33" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutAscii.H"]
    "34" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutCalbr.H"]
    "35" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutFrac.H"]
    "36" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PeriodicBC.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PotAccel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PotAccel.H" fillcolor="#BFBFBF"]
    "31" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H"]
    "9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H"]
    "39" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H"]
    "15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H"]
    "10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SphericalBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SphericalBasis.H"]
    "12" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "27" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/expand.H"]
    "16" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H"]
    "17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H"]
    "18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H"]
    "19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H"]
    "20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H"]
    "21" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H"]
    "26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H"]
    "32" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "5" [dir=back tooltip="include"]
    "3" -> "6" [dir=back tooltip="include"]
    "3" -> "9" [dir=back tooltip="include"]
    "3" -> "10" [dir=back tooltip="include"]
    "3" -> "16" [dir=back tooltip="include"]
    "3" -> "17" [dir=back tooltip="include"]
    "3" -> "18" [dir=back tooltip="include"]
    "3" -> "19" [dir=back tooltip="include"]
    "3" -> "20" [dir=back tooltip="include"]
    "3" -> "21" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "22" [dir=back tooltip="include"]
    "11" -> "12" [dir=back tooltip="include"]
    "23" -> "24" [dir=back tooltip="include"]
    "23" -> "29" [dir=back tooltip="include"]
    "23" -> "33" [dir=back tooltip="include"]
    "23" -> "34" [dir=back tooltip="include"]
    "23" -> "35" [dir=back tooltip="include"]
    "23" -> "36" [dir=back tooltip="include"]
    "24" -> "25" [dir=back tooltip="include"]
    "24" -> "27" [dir=back tooltip="include"]
    "28" -> "22" [dir=back tooltip="include"]
    "22" -> "12" [dir=back tooltip="include"]
    "25" -> "5" [dir=back tooltip="include"]
    "25" -> "16" [dir=back tooltip="include"]
    "25" -> "17" [dir=back tooltip="include"]
    "25" -> "18" [dir=back tooltip="include"]
    "25" -> "19" [dir=back tooltip="include"]
    "25" -> "20" [dir=back tooltip="include"]
    "25" -> "21" [dir=back tooltip="include"]
    "25" -> "26" [dir=back tooltip="include"]
    "29" -> "25" [dir=back tooltip="include"]
    "29" -> "30" [dir=back tooltip="include"]
    "29" -> "31" [dir=back tooltip="include"]
    "29" -> "27" [dir=back tooltip="include"]
    "29" -> "32" [dir=back tooltip="include"]
    "33" -> "33" [dir=back tooltip="include"]
    "6" -> "7" [dir=back tooltip="include"]
    "6" -> "8" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "23" [dir=back tooltip="include"]
    "1" -> "37" [dir=back tooltip="include"]
    "1" -> "29" [dir=back tooltip="include"]
    "1" -> "38" [dir=back tooltip="include"]
    "1" -> "39" [dir=back tooltip="include"]
    "15" -> "12" [dir=back tooltip="include"]
    "10" -> "11" [dir=back tooltip="include"]
    "10" -> "15" [dir=back tooltip="include"]
    "12" -> "13" [dir=back tooltip="include"]
    "12" -> "14" [dir=back tooltip="include"]
    "27" -> "28" [dir=back tooltip="include"]
    "27" -> "9" [dir=back tooltip="include"]
}

Functions

bool ltdub(const pair<double, PotAccel::NData> &A, const pair<double, PotAccel::NData> &B)

Used for thread timing only (VERBOSE>5)

file ScatterMFP.H
#include <utility>
#include <random>
#include <ExternalForce.H>

Include dependency graph for ScatterMFP.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "33" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "48" [label="CenterFile.H" tooltip="CenterFile.H"]
    "49" [label="Circular.H" tooltip="Circular.H"]
    "20" [label="EXPException.H" tooltip="EXPException.H"]
    "42" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "44" [label="QuadLS.H" tooltip="QuadLS.H"]
    "36" [label="Species.H" tooltip="Species.H"]
    "14" [label="StringTok.H" tooltip="StringTok.H"]
    "34" [label="Timer.H" tooltip="Timer.H"]
    "15" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "40" [label="euler.H" tooltip="euler.H"]
    "46" [label="header.H" tooltip="header.H"]
    "23" [label="libvars.H" tooltip="libvars.H"]
    "35" [label="localmpi.H" tooltip="localmpi.H"]
    "18" [label="Component.H" tooltip="Component.H"]
    "4" [label="ExternalForce.H" tooltip="ExternalForce.H"]
    "37" [label="Orient.H" tooltip="Orient.H"]
    "47" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "5" [label="PotAccel.H" tooltip="PotAccel.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ScatterMFP.H" fillcolor="#BFBFBF"]
    "27" [label="chkTimer.H" tooltip="chkTimer.H"]
    "26" [label="coef.H" tooltip="coef.H"]
    "24" [label="global.H" tooltip="global.H"]
    "41" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "13" [label="Particle.H" tooltip="Particle.H"]
    "39" [label="algorithm" tooltip="algorithm"]
    "43" [label="array" tooltip="array"]
    "8" [label="chrono" tooltip="chrono"]
    "29" [label="cmath" tooltip="cmath"]
    "17" [label="config_exp.h" tooltip="config_exp.h"]
    "6" [label="cstdlib" tooltip="cstdlib"]
    "38" [label="deque" tooltip="deque"]
    "31" [label="fstream" tooltip="fstream"]
    "32" [label="iomanip" tooltip="iomanip"]
    "30" [label="iostream" tooltip="iostream"]
    "9" [label="list" tooltip="list"]
    "10" [label="map" tooltip="map"]
    "11" [label="memory" tooltip="memory"]
    "19" [label="mpi.h" tooltip="mpi.h"]
    "25" [label="pthread.h" tooltip="pthread.h"]
    "3" [label="random" tooltip="random"]
    "16" [label="set" tooltip="set"]
    "22" [label="sstream" tooltip="sstream"]
    "7" [label="string" tooltip="string"]
    "28" [label="time.h" tooltip="time.h"]
    "45" [label="tuple" tooltip="tuple"]
    "2" [label="utility" tooltip="utility"]
    "21" [label="vector" tooltip="vector"]
    "12" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "33" -> "30" [dir=forward tooltip="include"]
    "33" -> "32" [dir=forward tooltip="include"]
    "33" -> "21" [dir=forward tooltip="include"]
    "33" -> "7" [dir=forward tooltip="include"]
    "33" -> "9" [dir=forward tooltip="include"]
    "33" -> "10" [dir=forward tooltip="include"]
    "33" -> "16" [dir=forward tooltip="include"]
    "33" -> "11" [dir=forward tooltip="include"]
    "33" -> "34" [dir=forward tooltip="include"]
    "33" -> "19" [dir=forward tooltip="include"]
    "48" -> "31" [dir=forward tooltip="include"]
    "48" -> "21" [dir=forward tooltip="include"]
    "48" -> "43" [dir=forward tooltip="include"]
    "48" -> "12" [dir=forward tooltip="include"]
    "49" -> "21" [dir=forward tooltip="include"]
    "20" -> "16" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "7" [dir=forward tooltip="include"]
    "20" -> "22" [dir=forward tooltip="include"]
    "20" -> "23" [dir=forward tooltip="include"]
    "42" -> "38" [dir=forward tooltip="include"]
    "42" -> "43" [dir=forward tooltip="include"]
    "42" -> "41" [dir=forward tooltip="include"]
    "42" -> "44" [dir=forward tooltip="include"]
    "44" -> "30" [dir=forward tooltip="include"]
    "44" -> "32" [dir=forward tooltip="include"]
    "44" -> "45" [dir=forward tooltip="include"]
    "36" -> "10" [dir=forward tooltip="include"]
    "36" -> "16" [dir=forward tooltip="include"]
    "36" -> "21" [dir=forward tooltip="include"]
    "34" -> "30" [dir=forward tooltip="include"]
    "34" -> "6" [dir=forward tooltip="include"]
    "34" -> "8" [dir=forward tooltip="include"]
    "15" -> "7" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "12" [dir=forward tooltip="include"]
    "40" -> "41" [dir=forward tooltip="include"]
    "46" -> "30" [dir=forward tooltip="include"]
    "46" -> "32" [dir=forward tooltip="include"]
    "46" -> "22" [dir=forward tooltip="include"]
    "46" -> "11" [dir=forward tooltip="include"]
    "46" -> "35" [dir=forward tooltip="include"]
    "23" -> "3" [dir=forward tooltip="include"]
    "23" -> "19" [dir=forward tooltip="include"]
    "35" -> "19" [dir=forward tooltip="include"]
    "35" -> "30" [dir=forward tooltip="include"]
    "35" -> "31" [dir=forward tooltip="include"]
    "35" -> "32" [dir=forward tooltip="include"]
    "35" -> "7" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "2" [dir=forward tooltip="include"]
    "18" -> "12" [dir=forward tooltip="include"]
    "18" -> "20" [dir=forward tooltip="include"]
    "18" -> "24" [dir=forward tooltip="include"]
    "18" -> "37" [dir=forward tooltip="include"]
    "18" -> "46" [dir=forward tooltip="include"]
    "18" -> "35" [dir=forward tooltip="include"]
    "18" -> "47" [dir=forward tooltip="include"]
    "18" -> "48" [dir=forward tooltip="include"]
    "18" -> "5" [dir=forward tooltip="include"]
    "18" -> "49" [dir=forward tooltip="include"]
    "18" -> "34" [dir=forward tooltip="include"]
    "18" -> "17" [dir=forward tooltip="include"]
    "4" -> "5" [dir=forward tooltip="include"]
    "4" -> "18" [dir=forward tooltip="include"]
    "37" -> "21" [dir=forward tooltip="include"]
    "37" -> "16" [dir=forward tooltip="include"]
    "37" -> "38" [dir=forward tooltip="include"]
    "37" -> "39" [dir=forward tooltip="include"]
    "37" -> "40" [dir=forward tooltip="include"]
    "37" -> "13" [dir=forward tooltip="include"]
    "37" -> "42" [dir=forward tooltip="include"]
    "37" -> "17" [dir=forward tooltip="include"]
    "47" -> "21" [dir=forward tooltip="include"]
    "47" -> "11" [dir=forward tooltip="include"]
    "47" -> "35" [dir=forward tooltip="include"]
    "47" -> "13" [dir=forward tooltip="include"]
    "5" -> "6" [dir=forward tooltip="include"]
    "5" -> "7" [dir=forward tooltip="include"]
    "5" -> "8" [dir=forward tooltip="include"]
    "5" -> "9" [dir=forward tooltip="include"]
    "5" -> "10" [dir=forward tooltip="include"]
    "5" -> "11" [dir=forward tooltip="include"]
    "5" -> "12" [dir=forward tooltip="include"]
    "5" -> "13" [dir=forward tooltip="include"]
    "5" -> "14" [dir=forward tooltip="include"]
    "5" -> "15" [dir=forward tooltip="include"]
    "5" -> "17" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "27" -> "28" [dir=forward tooltip="include"]
    "27" -> "29" [dir=forward tooltip="include"]
    "27" -> "30" [dir=forward tooltip="include"]
    "27" -> "31" [dir=forward tooltip="include"]
    "27" -> "32" [dir=forward tooltip="include"]
    "24" -> "25" [dir=forward tooltip="include"]
    "24" -> "19" [dir=forward tooltip="include"]
    "24" -> "21" [dir=forward tooltip="include"]
    "24" -> "7" [dir=forward tooltip="include"]
    "24" -> "11" [dir=forward tooltip="include"]
    "24" -> "3" [dir=forward tooltip="include"]
    "24" -> "9" [dir=forward tooltip="include"]
    "24" -> "26" [dir=forward tooltip="include"]
    "24" -> "27" [dir=forward tooltip="include"]
    "24" -> "33" [dir=forward tooltip="include"]
    "24" -> "12" [dir=forward tooltip="include"]
    "24" -> "35" [dir=forward tooltip="include"]
    "24" -> "23" [dir=forward tooltip="include"]
    "24" -> "36" [dir=forward tooltip="include"]
}

Typedefs

typedef pair<double, int> rpair

Functions

bool less_rpair(const rpair &one, const rpair &two)
file Shells.H
#include <vector>
#include <string>
#include <set>
#include “expand.H
#include “interp.H
#include <massmodel.H>

Include dependency graph for Shells.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "32" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "49" [label="CenterFile.H" tooltip="CenterFile.H"]
    "53" [label="Circular.H" tooltip="Circular.H"]
    "65" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "24" [label="EXPException.H" tooltip="EXPException.H"]
    "57" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "43" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "64" [label="QPDistF.H" tooltip="QPDistF.H"]
    "45" [label="QuadLS.H" tooltip="QuadLS.H"]
    "37" [label="Species.H" tooltip="Species.H"]
    "51" [label="StringTok.H" tooltip="StringTok.H"]
    "34" [label="Timer.H" tooltip="Timer.H"]
    "52" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "41" [label="euler.H" tooltip="euler.H"]
    "63" [label="gaussQ.H" tooltip="gaussQ.H"]
    "47" [label="header.H" tooltip="header.H"]
    "56" [label="interp.H" tooltip="interp.H"]
    "25" [label="libvars.H" tooltip="libvars.H"]
    "36" [label="localmpi.H" tooltip="localmpi.H"]
    "60" [label="massmodel.H" tooltip="massmodel.H"]
    "61" [label="orbit.H" tooltip="orbit.H"]
    "58" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
    "59" [label="Basis.H" tooltip="Basis.H"]
    "21" [label="Component.H" tooltip="Component.H"]
    "19" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
    "54" [label="ExternalForce.H" tooltip="ExternalForce.H"]
    "38" [label="Orient.H" tooltip="Orient.H"]
    "55" [label="Output.H" tooltip="Output.H"]
    "48" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "50" [label="PotAccel.H" tooltip="PotAccel.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Shells.H" fillcolor="#BFBFBF"]
    "30" [label="chkTimer.H" tooltip="chkTimer.H"]
    "29" [label="coef.H" tooltip="coef.H"]
    "5" [label="expand.H" tooltip="expand.H"]
    "27" [label="global.H" tooltip="global.H"]
    "18" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "42" [label="Particle.H" tooltip="Particle.H"]
    "40" [label="algorithm" tooltip="algorithm"]
    "44" [label="array" tooltip="array"]
    "35" [label="chrono" tooltip="chrono"]
    "11" [label="cmath" tooltip="cmath"]
    "6" [label="config_exp.h" tooltip="config_exp.h"]
    "10" [label="cstdlib" tooltip="cstdlib"]
    "12" [label="cstring" tooltip="cstring"]
    "39" [label="deque" tooltip="deque"]
    "14" [label="fstream" tooltip="fstream"]
    "62" [label="functional" tooltip="functional"]
    "16" [label="iomanip" tooltip="iomanip"]
    "13" [label="iostream" tooltip="iostream"]
    "17" [label="limits" tooltip="limits"]
    "20" [label="list" tooltip="list"]
    "33" [label="map" tooltip="map"]
    "28" [label="memory" tooltip="memory"]
    "7" [label="mpi.h" tooltip="mpi.h"]
    "8" [label="pthread.h" tooltip="pthread.h"]
    "26" [label="random" tooltip="random"]
    "4" [label="set" tooltip="set"]
    "15" [label="sstream" tooltip="sstream"]
    "9" [label="stdexcept" tooltip="stdexcept"]
    "3" [label="string" tooltip="string"]
    "31" [label="time.h" tooltip="time.h"]
    "46" [label="tuple" tooltip="tuple"]
    "22" [label="utility" tooltip="utility"]
    "2" [label="vector" tooltip="vector"]
    "23" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "32" -> "13" [dir=forward tooltip="include"]
    "32" -> "16" [dir=forward tooltip="include"]
    "32" -> "2" [dir=forward tooltip="include"]
    "32" -> "3" [dir=forward tooltip="include"]
    "32" -> "20" [dir=forward tooltip="include"]
    "32" -> "33" [dir=forward tooltip="include"]
    "32" -> "4" [dir=forward tooltip="include"]
    "32" -> "28" [dir=forward tooltip="include"]
    "32" -> "34" [dir=forward tooltip="include"]
    "32" -> "7" [dir=forward tooltip="include"]
    "49" -> "14" [dir=forward tooltip="include"]
    "49" -> "2" [dir=forward tooltip="include"]
    "49" -> "44" [dir=forward tooltip="include"]
    "49" -> "23" [dir=forward tooltip="include"]
    "53" -> "2" [dir=forward tooltip="include"]
    "65" -> "60" [dir=forward tooltip="include"]
    "24" -> "4" [dir=forward tooltip="include"]
    "24" -> "2" [dir=forward tooltip="include"]
    "24" -> "3" [dir=forward tooltip="include"]
    "24" -> "15" [dir=forward tooltip="include"]
    "24" -> "25" [dir=forward tooltip="include"]
    "57" -> "2" [dir=forward tooltip="include"]
    "57" -> "33" [dir=forward tooltip="include"]
    "57" -> "3" [dir=forward tooltip="include"]
    "43" -> "39" [dir=forward tooltip="include"]
    "43" -> "44" [dir=forward tooltip="include"]
    "43" -> "18" [dir=forward tooltip="include"]
    "43" -> "45" [dir=forward tooltip="include"]
    "64" -> "16" [dir=forward tooltip="include"]
    "64" -> "3" [dir=forward tooltip="include"]
    "64" -> "33" [dir=forward tooltip="include"]
    "64" -> "60" [dir=forward tooltip="include"]
    "64" -> "65" [dir=forward tooltip="include"]
    "64" -> "61" [dir=forward tooltip="include"]
    "45" -> "13" [dir=forward tooltip="include"]
    "45" -> "16" [dir=forward tooltip="include"]
    "45" -> "46" [dir=forward tooltip="include"]
    "37" -> "33" [dir=forward tooltip="include"]
    "37" -> "4" [dir=forward tooltip="include"]
    "37" -> "2" [dir=forward tooltip="include"]
    "34" -> "13" [dir=forward tooltip="include"]
    "34" -> "10" [dir=forward tooltip="include"]
    "34" -> "35" [dir=forward tooltip="include"]
    "52" -> "3" [dir=forward tooltip="include"]
    "52" -> "4" [dir=forward tooltip="include"]
    "52" -> "23" [dir=forward tooltip="include"]
    "41" -> "18" [dir=forward tooltip="include"]
    "63" -> "13" [dir=forward tooltip="include"]
    "63" -> "16" [dir=forward tooltip="include"]
    "63" -> "15" [dir=forward tooltip="include"]
    "63" -> "10" [dir=forward tooltip="include"]
    "63" -> "3" [dir=forward tooltip="include"]
    "63" -> "2" [dir=forward tooltip="include"]
    "47" -> "13" [dir=forward tooltip="include"]
    "47" -> "16" [dir=forward tooltip="include"]
    "47" -> "15" [dir=forward tooltip="include"]
    "47" -> "28" [dir=forward tooltip="include"]
    "47" -> "36" [dir=forward tooltip="include"]
    "56" -> "18" [dir=forward tooltip="include"]
    "56" -> "2" [dir=forward tooltip="include"]
    "56" -> "39" [dir=forward tooltip="include"]
    "56" -> "57" [dir=forward tooltip="include"]
    "25" -> "26" [dir=forward tooltip="include"]
    "25" -> "7" [dir=forward tooltip="include"]
    "36" -> "7" [dir=forward tooltip="include"]
    "36" -> "13" [dir=forward tooltip="include"]
    "36" -> "14" [dir=forward tooltip="include"]
    "36" -> "16" [dir=forward tooltip="include"]
    "36" -> "3" [dir=forward tooltip="include"]
    "60" -> "2" [dir=forward tooltip="include"]
    "60" -> "28" [dir=forward tooltip="include"]
    "60" -> "26" [dir=forward tooltip="include"]
    "60" -> "46" [dir=forward tooltip="include"]
    "60" -> "18" [dir=forward tooltip="include"]
    "60" -> "56" [dir=forward tooltip="include"]
    "60" -> "61" [dir=forward tooltip="include"]
    "60" -> "64" [dir=forward tooltip="include"]
    "61" -> "62" [dir=forward tooltip="include"]
    "61" -> "28" [dir=forward tooltip="include"]
    "61" -> "18" [dir=forward tooltip="include"]
    "61" -> "63" [dir=forward tooltip="include"]
    "58" -> "59" [dir=forward tooltip="include"]
    "58" -> "18" [dir=forward tooltip="include"]
    "59" -> "50" [dir=forward tooltip="include"]
    "59" -> "18" [dir=forward tooltip="include"]
    "21" -> "7" [dir=forward tooltip="include"]
    "21" -> "22" [dir=forward tooltip="include"]
    "21" -> "23" [dir=forward tooltip="include"]
    "21" -> "24" [dir=forward tooltip="include"]
    "21" -> "27" [dir=forward tooltip="include"]
    "21" -> "38" [dir=forward tooltip="include"]
    "21" -> "47" [dir=forward tooltip="include"]
    "21" -> "36" [dir=forward tooltip="include"]
    "21" -> "48" [dir=forward tooltip="include"]
    "21" -> "49" [dir=forward tooltip="include"]
    "21" -> "50" [dir=forward tooltip="include"]
    "21" -> "53" [dir=forward tooltip="include"]
    "21" -> "34" [dir=forward tooltip="include"]
    "21" -> "6" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "19" -> "21" [dir=forward tooltip="include"]
    "19" -> "34" [dir=forward tooltip="include"]
    "54" -> "50" [dir=forward tooltip="include"]
    "54" -> "21" [dir=forward tooltip="include"]
    "38" -> "2" [dir=forward tooltip="include"]
    "38" -> "4" [dir=forward tooltip="include"]
    "38" -> "39" [dir=forward tooltip="include"]
    "38" -> "40" [dir=forward tooltip="include"]
    "38" -> "41" [dir=forward tooltip="include"]
    "38" -> "42" [dir=forward tooltip="include"]
    "38" -> "43" [dir=forward tooltip="include"]
    "38" -> "6" [dir=forward tooltip="include"]
    "55" -> "3" [dir=forward tooltip="include"]
    "55" -> "2" [dir=forward tooltip="include"]
    "55" -> "22" [dir=forward tooltip="include"]
    "55" -> "4" [dir=forward tooltip="include"]
    "55" -> "51" [dir=forward tooltip="include"]
    "55" -> "34" [dir=forward tooltip="include"]
    "48" -> "2" [dir=forward tooltip="include"]
    "48" -> "28" [dir=forward tooltip="include"]
    "48" -> "36" [dir=forward tooltip="include"]
    "48" -> "42" [dir=forward tooltip="include"]
    "50" -> "10" [dir=forward tooltip="include"]
    "50" -> "3" [dir=forward tooltip="include"]
    "50" -> "35" [dir=forward tooltip="include"]
    "50" -> "20" [dir=forward tooltip="include"]
    "50" -> "33" [dir=forward tooltip="include"]
    "50" -> "28" [dir=forward tooltip="include"]
    "50" -> "23" [dir=forward tooltip="include"]
    "50" -> "42" [dir=forward tooltip="include"]
    "50" -> "51" [dir=forward tooltip="include"]
    "50" -> "52" [dir=forward tooltip="include"]
    "50" -> "6" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "56" [dir=forward tooltip="include"]
    "1" -> "58" [dir=forward tooltip="include"]
    "1" -> "60" [dir=forward tooltip="include"]
    "30" -> "31" [dir=forward tooltip="include"]
    "30" -> "11" [dir=forward tooltip="include"]
    "30" -> "13" [dir=forward tooltip="include"]
    "30" -> "14" [dir=forward tooltip="include"]
    "30" -> "16" [dir=forward tooltip="include"]
    "5" -> "6" [dir=forward tooltip="include"]
    "5" -> "7" [dir=forward tooltip="include"]
    "5" -> "8" [dir=forward tooltip="include"]
    "5" -> "9" [dir=forward tooltip="include"]
    "5" -> "10" [dir=forward tooltip="include"]
    "5" -> "11" [dir=forward tooltip="include"]
    "5" -> "12" [dir=forward tooltip="include"]
    "5" -> "13" [dir=forward tooltip="include"]
    "5" -> "14" [dir=forward tooltip="include"]
    "5" -> "15" [dir=forward tooltip="include"]
    "5" -> "16" [dir=forward tooltip="include"]
    "5" -> "2" [dir=forward tooltip="include"]
    "5" -> "3" [dir=forward tooltip="include"]
    "5" -> "17" [dir=forward tooltip="include"]
    "5" -> "18" [dir=forward tooltip="include"]
    "5" -> "19" [dir=forward tooltip="include"]
    "5" -> "54" [dir=forward tooltip="include"]
    "5" -> "55" [dir=forward tooltip="include"]
    "5" -> "23" [dir=forward tooltip="include"]
    "5" -> "27" [dir=forward tooltip="include"]
    "5" -> "24" [dir=forward tooltip="include"]
    "27" -> "8" [dir=forward tooltip="include"]
    "27" -> "7" [dir=forward tooltip="include"]
    "27" -> "2" [dir=forward tooltip="include"]
    "27" -> "3" [dir=forward tooltip="include"]
    "27" -> "28" [dir=forward tooltip="include"]
    "27" -> "26" [dir=forward tooltip="include"]
    "27" -> "20" [dir=forward tooltip="include"]
    "27" -> "29" [dir=forward tooltip="include"]
    "27" -> "30" [dir=forward tooltip="include"]
    "27" -> "32" [dir=forward tooltip="include"]
    "27" -> "23" [dir=forward tooltip="include"]
    "27" -> "36" [dir=forward tooltip="include"]
    "27" -> "25" [dir=forward tooltip="include"]
    "27" -> "37" [dir=forward tooltip="include"]
}
file SlabSL.H
#include <complex>
#include <Eigen/Eigen>
#include <unsupported/Eigen/CXX11/Tensor>
#include <Coefficients.H>
#include <SLGridMP2.H>
#include <biorth1d.H>
#include <PotAccel.H>

Include dependency graph for SlabSL.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "30" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "22" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "29" [label="QPDistF.H" tooltip="QPDistF.H"]
    "6" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
    "41" [label="StringTok.H" tooltip="StringTok.H"]
    "42" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "36" [label="biorth.H" tooltip="biorth.H"]
    "34" [label="biorth1d.H" tooltip="biorth1d.H"]
    "26" [label="gaussQ.H" tooltip="gaussQ.H"]
    "20" [label="interp.H" tooltip="interp.H"]
    "33" [label="libvars.H" tooltip="libvars.H"]
    "12" [label="localmpi.H" tooltip="localmpi.H"]
    "15" [label="massmodel.H" tooltip="massmodel.H"]
    "24" [label="orbit.H" tooltip="orbit.H"]
    "31" [label="sltableMP2.H" tooltip="sltableMP2.H"]
    "37" [label="PotAccel.H" tooltip="PotAccel.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SlabSL.H" fillcolor="#BFBFBF"]
    "5" [label="Coefficients.H" tooltip="Coefficients.H"]
    "3" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "40" [label="Particle.H" tooltip="Particle.H"]
    "38" [label="chrono" tooltip="chrono"]
    "35" [label="cmath" tooltip="cmath"]
    "2" [label="complex" tooltip="complex"]
    "14" [label="config_exp.h" tooltip="config_exp.h"]
    "28" [label="cstdlib" tooltip="cstdlib"]
    "21" [label="deque" tooltip="deque"]
    "9" [label="fstream" tooltip="fstream"]
    "25" [label="functional" tooltip="functional"]
    "13" [label="iomanip" tooltip="iomanip"]
    "8" [label="iostream" tooltip="iostream"]
    "39" [label="list" tooltip="list"]
    "23" [label="map" tooltip="map"]
    "7" [label="math.h" tooltip="math.h"]
    "17" [label="memory" tooltip="memory"]
    "11" [label="mpi.h" tooltip="mpi.h"]
    "18" [label="random" tooltip="random"]
    "43" [label="set" tooltip="set"]
    "27" [label="sstream" tooltip="sstream"]
    "10" [label="string" tooltip="string"]
    "19" [label="tuple" tooltip="tuple"]
    "4" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
    "16" [label="vector" tooltip="vector"]
    "32" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "30" -> "15" [dir=forward tooltip="include"]
    "22" -> "16" [dir=forward tooltip="include"]
    "22" -> "23" [dir=forward tooltip="include"]
    "22" -> "10" [dir=forward tooltip="include"]
    "29" -> "13" [dir=forward tooltip="include"]
    "29" -> "10" [dir=forward tooltip="include"]
    "29" -> "23" [dir=forward tooltip="include"]
    "29" -> "15" [dir=forward tooltip="include"]
    "29" -> "30" [dir=forward tooltip="include"]
    "29" -> "24" [dir=forward tooltip="include"]
    "6" -> "7" [dir=forward tooltip="include"]
    "6" -> "8" [dir=forward tooltip="include"]
    "6" -> "9" [dir=forward tooltip="include"]
    "6" -> "10" [dir=forward tooltip="include"]
    "6" -> "11" [dir=forward tooltip="include"]
    "6" -> "12" [dir=forward tooltip="include"]
    "6" -> "14" [dir=forward tooltip="include"]
    "6" -> "15" [dir=forward tooltip="include"]
    "6" -> "31" [dir=forward tooltip="include"]
    "6" -> "32" [dir=forward tooltip="include"]
    "6" -> "33" [dir=forward tooltip="include"]
    "42" -> "10" [dir=forward tooltip="include"]
    "42" -> "43" [dir=forward tooltip="include"]
    "42" -> "32" [dir=forward tooltip="include"]
    "36" -> "8" [dir=forward tooltip="include"]
    "36" -> "13" [dir=forward tooltip="include"]
    "36" -> "28" [dir=forward tooltip="include"]
    "36" -> "10" [dir=forward tooltip="include"]
    "36" -> "17" [dir=forward tooltip="include"]
    "36" -> "3" [dir=forward tooltip="include"]
    "34" -> "35" [dir=forward tooltip="include"]
    "34" -> "36" [dir=forward tooltip="include"]
    "26" -> "8" [dir=forward tooltip="include"]
    "26" -> "13" [dir=forward tooltip="include"]
    "26" -> "27" [dir=forward tooltip="include"]
    "26" -> "28" [dir=forward tooltip="include"]
    "26" -> "10" [dir=forward tooltip="include"]
    "26" -> "16" [dir=forward tooltip="include"]
    "20" -> "3" [dir=forward tooltip="include"]
    "20" -> "16" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "22" [dir=forward tooltip="include"]
    "33" -> "18" [dir=forward tooltip="include"]
    "33" -> "11" [dir=forward tooltip="include"]
    "12" -> "11" [dir=forward tooltip="include"]
    "12" -> "8" [dir=forward tooltip="include"]
    "12" -> "9" [dir=forward tooltip="include"]
    "12" -> "13" [dir=forward tooltip="include"]
    "12" -> "10" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "17" [dir=forward tooltip="include"]
    "15" -> "18" [dir=forward tooltip="include"]
    "15" -> "19" [dir=forward tooltip="include"]
    "15" -> "3" [dir=forward tooltip="include"]
    "15" -> "20" [dir=forward tooltip="include"]
    "15" -> "24" [dir=forward tooltip="include"]
    "15" -> "29" [dir=forward tooltip="include"]
    "24" -> "25" [dir=forward tooltip="include"]
    "24" -> "17" [dir=forward tooltip="include"]
    "24" -> "3" [dir=forward tooltip="include"]
    "24" -> "26" [dir=forward tooltip="include"]
    "31" -> "3" [dir=forward tooltip="include"]
    "37" -> "28" [dir=forward tooltip="include"]
    "37" -> "10" [dir=forward tooltip="include"]
    "37" -> "38" [dir=forward tooltip="include"]
    "37" -> "39" [dir=forward tooltip="include"]
    "37" -> "23" [dir=forward tooltip="include"]
    "37" -> "17" [dir=forward tooltip="include"]
    "37" -> "32" [dir=forward tooltip="include"]
    "37" -> "40" [dir=forward tooltip="include"]
    "37" -> "41" [dir=forward tooltip="include"]
    "37" -> "42" [dir=forward tooltip="include"]
    "37" -> "14" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "34" [dir=forward tooltip="include"]
    "1" -> "37" [dir=forward tooltip="include"]
}
file Sphere.H
#include <memory>
#include <map>
#include <SLGridMP2.H>
#include <SphericalBasis.H>

Include dependency graph for Sphere.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "27" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "20" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "26" [label="QPDistF.H" tooltip="QPDistF.H"]
    "4" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
    "39" [label="StringTok.H" tooltip="StringTok.H"]
    "40" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "23" [label="gaussQ.H" tooltip="gaussQ.H"]
    "18" [label="interp.H" tooltip="interp.H"]
    "30" [label="libvars.H" tooltip="libvars.H"]
    "10" [label="localmpi.H" tooltip="localmpi.H"]
    "13" [label="massmodel.H" tooltip="massmodel.H"]
    "21" [label="orbit.H" tooltip="orbit.H"]
    "28" [label="sltableMP2.H" tooltip="sltableMP2.H"]
    "33" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
    "34" [label="Basis.H" tooltip="Basis.H"]
    "42" [label="NVTX.H" tooltip="NVTX.H"]
    "35" [label="PotAccel.H" tooltip="PotAccel.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" fillcolor="#BFBFBF"]
    "31" [label="SphericalBasis.H" tooltip="SphericalBasis.H"]
    "43" [label="CoefContainer.H" tooltip="CoefContainer.H"]
    "41" [label="Coefficients.H" tooltip="Coefficients.H"]
    "17" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "38" [label="Particle.H" tooltip="Particle.H"]
    "36" [label="chrono" tooltip="chrono"]
    "12" [label="config_exp.h" tooltip="config_exp.h"]
    "25" [label="cstdlib" tooltip="cstdlib"]
    "19" [label="deque" tooltip="deque"]
    "7" [label="fstream" tooltip="fstream"]
    "22" [label="functional" tooltip="functional"]
    "11" [label="iomanip" tooltip="iomanip"]
    "6" [label="iostream" tooltip="iostream"]
    "37" [label="list" tooltip="list"]
    "3" [label="map" tooltip="map"]
    "5" [label="math.h" tooltip="math.h"]
    "2" [label="memory" tooltip="memory"]
    "9" [label="mpi.h" tooltip="mpi.h"]
    "15" [label="random" tooltip="random"]
    "32" [label="set" tooltip="set"]
    "24" [label="sstream" tooltip="sstream"]
    "8" [label="string" tooltip="string"]
    "16" [label="tuple" tooltip="tuple"]
    "14" [label="vector" tooltip="vector"]
    "29" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "27" -> "13" [dir=forward tooltip="include"]
    "20" -> "14" [dir=forward tooltip="include"]
    "20" -> "3" [dir=forward tooltip="include"]
    "20" -> "8" [dir=forward tooltip="include"]
    "26" -> "11" [dir=forward tooltip="include"]
    "26" -> "8" [dir=forward tooltip="include"]
    "26" -> "3" [dir=forward tooltip="include"]
    "26" -> "13" [dir=forward tooltip="include"]
    "26" -> "27" [dir=forward tooltip="include"]
    "26" -> "21" [dir=forward tooltip="include"]
    "4" -> "5" [dir=forward tooltip="include"]
    "4" -> "6" [dir=forward tooltip="include"]
    "4" -> "7" [dir=forward tooltip="include"]
    "4" -> "8" [dir=forward tooltip="include"]
    "4" -> "9" [dir=forward tooltip="include"]
    "4" -> "10" [dir=forward tooltip="include"]
    "4" -> "12" [dir=forward tooltip="include"]
    "4" -> "13" [dir=forward tooltip="include"]
    "4" -> "28" [dir=forward tooltip="include"]
    "4" -> "29" [dir=forward tooltip="include"]
    "4" -> "30" [dir=forward tooltip="include"]
    "40" -> "8" [dir=forward tooltip="include"]
    "40" -> "32" [dir=forward tooltip="include"]
    "40" -> "29" [dir=forward tooltip="include"]
    "23" -> "6" [dir=forward tooltip="include"]
    "23" -> "11" [dir=forward tooltip="include"]
    "23" -> "24" [dir=forward tooltip="include"]
    "23" -> "25" [dir=forward tooltip="include"]
    "23" -> "8" [dir=forward tooltip="include"]
    "23" -> "14" [dir=forward tooltip="include"]
    "18" -> "17" [dir=forward tooltip="include"]
    "18" -> "14" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "20" [dir=forward tooltip="include"]
    "30" -> "15" [dir=forward tooltip="include"]
    "30" -> "9" [dir=forward tooltip="include"]
    "10" -> "9" [dir=forward tooltip="include"]
    "10" -> "6" [dir=forward tooltip="include"]
    "10" -> "7" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "8" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "2" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
    "13" -> "16" [dir=forward tooltip="include"]
    "13" -> "17" [dir=forward tooltip="include"]
    "13" -> "18" [dir=forward tooltip="include"]
    "13" -> "21" [dir=forward tooltip="include"]
    "13" -> "26" [dir=forward tooltip="include"]
    "21" -> "22" [dir=forward tooltip="include"]
    "21" -> "2" [dir=forward tooltip="include"]
    "21" -> "17" [dir=forward tooltip="include"]
    "21" -> "23" [dir=forward tooltip="include"]
    "28" -> "17" [dir=forward tooltip="include"]
    "33" -> "34" [dir=forward tooltip="include"]
    "33" -> "17" [dir=forward tooltip="include"]
    "34" -> "35" [dir=forward tooltip="include"]
    "34" -> "17" [dir=forward tooltip="include"]
    "42" -> "2" [dir=forward tooltip="include"]
    "42" -> "12" [dir=forward tooltip="include"]
    "35" -> "25" [dir=forward tooltip="include"]
    "35" -> "8" [dir=forward tooltip="include"]
    "35" -> "36" [dir=forward tooltip="include"]
    "35" -> "37" [dir=forward tooltip="include"]
    "35" -> "3" [dir=forward tooltip="include"]
    "35" -> "2" [dir=forward tooltip="include"]
    "35" -> "29" [dir=forward tooltip="include"]
    "35" -> "38" [dir=forward tooltip="include"]
    "35" -> "39" [dir=forward tooltip="include"]
    "35" -> "40" [dir=forward tooltip="include"]
    "35" -> "12" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "31" [dir=forward tooltip="include"]
    "31" -> "2" [dir=forward tooltip="include"]
    "31" -> "15" [dir=forward tooltip="include"]
    "31" -> "14" [dir=forward tooltip="include"]
    "31" -> "8" [dir=forward tooltip="include"]
    "31" -> "32" [dir=forward tooltip="include"]
    "31" -> "33" [dir=forward tooltip="include"]
    "31" -> "41" [dir=forward tooltip="include"]
    "31" -> "12" [dir=forward tooltip="include"]
    "31" -> "42" [dir=forward tooltip="include"]
    "31" -> "43" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include Sphere.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" fillcolor="#BFBFBF"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "2" -> "3" [dir=back tooltip="include"]
    "2" -> "4" [dir=back tooltip="include"]
}

Typedefs

typedef std::shared_ptr<SLGridSph> SLGridSphPtr
file SphericalBasis.H
#include <memory>
#include <random>
#include <vector>
#include <string>
#include <set>
#include <Coefficients.H>
#include <config_exp.h>
#include <NVTX.H>
#include <CoefContainer.H>

Include dependency graph for SphericalBasis.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "16" [label="StringTok.H" tooltip="StringTok.H"]
    "17" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "7" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
    "8" [label="Basis.H" tooltip="Basis.H"]
    "21" [label="NVTX.H" tooltip="NVTX.H"]
    "9" [label="PotAccel.H" tooltip="PotAccel.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SphericalBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SphericalBasis.H" fillcolor="#BFBFBF"]
    "22" [label="CoefContainer.H" tooltip="CoefContainer.H"]
    "20" [label="Coefficients.H" tooltip="Coefficients.H"]
    "19" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "15" [label="Particle.H" tooltip="Particle.H"]
    "11" [label="chrono" tooltip="chrono"]
    "18" [label="config_exp.h" tooltip="config_exp.h"]
    "10" [label="cstdlib" tooltip="cstdlib"]
    "12" [label="list" tooltip="list"]
    "13" [label="map" tooltip="map"]
    "2" [label="memory" tooltip="memory"]
    "3" [label="random" tooltip="random"]
    "6" [label="set" tooltip="set"]
    "5" [label="string" tooltip="string"]
    "4" [label="vector" tooltip="vector"]
    "14" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "17" -> "5" [dir=forward tooltip="include"]
    "17" -> "6" [dir=forward tooltip="include"]
    "17" -> "14" [dir=forward tooltip="include"]
    "7" -> "8" [dir=forward tooltip="include"]
    "7" -> "19" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "19" [dir=forward tooltip="include"]
    "21" -> "2" [dir=forward tooltip="include"]
    "21" -> "18" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "5" [dir=forward tooltip="include"]
    "9" -> "11" [dir=forward tooltip="include"]
    "9" -> "12" [dir=forward tooltip="include"]
    "9" -> "13" [dir=forward tooltip="include"]
    "9" -> "2" [dir=forward tooltip="include"]
    "9" -> "14" [dir=forward tooltip="include"]
    "9" -> "15" [dir=forward tooltip="include"]
    "9" -> "16" [dir=forward tooltip="include"]
    "9" -> "17" [dir=forward tooltip="include"]
    "9" -> "18" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "20" [dir=forward tooltip="include"]
    "1" -> "18" [dir=forward tooltip="include"]
    "1" -> "21" [dir=forward tooltip="include"]
    "1" -> "22" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include SphericalBasis.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Bessel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Bessel.H"]
    "4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Sphere.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SphericalBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SphericalBasis.H" fillcolor="#BFBFBF"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
    "2" -> "3" [dir=back tooltip="include"]
    "6" -> "3" [dir=back tooltip="include"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "6" [dir=back tooltip="include"]
    "3" -> "4" [dir=back tooltip="include"]
    "3" -> "5" [dir=back tooltip="include"]
}
file StatsMPI.H
#include “localmpi.H
#include “Species.H
#include <array>
#include <map>

Include dependency graph for StatsMPI.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "8" [label="Species.H" tooltip="Species.H"]
    "2" [label="localmpi.H" tooltip="localmpi.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/StatsMPI.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/StatsMPI.H" fillcolor="#BFBFBF"]
    "12" [label="array" tooltip="array"]
    "5" [label="fstream" tooltip="fstream"]
    "6" [label="iomanip" tooltip="iomanip"]
    "4" [label="iostream" tooltip="iostream"]
    "9" [label="map" tooltip="map"]
    "3" [label="mpi.h" tooltip="mpi.h"]
    "10" [label="set" tooltip="set"]
    "7" [label="string" tooltip="string"]
    "11" [label="vector" tooltip="vector"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "10" [dir=forward tooltip="include"]
    "8" -> "11" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "2" -> "7" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "12" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
}
file tidalField.H
#include <yaml-cpp/yaml.h>

Include dependency graph for tidalField.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/tidalField.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/tidalField.H" fillcolor="#BFBFBF"]
    "2" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "1" -> "2" [dir=forward tooltip="include"]
}
file tipsydefs.h

Defines

forever
MAXDIM

Typedefs

typedef float Real

Variables

struct dark_particle *dark_particles
struct gas_particle *gas_particles
struct dump header
struct star_particle *star_particles
file tipsydefs.h

Defines

MAXDIM

Typedefs

typedef float Real

Functions

void xdr_dark()
void xdr_gas()
int xdr_init()
void xdr_quit()
void xdr_star()

Variables

struct dark_particle *dark_particles
struct gas_particle *gas_particles
struct dump header
struct star_particle *star_particles
file TwoCenter.H
#include <SLGridMP2.H>
#include <Sphere.H>
#include <Bessel.H>
#include <Cylinder.H>

Include dependency graph for TwoCenter.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "61" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "74" [label="CenterFile.H" tooltip="CenterFile.H"]
    "75" [label="Circular.H" tooltip="Circular.H"]
    "27" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "71" [label="EXPException.H" tooltip="EXPException.H"]
    "78" [label="EmpCylSL.H" tooltip="EmpCylSL.H"]
    "19" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "79" [label="Particle.H" tooltip="Particle.H"]
    "51" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "26" [label="QPDistF.H" tooltip="QPDistF.H"]
    "53" [label="QuadLS.H" tooltip="QuadLS.H"]
    "2" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
    "63" [label="Species.H" tooltip="Species.H"]
    "40" [label="StringTok.H" tooltip="StringTok.H"]
    "62" [label="Timer.H" tooltip="Timer.H"]
    "41" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "81" [label="coef.H" tooltip="coef.H"]
    "50" [label="euler.H" tooltip="euler.H"]
    "23" [label="gaussQ.H" tooltip="gaussQ.H"]
    "72" [label="header.H" tooltip="header.H"]
    "17" [label="interp.H" tooltip="interp.H"]
    "30" [label="libvars.H" tooltip="libvars.H"]
    "8" [label="localmpi.H" tooltip="localmpi.H"]
    "11" [label="massmodel.H" tooltip="massmodel.H"]
    "21" [label="orbit.H" tooltip="orbit.H"]
    "28" [label="sltableMP2.H" tooltip="sltableMP2.H"]
    "34" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
    "35" [label="Basis.H" tooltip="Basis.H"]
    "45" [label="Bessel.H" tooltip="Bessel.H"]
    "69" [label="Component.H" tooltip="Component.H"]
    "68" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
    "54" [label="CylEXP.H" tooltip="CylEXP.H"]
    "47" [label="Cylinder.H" tooltip="Cylinder.H"]
    "76" [label="ExternalForce.H" tooltip="ExternalForce.H"]
    "43" [label="NVTX.H" tooltip="NVTX.H"]
    "48" [label="Orient.H" tooltip="Orient.H"]
    "77" [label="Output.H" tooltip="Output.H"]
    "73" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "36" [label="PotAccel.H" tooltip="PotAccel.H"]
    "31" [label="Sphere.H" tooltip="Sphere.H"]
    "32" [label="SphericalBasis.H" tooltip="SphericalBasis.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" fillcolor="#BFBFBF"]
    "58" [label="chkTimer.H" tooltip="chkTimer.H"]
    "57" [label="coef.H" tooltip="coef.H"]
    "64" [label="expand.H" tooltip="expand.H"]
    "55" [label="global.H" tooltip="global.H"]
    "44" [label="CoefContainer.H" tooltip="CoefContainer.H"]
    "42" [label="Coefficients.H" tooltip="Coefficients.H"]
    "16" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "39" [label="Particle.H" tooltip="Particle.H"]
    "49" [label="algorithm" tooltip="algorithm"]
    "52" [label="array" tooltip="array"]
    "46" [label="assert.h" tooltip="assert.h"]
    "37" [label="chrono" tooltip="chrono"]
    "60" [label="cmath" tooltip="cmath"]
    "10" [label="config_exp.h" tooltip="config_exp.h"]
    "25" [label="cstdlib" tooltip="cstdlib"]
    "66" [label="cstring" tooltip="cstring"]
    "18" [label="deque" tooltip="deque"]
    "5" [label="fstream" tooltip="fstream"]
    "22" [label="functional" tooltip="functional"]
    "9" [label="iomanip" tooltip="iomanip"]
    "4" [label="iostream" tooltip="iostream"]
    "67" [label="limits" tooltip="limits"]
    "38" [label="list" tooltip="list"]
    "20" [label="map" tooltip="map"]
    "3" [label="math.h" tooltip="math.h"]
    "13" [label="memory" tooltip="memory"]
    "7" [label="mpi.h" tooltip="mpi.h"]
    "56" [label="pthread.h" tooltip="pthread.h"]
    "14" [label="random" tooltip="random"]
    "33" [label="set" tooltip="set"]
    "24" [label="sstream" tooltip="sstream"]
    "65" [label="stdexcept" tooltip="stdexcept"]
    "6" [label="string" tooltip="string"]
    "59" [label="time.h" tooltip="time.h"]
    "15" [label="tuple" tooltip="tuple"]
    "80" [label="unordered_map" tooltip="unordered_map"]
    "70" [label="utility" tooltip="utility"]
    "12" [label="vector" tooltip="vector"]
    "29" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "61" -> "4" [dir=forward tooltip="include"]
    "61" -> "9" [dir=forward tooltip="include"]
    "61" -> "12" [dir=forward tooltip="include"]
    "61" -> "6" [dir=forward tooltip="include"]
    "61" -> "38" [dir=forward tooltip="include"]
    "61" -> "20" [dir=forward tooltip="include"]
    "61" -> "33" [dir=forward tooltip="include"]
    "61" -> "13" [dir=forward tooltip="include"]
    "61" -> "62" [dir=forward tooltip="include"]
    "61" -> "7" [dir=forward tooltip="include"]
    "74" -> "5" [dir=forward tooltip="include"]
    "74" -> "12" [dir=forward tooltip="include"]
    "74" -> "52" [dir=forward tooltip="include"]
    "74" -> "29" [dir=forward tooltip="include"]
    "75" -> "12" [dir=forward tooltip="include"]
    "27" -> "11" [dir=forward tooltip="include"]
    "71" -> "33" [dir=forward tooltip="include"]
    "71" -> "12" [dir=forward tooltip="include"]
    "71" -> "6" [dir=forward tooltip="include"]
    "71" -> "24" [dir=forward tooltip="include"]
    "71" -> "30" [dir=forward tooltip="include"]
    "78" -> "22" [dir=forward tooltip="include"]
    "78" -> "12" [dir=forward tooltip="include"]
    "78" -> "13" [dir=forward tooltip="include"]
    "78" -> "67" [dir=forward tooltip="include"]
    "78" -> "60" [dir=forward tooltip="include"]
    "78" -> "16" [dir=forward tooltip="include"]
    "78" -> "23" [dir=forward tooltip="include"]
    "78" -> "17" [dir=forward tooltip="include"]
    "78" -> "62" [dir=forward tooltip="include"]
    "78" -> "79" [dir=forward tooltip="include"]
    "78" -> "2" [dir=forward tooltip="include"]
    "78" -> "81" [dir=forward tooltip="include"]
    "78" -> "30" [dir=forward tooltip="include"]
    "19" -> "12" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "19" -> "6" [dir=forward tooltip="include"]
    "79" -> "80" [dir=forward tooltip="include"]
    "79" -> "12" [dir=forward tooltip="include"]
    "79" -> "13" [dir=forward tooltip="include"]
    "51" -> "18" [dir=forward tooltip="include"]
    "51" -> "52" [dir=forward tooltip="include"]
    "51" -> "16" [dir=forward tooltip="include"]
    "51" -> "53" [dir=forward tooltip="include"]
    "26" -> "9" [dir=forward tooltip="include"]
    "26" -> "6" [dir=forward tooltip="include"]
    "26" -> "20" [dir=forward tooltip="include"]
    "26" -> "11" [dir=forward tooltip="include"]
    "26" -> "27" [dir=forward tooltip="include"]
    "26" -> "21" [dir=forward tooltip="include"]
    "53" -> "4" [dir=forward tooltip="include"]
    "53" -> "9" [dir=forward tooltip="include"]
    "53" -> "15" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "2" -> "7" [dir=forward tooltip="include"]
    "2" -> "8" [dir=forward tooltip="include"]
    "2" -> "10" [dir=forward tooltip="include"]
    "2" -> "11" [dir=forward tooltip="include"]
    "2" -> "28" [dir=forward tooltip="include"]
    "2" -> "29" [dir=forward tooltip="include"]
    "2" -> "30" [dir=forward tooltip="include"]
    "63" -> "20" [dir=forward tooltip="include"]
    "63" -> "33" [dir=forward tooltip="include"]
    "63" -> "12" [dir=forward tooltip="include"]
    "62" -> "4" [dir=forward tooltip="include"]
    "62" -> "25" [dir=forward tooltip="include"]
    "62" -> "37" [dir=forward tooltip="include"]
    "41" -> "6" [dir=forward tooltip="include"]
    "41" -> "33" [dir=forward tooltip="include"]
    "41" -> "29" [dir=forward tooltip="include"]
    "50" -> "16" [dir=forward tooltip="include"]
    "23" -> "4" [dir=forward tooltip="include"]
    "23" -> "9" [dir=forward tooltip="include"]
    "23" -> "24" [dir=forward tooltip="include"]
    "23" -> "25" [dir=forward tooltip="include"]
    "23" -> "6" [dir=forward tooltip="include"]
    "23" -> "12" [dir=forward tooltip="include"]
    "72" -> "4" [dir=forward tooltip="include"]
    "72" -> "9" [dir=forward tooltip="include"]
    "72" -> "24" [dir=forward tooltip="include"]
    "72" -> "13" [dir=forward tooltip="include"]
    "72" -> "8" [dir=forward tooltip="include"]
    "17" -> "16" [dir=forward tooltip="include"]
    "17" -> "12" [dir=forward tooltip="include"]
    "17" -> "18" [dir=forward tooltip="include"]
    "17" -> "19" [dir=forward tooltip="include"]
    "30" -> "14" [dir=forward tooltip="include"]
    "30" -> "7" [dir=forward tooltip="include"]
    "8" -> "7" [dir=forward tooltip="include"]
    "8" -> "4" [dir=forward tooltip="include"]
    "8" -> "5" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "6" [dir=forward tooltip="include"]
    "11" -> "12" [dir=forward tooltip="include"]
    "11" -> "13" [dir=forward tooltip="include"]
    "11" -> "14" [dir=forward tooltip="include"]
    "11" -> "15" [dir=forward tooltip="include"]
    "11" -> "16" [dir=forward tooltip="include"]
    "11" -> "17" [dir=forward tooltip="include"]
    "11" -> "21" [dir=forward tooltip="include"]
    "11" -> "26" [dir=forward tooltip="include"]
    "21" -> "22" [dir=forward tooltip="include"]
    "21" -> "13" [dir=forward tooltip="include"]
    "21" -> "16" [dir=forward tooltip="include"]
    "21" -> "23" [dir=forward tooltip="include"]
    "28" -> "16" [dir=forward tooltip="include"]
    "34" -> "35" [dir=forward tooltip="include"]
    "34" -> "16" [dir=forward tooltip="include"]
    "35" -> "36" [dir=forward tooltip="include"]
    "35" -> "16" [dir=forward tooltip="include"]
    "45" -> "46" [dir=forward tooltip="include"]
    "45" -> "32" [dir=forward tooltip="include"]
    "69" -> "7" [dir=forward tooltip="include"]
    "69" -> "70" [dir=forward tooltip="include"]
    "69" -> "29" [dir=forward tooltip="include"]
    "69" -> "71" [dir=forward tooltip="include"]
    "69" -> "55" [dir=forward tooltip="include"]
    "69" -> "48" [dir=forward tooltip="include"]
    "69" -> "72" [dir=forward tooltip="include"]
    "69" -> "8" [dir=forward tooltip="include"]
    "69" -> "73" [dir=forward tooltip="include"]
    "69" -> "74" [dir=forward tooltip="include"]
    "69" -> "36" [dir=forward tooltip="include"]
    "69" -> "75" [dir=forward tooltip="include"]
    "69" -> "62" [dir=forward tooltip="include"]
    "69" -> "10" [dir=forward tooltip="include"]
    "68" -> "38" [dir=forward tooltip="include"]
    "68" -> "69" [dir=forward tooltip="include"]
    "68" -> "62" [dir=forward tooltip="include"]
    "54" -> "55" [dir=forward tooltip="include"]
    "54" -> "64" [dir=forward tooltip="include"]
    "54" -> "78" [dir=forward tooltip="include"]
    "47" -> "13" [dir=forward tooltip="include"]
    "47" -> "48" [dir=forward tooltip="include"]
    "47" -> "35" [dir=forward tooltip="include"]
    "47" -> "54" [dir=forward tooltip="include"]
    "47" -> "42" [dir=forward tooltip="include"]
    "47" -> "10" [dir=forward tooltip="include"]
    "47" -> "44" [dir=forward tooltip="include"]
    "76" -> "36" [dir=forward tooltip="include"]
    "76" -> "69" [dir=forward tooltip="include"]
    "43" -> "13" [dir=forward tooltip="include"]
    "43" -> "10" [dir=forward tooltip="include"]
    "48" -> "12" [dir=forward tooltip="include"]
    "48" -> "33" [dir=forward tooltip="include"]
    "48" -> "18" [dir=forward tooltip="include"]
    "48" -> "49" [dir=forward tooltip="include"]
    "48" -> "50" [dir=forward tooltip="include"]
    "48" -> "39" [dir=forward tooltip="include"]
    "48" -> "51" [dir=forward tooltip="include"]
    "48" -> "10" [dir=forward tooltip="include"]
    "77" -> "6" [dir=forward tooltip="include"]
    "77" -> "12" [dir=forward tooltip="include"]
    "77" -> "70" [dir=forward tooltip="include"]
    "77" -> "33" [dir=forward tooltip="include"]
    "77" -> "40" [dir=forward tooltip="include"]
    "77" -> "62" [dir=forward tooltip="include"]
    "73" -> "12" [dir=forward tooltip="include"]
    "73" -> "13" [dir=forward tooltip="include"]
    "73" -> "8" [dir=forward tooltip="include"]
    "73" -> "39" [dir=forward tooltip="include"]
    "36" -> "25" [dir=forward tooltip="include"]
    "36" -> "6" [dir=forward tooltip="include"]
    "36" -> "37" [dir=forward tooltip="include"]
    "36" -> "38" [dir=forward tooltip="include"]
    "36" -> "20" [dir=forward tooltip="include"]
    "36" -> "13" [dir=forward tooltip="include"]
    "36" -> "29" [dir=forward tooltip="include"]
    "36" -> "39" [dir=forward tooltip="include"]
    "36" -> "40" [dir=forward tooltip="include"]
    "36" -> "41" [dir=forward tooltip="include"]
    "36" -> "10" [dir=forward tooltip="include"]
    "31" -> "13" [dir=forward tooltip="include"]
    "31" -> "20" [dir=forward tooltip="include"]
    "31" -> "2" [dir=forward tooltip="include"]
    "31" -> "32" [dir=forward tooltip="include"]
    "32" -> "13" [dir=forward tooltip="include"]
    "32" -> "14" [dir=forward tooltip="include"]
    "32" -> "12" [dir=forward tooltip="include"]
    "32" -> "6" [dir=forward tooltip="include"]
    "32" -> "33" [dir=forward tooltip="include"]
    "32" -> "34" [dir=forward tooltip="include"]
    "32" -> "42" [dir=forward tooltip="include"]
    "32" -> "10" [dir=forward tooltip="include"]
    "32" -> "43" [dir=forward tooltip="include"]
    "32" -> "44" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "31" [dir=forward tooltip="include"]
    "1" -> "45" [dir=forward tooltip="include"]
    "1" -> "47" [dir=forward tooltip="include"]
    "58" -> "59" [dir=forward tooltip="include"]
    "58" -> "60" [dir=forward tooltip="include"]
    "58" -> "4" [dir=forward tooltip="include"]
    "58" -> "5" [dir=forward tooltip="include"]
    "58" -> "9" [dir=forward tooltip="include"]
    "64" -> "10" [dir=forward tooltip="include"]
    "64" -> "7" [dir=forward tooltip="include"]
    "64" -> "56" [dir=forward tooltip="include"]
    "64" -> "65" [dir=forward tooltip="include"]
    "64" -> "25" [dir=forward tooltip="include"]
    "64" -> "60" [dir=forward tooltip="include"]
    "64" -> "66" [dir=forward tooltip="include"]
    "64" -> "4" [dir=forward tooltip="include"]
    "64" -> "5" [dir=forward tooltip="include"]
    "64" -> "24" [dir=forward tooltip="include"]
    "64" -> "9" [dir=forward tooltip="include"]
    "64" -> "12" [dir=forward tooltip="include"]
    "64" -> "6" [dir=forward tooltip="include"]
    "64" -> "67" [dir=forward tooltip="include"]
    "64" -> "16" [dir=forward tooltip="include"]
    "64" -> "68" [dir=forward tooltip="include"]
    "64" -> "76" [dir=forward tooltip="include"]
    "64" -> "77" [dir=forward tooltip="include"]
    "64" -> "29" [dir=forward tooltip="include"]
    "64" -> "55" [dir=forward tooltip="include"]
    "64" -> "71" [dir=forward tooltip="include"]
    "55" -> "56" [dir=forward tooltip="include"]
    "55" -> "7" [dir=forward tooltip="include"]
    "55" -> "12" [dir=forward tooltip="include"]
    "55" -> "6" [dir=forward tooltip="include"]
    "55" -> "13" [dir=forward tooltip="include"]
    "55" -> "14" [dir=forward tooltip="include"]
    "55" -> "38" [dir=forward tooltip="include"]
    "55" -> "57" [dir=forward tooltip="include"]
    "55" -> "58" [dir=forward tooltip="include"]
    "55" -> "61" [dir=forward tooltip="include"]
    "55" -> "29" [dir=forward tooltip="include"]
    "55" -> "8" [dir=forward tooltip="include"]
    "55" -> "30" [dir=forward tooltip="include"]
    "55" -> "63" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include TwoCenter.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/EJcom.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/MixtureBasis.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
}
file TwoDCoefs.H
#include <iostream>
#include <iomanip>
#include <fstream>
#include <memory>
#include <vector>
#include <tuple>
#include <cmath>
#include <map>
#include <Eigen/Eigen>

Include dependency graph for TwoDCoefs.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoDCoefs.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoDCoefs.H" fillcolor="#BFBFBF"]
    "10" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "8" [label="cmath" tooltip="cmath"]
    "4" [label="fstream" tooltip="fstream"]
    "3" [label="iomanip" tooltip="iomanip"]
    "2" [label="iostream" tooltip="iostream"]
    "9" [label="map" tooltip="map"]
    "5" [label="memory" tooltip="memory"]
    "7" [label="tuple" tooltip="tuple"]
    "6" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "1" -> "10" [dir=forward tooltip="include"]
}
file UserBar.H
#include <Particle.H>

Include dependency graph for UserBar.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "37" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "51" [label="CenterFile.H" tooltip="CenterFile.H"]
    "52" [label="Circular.H" tooltip="Circular.H"]
    "23" [label="EXPException.H" tooltip="EXPException.H"]
    "45" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "47" [label="QuadLS.H" tooltip="QuadLS.H"]
    "40" [label="Species.H" tooltip="Species.H"]
    "13" [label="StringTok.H" tooltip="StringTok.H"]
    "38" [label="Timer.H" tooltip="Timer.H"]
    "14" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "44" [label="euler.H" tooltip="euler.H"]
    "49" [label="header.H" tooltip="header.H"]
    "26" [label="libvars.H" tooltip="libvars.H"]
    "39" [label="localmpi.H" tooltip="localmpi.H"]
    "3" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
    "4" [label="Basis.H" tooltip="Basis.H"]
    "20" [label="Component.H" tooltip="Component.H"]
    "19" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
    "18" [label="ExternalCollection.H" tooltip="ExternalCollection.H"]
    "53" [label="ExternalForce.H" tooltip="ExternalForce.H"]
    "41" [label="Orient.H" tooltip="Orient.H"]
    "50" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "5" [label="PotAccel.H" tooltip="PotAccel.H"]
    "31" [label="chkTimer.H" tooltip="chkTimer.H"]
    "30" [label="coef.H" tooltip="coef.H"]
    "28" [label="global.H" tooltip="global.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserBar.H" fillcolor="#BFBFBF"]
    "17" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "2" [label="Particle.H" tooltip="Particle.H"]
    "43" [label="algorithm" tooltip="algorithm"]
    "46" [label="array" tooltip="array"]
    "8" [label="chrono" tooltip="chrono"]
    "33" [label="cmath" tooltip="cmath"]
    "16" [label="config_exp.h" tooltip="config_exp.h"]
    "6" [label="cstdlib" tooltip="cstdlib"]
    "42" [label="deque" tooltip="deque"]
    "35" [label="fstream" tooltip="fstream"]
    "36" [label="iomanip" tooltip="iomanip"]
    "34" [label="iostream" tooltip="iostream"]
    "9" [label="list" tooltip="list"]
    "10" [label="map" tooltip="map"]
    "11" [label="memory" tooltip="memory"]
    "21" [label="mpi.h" tooltip="mpi.h"]
    "29" [label="pthread.h" tooltip="pthread.h"]
    "27" [label="random" tooltip="random"]
    "15" [label="set" tooltip="set"]
    "25" [label="sstream" tooltip="sstream"]
    "7" [label="string" tooltip="string"]
    "32" [label="time.h" tooltip="time.h"]
    "48" [label="tuple" tooltip="tuple"]
    "22" [label="utility" tooltip="utility"]
    "24" [label="vector" tooltip="vector"]
    "12" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "37" -> "34" [dir=forward tooltip="include"]
    "37" -> "36" [dir=forward tooltip="include"]
    "37" -> "24" [dir=forward tooltip="include"]
    "37" -> "7" [dir=forward tooltip="include"]
    "37" -> "9" [dir=forward tooltip="include"]
    "37" -> "10" [dir=forward tooltip="include"]
    "37" -> "15" [dir=forward tooltip="include"]
    "37" -> "11" [dir=forward tooltip="include"]
    "37" -> "38" [dir=forward tooltip="include"]
    "37" -> "21" [dir=forward tooltip="include"]
    "51" -> "35" [dir=forward tooltip="include"]
    "51" -> "24" [dir=forward tooltip="include"]
    "51" -> "46" [dir=forward tooltip="include"]
    "51" -> "12" [dir=forward tooltip="include"]
    "52" -> "24" [dir=forward tooltip="include"]
    "23" -> "15" [dir=forward tooltip="include"]
    "23" -> "24" [dir=forward tooltip="include"]
    "23" -> "7" [dir=forward tooltip="include"]
    "23" -> "25" [dir=forward tooltip="include"]
    "23" -> "26" [dir=forward tooltip="include"]
    "45" -> "42" [dir=forward tooltip="include"]
    "45" -> "46" [dir=forward tooltip="include"]
    "45" -> "17" [dir=forward tooltip="include"]
    "45" -> "47" [dir=forward tooltip="include"]
    "47" -> "34" [dir=forward tooltip="include"]
    "47" -> "36" [dir=forward tooltip="include"]
    "47" -> "48" [dir=forward tooltip="include"]
    "40" -> "10" [dir=forward tooltip="include"]
    "40" -> "15" [dir=forward tooltip="include"]
    "40" -> "24" [dir=forward tooltip="include"]
    "38" -> "34" [dir=forward tooltip="include"]
    "38" -> "6" [dir=forward tooltip="include"]
    "38" -> "8" [dir=forward tooltip="include"]
    "14" -> "7" [dir=forward tooltip="include"]
    "14" -> "15" [dir=forward tooltip="include"]
    "14" -> "12" [dir=forward tooltip="include"]
    "44" -> "17" [dir=forward tooltip="include"]
    "49" -> "34" [dir=forward tooltip="include"]
    "49" -> "36" [dir=forward tooltip="include"]
    "49" -> "25" [dir=forward tooltip="include"]
    "49" -> "11" [dir=forward tooltip="include"]
    "49" -> "39" [dir=forward tooltip="include"]
    "26" -> "27" [dir=forward tooltip="include"]
    "26" -> "21" [dir=forward tooltip="include"]
    "39" -> "21" [dir=forward tooltip="include"]
    "39" -> "34" [dir=forward tooltip="include"]
    "39" -> "35" [dir=forward tooltip="include"]
    "39" -> "36" [dir=forward tooltip="include"]
    "39" -> "7" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "17" [dir=forward tooltip="include"]
    "4" -> "5" [dir=forward tooltip="include"]
    "4" -> "17" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "22" [dir=forward tooltip="include"]
    "20" -> "12" [dir=forward tooltip="include"]
    "20" -> "23" [dir=forward tooltip="include"]
    "20" -> "28" [dir=forward tooltip="include"]
    "20" -> "41" [dir=forward tooltip="include"]
    "20" -> "49" [dir=forward tooltip="include"]
    "20" -> "39" [dir=forward tooltip="include"]
    "20" -> "50" [dir=forward tooltip="include"]
    "20" -> "51" [dir=forward tooltip="include"]
    "20" -> "5" [dir=forward tooltip="include"]
    "20" -> "52" [dir=forward tooltip="include"]
    "20" -> "38" [dir=forward tooltip="include"]
    "20" -> "16" [dir=forward tooltip="include"]
    "19" -> "9" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "19" -> "38" [dir=forward tooltip="include"]
    "18" -> "10" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "53" [dir=forward tooltip="include"]
    "53" -> "5" [dir=forward tooltip="include"]
    "53" -> "20" [dir=forward tooltip="include"]
    "41" -> "24" [dir=forward tooltip="include"]
    "41" -> "15" [dir=forward tooltip="include"]
    "41" -> "42" [dir=forward tooltip="include"]
    "41" -> "43" [dir=forward tooltip="include"]
    "41" -> "44" [dir=forward tooltip="include"]
    "41" -> "2" [dir=forward tooltip="include"]
    "41" -> "45" [dir=forward tooltip="include"]
    "41" -> "16" [dir=forward tooltip="include"]
    "50" -> "24" [dir=forward tooltip="include"]
    "50" -> "11" [dir=forward tooltip="include"]
    "50" -> "39" [dir=forward tooltip="include"]
    "50" -> "2" [dir=forward tooltip="include"]
    "5" -> "6" [dir=forward tooltip="include"]
    "5" -> "7" [dir=forward tooltip="include"]
    "5" -> "8" [dir=forward tooltip="include"]
    "5" -> "9" [dir=forward tooltip="include"]
    "5" -> "10" [dir=forward tooltip="include"]
    "5" -> "11" [dir=forward tooltip="include"]
    "5" -> "12" [dir=forward tooltip="include"]
    "5" -> "2" [dir=forward tooltip="include"]
    "5" -> "13" [dir=forward tooltip="include"]
    "5" -> "14" [dir=forward tooltip="include"]
    "5" -> "16" [dir=forward tooltip="include"]
    "31" -> "32" [dir=forward tooltip="include"]
    "31" -> "33" [dir=forward tooltip="include"]
    "31" -> "34" [dir=forward tooltip="include"]
    "31" -> "35" [dir=forward tooltip="include"]
    "31" -> "36" [dir=forward tooltip="include"]
    "28" -> "29" [dir=forward tooltip="include"]
    "28" -> "21" [dir=forward tooltip="include"]
    "28" -> "24" [dir=forward tooltip="include"]
    "28" -> "7" [dir=forward tooltip="include"]
    "28" -> "11" [dir=forward tooltip="include"]
    "28" -> "27" [dir=forward tooltip="include"]
    "28" -> "9" [dir=forward tooltip="include"]
    "28" -> "30" [dir=forward tooltip="include"]
    "28" -> "31" [dir=forward tooltip="include"]
    "28" -> "37" [dir=forward tooltip="include"]
    "28" -> "12" [dir=forward tooltip="include"]
    "28" -> "39" [dir=forward tooltip="include"]
    "28" -> "26" [dir=forward tooltip="include"]
    "28" -> "40" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "18" [dir=forward tooltip="include"]
}
file UserDisk.H
#include <Particle.H>

Include dependency graph for UserDisk.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "37" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "51" [label="CenterFile.H" tooltip="CenterFile.H"]
    "52" [label="Circular.H" tooltip="Circular.H"]
    "23" [label="EXPException.H" tooltip="EXPException.H"]
    "45" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "47" [label="QuadLS.H" tooltip="QuadLS.H"]
    "40" [label="Species.H" tooltip="Species.H"]
    "13" [label="StringTok.H" tooltip="StringTok.H"]
    "38" [label="Timer.H" tooltip="Timer.H"]
    "14" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "44" [label="euler.H" tooltip="euler.H"]
    "49" [label="header.H" tooltip="header.H"]
    "26" [label="libvars.H" tooltip="libvars.H"]
    "39" [label="localmpi.H" tooltip="localmpi.H"]
    "3" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
    "4" [label="Basis.H" tooltip="Basis.H"]
    "20" [label="Component.H" tooltip="Component.H"]
    "19" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
    "18" [label="ExternalCollection.H" tooltip="ExternalCollection.H"]
    "53" [label="ExternalForce.H" tooltip="ExternalForce.H"]
    "41" [label="Orient.H" tooltip="Orient.H"]
    "50" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "5" [label="PotAccel.H" tooltip="PotAccel.H"]
    "31" [label="chkTimer.H" tooltip="chkTimer.H"]
    "30" [label="coef.H" tooltip="coef.H"]
    "28" [label="global.H" tooltip="global.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserDisk.H" fillcolor="#BFBFBF"]
    "17" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "2" [label="Particle.H" tooltip="Particle.H"]
    "43" [label="algorithm" tooltip="algorithm"]
    "46" [label="array" tooltip="array"]
    "8" [label="chrono" tooltip="chrono"]
    "33" [label="cmath" tooltip="cmath"]
    "16" [label="config_exp.h" tooltip="config_exp.h"]
    "6" [label="cstdlib" tooltip="cstdlib"]
    "42" [label="deque" tooltip="deque"]
    "35" [label="fstream" tooltip="fstream"]
    "36" [label="iomanip" tooltip="iomanip"]
    "34" [label="iostream" tooltip="iostream"]
    "9" [label="list" tooltip="list"]
    "10" [label="map" tooltip="map"]
    "11" [label="memory" tooltip="memory"]
    "21" [label="mpi.h" tooltip="mpi.h"]
    "29" [label="pthread.h" tooltip="pthread.h"]
    "27" [label="random" tooltip="random"]
    "15" [label="set" tooltip="set"]
    "25" [label="sstream" tooltip="sstream"]
    "7" [label="string" tooltip="string"]
    "32" [label="time.h" tooltip="time.h"]
    "48" [label="tuple" tooltip="tuple"]
    "22" [label="utility" tooltip="utility"]
    "24" [label="vector" tooltip="vector"]
    "12" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "37" -> "34" [dir=forward tooltip="include"]
    "37" -> "36" [dir=forward tooltip="include"]
    "37" -> "24" [dir=forward tooltip="include"]
    "37" -> "7" [dir=forward tooltip="include"]
    "37" -> "9" [dir=forward tooltip="include"]
    "37" -> "10" [dir=forward tooltip="include"]
    "37" -> "15" [dir=forward tooltip="include"]
    "37" -> "11" [dir=forward tooltip="include"]
    "37" -> "38" [dir=forward tooltip="include"]
    "37" -> "21" [dir=forward tooltip="include"]
    "51" -> "35" [dir=forward tooltip="include"]
    "51" -> "24" [dir=forward tooltip="include"]
    "51" -> "46" [dir=forward tooltip="include"]
    "51" -> "12" [dir=forward tooltip="include"]
    "52" -> "24" [dir=forward tooltip="include"]
    "23" -> "15" [dir=forward tooltip="include"]
    "23" -> "24" [dir=forward tooltip="include"]
    "23" -> "7" [dir=forward tooltip="include"]
    "23" -> "25" [dir=forward tooltip="include"]
    "23" -> "26" [dir=forward tooltip="include"]
    "45" -> "42" [dir=forward tooltip="include"]
    "45" -> "46" [dir=forward tooltip="include"]
    "45" -> "17" [dir=forward tooltip="include"]
    "45" -> "47" [dir=forward tooltip="include"]
    "47" -> "34" [dir=forward tooltip="include"]
    "47" -> "36" [dir=forward tooltip="include"]
    "47" -> "48" [dir=forward tooltip="include"]
    "40" -> "10" [dir=forward tooltip="include"]
    "40" -> "15" [dir=forward tooltip="include"]
    "40" -> "24" [dir=forward tooltip="include"]
    "38" -> "34" [dir=forward tooltip="include"]
    "38" -> "6" [dir=forward tooltip="include"]
    "38" -> "8" [dir=forward tooltip="include"]
    "14" -> "7" [dir=forward tooltip="include"]
    "14" -> "15" [dir=forward tooltip="include"]
    "14" -> "12" [dir=forward tooltip="include"]
    "44" -> "17" [dir=forward tooltip="include"]
    "49" -> "34" [dir=forward tooltip="include"]
    "49" -> "36" [dir=forward tooltip="include"]
    "49" -> "25" [dir=forward tooltip="include"]
    "49" -> "11" [dir=forward tooltip="include"]
    "49" -> "39" [dir=forward tooltip="include"]
    "26" -> "27" [dir=forward tooltip="include"]
    "26" -> "21" [dir=forward tooltip="include"]
    "39" -> "21" [dir=forward tooltip="include"]
    "39" -> "34" [dir=forward tooltip="include"]
    "39" -> "35" [dir=forward tooltip="include"]
    "39" -> "36" [dir=forward tooltip="include"]
    "39" -> "7" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "17" [dir=forward tooltip="include"]
    "4" -> "5" [dir=forward tooltip="include"]
    "4" -> "17" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "22" [dir=forward tooltip="include"]
    "20" -> "12" [dir=forward tooltip="include"]
    "20" -> "23" [dir=forward tooltip="include"]
    "20" -> "28" [dir=forward tooltip="include"]
    "20" -> "41" [dir=forward tooltip="include"]
    "20" -> "49" [dir=forward tooltip="include"]
    "20" -> "39" [dir=forward tooltip="include"]
    "20" -> "50" [dir=forward tooltip="include"]
    "20" -> "51" [dir=forward tooltip="include"]
    "20" -> "5" [dir=forward tooltip="include"]
    "20" -> "52" [dir=forward tooltip="include"]
    "20" -> "38" [dir=forward tooltip="include"]
    "20" -> "16" [dir=forward tooltip="include"]
    "19" -> "9" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "19" -> "38" [dir=forward tooltip="include"]
    "18" -> "10" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "53" [dir=forward tooltip="include"]
    "53" -> "5" [dir=forward tooltip="include"]
    "53" -> "20" [dir=forward tooltip="include"]
    "41" -> "24" [dir=forward tooltip="include"]
    "41" -> "15" [dir=forward tooltip="include"]
    "41" -> "42" [dir=forward tooltip="include"]
    "41" -> "43" [dir=forward tooltip="include"]
    "41" -> "44" [dir=forward tooltip="include"]
    "41" -> "2" [dir=forward tooltip="include"]
    "41" -> "45" [dir=forward tooltip="include"]
    "41" -> "16" [dir=forward tooltip="include"]
    "50" -> "24" [dir=forward tooltip="include"]
    "50" -> "11" [dir=forward tooltip="include"]
    "50" -> "39" [dir=forward tooltip="include"]
    "50" -> "2" [dir=forward tooltip="include"]
    "5" -> "6" [dir=forward tooltip="include"]
    "5" -> "7" [dir=forward tooltip="include"]
    "5" -> "8" [dir=forward tooltip="include"]
    "5" -> "9" [dir=forward tooltip="include"]
    "5" -> "10" [dir=forward tooltip="include"]
    "5" -> "11" [dir=forward tooltip="include"]
    "5" -> "12" [dir=forward tooltip="include"]
    "5" -> "2" [dir=forward tooltip="include"]
    "5" -> "13" [dir=forward tooltip="include"]
    "5" -> "14" [dir=forward tooltip="include"]
    "5" -> "16" [dir=forward tooltip="include"]
    "31" -> "32" [dir=forward tooltip="include"]
    "31" -> "33" [dir=forward tooltip="include"]
    "31" -> "34" [dir=forward tooltip="include"]
    "31" -> "35" [dir=forward tooltip="include"]
    "31" -> "36" [dir=forward tooltip="include"]
    "28" -> "29" [dir=forward tooltip="include"]
    "28" -> "21" [dir=forward tooltip="include"]
    "28" -> "24" [dir=forward tooltip="include"]
    "28" -> "7" [dir=forward tooltip="include"]
    "28" -> "11" [dir=forward tooltip="include"]
    "28" -> "27" [dir=forward tooltip="include"]
    "28" -> "9" [dir=forward tooltip="include"]
    "28" -> "30" [dir=forward tooltip="include"]
    "28" -> "31" [dir=forward tooltip="include"]
    "28" -> "37" [dir=forward tooltip="include"]
    "28" -> "12" [dir=forward tooltip="include"]
    "28" -> "39" [dir=forward tooltip="include"]
    "28" -> "26" [dir=forward tooltip="include"]
    "28" -> "40" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "18" [dir=forward tooltip="include"]
}
file UserHalo.H
#include <Particle.H>

Include dependency graph for UserHalo.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "37" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "51" [label="CenterFile.H" tooltip="CenterFile.H"]
    "52" [label="Circular.H" tooltip="Circular.H"]
    "23" [label="EXPException.H" tooltip="EXPException.H"]
    "45" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "47" [label="QuadLS.H" tooltip="QuadLS.H"]
    "40" [label="Species.H" tooltip="Species.H"]
    "13" [label="StringTok.H" tooltip="StringTok.H"]
    "38" [label="Timer.H" tooltip="Timer.H"]
    "14" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "44" [label="euler.H" tooltip="euler.H"]
    "49" [label="header.H" tooltip="header.H"]
    "26" [label="libvars.H" tooltip="libvars.H"]
    "39" [label="localmpi.H" tooltip="localmpi.H"]
    "3" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
    "4" [label="Basis.H" tooltip="Basis.H"]
    "20" [label="Component.H" tooltip="Component.H"]
    "19" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
    "18" [label="ExternalCollection.H" tooltip="ExternalCollection.H"]
    "53" [label="ExternalForce.H" tooltip="ExternalForce.H"]
    "41" [label="Orient.H" tooltip="Orient.H"]
    "50" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "5" [label="PotAccel.H" tooltip="PotAccel.H"]
    "31" [label="chkTimer.H" tooltip="chkTimer.H"]
    "30" [label="coef.H" tooltip="coef.H"]
    "28" [label="global.H" tooltip="global.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserHalo.H" fillcolor="#BFBFBF"]
    "17" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "2" [label="Particle.H" tooltip="Particle.H"]
    "43" [label="algorithm" tooltip="algorithm"]
    "46" [label="array" tooltip="array"]
    "8" [label="chrono" tooltip="chrono"]
    "33" [label="cmath" tooltip="cmath"]
    "16" [label="config_exp.h" tooltip="config_exp.h"]
    "6" [label="cstdlib" tooltip="cstdlib"]
    "42" [label="deque" tooltip="deque"]
    "35" [label="fstream" tooltip="fstream"]
    "36" [label="iomanip" tooltip="iomanip"]
    "34" [label="iostream" tooltip="iostream"]
    "9" [label="list" tooltip="list"]
    "10" [label="map" tooltip="map"]
    "11" [label="memory" tooltip="memory"]
    "21" [label="mpi.h" tooltip="mpi.h"]
    "29" [label="pthread.h" tooltip="pthread.h"]
    "27" [label="random" tooltip="random"]
    "15" [label="set" tooltip="set"]
    "25" [label="sstream" tooltip="sstream"]
    "7" [label="string" tooltip="string"]
    "32" [label="time.h" tooltip="time.h"]
    "48" [label="tuple" tooltip="tuple"]
    "22" [label="utility" tooltip="utility"]
    "24" [label="vector" tooltip="vector"]
    "12" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "37" -> "34" [dir=forward tooltip="include"]
    "37" -> "36" [dir=forward tooltip="include"]
    "37" -> "24" [dir=forward tooltip="include"]
    "37" -> "7" [dir=forward tooltip="include"]
    "37" -> "9" [dir=forward tooltip="include"]
    "37" -> "10" [dir=forward tooltip="include"]
    "37" -> "15" [dir=forward tooltip="include"]
    "37" -> "11" [dir=forward tooltip="include"]
    "37" -> "38" [dir=forward tooltip="include"]
    "37" -> "21" [dir=forward tooltip="include"]
    "51" -> "35" [dir=forward tooltip="include"]
    "51" -> "24" [dir=forward tooltip="include"]
    "51" -> "46" [dir=forward tooltip="include"]
    "51" -> "12" [dir=forward tooltip="include"]
    "52" -> "24" [dir=forward tooltip="include"]
    "23" -> "15" [dir=forward tooltip="include"]
    "23" -> "24" [dir=forward tooltip="include"]
    "23" -> "7" [dir=forward tooltip="include"]
    "23" -> "25" [dir=forward tooltip="include"]
    "23" -> "26" [dir=forward tooltip="include"]
    "45" -> "42" [dir=forward tooltip="include"]
    "45" -> "46" [dir=forward tooltip="include"]
    "45" -> "17" [dir=forward tooltip="include"]
    "45" -> "47" [dir=forward tooltip="include"]
    "47" -> "34" [dir=forward tooltip="include"]
    "47" -> "36" [dir=forward tooltip="include"]
    "47" -> "48" [dir=forward tooltip="include"]
    "40" -> "10" [dir=forward tooltip="include"]
    "40" -> "15" [dir=forward tooltip="include"]
    "40" -> "24" [dir=forward tooltip="include"]
    "38" -> "34" [dir=forward tooltip="include"]
    "38" -> "6" [dir=forward tooltip="include"]
    "38" -> "8" [dir=forward tooltip="include"]
    "14" -> "7" [dir=forward tooltip="include"]
    "14" -> "15" [dir=forward tooltip="include"]
    "14" -> "12" [dir=forward tooltip="include"]
    "44" -> "17" [dir=forward tooltip="include"]
    "49" -> "34" [dir=forward tooltip="include"]
    "49" -> "36" [dir=forward tooltip="include"]
    "49" -> "25" [dir=forward tooltip="include"]
    "49" -> "11" [dir=forward tooltip="include"]
    "49" -> "39" [dir=forward tooltip="include"]
    "26" -> "27" [dir=forward tooltip="include"]
    "26" -> "21" [dir=forward tooltip="include"]
    "39" -> "21" [dir=forward tooltip="include"]
    "39" -> "34" [dir=forward tooltip="include"]
    "39" -> "35" [dir=forward tooltip="include"]
    "39" -> "36" [dir=forward tooltip="include"]
    "39" -> "7" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "17" [dir=forward tooltip="include"]
    "4" -> "5" [dir=forward tooltip="include"]
    "4" -> "17" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "22" [dir=forward tooltip="include"]
    "20" -> "12" [dir=forward tooltip="include"]
    "20" -> "23" [dir=forward tooltip="include"]
    "20" -> "28" [dir=forward tooltip="include"]
    "20" -> "41" [dir=forward tooltip="include"]
    "20" -> "49" [dir=forward tooltip="include"]
    "20" -> "39" [dir=forward tooltip="include"]
    "20" -> "50" [dir=forward tooltip="include"]
    "20" -> "51" [dir=forward tooltip="include"]
    "20" -> "5" [dir=forward tooltip="include"]
    "20" -> "52" [dir=forward tooltip="include"]
    "20" -> "38" [dir=forward tooltip="include"]
    "20" -> "16" [dir=forward tooltip="include"]
    "19" -> "9" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "19" -> "38" [dir=forward tooltip="include"]
    "18" -> "10" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "53" [dir=forward tooltip="include"]
    "53" -> "5" [dir=forward tooltip="include"]
    "53" -> "20" [dir=forward tooltip="include"]
    "41" -> "24" [dir=forward tooltip="include"]
    "41" -> "15" [dir=forward tooltip="include"]
    "41" -> "42" [dir=forward tooltip="include"]
    "41" -> "43" [dir=forward tooltip="include"]
    "41" -> "44" [dir=forward tooltip="include"]
    "41" -> "2" [dir=forward tooltip="include"]
    "41" -> "45" [dir=forward tooltip="include"]
    "41" -> "16" [dir=forward tooltip="include"]
    "50" -> "24" [dir=forward tooltip="include"]
    "50" -> "11" [dir=forward tooltip="include"]
    "50" -> "39" [dir=forward tooltip="include"]
    "50" -> "2" [dir=forward tooltip="include"]
    "5" -> "6" [dir=forward tooltip="include"]
    "5" -> "7" [dir=forward tooltip="include"]
    "5" -> "8" [dir=forward tooltip="include"]
    "5" -> "9" [dir=forward tooltip="include"]
    "5" -> "10" [dir=forward tooltip="include"]
    "5" -> "11" [dir=forward tooltip="include"]
    "5" -> "12" [dir=forward tooltip="include"]
    "5" -> "2" [dir=forward tooltip="include"]
    "5" -> "13" [dir=forward tooltip="include"]
    "5" -> "14" [dir=forward tooltip="include"]
    "5" -> "16" [dir=forward tooltip="include"]
    "31" -> "32" [dir=forward tooltip="include"]
    "31" -> "33" [dir=forward tooltip="include"]
    "31" -> "34" [dir=forward tooltip="include"]
    "31" -> "35" [dir=forward tooltip="include"]
    "31" -> "36" [dir=forward tooltip="include"]
    "28" -> "29" [dir=forward tooltip="include"]
    "28" -> "21" [dir=forward tooltip="include"]
    "28" -> "24" [dir=forward tooltip="include"]
    "28" -> "7" [dir=forward tooltip="include"]
    "28" -> "11" [dir=forward tooltip="include"]
    "28" -> "27" [dir=forward tooltip="include"]
    "28" -> "9" [dir=forward tooltip="include"]
    "28" -> "30" [dir=forward tooltip="include"]
    "28" -> "31" [dir=forward tooltip="include"]
    "28" -> "37" [dir=forward tooltip="include"]
    "28" -> "12" [dir=forward tooltip="include"]
    "28" -> "39" [dir=forward tooltip="include"]
    "28" -> "26" [dir=forward tooltip="include"]
    "28" -> "40" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "18" [dir=forward tooltip="include"]
}
file UserLogPot.H
#include <Particle.H>

Include dependency graph for UserLogPot.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "37" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "51" [label="CenterFile.H" tooltip="CenterFile.H"]
    "52" [label="Circular.H" tooltip="Circular.H"]
    "23" [label="EXPException.H" tooltip="EXPException.H"]
    "45" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "47" [label="QuadLS.H" tooltip="QuadLS.H"]
    "40" [label="Species.H" tooltip="Species.H"]
    "13" [label="StringTok.H" tooltip="StringTok.H"]
    "38" [label="Timer.H" tooltip="Timer.H"]
    "14" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "44" [label="euler.H" tooltip="euler.H"]
    "49" [label="header.H" tooltip="header.H"]
    "26" [label="libvars.H" tooltip="libvars.H"]
    "39" [label="localmpi.H" tooltip="localmpi.H"]
    "3" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
    "4" [label="Basis.H" tooltip="Basis.H"]
    "20" [label="Component.H" tooltip="Component.H"]
    "19" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
    "18" [label="ExternalCollection.H" tooltip="ExternalCollection.H"]
    "53" [label="ExternalForce.H" tooltip="ExternalForce.H"]
    "41" [label="Orient.H" tooltip="Orient.H"]
    "50" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "5" [label="PotAccel.H" tooltip="PotAccel.H"]
    "31" [label="chkTimer.H" tooltip="chkTimer.H"]
    "30" [label="coef.H" tooltip="coef.H"]
    "28" [label="global.H" tooltip="global.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserLogPot.H" fillcolor="#BFBFBF"]
    "17" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "2" [label="Particle.H" tooltip="Particle.H"]
    "43" [label="algorithm" tooltip="algorithm"]
    "46" [label="array" tooltip="array"]
    "8" [label="chrono" tooltip="chrono"]
    "33" [label="cmath" tooltip="cmath"]
    "16" [label="config_exp.h" tooltip="config_exp.h"]
    "6" [label="cstdlib" tooltip="cstdlib"]
    "42" [label="deque" tooltip="deque"]
    "35" [label="fstream" tooltip="fstream"]
    "36" [label="iomanip" tooltip="iomanip"]
    "34" [label="iostream" tooltip="iostream"]
    "9" [label="list" tooltip="list"]
    "10" [label="map" tooltip="map"]
    "11" [label="memory" tooltip="memory"]
    "21" [label="mpi.h" tooltip="mpi.h"]
    "29" [label="pthread.h" tooltip="pthread.h"]
    "27" [label="random" tooltip="random"]
    "15" [label="set" tooltip="set"]
    "25" [label="sstream" tooltip="sstream"]
    "7" [label="string" tooltip="string"]
    "32" [label="time.h" tooltip="time.h"]
    "48" [label="tuple" tooltip="tuple"]
    "22" [label="utility" tooltip="utility"]
    "24" [label="vector" tooltip="vector"]
    "12" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "37" -> "34" [dir=forward tooltip="include"]
    "37" -> "36" [dir=forward tooltip="include"]
    "37" -> "24" [dir=forward tooltip="include"]
    "37" -> "7" [dir=forward tooltip="include"]
    "37" -> "9" [dir=forward tooltip="include"]
    "37" -> "10" [dir=forward tooltip="include"]
    "37" -> "15" [dir=forward tooltip="include"]
    "37" -> "11" [dir=forward tooltip="include"]
    "37" -> "38" [dir=forward tooltip="include"]
    "37" -> "21" [dir=forward tooltip="include"]
    "51" -> "35" [dir=forward tooltip="include"]
    "51" -> "24" [dir=forward tooltip="include"]
    "51" -> "46" [dir=forward tooltip="include"]
    "51" -> "12" [dir=forward tooltip="include"]
    "52" -> "24" [dir=forward tooltip="include"]
    "23" -> "15" [dir=forward tooltip="include"]
    "23" -> "24" [dir=forward tooltip="include"]
    "23" -> "7" [dir=forward tooltip="include"]
    "23" -> "25" [dir=forward tooltip="include"]
    "23" -> "26" [dir=forward tooltip="include"]
    "45" -> "42" [dir=forward tooltip="include"]
    "45" -> "46" [dir=forward tooltip="include"]
    "45" -> "17" [dir=forward tooltip="include"]
    "45" -> "47" [dir=forward tooltip="include"]
    "47" -> "34" [dir=forward tooltip="include"]
    "47" -> "36" [dir=forward tooltip="include"]
    "47" -> "48" [dir=forward tooltip="include"]
    "40" -> "10" [dir=forward tooltip="include"]
    "40" -> "15" [dir=forward tooltip="include"]
    "40" -> "24" [dir=forward tooltip="include"]
    "38" -> "34" [dir=forward tooltip="include"]
    "38" -> "6" [dir=forward tooltip="include"]
    "38" -> "8" [dir=forward tooltip="include"]
    "14" -> "7" [dir=forward tooltip="include"]
    "14" -> "15" [dir=forward tooltip="include"]
    "14" -> "12" [dir=forward tooltip="include"]
    "44" -> "17" [dir=forward tooltip="include"]
    "49" -> "34" [dir=forward tooltip="include"]
    "49" -> "36" [dir=forward tooltip="include"]
    "49" -> "25" [dir=forward tooltip="include"]
    "49" -> "11" [dir=forward tooltip="include"]
    "49" -> "39" [dir=forward tooltip="include"]
    "26" -> "27" [dir=forward tooltip="include"]
    "26" -> "21" [dir=forward tooltip="include"]
    "39" -> "21" [dir=forward tooltip="include"]
    "39" -> "34" [dir=forward tooltip="include"]
    "39" -> "35" [dir=forward tooltip="include"]
    "39" -> "36" [dir=forward tooltip="include"]
    "39" -> "7" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "17" [dir=forward tooltip="include"]
    "4" -> "5" [dir=forward tooltip="include"]
    "4" -> "17" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "22" [dir=forward tooltip="include"]
    "20" -> "12" [dir=forward tooltip="include"]
    "20" -> "23" [dir=forward tooltip="include"]
    "20" -> "28" [dir=forward tooltip="include"]
    "20" -> "41" [dir=forward tooltip="include"]
    "20" -> "49" [dir=forward tooltip="include"]
    "20" -> "39" [dir=forward tooltip="include"]
    "20" -> "50" [dir=forward tooltip="include"]
    "20" -> "51" [dir=forward tooltip="include"]
    "20" -> "5" [dir=forward tooltip="include"]
    "20" -> "52" [dir=forward tooltip="include"]
    "20" -> "38" [dir=forward tooltip="include"]
    "20" -> "16" [dir=forward tooltip="include"]
    "19" -> "9" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "19" -> "38" [dir=forward tooltip="include"]
    "18" -> "10" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "53" [dir=forward tooltip="include"]
    "53" -> "5" [dir=forward tooltip="include"]
    "53" -> "20" [dir=forward tooltip="include"]
    "41" -> "24" [dir=forward tooltip="include"]
    "41" -> "15" [dir=forward tooltip="include"]
    "41" -> "42" [dir=forward tooltip="include"]
    "41" -> "43" [dir=forward tooltip="include"]
    "41" -> "44" [dir=forward tooltip="include"]
    "41" -> "2" [dir=forward tooltip="include"]
    "41" -> "45" [dir=forward tooltip="include"]
    "41" -> "16" [dir=forward tooltip="include"]
    "50" -> "24" [dir=forward tooltip="include"]
    "50" -> "11" [dir=forward tooltip="include"]
    "50" -> "39" [dir=forward tooltip="include"]
    "50" -> "2" [dir=forward tooltip="include"]
    "5" -> "6" [dir=forward tooltip="include"]
    "5" -> "7" [dir=forward tooltip="include"]
    "5" -> "8" [dir=forward tooltip="include"]
    "5" -> "9" [dir=forward tooltip="include"]
    "5" -> "10" [dir=forward tooltip="include"]
    "5" -> "11" [dir=forward tooltip="include"]
    "5" -> "12" [dir=forward tooltip="include"]
    "5" -> "2" [dir=forward tooltip="include"]
    "5" -> "13" [dir=forward tooltip="include"]
    "5" -> "14" [dir=forward tooltip="include"]
    "5" -> "16" [dir=forward tooltip="include"]
    "31" -> "32" [dir=forward tooltip="include"]
    "31" -> "33" [dir=forward tooltip="include"]
    "31" -> "34" [dir=forward tooltip="include"]
    "31" -> "35" [dir=forward tooltip="include"]
    "31" -> "36" [dir=forward tooltip="include"]
    "28" -> "29" [dir=forward tooltip="include"]
    "28" -> "21" [dir=forward tooltip="include"]
    "28" -> "24" [dir=forward tooltip="include"]
    "28" -> "7" [dir=forward tooltip="include"]
    "28" -> "11" [dir=forward tooltip="include"]
    "28" -> "27" [dir=forward tooltip="include"]
    "28" -> "9" [dir=forward tooltip="include"]
    "28" -> "30" [dir=forward tooltip="include"]
    "28" -> "31" [dir=forward tooltip="include"]
    "28" -> "37" [dir=forward tooltip="include"]
    "28" -> "12" [dir=forward tooltip="include"]
    "28" -> "39" [dir=forward tooltip="include"]
    "28" -> "26" [dir=forward tooltip="include"]
    "28" -> "40" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "18" [dir=forward tooltip="include"]
}
file UserMNdisk.H
#include <Particle.H>

Include dependency graph for UserMNdisk.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "37" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "51" [label="CenterFile.H" tooltip="CenterFile.H"]
    "52" [label="Circular.H" tooltip="Circular.H"]
    "23" [label="EXPException.H" tooltip="EXPException.H"]
    "45" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "47" [label="QuadLS.H" tooltip="QuadLS.H"]
    "40" [label="Species.H" tooltip="Species.H"]
    "13" [label="StringTok.H" tooltip="StringTok.H"]
    "38" [label="Timer.H" tooltip="Timer.H"]
    "14" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "44" [label="euler.H" tooltip="euler.H"]
    "49" [label="header.H" tooltip="header.H"]
    "26" [label="libvars.H" tooltip="libvars.H"]
    "39" [label="localmpi.H" tooltip="localmpi.H"]
    "3" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
    "4" [label="Basis.H" tooltip="Basis.H"]
    "20" [label="Component.H" tooltip="Component.H"]
    "19" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
    "18" [label="ExternalCollection.H" tooltip="ExternalCollection.H"]
    "53" [label="ExternalForce.H" tooltip="ExternalForce.H"]
    "41" [label="Orient.H" tooltip="Orient.H"]
    "50" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "5" [label="PotAccel.H" tooltip="PotAccel.H"]
    "31" [label="chkTimer.H" tooltip="chkTimer.H"]
    "30" [label="coef.H" tooltip="coef.H"]
    "28" [label="global.H" tooltip="global.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMNdisk.H" fillcolor="#BFBFBF"]
    "17" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "2" [label="Particle.H" tooltip="Particle.H"]
    "43" [label="algorithm" tooltip="algorithm"]
    "46" [label="array" tooltip="array"]
    "8" [label="chrono" tooltip="chrono"]
    "33" [label="cmath" tooltip="cmath"]
    "16" [label="config_exp.h" tooltip="config_exp.h"]
    "6" [label="cstdlib" tooltip="cstdlib"]
    "42" [label="deque" tooltip="deque"]
    "35" [label="fstream" tooltip="fstream"]
    "36" [label="iomanip" tooltip="iomanip"]
    "34" [label="iostream" tooltip="iostream"]
    "9" [label="list" tooltip="list"]
    "10" [label="map" tooltip="map"]
    "11" [label="memory" tooltip="memory"]
    "21" [label="mpi.h" tooltip="mpi.h"]
    "29" [label="pthread.h" tooltip="pthread.h"]
    "27" [label="random" tooltip="random"]
    "15" [label="set" tooltip="set"]
    "25" [label="sstream" tooltip="sstream"]
    "7" [label="string" tooltip="string"]
    "32" [label="time.h" tooltip="time.h"]
    "48" [label="tuple" tooltip="tuple"]
    "22" [label="utility" tooltip="utility"]
    "24" [label="vector" tooltip="vector"]
    "12" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "37" -> "34" [dir=forward tooltip="include"]
    "37" -> "36" [dir=forward tooltip="include"]
    "37" -> "24" [dir=forward tooltip="include"]
    "37" -> "7" [dir=forward tooltip="include"]
    "37" -> "9" [dir=forward tooltip="include"]
    "37" -> "10" [dir=forward tooltip="include"]
    "37" -> "15" [dir=forward tooltip="include"]
    "37" -> "11" [dir=forward tooltip="include"]
    "37" -> "38" [dir=forward tooltip="include"]
    "37" -> "21" [dir=forward tooltip="include"]
    "51" -> "35" [dir=forward tooltip="include"]
    "51" -> "24" [dir=forward tooltip="include"]
    "51" -> "46" [dir=forward tooltip="include"]
    "51" -> "12" [dir=forward tooltip="include"]
    "52" -> "24" [dir=forward tooltip="include"]
    "23" -> "15" [dir=forward tooltip="include"]
    "23" -> "24" [dir=forward tooltip="include"]
    "23" -> "7" [dir=forward tooltip="include"]
    "23" -> "25" [dir=forward tooltip="include"]
    "23" -> "26" [dir=forward tooltip="include"]
    "45" -> "42" [dir=forward tooltip="include"]
    "45" -> "46" [dir=forward tooltip="include"]
    "45" -> "17" [dir=forward tooltip="include"]
    "45" -> "47" [dir=forward tooltip="include"]
    "47" -> "34" [dir=forward tooltip="include"]
    "47" -> "36" [dir=forward tooltip="include"]
    "47" -> "48" [dir=forward tooltip="include"]
    "40" -> "10" [dir=forward tooltip="include"]
    "40" -> "15" [dir=forward tooltip="include"]
    "40" -> "24" [dir=forward tooltip="include"]
    "38" -> "34" [dir=forward tooltip="include"]
    "38" -> "6" [dir=forward tooltip="include"]
    "38" -> "8" [dir=forward tooltip="include"]
    "14" -> "7" [dir=forward tooltip="include"]
    "14" -> "15" [dir=forward tooltip="include"]
    "14" -> "12" [dir=forward tooltip="include"]
    "44" -> "17" [dir=forward tooltip="include"]
    "49" -> "34" [dir=forward tooltip="include"]
    "49" -> "36" [dir=forward tooltip="include"]
    "49" -> "25" [dir=forward tooltip="include"]
    "49" -> "11" [dir=forward tooltip="include"]
    "49" -> "39" [dir=forward tooltip="include"]
    "26" -> "27" [dir=forward tooltip="include"]
    "26" -> "21" [dir=forward tooltip="include"]
    "39" -> "21" [dir=forward tooltip="include"]
    "39" -> "34" [dir=forward tooltip="include"]
    "39" -> "35" [dir=forward tooltip="include"]
    "39" -> "36" [dir=forward tooltip="include"]
    "39" -> "7" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "17" [dir=forward tooltip="include"]
    "4" -> "5" [dir=forward tooltip="include"]
    "4" -> "17" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "22" [dir=forward tooltip="include"]
    "20" -> "12" [dir=forward tooltip="include"]
    "20" -> "23" [dir=forward tooltip="include"]
    "20" -> "28" [dir=forward tooltip="include"]
    "20" -> "41" [dir=forward tooltip="include"]
    "20" -> "49" [dir=forward tooltip="include"]
    "20" -> "39" [dir=forward tooltip="include"]
    "20" -> "50" [dir=forward tooltip="include"]
    "20" -> "51" [dir=forward tooltip="include"]
    "20" -> "5" [dir=forward tooltip="include"]
    "20" -> "52" [dir=forward tooltip="include"]
    "20" -> "38" [dir=forward tooltip="include"]
    "20" -> "16" [dir=forward tooltip="include"]
    "19" -> "9" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "19" -> "38" [dir=forward tooltip="include"]
    "18" -> "10" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "53" [dir=forward tooltip="include"]
    "53" -> "5" [dir=forward tooltip="include"]
    "53" -> "20" [dir=forward tooltip="include"]
    "41" -> "24" [dir=forward tooltip="include"]
    "41" -> "15" [dir=forward tooltip="include"]
    "41" -> "42" [dir=forward tooltip="include"]
    "41" -> "43" [dir=forward tooltip="include"]
    "41" -> "44" [dir=forward tooltip="include"]
    "41" -> "2" [dir=forward tooltip="include"]
    "41" -> "45" [dir=forward tooltip="include"]
    "41" -> "16" [dir=forward tooltip="include"]
    "50" -> "24" [dir=forward tooltip="include"]
    "50" -> "11" [dir=forward tooltip="include"]
    "50" -> "39" [dir=forward tooltip="include"]
    "50" -> "2" [dir=forward tooltip="include"]
    "5" -> "6" [dir=forward tooltip="include"]
    "5" -> "7" [dir=forward tooltip="include"]
    "5" -> "8" [dir=forward tooltip="include"]
    "5" -> "9" [dir=forward tooltip="include"]
    "5" -> "10" [dir=forward tooltip="include"]
    "5" -> "11" [dir=forward tooltip="include"]
    "5" -> "12" [dir=forward tooltip="include"]
    "5" -> "2" [dir=forward tooltip="include"]
    "5" -> "13" [dir=forward tooltip="include"]
    "5" -> "14" [dir=forward tooltip="include"]
    "5" -> "16" [dir=forward tooltip="include"]
    "31" -> "32" [dir=forward tooltip="include"]
    "31" -> "33" [dir=forward tooltip="include"]
    "31" -> "34" [dir=forward tooltip="include"]
    "31" -> "35" [dir=forward tooltip="include"]
    "31" -> "36" [dir=forward tooltip="include"]
    "28" -> "29" [dir=forward tooltip="include"]
    "28" -> "21" [dir=forward tooltip="include"]
    "28" -> "24" [dir=forward tooltip="include"]
    "28" -> "7" [dir=forward tooltip="include"]
    "28" -> "11" [dir=forward tooltip="include"]
    "28" -> "27" [dir=forward tooltip="include"]
    "28" -> "9" [dir=forward tooltip="include"]
    "28" -> "30" [dir=forward tooltip="include"]
    "28" -> "31" [dir=forward tooltip="include"]
    "28" -> "37" [dir=forward tooltip="include"]
    "28" -> "12" [dir=forward tooltip="include"]
    "28" -> "39" [dir=forward tooltip="include"]
    "28" -> "26" [dir=forward tooltip="include"]
    "28" -> "40" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "18" [dir=forward tooltip="include"]
}
file UserMW.H
#include <Particle.H>

Include dependency graph for UserMW.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "37" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "51" [label="CenterFile.H" tooltip="CenterFile.H"]
    "52" [label="Circular.H" tooltip="Circular.H"]
    "23" [label="EXPException.H" tooltip="EXPException.H"]
    "45" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "47" [label="QuadLS.H" tooltip="QuadLS.H"]
    "40" [label="Species.H" tooltip="Species.H"]
    "13" [label="StringTok.H" tooltip="StringTok.H"]
    "38" [label="Timer.H" tooltip="Timer.H"]
    "14" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "44" [label="euler.H" tooltip="euler.H"]
    "49" [label="header.H" tooltip="header.H"]
    "26" [label="libvars.H" tooltip="libvars.H"]
    "39" [label="localmpi.H" tooltip="localmpi.H"]
    "3" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
    "4" [label="Basis.H" tooltip="Basis.H"]
    "20" [label="Component.H" tooltip="Component.H"]
    "19" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
    "18" [label="ExternalCollection.H" tooltip="ExternalCollection.H"]
    "53" [label="ExternalForce.H" tooltip="ExternalForce.H"]
    "41" [label="Orient.H" tooltip="Orient.H"]
    "50" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "5" [label="PotAccel.H" tooltip="PotAccel.H"]
    "31" [label="chkTimer.H" tooltip="chkTimer.H"]
    "30" [label="coef.H" tooltip="coef.H"]
    "28" [label="global.H" tooltip="global.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserMW.H" fillcolor="#BFBFBF"]
    "17" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "2" [label="Particle.H" tooltip="Particle.H"]
    "43" [label="algorithm" tooltip="algorithm"]
    "46" [label="array" tooltip="array"]
    "8" [label="chrono" tooltip="chrono"]
    "33" [label="cmath" tooltip="cmath"]
    "16" [label="config_exp.h" tooltip="config_exp.h"]
    "6" [label="cstdlib" tooltip="cstdlib"]
    "42" [label="deque" tooltip="deque"]
    "35" [label="fstream" tooltip="fstream"]
    "36" [label="iomanip" tooltip="iomanip"]
    "34" [label="iostream" tooltip="iostream"]
    "9" [label="list" tooltip="list"]
    "10" [label="map" tooltip="map"]
    "11" [label="memory" tooltip="memory"]
    "21" [label="mpi.h" tooltip="mpi.h"]
    "29" [label="pthread.h" tooltip="pthread.h"]
    "27" [label="random" tooltip="random"]
    "15" [label="set" tooltip="set"]
    "25" [label="sstream" tooltip="sstream"]
    "7" [label="string" tooltip="string"]
    "32" [label="time.h" tooltip="time.h"]
    "48" [label="tuple" tooltip="tuple"]
    "22" [label="utility" tooltip="utility"]
    "24" [label="vector" tooltip="vector"]
    "12" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "37" -> "34" [dir=forward tooltip="include"]
    "37" -> "36" [dir=forward tooltip="include"]
    "37" -> "24" [dir=forward tooltip="include"]
    "37" -> "7" [dir=forward tooltip="include"]
    "37" -> "9" [dir=forward tooltip="include"]
    "37" -> "10" [dir=forward tooltip="include"]
    "37" -> "15" [dir=forward tooltip="include"]
    "37" -> "11" [dir=forward tooltip="include"]
    "37" -> "38" [dir=forward tooltip="include"]
    "37" -> "21" [dir=forward tooltip="include"]
    "51" -> "35" [dir=forward tooltip="include"]
    "51" -> "24" [dir=forward tooltip="include"]
    "51" -> "46" [dir=forward tooltip="include"]
    "51" -> "12" [dir=forward tooltip="include"]
    "52" -> "24" [dir=forward tooltip="include"]
    "23" -> "15" [dir=forward tooltip="include"]
    "23" -> "24" [dir=forward tooltip="include"]
    "23" -> "7" [dir=forward tooltip="include"]
    "23" -> "25" [dir=forward tooltip="include"]
    "23" -> "26" [dir=forward tooltip="include"]
    "45" -> "42" [dir=forward tooltip="include"]
    "45" -> "46" [dir=forward tooltip="include"]
    "45" -> "17" [dir=forward tooltip="include"]
    "45" -> "47" [dir=forward tooltip="include"]
    "47" -> "34" [dir=forward tooltip="include"]
    "47" -> "36" [dir=forward tooltip="include"]
    "47" -> "48" [dir=forward tooltip="include"]
    "40" -> "10" [dir=forward tooltip="include"]
    "40" -> "15" [dir=forward tooltip="include"]
    "40" -> "24" [dir=forward tooltip="include"]
    "38" -> "34" [dir=forward tooltip="include"]
    "38" -> "6" [dir=forward tooltip="include"]
    "38" -> "8" [dir=forward tooltip="include"]
    "14" -> "7" [dir=forward tooltip="include"]
    "14" -> "15" [dir=forward tooltip="include"]
    "14" -> "12" [dir=forward tooltip="include"]
    "44" -> "17" [dir=forward tooltip="include"]
    "49" -> "34" [dir=forward tooltip="include"]
    "49" -> "36" [dir=forward tooltip="include"]
    "49" -> "25" [dir=forward tooltip="include"]
    "49" -> "11" [dir=forward tooltip="include"]
    "49" -> "39" [dir=forward tooltip="include"]
    "26" -> "27" [dir=forward tooltip="include"]
    "26" -> "21" [dir=forward tooltip="include"]
    "39" -> "21" [dir=forward tooltip="include"]
    "39" -> "34" [dir=forward tooltip="include"]
    "39" -> "35" [dir=forward tooltip="include"]
    "39" -> "36" [dir=forward tooltip="include"]
    "39" -> "7" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "17" [dir=forward tooltip="include"]
    "4" -> "5" [dir=forward tooltip="include"]
    "4" -> "17" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "22" [dir=forward tooltip="include"]
    "20" -> "12" [dir=forward tooltip="include"]
    "20" -> "23" [dir=forward tooltip="include"]
    "20" -> "28" [dir=forward tooltip="include"]
    "20" -> "41" [dir=forward tooltip="include"]
    "20" -> "49" [dir=forward tooltip="include"]
    "20" -> "39" [dir=forward tooltip="include"]
    "20" -> "50" [dir=forward tooltip="include"]
    "20" -> "51" [dir=forward tooltip="include"]
    "20" -> "5" [dir=forward tooltip="include"]
    "20" -> "52" [dir=forward tooltip="include"]
    "20" -> "38" [dir=forward tooltip="include"]
    "20" -> "16" [dir=forward tooltip="include"]
    "19" -> "9" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "19" -> "38" [dir=forward tooltip="include"]
    "18" -> "10" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "53" [dir=forward tooltip="include"]
    "53" -> "5" [dir=forward tooltip="include"]
    "53" -> "20" [dir=forward tooltip="include"]
    "41" -> "24" [dir=forward tooltip="include"]
    "41" -> "15" [dir=forward tooltip="include"]
    "41" -> "42" [dir=forward tooltip="include"]
    "41" -> "43" [dir=forward tooltip="include"]
    "41" -> "44" [dir=forward tooltip="include"]
    "41" -> "2" [dir=forward tooltip="include"]
    "41" -> "45" [dir=forward tooltip="include"]
    "41" -> "16" [dir=forward tooltip="include"]
    "50" -> "24" [dir=forward tooltip="include"]
    "50" -> "11" [dir=forward tooltip="include"]
    "50" -> "39" [dir=forward tooltip="include"]
    "50" -> "2" [dir=forward tooltip="include"]
    "5" -> "6" [dir=forward tooltip="include"]
    "5" -> "7" [dir=forward tooltip="include"]
    "5" -> "8" [dir=forward tooltip="include"]
    "5" -> "9" [dir=forward tooltip="include"]
    "5" -> "10" [dir=forward tooltip="include"]
    "5" -> "11" [dir=forward tooltip="include"]
    "5" -> "12" [dir=forward tooltip="include"]
    "5" -> "2" [dir=forward tooltip="include"]
    "5" -> "13" [dir=forward tooltip="include"]
    "5" -> "14" [dir=forward tooltip="include"]
    "5" -> "16" [dir=forward tooltip="include"]
    "31" -> "32" [dir=forward tooltip="include"]
    "31" -> "33" [dir=forward tooltip="include"]
    "31" -> "34" [dir=forward tooltip="include"]
    "31" -> "35" [dir=forward tooltip="include"]
    "31" -> "36" [dir=forward tooltip="include"]
    "28" -> "29" [dir=forward tooltip="include"]
    "28" -> "21" [dir=forward tooltip="include"]
    "28" -> "24" [dir=forward tooltip="include"]
    "28" -> "7" [dir=forward tooltip="include"]
    "28" -> "11" [dir=forward tooltip="include"]
    "28" -> "27" [dir=forward tooltip="include"]
    "28" -> "9" [dir=forward tooltip="include"]
    "28" -> "30" [dir=forward tooltip="include"]
    "28" -> "31" [dir=forward tooltip="include"]
    "28" -> "37" [dir=forward tooltip="include"]
    "28" -> "12" [dir=forward tooltip="include"]
    "28" -> "39" [dir=forward tooltip="include"]
    "28" -> "26" [dir=forward tooltip="include"]
    "28" -> "40" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "18" [dir=forward tooltip="include"]
}
file UserTest.H

Include dependency graph for UserTest.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "27" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "46" [label="CenterFile.H" tooltip="CenterFile.H"]
    "50" [label="Circular.H" tooltip="Circular.H"]
    "10" [label="EXPException.H" tooltip="EXPException.H"]
    "39" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "41" [label="QuadLS.H" tooltip="QuadLS.H"]
    "32" [label="Species.H" tooltip="Species.H"]
    "48" [label="StringTok.H" tooltip="StringTok.H"]
    "28" [label="Timer.H" tooltip="Timer.H"]
    "49" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "36" [label="euler.H" tooltip="euler.H"]
    "44" [label="header.H" tooltip="header.H"]
    "15" [label="libvars.H" tooltip="libvars.H"]
    "31" [label="localmpi.H" tooltip="localmpi.H"]
    "6" [label="Component.H" tooltip="Component.H"]
    "4" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
    "2" [label="ExternalCollection.H" tooltip="ExternalCollection.H"]
    "51" [label="ExternalForce.H" tooltip="ExternalForce.H"]
    "33" [label="Orient.H" tooltip="Orient.H"]
    "45" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "47" [label="PotAccel.H" tooltip="PotAccel.H"]
    "21" [label="chkTimer.H" tooltip="chkTimer.H"]
    "20" [label="coef.H" tooltip="coef.H"]
    "17" [label="global.H" tooltip="global.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTest.H" fillcolor="#BFBFBF"]
    "37" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "38" [label="Particle.H" tooltip="Particle.H"]
    "35" [label="algorithm" tooltip="algorithm"]
    "40" [label="array" tooltip="array"]
    "30" [label="chrono" tooltip="chrono"]
    "23" [label="cmath" tooltip="cmath"]
    "43" [label="config_exp.h" tooltip="config_exp.h"]
    "29" [label="cstdlib" tooltip="cstdlib"]
    "34" [label="deque" tooltip="deque"]
    "25" [label="fstream" tooltip="fstream"]
    "26" [label="iomanip" tooltip="iomanip"]
    "24" [label="iostream" tooltip="iostream"]
    "5" [label="list" tooltip="list"]
    "3" [label="map" tooltip="map"]
    "19" [label="memory" tooltip="memory"]
    "7" [label="mpi.h" tooltip="mpi.h"]
    "18" [label="pthread.h" tooltip="pthread.h"]
    "16" [label="random" tooltip="random"]
    "11" [label="set" tooltip="set"]
    "14" [label="sstream" tooltip="sstream"]
    "13" [label="string" tooltip="string"]
    "22" [label="time.h" tooltip="time.h"]
    "42" [label="tuple" tooltip="tuple"]
    "8" [label="utility" tooltip="utility"]
    "12" [label="vector" tooltip="vector"]
    "9" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "27" -> "24" [dir=forward tooltip="include"]
    "27" -> "26" [dir=forward tooltip="include"]
    "27" -> "12" [dir=forward tooltip="include"]
    "27" -> "13" [dir=forward tooltip="include"]
    "27" -> "5" [dir=forward tooltip="include"]
    "27" -> "3" [dir=forward tooltip="include"]
    "27" -> "11" [dir=forward tooltip="include"]
    "27" -> "19" [dir=forward tooltip="include"]
    "27" -> "28" [dir=forward tooltip="include"]
    "27" -> "7" [dir=forward tooltip="include"]
    "46" -> "25" [dir=forward tooltip="include"]
    "46" -> "12" [dir=forward tooltip="include"]
    "46" -> "40" [dir=forward tooltip="include"]
    "46" -> "9" [dir=forward tooltip="include"]
    "50" -> "12" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "12" [dir=forward tooltip="include"]
    "10" -> "13" [dir=forward tooltip="include"]
    "10" -> "14" [dir=forward tooltip="include"]
    "10" -> "15" [dir=forward tooltip="include"]
    "39" -> "34" [dir=forward tooltip="include"]
    "39" -> "40" [dir=forward tooltip="include"]
    "39" -> "37" [dir=forward tooltip="include"]
    "39" -> "41" [dir=forward tooltip="include"]
    "41" -> "24" [dir=forward tooltip="include"]
    "41" -> "26" [dir=forward tooltip="include"]
    "41" -> "42" [dir=forward tooltip="include"]
    "32" -> "3" [dir=forward tooltip="include"]
    "32" -> "11" [dir=forward tooltip="include"]
    "32" -> "12" [dir=forward tooltip="include"]
    "28" -> "24" [dir=forward tooltip="include"]
    "28" -> "29" [dir=forward tooltip="include"]
    "28" -> "30" [dir=forward tooltip="include"]
    "49" -> "13" [dir=forward tooltip="include"]
    "49" -> "11" [dir=forward tooltip="include"]
    "49" -> "9" [dir=forward tooltip="include"]
    "36" -> "37" [dir=forward tooltip="include"]
    "44" -> "24" [dir=forward tooltip="include"]
    "44" -> "26" [dir=forward tooltip="include"]
    "44" -> "14" [dir=forward tooltip="include"]
    "44" -> "19" [dir=forward tooltip="include"]
    "44" -> "31" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "7" [dir=forward tooltip="include"]
    "31" -> "7" [dir=forward tooltip="include"]
    "31" -> "24" [dir=forward tooltip="include"]
    "31" -> "25" [dir=forward tooltip="include"]
    "31" -> "26" [dir=forward tooltip="include"]
    "31" -> "13" [dir=forward tooltip="include"]
    "6" -> "7" [dir=forward tooltip="include"]
    "6" -> "8" [dir=forward tooltip="include"]
    "6" -> "9" [dir=forward tooltip="include"]
    "6" -> "10" [dir=forward tooltip="include"]
    "6" -> "17" [dir=forward tooltip="include"]
    "6" -> "33" [dir=forward tooltip="include"]
    "6" -> "44" [dir=forward tooltip="include"]
    "6" -> "31" [dir=forward tooltip="include"]
    "6" -> "45" [dir=forward tooltip="include"]
    "6" -> "46" [dir=forward tooltip="include"]
    "6" -> "47" [dir=forward tooltip="include"]
    "6" -> "50" [dir=forward tooltip="include"]
    "6" -> "28" [dir=forward tooltip="include"]
    "6" -> "43" [dir=forward tooltip="include"]
    "4" -> "5" [dir=forward tooltip="include"]
    "4" -> "6" [dir=forward tooltip="include"]
    "4" -> "28" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "51" [dir=forward tooltip="include"]
    "51" -> "47" [dir=forward tooltip="include"]
    "51" -> "6" [dir=forward tooltip="include"]
    "33" -> "12" [dir=forward tooltip="include"]
    "33" -> "11" [dir=forward tooltip="include"]
    "33" -> "34" [dir=forward tooltip="include"]
    "33" -> "35" [dir=forward tooltip="include"]
    "33" -> "36" [dir=forward tooltip="include"]
    "33" -> "38" [dir=forward tooltip="include"]
    "33" -> "39" [dir=forward tooltip="include"]
    "33" -> "43" [dir=forward tooltip="include"]
    "45" -> "12" [dir=forward tooltip="include"]
    "45" -> "19" [dir=forward tooltip="include"]
    "45" -> "31" [dir=forward tooltip="include"]
    "45" -> "38" [dir=forward tooltip="include"]
    "47" -> "29" [dir=forward tooltip="include"]
    "47" -> "13" [dir=forward tooltip="include"]
    "47" -> "30" [dir=forward tooltip="include"]
    "47" -> "5" [dir=forward tooltip="include"]
    "47" -> "3" [dir=forward tooltip="include"]
    "47" -> "19" [dir=forward tooltip="include"]
    "47" -> "9" [dir=forward tooltip="include"]
    "47" -> "38" [dir=forward tooltip="include"]
    "47" -> "48" [dir=forward tooltip="include"]
    "47" -> "49" [dir=forward tooltip="include"]
    "47" -> "43" [dir=forward tooltip="include"]
    "21" -> "22" [dir=forward tooltip="include"]
    "21" -> "23" [dir=forward tooltip="include"]
    "21" -> "24" [dir=forward tooltip="include"]
    "21" -> "25" [dir=forward tooltip="include"]
    "21" -> "26" [dir=forward tooltip="include"]
    "17" -> "18" [dir=forward tooltip="include"]
    "17" -> "7" [dir=forward tooltip="include"]
    "17" -> "12" [dir=forward tooltip="include"]
    "17" -> "13" [dir=forward tooltip="include"]
    "17" -> "19" [dir=forward tooltip="include"]
    "17" -> "16" [dir=forward tooltip="include"]
    "17" -> "5" [dir=forward tooltip="include"]
    "17" -> "20" [dir=forward tooltip="include"]
    "17" -> "21" [dir=forward tooltip="include"]
    "17" -> "27" [dir=forward tooltip="include"]
    "17" -> "9" [dir=forward tooltip="include"]
    "17" -> "31" [dir=forward tooltip="include"]
    "17" -> "15" [dir=forward tooltip="include"]
    "17" -> "32" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
}
file UserTestCuda.H
#include <ExternalForce.H>

Include dependency graph for UserTestCuda.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "33" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
    "48" [label="CenterFile.H" tooltip="CenterFile.H"]
    "49" [label="Circular.H" tooltip="Circular.H"]
    "19" [label="EXPException.H" tooltip="EXPException.H"]
    "42" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
    "44" [label="QuadLS.H" tooltip="QuadLS.H"]
    "36" [label="Species.H" tooltip="Species.H"]
    "12" [label="StringTok.H" tooltip="StringTok.H"]
    "34" [label="Timer.H" tooltip="Timer.H"]
    "13" [label="YamlCheck.H" tooltip="YamlCheck.H"]
    "40" [label="euler.H" tooltip="euler.H"]
    "46" [label="header.H" tooltip="header.H"]
    "22" [label="libvars.H" tooltip="libvars.H"]
    "35" [label="localmpi.H" tooltip="localmpi.H"]
    "16" [label="Component.H" tooltip="Component.H"]
    "2" [label="ExternalForce.H" tooltip="ExternalForce.H"]
    "37" [label="Orient.H" tooltip="Orient.H"]
    "47" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
    "3" [label="PotAccel.H" tooltip="PotAccel.H"]
    "27" [label="chkTimer.H" tooltip="chkTimer.H"]
    "26" [label="coef.H" tooltip="coef.H"]
    "24" [label="global.H" tooltip="global.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user/UserTestCuda.H" fillcolor="#BFBFBF"]
    "41" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "11" [label="Particle.H" tooltip="Particle.H"]
    "39" [label="algorithm" tooltip="algorithm"]
    "43" [label="array" tooltip="array"]
    "6" [label="chrono" tooltip="chrono"]
    "29" [label="cmath" tooltip="cmath"]
    "15" [label="config_exp.h" tooltip="config_exp.h"]
    "4" [label="cstdlib" tooltip="cstdlib"]
    "38" [label="deque" tooltip="deque"]
    "31" [label="fstream" tooltip="fstream"]
    "32" [label="iomanip" tooltip="iomanip"]
    "30" [label="iostream" tooltip="iostream"]
    "7" [label="list" tooltip="list"]
    "8" [label="map" tooltip="map"]
    "9" [label="memory" tooltip="memory"]
    "17" [label="mpi.h" tooltip="mpi.h"]
    "25" [label="pthread.h" tooltip="pthread.h"]
    "23" [label="random" tooltip="random"]
    "14" [label="set" tooltip="set"]
    "21" [label="sstream" tooltip="sstream"]
    "5" [label="string" tooltip="string"]
    "28" [label="time.h" tooltip="time.h"]
    "45" [label="tuple" tooltip="tuple"]
    "18" [label="utility" tooltip="utility"]
    "20" [label="vector" tooltip="vector"]
    "10" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "33" -> "30" [dir=forward tooltip="include"]
    "33" -> "32" [dir=forward tooltip="include"]
    "33" -> "20" [dir=forward tooltip="include"]
    "33" -> "5" [dir=forward tooltip="include"]
    "33" -> "7" [dir=forward tooltip="include"]
    "33" -> "8" [dir=forward tooltip="include"]
    "33" -> "14" [dir=forward tooltip="include"]
    "33" -> "9" [dir=forward tooltip="include"]
    "33" -> "34" [dir=forward tooltip="include"]
    "33" -> "17" [dir=forward tooltip="include"]
    "48" -> "31" [dir=forward tooltip="include"]
    "48" -> "20" [dir=forward tooltip="include"]
    "48" -> "43" [dir=forward tooltip="include"]
    "48" -> "10" [dir=forward tooltip="include"]
    "49" -> "20" [dir=forward tooltip="include"]
    "19" -> "14" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "19" -> "5" [dir=forward tooltip="include"]
    "19" -> "21" [dir=forward tooltip="include"]
    "19" -> "22" [dir=forward tooltip="include"]
    "42" -> "38" [dir=forward tooltip="include"]
    "42" -> "43" [dir=forward tooltip="include"]
    "42" -> "41" [dir=forward tooltip="include"]
    "42" -> "44" [dir=forward tooltip="include"]
    "44" -> "30" [dir=forward tooltip="include"]
    "44" -> "32" [dir=forward tooltip="include"]
    "44" -> "45" [dir=forward tooltip="include"]
    "36" -> "8" [dir=forward tooltip="include"]
    "36" -> "14" [dir=forward tooltip="include"]
    "36" -> "20" [dir=forward tooltip="include"]
    "34" -> "30" [dir=forward tooltip="include"]
    "34" -> "4" [dir=forward tooltip="include"]
    "34" -> "6" [dir=forward tooltip="include"]
    "13" -> "5" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "10" [dir=forward tooltip="include"]
    "40" -> "41" [dir=forward tooltip="include"]
    "46" -> "30" [dir=forward tooltip="include"]
    "46" -> "32" [dir=forward tooltip="include"]
    "46" -> "21" [dir=forward tooltip="include"]
    "46" -> "9" [dir=forward tooltip="include"]
    "46" -> "35" [dir=forward tooltip="include"]
    "22" -> "23" [dir=forward tooltip="include"]
    "22" -> "17" [dir=forward tooltip="include"]
    "35" -> "17" [dir=forward tooltip="include"]
    "35" -> "30" [dir=forward tooltip="include"]
    "35" -> "31" [dir=forward tooltip="include"]
    "35" -> "32" [dir=forward tooltip="include"]
    "35" -> "5" [dir=forward tooltip="include"]
    "16" -> "17" [dir=forward tooltip="include"]
    "16" -> "18" [dir=forward tooltip="include"]
    "16" -> "10" [dir=forward tooltip="include"]
    "16" -> "19" [dir=forward tooltip="include"]
    "16" -> "24" [dir=forward tooltip="include"]
    "16" -> "37" [dir=forward tooltip="include"]
    "16" -> "46" [dir=forward tooltip="include"]
    "16" -> "35" [dir=forward tooltip="include"]
    "16" -> "47" [dir=forward tooltip="include"]
    "16" -> "48" [dir=forward tooltip="include"]
    "16" -> "3" [dir=forward tooltip="include"]
    "16" -> "49" [dir=forward tooltip="include"]
    "16" -> "34" [dir=forward tooltip="include"]
    "16" -> "15" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "16" [dir=forward tooltip="include"]
    "37" -> "20" [dir=forward tooltip="include"]
    "37" -> "14" [dir=forward tooltip="include"]
    "37" -> "38" [dir=forward tooltip="include"]
    "37" -> "39" [dir=forward tooltip="include"]
    "37" -> "40" [dir=forward tooltip="include"]
    "37" -> "11" [dir=forward tooltip="include"]
    "37" -> "42" [dir=forward tooltip="include"]
    "37" -> "15" [dir=forward tooltip="include"]
    "47" -> "20" [dir=forward tooltip="include"]
    "47" -> "9" [dir=forward tooltip="include"]
    "47" -> "35" [dir=forward tooltip="include"]
    "47" -> "11" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "5" [dir=forward tooltip="include"]
    "3" -> "6" [dir=forward tooltip="include"]
    "3" -> "7" [dir=forward tooltip="include"]
    "3" -> "8" [dir=forward tooltip="include"]
    "3" -> "9" [dir=forward tooltip="include"]
    "3" -> "10" [dir=forward tooltip="include"]
    "3" -> "11" [dir=forward tooltip="include"]
    "3" -> "12" [dir=forward tooltip="include"]
    "3" -> "13" [dir=forward tooltip="include"]
    "3" -> "15" [dir=forward tooltip="include"]
    "27" -> "28" [dir=forward tooltip="include"]
    "27" -> "29" [dir=forward tooltip="include"]
    "27" -> "30" [dir=forward tooltip="include"]
    "27" -> "31" [dir=forward tooltip="include"]
    "27" -> "32" [dir=forward tooltip="include"]
    "24" -> "25" [dir=forward tooltip="include"]
    "24" -> "17" [dir=forward tooltip="include"]
    "24" -> "20" [dir=forward tooltip="include"]
    "24" -> "5" [dir=forward tooltip="include"]
    "24" -> "9" [dir=forward tooltip="include"]
    "24" -> "23" [dir=forward tooltip="include"]
    "24" -> "7" [dir=forward tooltip="include"]
    "24" -> "26" [dir=forward tooltip="include"]
    "24" -> "27" [dir=forward tooltip="include"]
    "24" -> "33" [dir=forward tooltip="include"]
    "24" -> "10" [dir=forward tooltip="include"]
    "24" -> "35" [dir=forward tooltip="include"]
    "24" -> "22" [dir=forward tooltip="include"]
    "24" -> "36" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
}
file version.h

Variables

static char version_id[] = "[$Id$]"
file foarray.H
#include <vector>
#include <string>
#include <algorithm>

Include dependency graph for foarray.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/foarray.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/foarray.H" fillcolor="#BFBFBF"]
    "4" [label="algorithm" tooltip="algorithm"]
    "3" [label="string" tooltip="string"]
    "2" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
}
file largest.H
#include <queue>

Include dependency graph for largest.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/largest.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/largest.H" fillcolor="#BFBFBF"]
    "2" [label="queue" tooltip="queue"]
    "1" -> "2" [dir=forward tooltip="include"]
}
file PSP2.H
#include <stdexcept>
#include <algorithm>
#include <iostream>
#include <fstream>
#include <iomanip>
#include <vector>
#include <memory>
#include <string>
#include <cmath>
#include <list>
#include <StringTok.H>
#include <header.H>

Include dependency graph for PSP2.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "12" [label="StringTok.H" tooltip="StringTok.H"]
    "13" [label="header.H" tooltip="header.H"]
    "15" [label="localmpi.H" tooltip="localmpi.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/PSP2.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/PSP2.H" fillcolor="#BFBFBF"]
    "3" [label="algorithm" tooltip="algorithm"]
    "10" [label="cmath" tooltip="cmath"]
    "5" [label="fstream" tooltip="fstream"]
    "6" [label="iomanip" tooltip="iomanip"]
    "4" [label="iostream" tooltip="iostream"]
    "11" [label="list" tooltip="list"]
    "8" [label="memory" tooltip="memory"]
    "16" [label="mpi.h" tooltip="mpi.h"]
    "14" [label="sstream" tooltip="sstream"]
    "2" [label="stdexcept" tooltip="stdexcept"]
    "9" [label="string" tooltip="string"]
    "7" [label="vector" tooltip="vector"]
    "13" -> "4" [dir=forward tooltip="include"]
    "13" -> "6" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "8" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "4" [dir=forward tooltip="include"]
    "15" -> "5" [dir=forward tooltip="include"]
    "15" -> "6" [dir=forward tooltip="include"]
    "15" -> "9" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "1" -> "10" [dir=forward tooltip="include"]
    "1" -> "11" [dir=forward tooltip="include"]
    "1" -> "12" [dir=forward tooltip="include"]
    "1" -> "13" [dir=forward tooltip="include"]
}

Typedefs

typedef std::shared_ptr<PSP> PSPptr

Functions

std::string trimLeft(const string)
std::string trimRight(const string)
file psp_io.py
file SphSL.H
#include <string>
#include <SLGridMP2.H>
#include <localmpi.H>
#include <Eigen/Eigen>

Include dependency graph for SphSL.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "27" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "19" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "26" [label="QPDistF.H" tooltip="QPDistF.H"]
    "3" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
    "23" [label="gaussQ.H" tooltip="gaussQ.H"]
    "17" [label="interp.H" tooltip="interp.H"]
    "30" [label="libvars.H" tooltip="libvars.H"]
    "8" [label="localmpi.H" tooltip="localmpi.H"]
    "11" [label="massmodel.H" tooltip="massmodel.H"]
    "21" [label="orbit.H" tooltip="orbit.H"]
    "28" [label="sltableMP2.H" tooltip="sltableMP2.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H" fillcolor="#BFBFBF"]
    "16" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "10" [label="config_exp.h" tooltip="config_exp.h"]
    "25" [label="cstdlib" tooltip="cstdlib"]
    "18" [label="deque" tooltip="deque"]
    "6" [label="fstream" tooltip="fstream"]
    "22" [label="functional" tooltip="functional"]
    "9" [label="iomanip" tooltip="iomanip"]
    "5" [label="iostream" tooltip="iostream"]
    "20" [label="map" tooltip="map"]
    "4" [label="math.h" tooltip="math.h"]
    "13" [label="memory" tooltip="memory"]
    "7" [label="mpi.h" tooltip="mpi.h"]
    "14" [label="random" tooltip="random"]
    "24" [label="sstream" tooltip="sstream"]
    "2" [label="string" tooltip="string"]
    "15" [label="tuple" tooltip="tuple"]
    "12" [label="vector" tooltip="vector"]
    "29" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "27" -> "11" [dir=forward tooltip="include"]
    "19" -> "12" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "19" -> "2" [dir=forward tooltip="include"]
    "26" -> "9" [dir=forward tooltip="include"]
    "26" -> "2" [dir=forward tooltip="include"]
    "26" -> "20" [dir=forward tooltip="include"]
    "26" -> "11" [dir=forward tooltip="include"]
    "26" -> "27" [dir=forward tooltip="include"]
    "26" -> "21" [dir=forward tooltip="include"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "5" [dir=forward tooltip="include"]
    "3" -> "6" [dir=forward tooltip="include"]
    "3" -> "2" [dir=forward tooltip="include"]
    "3" -> "7" [dir=forward tooltip="include"]
    "3" -> "8" [dir=forward tooltip="include"]
    "3" -> "10" [dir=forward tooltip="include"]
    "3" -> "11" [dir=forward tooltip="include"]
    "3" -> "28" [dir=forward tooltip="include"]
    "3" -> "29" [dir=forward tooltip="include"]
    "3" -> "30" [dir=forward tooltip="include"]
    "23" -> "5" [dir=forward tooltip="include"]
    "23" -> "9" [dir=forward tooltip="include"]
    "23" -> "24" [dir=forward tooltip="include"]
    "23" -> "25" [dir=forward tooltip="include"]
    "23" -> "2" [dir=forward tooltip="include"]
    "23" -> "12" [dir=forward tooltip="include"]
    "17" -> "16" [dir=forward tooltip="include"]
    "17" -> "12" [dir=forward tooltip="include"]
    "17" -> "18" [dir=forward tooltip="include"]
    "17" -> "19" [dir=forward tooltip="include"]
    "30" -> "14" [dir=forward tooltip="include"]
    "30" -> "7" [dir=forward tooltip="include"]
    "8" -> "7" [dir=forward tooltip="include"]
    "8" -> "5" [dir=forward tooltip="include"]
    "8" -> "6" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "2" [dir=forward tooltip="include"]
    "11" -> "12" [dir=forward tooltip="include"]
    "11" -> "13" [dir=forward tooltip="include"]
    "11" -> "14" [dir=forward tooltip="include"]
    "11" -> "15" [dir=forward tooltip="include"]
    "11" -> "16" [dir=forward tooltip="include"]
    "11" -> "17" [dir=forward tooltip="include"]
    "11" -> "21" [dir=forward tooltip="include"]
    "11" -> "26" [dir=forward tooltip="include"]
    "21" -> "22" [dir=forward tooltip="include"]
    "21" -> "13" [dir=forward tooltip="include"]
    "21" -> "16" [dir=forward tooltip="include"]
    "21" -> "23" [dir=forward tooltip="include"]
    "28" -> "16" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "16" [dir=forward tooltip="include"]
}
file AddDisk.H
#include <vector>
#include <memory>
#include <massmodel.H>

Include dependency graph for AddDisk.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "21" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "10" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "20" [label="QPDistF.H" tooltip="QPDistF.H"]
    "15" [label="gaussQ.H" tooltip="gaussQ.H"]
    "8" [label="interp.H" tooltip="interp.H"]
    "4" [label="massmodel.H" tooltip="massmodel.H"]
    "13" [label="orbit.H" tooltip="orbit.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddDisk.H" fillcolor="#BFBFBF"]
    "7" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "19" [label="cstdlib" tooltip="cstdlib"]
    "9" [label="deque" tooltip="deque"]
    "14" [label="functional" tooltip="functional"]
    "17" [label="iomanip" tooltip="iomanip"]
    "16" [label="iostream" tooltip="iostream"]
    "11" [label="map" tooltip="map"]
    "3" [label="memory" tooltip="memory"]
    "5" [label="random" tooltip="random"]
    "18" [label="sstream" tooltip="sstream"]
    "12" [label="string" tooltip="string"]
    "6" [label="tuple" tooltip="tuple"]
    "2" [label="vector" tooltip="vector"]
    "21" -> "4" [dir=forward tooltip="include"]
    "10" -> "2" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "12" [dir=forward tooltip="include"]
    "20" -> "17" [dir=forward tooltip="include"]
    "20" -> "12" [dir=forward tooltip="include"]
    "20" -> "11" [dir=forward tooltip="include"]
    "20" -> "4" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "13" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "17" [dir=forward tooltip="include"]
    "15" -> "18" [dir=forward tooltip="include"]
    "15" -> "19" [dir=forward tooltip="include"]
    "15" -> "12" [dir=forward tooltip="include"]
    "15" -> "2" [dir=forward tooltip="include"]
    "8" -> "7" [dir=forward tooltip="include"]
    "8" -> "2" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "10" [dir=forward tooltip="include"]
    "4" -> "2" [dir=forward tooltip="include"]
    "4" -> "3" [dir=forward tooltip="include"]
    "4" -> "5" [dir=forward tooltip="include"]
    "4" -> "6" [dir=forward tooltip="include"]
    "4" -> "7" [dir=forward tooltip="include"]
    "4" -> "8" [dir=forward tooltip="include"]
    "4" -> "13" [dir=forward tooltip="include"]
    "4" -> "20" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "3" [dir=forward tooltip="include"]
    "13" -> "7" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include AddDisk.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddDisk.H" fillcolor="#BFBFBF"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
}
file AddSpheres.H
#include <vector>
#include <memory>
#include <massmodel.H>

Include dependency graph for AddSpheres.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "21" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "10" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "20" [label="QPDistF.H" tooltip="QPDistF.H"]
    "15" [label="gaussQ.H" tooltip="gaussQ.H"]
    "8" [label="interp.H" tooltip="interp.H"]
    "4" [label="massmodel.H" tooltip="massmodel.H"]
    "13" [label="orbit.H" tooltip="orbit.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddSpheres.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/AddSpheres.H" fillcolor="#BFBFBF"]
    "7" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "19" [label="cstdlib" tooltip="cstdlib"]
    "9" [label="deque" tooltip="deque"]
    "14" [label="functional" tooltip="functional"]
    "17" [label="iomanip" tooltip="iomanip"]
    "16" [label="iostream" tooltip="iostream"]
    "11" [label="map" tooltip="map"]
    "3" [label="memory" tooltip="memory"]
    "5" [label="random" tooltip="random"]
    "18" [label="sstream" tooltip="sstream"]
    "12" [label="string" tooltip="string"]
    "6" [label="tuple" tooltip="tuple"]
    "2" [label="vector" tooltip="vector"]
    "21" -> "4" [dir=forward tooltip="include"]
    "10" -> "2" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "12" [dir=forward tooltip="include"]
    "20" -> "17" [dir=forward tooltip="include"]
    "20" -> "12" [dir=forward tooltip="include"]
    "20" -> "11" [dir=forward tooltip="include"]
    "20" -> "4" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "13" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "17" [dir=forward tooltip="include"]
    "15" -> "18" [dir=forward tooltip="include"]
    "15" -> "19" [dir=forward tooltip="include"]
    "15" -> "12" [dir=forward tooltip="include"]
    "15" -> "2" [dir=forward tooltip="include"]
    "8" -> "7" [dir=forward tooltip="include"]
    "8" -> "2" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "10" [dir=forward tooltip="include"]
    "4" -> "2" [dir=forward tooltip="include"]
    "4" -> "3" [dir=forward tooltip="include"]
    "4" -> "5" [dir=forward tooltip="include"]
    "4" -> "6" [dir=forward tooltip="include"]
    "4" -> "7" [dir=forward tooltip="include"]
    "4" -> "8" [dir=forward tooltip="include"]
    "4" -> "13" [dir=forward tooltip="include"]
    "4" -> "20" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "3" [dir=forward tooltip="include"]
    "13" -> "7" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
}
file CylDisk.H
#include “massmodel.H
#include “EmpCylSL.H
#include “interp.H

Include dependency graph for CylDisk.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "21" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "22" [label="EmpCylSL.H" tooltip="EmpCylSL.H"]
    "10" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "27" [label="Particle.H" tooltip="Particle.H"]
    "20" [label="QPDistF.H" tooltip="QPDistF.H"]
    "29" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
    "25" [label="Timer.H" tooltip="Timer.H"]
    "38" [label="coef.H" tooltip="coef.H"]
    "15" [label="gaussQ.H" tooltip="gaussQ.H"]
    "8" [label="interp.H" tooltip="interp.H"]
    "37" [label="libvars.H" tooltip="libvars.H"]
    "33" [label="localmpi.H" tooltip="localmpi.H"]
    "2" [label="massmodel.H" tooltip="massmodel.H"]
    "13" [label="orbit.H" tooltip="orbit.H"]
    "35" [label="sltableMP2.H" tooltip="sltableMP2.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/CylDisk.H" fillcolor="#BFBFBF"]
    "7" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "26" [label="chrono" tooltip="chrono"]
    "24" [label="cmath" tooltip="cmath"]
    "34" [label="config_exp.h" tooltip="config_exp.h"]
    "19" [label="cstdlib" tooltip="cstdlib"]
    "9" [label="deque" tooltip="deque"]
    "31" [label="fstream" tooltip="fstream"]
    "14" [label="functional" tooltip="functional"]
    "17" [label="iomanip" tooltip="iomanip"]
    "16" [label="iostream" tooltip="iostream"]
    "23" [label="limits" tooltip="limits"]
    "11" [label="map" tooltip="map"]
    "30" [label="math.h" tooltip="math.h"]
    "4" [label="memory" tooltip="memory"]
    "32" [label="mpi.h" tooltip="mpi.h"]
    "5" [label="random" tooltip="random"]
    "18" [label="sstream" tooltip="sstream"]
    "12" [label="string" tooltip="string"]
    "6" [label="tuple" tooltip="tuple"]
    "28" [label="unordered_map" tooltip="unordered_map"]
    "3" [label="vector" tooltip="vector"]
    "36" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "21" -> "2" [dir=forward tooltip="include"]
    "22" -> "14" [dir=forward tooltip="include"]
    "22" -> "3" [dir=forward tooltip="include"]
    "22" -> "4" [dir=forward tooltip="include"]
    "22" -> "23" [dir=forward tooltip="include"]
    "22" -> "24" [dir=forward tooltip="include"]
    "22" -> "7" [dir=forward tooltip="include"]
    "22" -> "15" [dir=forward tooltip="include"]
    "22" -> "8" [dir=forward tooltip="include"]
    "22" -> "25" [dir=forward tooltip="include"]
    "22" -> "27" [dir=forward tooltip="include"]
    "22" -> "29" [dir=forward tooltip="include"]
    "22" -> "38" [dir=forward tooltip="include"]
    "22" -> "37" [dir=forward tooltip="include"]
    "10" -> "3" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "12" [dir=forward tooltip="include"]
    "27" -> "28" [dir=forward tooltip="include"]
    "27" -> "3" [dir=forward tooltip="include"]
    "27" -> "4" [dir=forward tooltip="include"]
    "20" -> "17" [dir=forward tooltip="include"]
    "20" -> "12" [dir=forward tooltip="include"]
    "20" -> "11" [dir=forward tooltip="include"]
    "20" -> "2" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "13" [dir=forward tooltip="include"]
    "29" -> "30" [dir=forward tooltip="include"]
    "29" -> "16" [dir=forward tooltip="include"]
    "29" -> "31" [dir=forward tooltip="include"]
    "29" -> "12" [dir=forward tooltip="include"]
    "29" -> "32" [dir=forward tooltip="include"]
    "29" -> "33" [dir=forward tooltip="include"]
    "29" -> "34" [dir=forward tooltip="include"]
    "29" -> "2" [dir=forward tooltip="include"]
    "29" -> "35" [dir=forward tooltip="include"]
    "29" -> "36" [dir=forward tooltip="include"]
    "29" -> "37" [dir=forward tooltip="include"]
    "25" -> "16" [dir=forward tooltip="include"]
    "25" -> "19" [dir=forward tooltip="include"]
    "25" -> "26" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "17" [dir=forward tooltip="include"]
    "15" -> "18" [dir=forward tooltip="include"]
    "15" -> "19" [dir=forward tooltip="include"]
    "15" -> "12" [dir=forward tooltip="include"]
    "15" -> "3" [dir=forward tooltip="include"]
    "8" -> "7" [dir=forward tooltip="include"]
    "8" -> "3" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "10" [dir=forward tooltip="include"]
    "37" -> "5" [dir=forward tooltip="include"]
    "37" -> "32" [dir=forward tooltip="include"]
    "33" -> "32" [dir=forward tooltip="include"]
    "33" -> "16" [dir=forward tooltip="include"]
    "33" -> "31" [dir=forward tooltip="include"]
    "33" -> "17" [dir=forward tooltip="include"]
    "33" -> "12" [dir=forward tooltip="include"]
    "2" -> "3" [dir=forward tooltip="include"]
    "2" -> "4" [dir=forward tooltip="include"]
    "2" -> "5" [dir=forward tooltip="include"]
    "2" -> "6" [dir=forward tooltip="include"]
    "2" -> "7" [dir=forward tooltip="include"]
    "2" -> "8" [dir=forward tooltip="include"]
    "2" -> "13" [dir=forward tooltip="include"]
    "2" -> "20" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "4" [dir=forward tooltip="include"]
    "13" -> "7" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
    "35" -> "7" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "22" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
}
file Disk2d.H
#include <memory>
#include <tuple>
#include <map>
#include <yaml-cpp/yaml.h>
#include <BiorthCyl.H>
#include <Particle.H>
#include <gaussQ.H>

Include dependency graph for Disk2d.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "6" [label="BiorthCyl.H" tooltip="BiorthCyl.H"]
    "28" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "37" [label="EXPmath.H" tooltip="EXPmath.H"]
    "33" [label="EmpCyl2d.H" tooltip="EmpCyl2d.H"]
    "21" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "27" [label="QPDistF.H" tooltip="QPDistF.H"]
    "24" [label="gaussQ.H" tooltip="gaussQ.H"]
    "19" [label="interp.H" tooltip="interp.H"]
    "13" [label="localmpi.H" tooltip="localmpi.H"]
    "16" [label="massmodel.H" tooltip="massmodel.H"]
    "22" [label="orbit.H" tooltip="orbit.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H" fillcolor="#BFBFBF"]
    "11" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "36" [label="Eigen/Eigenvalues" tooltip="Eigen/Eigenvalues"]
    "40" [label="Particle.H" tooltip="Particle.H"]
    "34" [label="algorithm" tooltip="algorithm"]
    "35" [label="array" tooltip="array"]
    "10" [label="cmath" tooltip="cmath"]
    "15" [label="config_exp.h" tooltip="config_exp.h"]
    "26" [label="cstdlib" tooltip="cstdlib"]
    "20" [label="deque" tooltip="deque"]
    "8" [label="fstream" tooltip="fstream"]
    "23" [label="functional" tooltip="functional"]
    "32" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
    "30" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
    "31" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
    "29" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
    "39" [label="highfive/eigen.hpp" tooltip="highfive/eigen.hpp"]
    "38" [label="highfive/highfive.hpp" tooltip="highfive/highfive.hpp"]
    "14" [label="iomanip" tooltip="iomanip"]
    "7" [label="iostream" tooltip="iostream"]
    "4" [label="map" tooltip="map"]
    "2" [label="memory" tooltip="memory"]
    "12" [label="mpi.h" tooltip="mpi.h"]
    "18" [label="random" tooltip="random"]
    "25" [label="sstream" tooltip="sstream"]
    "9" [label="string" tooltip="string"]
    "3" [label="tuple" tooltip="tuple"]
    "17" [label="vector" tooltip="vector"]
    "5" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "6" -> "7" [dir=forward tooltip="include"]
    "6" -> "8" [dir=forward tooltip="include"]
    "6" -> "9" [dir=forward tooltip="include"]
    "6" -> "10" [dir=forward tooltip="include"]
    "6" -> "11" [dir=forward tooltip="include"]
    "6" -> "12" [dir=forward tooltip="include"]
    "6" -> "13" [dir=forward tooltip="include"]
    "6" -> "15" [dir=forward tooltip="include"]
    "6" -> "16" [dir=forward tooltip="include"]
    "6" -> "5" [dir=forward tooltip="include"]
    "6" -> "29" [dir=forward tooltip="include"]
    "6" -> "30" [dir=forward tooltip="include"]
    "6" -> "31" [dir=forward tooltip="include"]
    "6" -> "32" [dir=forward tooltip="include"]
    "6" -> "33" [dir=forward tooltip="include"]
    "28" -> "16" [dir=forward tooltip="include"]
    "33" -> "34" [dir=forward tooltip="include"]
    "33" -> "2" [dir=forward tooltip="include"]
    "33" -> "9" [dir=forward tooltip="include"]
    "33" -> "17" [dir=forward tooltip="include"]
    "33" -> "35" [dir=forward tooltip="include"]
    "33" -> "3" [dir=forward tooltip="include"]
    "33" -> "11" [dir=forward tooltip="include"]
    "33" -> "36" [dir=forward tooltip="include"]
    "33" -> "5" [dir=forward tooltip="include"]
    "33" -> "15" [dir=forward tooltip="include"]
    "33" -> "24" [dir=forward tooltip="include"]
    "33" -> "37" [dir=forward tooltip="include"]
    "33" -> "13" [dir=forward tooltip="include"]
    "33" -> "38" [dir=forward tooltip="include"]
    "33" -> "39" [dir=forward tooltip="include"]
    "21" -> "17" [dir=forward tooltip="include"]
    "21" -> "4" [dir=forward tooltip="include"]
    "21" -> "9" [dir=forward tooltip="include"]
    "27" -> "14" [dir=forward tooltip="include"]
    "27" -> "9" [dir=forward tooltip="include"]
    "27" -> "4" [dir=forward tooltip="include"]
    "27" -> "16" [dir=forward tooltip="include"]
    "27" -> "28" [dir=forward tooltip="include"]
    "27" -> "22" [dir=forward tooltip="include"]
    "24" -> "7" [dir=forward tooltip="include"]
    "24" -> "14" [dir=forward tooltip="include"]
    "24" -> "25" [dir=forward tooltip="include"]
    "24" -> "26" [dir=forward tooltip="include"]
    "24" -> "9" [dir=forward tooltip="include"]
    "24" -> "17" [dir=forward tooltip="include"]
    "19" -> "11" [dir=forward tooltip="include"]
    "19" -> "17" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "19" -> "21" [dir=forward tooltip="include"]
    "13" -> "12" [dir=forward tooltip="include"]
    "13" -> "7" [dir=forward tooltip="include"]
    "13" -> "8" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "9" [dir=forward tooltip="include"]
    "16" -> "17" [dir=forward tooltip="include"]
    "16" -> "2" [dir=forward tooltip="include"]
    "16" -> "18" [dir=forward tooltip="include"]
    "16" -> "3" [dir=forward tooltip="include"]
    "16" -> "11" [dir=forward tooltip="include"]
    "16" -> "19" [dir=forward tooltip="include"]
    "16" -> "22" [dir=forward tooltip="include"]
    "16" -> "27" [dir=forward tooltip="include"]
    "22" -> "23" [dir=forward tooltip="include"]
    "22" -> "2" [dir=forward tooltip="include"]
    "22" -> "11" [dir=forward tooltip="include"]
    "22" -> "24" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "40" [dir=forward tooltip="include"]
    "1" -> "24" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include Disk2d.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2d.H" fillcolor="#BFBFBF"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H"]
    "1" -> "2" [dir=back tooltip="include"]
}

Typedefs

typedef std::shared_ptr<BiorthCyl> CylPtr
file Disk2dHalo.H
#include <stdexcept>
#include <iostream>
#include <iomanip>
#include <string>
#include <random>
#include <cmath>
#include <exponential.H>
#include <massmodel.H>
#include <gaussQ.H>
#include <localmpi.H>
#include <AddDisk.H>
#include <SphericalSL.H>
#include <Disk2d.H>
#include <SParticle.H>
#include <libvars.H>

Include dependency graph for Disk2dHalo.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "38" [label="BiorthCyl.H" tooltip="BiorthCyl.H"]
    "24" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "47" [label="EXPmath.H" tooltip="EXPmath.H"]
    "43" [label="EmpCyl2d.H" tooltip="EmpCyl2d.H"]
    "16" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "23" [label="QPDistF.H" tooltip="QPDistF.H"]
    "31" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
    "8" [label="exponential.H" tooltip="exponential.H"]
    "20" [label="gaussQ.H" tooltip="gaussQ.H"]
    "14" [label="interp.H" tooltip="interp.H"]
    "36" [label="libvars.H" tooltip="libvars.H"]
    "25" [label="localmpi.H" tooltip="localmpi.H"]
    "9" [label="massmodel.H" tooltip="massmodel.H"]
    "18" [label="orbit.H" tooltip="orbit.H"]
    "34" [label="sltableMP2.H" tooltip="sltableMP2.H"]
    "28" [label="AddDisk.H" tooltip="AddDisk.H"]
    "37" [label="Disk2d.H" tooltip="Disk2d.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" fillcolor="#BFBFBF"]
    "50" [label="SParticle.H" tooltip="SParticle.H"]
    "29" [label="SphericalSL.H" tooltip="SphericalSL.H"]
    "13" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "46" [label="Eigen/Eigenvalues" tooltip="Eigen/Eigenvalues"]
    "30" [label="Particle.H" tooltip="Particle.H"]
    "44" [label="algorithm" tooltip="algorithm"]
    "45" [label="array" tooltip="array"]
    "7" [label="cmath" tooltip="cmath"]
    "33" [label="config_exp.h" tooltip="config_exp.h"]
    "22" [label="cstdlib" tooltip="cstdlib"]
    "15" [label="deque" tooltip="deque"]
    "27" [label="fstream" tooltip="fstream"]
    "19" [label="functional" tooltip="functional"]
    "42" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
    "40" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
    "41" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
    "39" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
    "49" [label="highfive/eigen.hpp" tooltip="highfive/eigen.hpp"]
    "48" [label="highfive/highfive.hpp" tooltip="highfive/highfive.hpp"]
    "4" [label="iomanip" tooltip="iomanip"]
    "3" [label="iostream" tooltip="iostream"]
    "17" [label="map" tooltip="map"]
    "32" [label="math.h" tooltip="math.h"]
    "11" [label="memory" tooltip="memory"]
    "26" [label="mpi.h" tooltip="mpi.h"]
    "6" [label="random" tooltip="random"]
    "21" [label="sstream" tooltip="sstream"]
    "2" [label="stdexcept" tooltip="stdexcept"]
    "5" [label="string" tooltip="string"]
    "12" [label="tuple" tooltip="tuple"]
    "10" [label="vector" tooltip="vector"]
    "35" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "38" -> "3" [dir=forward tooltip="include"]
    "38" -> "27" [dir=forward tooltip="include"]
    "38" -> "5" [dir=forward tooltip="include"]
    "38" -> "7" [dir=forward tooltip="include"]
    "38" -> "13" [dir=forward tooltip="include"]
    "38" -> "26" [dir=forward tooltip="include"]
    "38" -> "25" [dir=forward tooltip="include"]
    "38" -> "33" [dir=forward tooltip="include"]
    "38" -> "9" [dir=forward tooltip="include"]
    "38" -> "35" [dir=forward tooltip="include"]
    "38" -> "39" [dir=forward tooltip="include"]
    "38" -> "40" [dir=forward tooltip="include"]
    "38" -> "41" [dir=forward tooltip="include"]
    "38" -> "42" [dir=forward tooltip="include"]
    "38" -> "43" [dir=forward tooltip="include"]
    "24" -> "9" [dir=forward tooltip="include"]
    "43" -> "44" [dir=forward tooltip="include"]
    "43" -> "11" [dir=forward tooltip="include"]
    "43" -> "5" [dir=forward tooltip="include"]
    "43" -> "10" [dir=forward tooltip="include"]
    "43" -> "45" [dir=forward tooltip="include"]
    "43" -> "12" [dir=forward tooltip="include"]
    "43" -> "13" [dir=forward tooltip="include"]
    "43" -> "46" [dir=forward tooltip="include"]
    "43" -> "35" [dir=forward tooltip="include"]
    "43" -> "33" [dir=forward tooltip="include"]
    "43" -> "20" [dir=forward tooltip="include"]
    "43" -> "47" [dir=forward tooltip="include"]
    "43" -> "25" [dir=forward tooltip="include"]
    "43" -> "48" [dir=forward tooltip="include"]
    "43" -> "49" [dir=forward tooltip="include"]
    "16" -> "10" [dir=forward tooltip="include"]
    "16" -> "17" [dir=forward tooltip="include"]
    "16" -> "5" [dir=forward tooltip="include"]
    "23" -> "4" [dir=forward tooltip="include"]
    "23" -> "5" [dir=forward tooltip="include"]
    "23" -> "17" [dir=forward tooltip="include"]
    "23" -> "9" [dir=forward tooltip="include"]
    "23" -> "24" [dir=forward tooltip="include"]
    "23" -> "18" [dir=forward tooltip="include"]
    "31" -> "32" [dir=forward tooltip="include"]
    "31" -> "3" [dir=forward tooltip="include"]
    "31" -> "27" [dir=forward tooltip="include"]
    "31" -> "5" [dir=forward tooltip="include"]
    "31" -> "26" [dir=forward tooltip="include"]
    "31" -> "25" [dir=forward tooltip="include"]
    "31" -> "33" [dir=forward tooltip="include"]
    "31" -> "9" [dir=forward tooltip="include"]
    "31" -> "34" [dir=forward tooltip="include"]
    "31" -> "35" [dir=forward tooltip="include"]
    "31" -> "36" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "20" -> "3" [dir=forward tooltip="include"]
    "20" -> "4" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "22" [dir=forward tooltip="include"]
    "20" -> "5" [dir=forward tooltip="include"]
    "20" -> "10" [dir=forward tooltip="include"]
    "14" -> "13" [dir=forward tooltip="include"]
    "14" -> "10" [dir=forward tooltip="include"]
    "14" -> "15" [dir=forward tooltip="include"]
    "14" -> "16" [dir=forward tooltip="include"]
    "36" -> "6" [dir=forward tooltip="include"]
    "36" -> "26" [dir=forward tooltip="include"]
    "25" -> "26" [dir=forward tooltip="include"]
    "25" -> "3" [dir=forward tooltip="include"]
    "25" -> "27" [dir=forward tooltip="include"]
    "25" -> "4" [dir=forward tooltip="include"]
    "25" -> "5" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "11" [dir=forward tooltip="include"]
    "9" -> "6" [dir=forward tooltip="include"]
    "9" -> "12" [dir=forward tooltip="include"]
    "9" -> "13" [dir=forward tooltip="include"]
    "9" -> "14" [dir=forward tooltip="include"]
    "9" -> "18" [dir=forward tooltip="include"]
    "9" -> "23" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "11" [dir=forward tooltip="include"]
    "18" -> "13" [dir=forward tooltip="include"]
    "18" -> "20" [dir=forward tooltip="include"]
    "34" -> "13" [dir=forward tooltip="include"]
    "28" -> "10" [dir=forward tooltip="include"]
    "28" -> "11" [dir=forward tooltip="include"]
    "28" -> "9" [dir=forward tooltip="include"]
    "37" -> "11" [dir=forward tooltip="include"]
    "37" -> "12" [dir=forward tooltip="include"]
    "37" -> "17" [dir=forward tooltip="include"]
    "37" -> "35" [dir=forward tooltip="include"]
    "37" -> "38" [dir=forward tooltip="include"]
    "37" -> "30" [dir=forward tooltip="include"]
    "37" -> "20" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "1" -> "20" [dir=forward tooltip="include"]
    "1" -> "25" [dir=forward tooltip="include"]
    "1" -> "28" [dir=forward tooltip="include"]
    "1" -> "29" [dir=forward tooltip="include"]
    "1" -> "37" [dir=forward tooltip="include"]
    "1" -> "50" [dir=forward tooltip="include"]
    "1" -> "36" [dir=forward tooltip="include"]
    "50" -> "30" [dir=forward tooltip="include"]
    "50" -> "25" [dir=forward tooltip="include"]
    "29" -> "10" [dir=forward tooltip="include"]
    "29" -> "30" [dir=forward tooltip="include"]
    "29" -> "31" [dir=forward tooltip="include"]
}
file DiskEval.H
#include <iostream>
#include <iomanip>
#include <cstdlib>
#include <fstream>
#include <sstream>
#include <cstring>
#include <string>
#include <vector>
#include <cmath>
#include <tuple>
#include <numerical.H>
#include <gaussQ.H>
#include <EmpCylSL.H>
#include <DiskModels.H>
#include <config_exp.h>

Include dependency graph for DiskEval.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "42" [label="DiskDensityFunc.H" tooltip="DiskDensityFunc.H"]
    "41" [label="DiskModels.H" tooltip="DiskModels.H"]
    "36" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "16" [label="EmpCylSL.H" tooltip="EmpCylSL.H"]
    "21" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "25" [label="Particle.H" tooltip="Particle.H"]
    "35" [label="QPDistF.H" tooltip="QPDistF.H"]
    "27" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
    "23" [label="Timer.H" tooltip="Timer.H"]
    "40" [label="coef.H" tooltip="coef.H"]
    "15" [label="gaussQ.H" tooltip="gaussQ.H"]
    "19" [label="interp.H" tooltip="interp.H"]
    "39" [label="libvars.H" tooltip="libvars.H"]
    "30" [label="localmpi.H" tooltip="localmpi.H"]
    "32" [label="massmodel.H" tooltip="massmodel.H"]
    "12" [label="numerical.H" tooltip="numerical.H"]
    "34" [label="orbit.H" tooltip="orbit.H"]
    "37" [label="sltableMP2.H" tooltip="sltableMP2.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskEval.H" fillcolor="#BFBFBF"]
    "14" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "24" [label="chrono" tooltip="chrono"]
    "10" [label="cmath" tooltip="cmath"]
    "31" [label="config_exp.h" tooltip="config_exp.h"]
    "4" [label="cstdlib" tooltip="cstdlib"]
    "7" [label="cstring" tooltip="cstring"]
    "20" [label="deque" tooltip="deque"]
    "5" [label="fstream" tooltip="fstream"]
    "13" [label="functional" tooltip="functional"]
    "3" [label="iomanip" tooltip="iomanip"]
    "2" [label="iostream" tooltip="iostream"]
    "18" [label="limits" tooltip="limits"]
    "22" [label="map" tooltip="map"]
    "28" [label="math.h" tooltip="math.h"]
    "17" [label="memory" tooltip="memory"]
    "29" [label="mpi.h" tooltip="mpi.h"]
    "44" [label="pybind11/embed.h" tooltip="pybind11/embed.h"]
    "43" [label="pybind11/pybind11.h" tooltip="pybind11/pybind11.h"]
    "33" [label="random" tooltip="random"]
    "6" [label="sstream" tooltip="sstream"]
    "8" [label="string" tooltip="string"]
    "11" [label="tuple" tooltip="tuple"]
    "26" [label="unordered_map" tooltip="unordered_map"]
    "9" [label="vector" tooltip="vector"]
    "38" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "42" -> "13" [dir=forward tooltip="include"]
    "42" -> "43" [dir=forward tooltip="include"]
    "42" -> "44" [dir=forward tooltip="include"]
    "41" -> "16" [dir=forward tooltip="include"]
    "41" -> "42" [dir=forward tooltip="include"]
    "36" -> "32" [dir=forward tooltip="include"]
    "16" -> "13" [dir=forward tooltip="include"]
    "16" -> "9" [dir=forward tooltip="include"]
    "16" -> "17" [dir=forward tooltip="include"]
    "16" -> "18" [dir=forward tooltip="include"]
    "16" -> "10" [dir=forward tooltip="include"]
    "16" -> "14" [dir=forward tooltip="include"]
    "16" -> "15" [dir=forward tooltip="include"]
    "16" -> "19" [dir=forward tooltip="include"]
    "16" -> "23" [dir=forward tooltip="include"]
    "16" -> "25" [dir=forward tooltip="include"]
    "16" -> "27" [dir=forward tooltip="include"]
    "16" -> "40" [dir=forward tooltip="include"]
    "16" -> "39" [dir=forward tooltip="include"]
    "21" -> "9" [dir=forward tooltip="include"]
    "21" -> "22" [dir=forward tooltip="include"]
    "21" -> "8" [dir=forward tooltip="include"]
    "25" -> "26" [dir=forward tooltip="include"]
    "25" -> "9" [dir=forward tooltip="include"]
    "25" -> "17" [dir=forward tooltip="include"]
    "35" -> "3" [dir=forward tooltip="include"]
    "35" -> "8" [dir=forward tooltip="include"]
    "35" -> "22" [dir=forward tooltip="include"]
    "35" -> "32" [dir=forward tooltip="include"]
    "35" -> "36" [dir=forward tooltip="include"]
    "35" -> "34" [dir=forward tooltip="include"]
    "27" -> "28" [dir=forward tooltip="include"]
    "27" -> "2" [dir=forward tooltip="include"]
    "27" -> "5" [dir=forward tooltip="include"]
    "27" -> "8" [dir=forward tooltip="include"]
    "27" -> "29" [dir=forward tooltip="include"]
    "27" -> "30" [dir=forward tooltip="include"]
    "27" -> "31" [dir=forward tooltip="include"]
    "27" -> "32" [dir=forward tooltip="include"]
    "27" -> "37" [dir=forward tooltip="include"]
    "27" -> "38" [dir=forward tooltip="include"]
    "27" -> "39" [dir=forward tooltip="include"]
    "23" -> "2" [dir=forward tooltip="include"]
    "23" -> "4" [dir=forward tooltip="include"]
    "23" -> "24" [dir=forward tooltip="include"]
    "15" -> "2" [dir=forward tooltip="include"]
    "15" -> "3" [dir=forward tooltip="include"]
    "15" -> "6" [dir=forward tooltip="include"]
    "15" -> "4" [dir=forward tooltip="include"]
    "15" -> "8" [dir=forward tooltip="include"]
    "15" -> "9" [dir=forward tooltip="include"]
    "19" -> "14" [dir=forward tooltip="include"]
    "19" -> "9" [dir=forward tooltip="include"]
    "19" -> "20" [dir=forward tooltip="include"]
    "19" -> "21" [dir=forward tooltip="include"]
    "39" -> "33" [dir=forward tooltip="include"]
    "39" -> "29" [dir=forward tooltip="include"]
    "30" -> "29" [dir=forward tooltip="include"]
    "30" -> "2" [dir=forward tooltip="include"]
    "30" -> "5" [dir=forward tooltip="include"]
    "30" -> "3" [dir=forward tooltip="include"]
    "30" -> "8" [dir=forward tooltip="include"]
    "32" -> "9" [dir=forward tooltip="include"]
    "32" -> "17" [dir=forward tooltip="include"]
    "32" -> "33" [dir=forward tooltip="include"]
    "32" -> "11" [dir=forward tooltip="include"]
    "32" -> "14" [dir=forward tooltip="include"]
    "32" -> "19" [dir=forward tooltip="include"]
    "32" -> "34" [dir=forward tooltip="include"]
    "32" -> "35" [dir=forward tooltip="include"]
    "12" -> "13" [dir=forward tooltip="include"]
    "12" -> "14" [dir=forward tooltip="include"]
    "34" -> "13" [dir=forward tooltip="include"]
    "34" -> "17" [dir=forward tooltip="include"]
    "34" -> "14" [dir=forward tooltip="include"]
    "34" -> "15" [dir=forward tooltip="include"]
    "37" -> "14" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "1" -> "10" [dir=forward tooltip="include"]
    "1" -> "11" [dir=forward tooltip="include"]
    "1" -> "12" [dir=forward tooltip="include"]
    "1" -> "15" [dir=forward tooltip="include"]
    "1" -> "16" [dir=forward tooltip="include"]
    "1" -> "41" [dir=forward tooltip="include"]
    "1" -> "31" [dir=forward tooltip="include"]
}

Functions

double dplgndr(int l, int m, double x)
double plgndr(int l, int m, double x)
file DiskHalo.H
#include <stdexcept>
#include <iostream>
#include <iomanip>
#include <string>
#include <random>
#include <cmath>
#include <exponential.H>
#include <massmodel.H>
#include <gaussQ.H>
#include <localmpi.H>
#include <AddDisk.H>
#include <SphericalSL.H>
#include <EmpCylSL.H>
#include <SParticle.H>
#include <libvars.H>

Include dependency graph for DiskHalo.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "24" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "37" [label="EmpCylSL.H" tooltip="EmpCylSL.H"]
    "16" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "41" [label="Particle.H" tooltip="Particle.H"]
    "23" [label="QPDistF.H" tooltip="QPDistF.H"]
    "31" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
    "39" [label="Timer.H" tooltip="Timer.H"]
    "43" [label="coef.H" tooltip="coef.H"]
    "8" [label="exponential.H" tooltip="exponential.H"]
    "20" [label="gaussQ.H" tooltip="gaussQ.H"]
    "14" [label="interp.H" tooltip="interp.H"]
    "36" [label="libvars.H" tooltip="libvars.H"]
    "25" [label="localmpi.H" tooltip="localmpi.H"]
    "9" [label="massmodel.H" tooltip="massmodel.H"]
    "18" [label="orbit.H" tooltip="orbit.H"]
    "34" [label="sltableMP2.H" tooltip="sltableMP2.H"]
    "28" [label="AddDisk.H" tooltip="AddDisk.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" fillcolor="#BFBFBF"]
    "44" [label="SParticle.H" tooltip="SParticle.H"]
    "29" [label="SphericalSL.H" tooltip="SphericalSL.H"]
    "13" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "30" [label="Particle.H" tooltip="Particle.H"]
    "40" [label="chrono" tooltip="chrono"]
    "7" [label="cmath" tooltip="cmath"]
    "33" [label="config_exp.h" tooltip="config_exp.h"]
    "22" [label="cstdlib" tooltip="cstdlib"]
    "15" [label="deque" tooltip="deque"]
    "27" [label="fstream" tooltip="fstream"]
    "19" [label="functional" tooltip="functional"]
    "4" [label="iomanip" tooltip="iomanip"]
    "3" [label="iostream" tooltip="iostream"]
    "38" [label="limits" tooltip="limits"]
    "17" [label="map" tooltip="map"]
    "32" [label="math.h" tooltip="math.h"]
    "11" [label="memory" tooltip="memory"]
    "26" [label="mpi.h" tooltip="mpi.h"]
    "6" [label="random" tooltip="random"]
    "21" [label="sstream" tooltip="sstream"]
    "2" [label="stdexcept" tooltip="stdexcept"]
    "5" [label="string" tooltip="string"]
    "12" [label="tuple" tooltip="tuple"]
    "42" [label="unordered_map" tooltip="unordered_map"]
    "10" [label="vector" tooltip="vector"]
    "35" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "24" -> "9" [dir=forward tooltip="include"]
    "37" -> "19" [dir=forward tooltip="include"]
    "37" -> "10" [dir=forward tooltip="include"]
    "37" -> "11" [dir=forward tooltip="include"]
    "37" -> "38" [dir=forward tooltip="include"]
    "37" -> "7" [dir=forward tooltip="include"]
    "37" -> "13" [dir=forward tooltip="include"]
    "37" -> "20" [dir=forward tooltip="include"]
    "37" -> "14" [dir=forward tooltip="include"]
    "37" -> "39" [dir=forward tooltip="include"]
    "37" -> "41" [dir=forward tooltip="include"]
    "37" -> "31" [dir=forward tooltip="include"]
    "37" -> "43" [dir=forward tooltip="include"]
    "37" -> "36" [dir=forward tooltip="include"]
    "16" -> "10" [dir=forward tooltip="include"]
    "16" -> "17" [dir=forward tooltip="include"]
    "16" -> "5" [dir=forward tooltip="include"]
    "41" -> "42" [dir=forward tooltip="include"]
    "41" -> "10" [dir=forward tooltip="include"]
    "41" -> "11" [dir=forward tooltip="include"]
    "23" -> "4" [dir=forward tooltip="include"]
    "23" -> "5" [dir=forward tooltip="include"]
    "23" -> "17" [dir=forward tooltip="include"]
    "23" -> "9" [dir=forward tooltip="include"]
    "23" -> "24" [dir=forward tooltip="include"]
    "23" -> "18" [dir=forward tooltip="include"]
    "31" -> "32" [dir=forward tooltip="include"]
    "31" -> "3" [dir=forward tooltip="include"]
    "31" -> "27" [dir=forward tooltip="include"]
    "31" -> "5" [dir=forward tooltip="include"]
    "31" -> "26" [dir=forward tooltip="include"]
    "31" -> "25" [dir=forward tooltip="include"]
    "31" -> "33" [dir=forward tooltip="include"]
    "31" -> "9" [dir=forward tooltip="include"]
    "31" -> "34" [dir=forward tooltip="include"]
    "31" -> "35" [dir=forward tooltip="include"]
    "31" -> "36" [dir=forward tooltip="include"]
    "39" -> "3" [dir=forward tooltip="include"]
    "39" -> "22" [dir=forward tooltip="include"]
    "39" -> "40" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "20" -> "3" [dir=forward tooltip="include"]
    "20" -> "4" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "22" [dir=forward tooltip="include"]
    "20" -> "5" [dir=forward tooltip="include"]
    "20" -> "10" [dir=forward tooltip="include"]
    "14" -> "13" [dir=forward tooltip="include"]
    "14" -> "10" [dir=forward tooltip="include"]
    "14" -> "15" [dir=forward tooltip="include"]
    "14" -> "16" [dir=forward tooltip="include"]
    "36" -> "6" [dir=forward tooltip="include"]
    "36" -> "26" [dir=forward tooltip="include"]
    "25" -> "26" [dir=forward tooltip="include"]
    "25" -> "3" [dir=forward tooltip="include"]
    "25" -> "27" [dir=forward tooltip="include"]
    "25" -> "4" [dir=forward tooltip="include"]
    "25" -> "5" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "11" [dir=forward tooltip="include"]
    "9" -> "6" [dir=forward tooltip="include"]
    "9" -> "12" [dir=forward tooltip="include"]
    "9" -> "13" [dir=forward tooltip="include"]
    "9" -> "14" [dir=forward tooltip="include"]
    "9" -> "18" [dir=forward tooltip="include"]
    "9" -> "23" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "11" [dir=forward tooltip="include"]
    "18" -> "13" [dir=forward tooltip="include"]
    "18" -> "20" [dir=forward tooltip="include"]
    "34" -> "13" [dir=forward tooltip="include"]
    "28" -> "10" [dir=forward tooltip="include"]
    "28" -> "11" [dir=forward tooltip="include"]
    "28" -> "9" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "1" -> "20" [dir=forward tooltip="include"]
    "1" -> "25" [dir=forward tooltip="include"]
    "1" -> "28" [dir=forward tooltip="include"]
    "1" -> "29" [dir=forward tooltip="include"]
    "1" -> "37" [dir=forward tooltip="include"]
    "1" -> "44" [dir=forward tooltip="include"]
    "1" -> "36" [dir=forward tooltip="include"]
    "44" -> "30" [dir=forward tooltip="include"]
    "44" -> "25" [dir=forward tooltip="include"]
    "29" -> "10" [dir=forward tooltip="include"]
    "29" -> "30" [dir=forward tooltip="include"]
    "29" -> "31" [dir=forward tooltip="include"]
}
file EllipForce.H
#include <algorithm>
#include <iostream>
#include <iomanip>
#include <memory>
#include <vector>
#include <interp.H>
#include <gaussQ.H>

Include dependency graph for EllipForce.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "10" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "13" [label="gaussQ.H" tooltip="gaussQ.H"]
    "7" [label="interp.H" tooltip="interp.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/EllipForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/EllipForce.H" fillcolor="#BFBFBF"]
    "8" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "2" [label="algorithm" tooltip="algorithm"]
    "15" [label="cstdlib" tooltip="cstdlib"]
    "9" [label="deque" tooltip="deque"]
    "4" [label="iomanip" tooltip="iomanip"]
    "3" [label="iostream" tooltip="iostream"]
    "11" [label="map" tooltip="map"]
    "5" [label="memory" tooltip="memory"]
    "14" [label="sstream" tooltip="sstream"]
    "12" [label="string" tooltip="string"]
    "6" [label="vector" tooltip="vector"]
    "10" -> "6" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "12" [dir=forward tooltip="include"]
    "13" -> "3" [dir=forward tooltip="include"]
    "13" -> "4" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
    "13" -> "12" [dir=forward tooltip="include"]
    "13" -> "6" [dir=forward tooltip="include"]
    "7" -> "8" [dir=forward tooltip="include"]
    "7" -> "6" [dir=forward tooltip="include"]
    "7" -> "9" [dir=forward tooltip="include"]
    "7" -> "10" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "13" [dir=forward tooltip="include"]
}
file EllipsoidForce.H
#include <algorithm>
#include <iostream>
#include <iomanip>
#include <memory>
#include <vector>
#include <Eigen/Eigen>
#include <interp.H>
#include <gaussQ.H>

Include dependency graph for EllipsoidForce.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "10" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "13" [label="gaussQ.H" tooltip="gaussQ.H"]
    "8" [label="interp.H" tooltip="interp.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/EllipsoidForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/EllipsoidForce.H" fillcolor="#BFBFBF"]
    "7" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "2" [label="algorithm" tooltip="algorithm"]
    "15" [label="cstdlib" tooltip="cstdlib"]
    "9" [label="deque" tooltip="deque"]
    "4" [label="iomanip" tooltip="iomanip"]
    "3" [label="iostream" tooltip="iostream"]
    "11" [label="map" tooltip="map"]
    "5" [label="memory" tooltip="memory"]
    "14" [label="sstream" tooltip="sstream"]
    "12" [label="string" tooltip="string"]
    "6" [label="vector" tooltip="vector"]
    "10" -> "6" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "12" [dir=forward tooltip="include"]
    "13" -> "3" [dir=forward tooltip="include"]
    "13" -> "4" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
    "13" -> "12" [dir=forward tooltip="include"]
    "13" -> "6" [dir=forward tooltip="include"]
    "8" -> "7" [dir=forward tooltip="include"]
    "8" -> "6" [dir=forward tooltip="include"]
    "8" -> "9" [dir=forward tooltip="include"]
    "8" -> "10" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "13" [dir=forward tooltip="include"]
}
file massmodel1d.H
#include <string>
#include <tuple>
#include <massmodel.H>

Include dependency graph for massmodel1d.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "21" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "11" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "20" [label="QPDistF.H" tooltip="QPDistF.H"]
    "15" [label="gaussQ.H" tooltip="gaussQ.H"]
    "9" [label="interp.H" tooltip="interp.H"]
    "4" [label="massmodel.H" tooltip="massmodel.H"]
    "13" [label="orbit.H" tooltip="orbit.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/massmodel1d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/massmodel1d.H" fillcolor="#BFBFBF"]
    "8" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "19" [label="cstdlib" tooltip="cstdlib"]
    "10" [label="deque" tooltip="deque"]
    "14" [label="functional" tooltip="functional"]
    "17" [label="iomanip" tooltip="iomanip"]
    "16" [label="iostream" tooltip="iostream"]
    "12" [label="map" tooltip="map"]
    "6" [label="memory" tooltip="memory"]
    "7" [label="random" tooltip="random"]
    "18" [label="sstream" tooltip="sstream"]
    "2" [label="string" tooltip="string"]
    "3" [label="tuple" tooltip="tuple"]
    "5" [label="vector" tooltip="vector"]
    "21" -> "4" [dir=forward tooltip="include"]
    "11" -> "5" [dir=forward tooltip="include"]
    "11" -> "12" [dir=forward tooltip="include"]
    "11" -> "2" [dir=forward tooltip="include"]
    "20" -> "17" [dir=forward tooltip="include"]
    "20" -> "2" [dir=forward tooltip="include"]
    "20" -> "12" [dir=forward tooltip="include"]
    "20" -> "4" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "13" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "17" [dir=forward tooltip="include"]
    "15" -> "18" [dir=forward tooltip="include"]
    "15" -> "19" [dir=forward tooltip="include"]
    "15" -> "2" [dir=forward tooltip="include"]
    "15" -> "5" [dir=forward tooltip="include"]
    "9" -> "8" [dir=forward tooltip="include"]
    "9" -> "5" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "11" [dir=forward tooltip="include"]
    "4" -> "5" [dir=forward tooltip="include"]
    "4" -> "6" [dir=forward tooltip="include"]
    "4" -> "7" [dir=forward tooltip="include"]
    "4" -> "3" [dir=forward tooltip="include"]
    "4" -> "8" [dir=forward tooltip="include"]
    "4" -> "9" [dir=forward tooltip="include"]
    "4" -> "13" [dir=forward tooltip="include"]
    "4" -> "20" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "6" [dir=forward tooltip="include"]
    "13" -> "8" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
}
file SParticle.H
#include <Particle.H>
#include <localmpi.H>

Include dependency graph for SParticle.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="localmpi.H" tooltip="localmpi.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SParticle.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SParticle.H" fillcolor="#BFBFBF"]
    "2" [label="Particle.H" tooltip="Particle.H"]
    "6" [label="fstream" tooltip="fstream"]
    "7" [label="iomanip" tooltip="iomanip"]
    "5" [label="iostream" tooltip="iostream"]
    "4" [label="mpi.h" tooltip="mpi.h"]
    "8" [label="string" tooltip="string"]
    "3" -> "4" [dir=forward tooltip="include"]
    "3" -> "5" [dir=forward tooltip="include"]
    "3" -> "6" [dir=forward tooltip="include"]
    "3" -> "7" [dir=forward tooltip="include"]
    "3" -> "8" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include SParticle.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SParticle.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SParticle.H" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
}
file SphericalSL.H
#include <vector>
#include <Particle.H>
#include <SLGridMP2.H>

Include dependency graph for SphericalSL.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "28" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "20" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "27" [label="QPDistF.H" tooltip="QPDistF.H"]
    "4" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
    "24" [label="gaussQ.H" tooltip="gaussQ.H"]
    "18" [label="interp.H" tooltip="interp.H"]
    "31" [label="libvars.H" tooltip="libvars.H"]
    "10" [label="localmpi.H" tooltip="localmpi.H"]
    "13" [label="massmodel.H" tooltip="massmodel.H"]
    "22" [label="orbit.H" tooltip="orbit.H"]
    "29" [label="sltableMP2.H" tooltip="sltableMP2.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H" fillcolor="#BFBFBF"]
    "17" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "3" [label="Particle.H" tooltip="Particle.H"]
    "12" [label="config_exp.h" tooltip="config_exp.h"]
    "26" [label="cstdlib" tooltip="cstdlib"]
    "19" [label="deque" tooltip="deque"]
    "7" [label="fstream" tooltip="fstream"]
    "23" [label="functional" tooltip="functional"]
    "11" [label="iomanip" tooltip="iomanip"]
    "6" [label="iostream" tooltip="iostream"]
    "21" [label="map" tooltip="map"]
    "5" [label="math.h" tooltip="math.h"]
    "14" [label="memory" tooltip="memory"]
    "9" [label="mpi.h" tooltip="mpi.h"]
    "15" [label="random" tooltip="random"]
    "25" [label="sstream" tooltip="sstream"]
    "8" [label="string" tooltip="string"]
    "16" [label="tuple" tooltip="tuple"]
    "2" [label="vector" tooltip="vector"]
    "30" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
    "28" -> "13" [dir=forward tooltip="include"]
    "20" -> "2" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "8" [dir=forward tooltip="include"]
    "27" -> "11" [dir=forward tooltip="include"]
    "27" -> "8" [dir=forward tooltip="include"]
    "27" -> "21" [dir=forward tooltip="include"]
    "27" -> "13" [dir=forward tooltip="include"]
    "27" -> "28" [dir=forward tooltip="include"]
    "27" -> "22" [dir=forward tooltip="include"]
    "4" -> "5" [dir=forward tooltip="include"]
    "4" -> "6" [dir=forward tooltip="include"]
    "4" -> "7" [dir=forward tooltip="include"]
    "4" -> "8" [dir=forward tooltip="include"]
    "4" -> "9" [dir=forward tooltip="include"]
    "4" -> "10" [dir=forward tooltip="include"]
    "4" -> "12" [dir=forward tooltip="include"]
    "4" -> "13" [dir=forward tooltip="include"]
    "4" -> "29" [dir=forward tooltip="include"]
    "4" -> "30" [dir=forward tooltip="include"]
    "4" -> "31" [dir=forward tooltip="include"]
    "24" -> "6" [dir=forward tooltip="include"]
    "24" -> "11" [dir=forward tooltip="include"]
    "24" -> "25" [dir=forward tooltip="include"]
    "24" -> "26" [dir=forward tooltip="include"]
    "24" -> "8" [dir=forward tooltip="include"]
    "24" -> "2" [dir=forward tooltip="include"]
    "18" -> "17" [dir=forward tooltip="include"]
    "18" -> "2" [dir=forward tooltip="include"]
    "18" -> "19" [dir=forward tooltip="include"]
    "18" -> "20" [dir=forward tooltip="include"]
    "31" -> "15" [dir=forward tooltip="include"]
    "31" -> "9" [dir=forward tooltip="include"]
    "10" -> "9" [dir=forward tooltip="include"]
    "10" -> "6" [dir=forward tooltip="include"]
    "10" -> "7" [dir=forward tooltip="include"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "8" [dir=forward tooltip="include"]
    "13" -> "2" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
    "13" -> "16" [dir=forward tooltip="include"]
    "13" -> "17" [dir=forward tooltip="include"]
    "13" -> "18" [dir=forward tooltip="include"]
    "13" -> "22" [dir=forward tooltip="include"]
    "13" -> "27" [dir=forward tooltip="include"]
    "22" -> "23" [dir=forward tooltip="include"]
    "22" -> "14" [dir=forward tooltip="include"]
    "22" -> "17" [dir=forward tooltip="include"]
    "22" -> "24" [dir=forward tooltip="include"]
    "29" -> "17" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
}

This graph shows which files directly or indirectly include SphericalSL.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H"]
    "3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/DiskHalo.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/SphericalSL.H" fillcolor="#BFBFBF"]
    "1" -> "2" [dir=back tooltip="include"]
    "1" -> "3" [dir=back tooltip="include"]
}

Typedefs

typedef std::shared_ptr<SphericalSL> SphericalSLptr
file atomic_constants.H

Variables

const double a0 = 0.052917721092e-7
const double amu = 1.660539e-24
const std::vector<double> atomic_mass
const double boltz = 1.3806504e-16
const double boltzEv = 8.6173324e-5
const double esu = 4.80320427e-10
const double eV = 1.60217653e-12
const double light = 2.99792458e+10
const double me = 9.10938291e-28
const double mec2 = 0.51099891013
const double mp = 1.67262158e-24
const double msun = 1.9891e33
const double pc = 3.08567758e18
const double planck = 6.626075540e-27
const double year = 365.242 * 24 * 3600
file Bess.H
#include <cmath>
#include <EXPmath.H>

Include dependency graph for Bess.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "3" [label="EXPmath.H" tooltip="EXPmath.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/Bess.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/Bess.H" fillcolor="#BFBFBF"]
    "2" [label="cmath" tooltip="cmath"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
}
file Grid2D.H
#include <fstream>
#include <vector>

Include dependency graph for Grid2D.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/Grid2D.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/Grid2D.H" fillcolor="#BFBFBF"]
    "2" [label="fstream" tooltip="fstream"]
    "3" [label="vector" tooltip="vector"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
}
file KDE2d.H
#include <iostream>
#include <iomanip>
#include <fstream>
#include <string>
#include <vector>
#include <cmath>
#include <Eigen/Eigen>
#include <fftw3.h>
#include <cxxopts.H>

Include dependency graph for KDE2d.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "10" [label="cxxopts.H" tooltip="cxxopts.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/KDE2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/KDE2d.H" fillcolor="#BFBFBF"]
    "8" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "22" [label="algorithm" tooltip="algorithm"]
    "11" [label="cctype" tooltip="cctype"]
    "7" [label="cmath" tooltip="cmath"]
    "12" [label="cstring" tooltip="cstring"]
    "13" [label="exception" tooltip="exception"]
    "9" [label="fftw3.h" tooltip="fftw3.h"]
    "4" [label="fstream" tooltip="fstream"]
    "3" [label="iomanip" tooltip="iomanip"]
    "2" [label="iostream" tooltip="iostream"]
    "14" [label="limits" tooltip="limits"]
    "15" [label="list" tooltip="list"]
    "16" [label="map" tooltip="map"]
    "17" [label="memory" tooltip="memory"]
    "23" [label="regex" tooltip="regex"]
    "18" [label="sstream" tooltip="sstream"]
    "5" [label="string" tooltip="string"]
    "19" [label="unordered_map" tooltip="unordered_map"]
    "20" [label="unordered_set" tooltip="unordered_set"]
    "21" [label="utility" tooltip="utility"]
    "6" [label="vector" tooltip="vector"]
    "10" -> "11" [dir=forward tooltip="include"]
    "10" -> "12" [dir=forward tooltip="include"]
    "10" -> "13" [dir=forward tooltip="include"]
    "10" -> "2" [dir=forward tooltip="include"]
    "10" -> "14" [dir=forward tooltip="include"]
    "10" -> "15" [dir=forward tooltip="include"]
    "10" -> "16" [dir=forward tooltip="include"]
    "10" -> "17" [dir=forward tooltip="include"]
    "10" -> "18" [dir=forward tooltip="include"]
    "10" -> "5" [dir=forward tooltip="include"]
    "10" -> "19" [dir=forward tooltip="include"]
    "10" -> "20" [dir=forward tooltip="include"]
    "10" -> "21" [dir=forward tooltip="include"]
    "10" -> "6" [dir=forward tooltip="include"]
    "10" -> "22" [dir=forward tooltip="include"]
    "10" -> "23" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "1" -> "10" [dir=forward tooltip="include"]
}
file MakeModel.H
#include <string>
#include <memory>
#include <Eigen/Eigen>
#include <massmodel.H>

Include dependency graph for MakeModel.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "21" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
    "11" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
    "20" [label="QPDistF.H" tooltip="QPDistF.H"]
    "15" [label="gaussQ.H" tooltip="gaussQ.H"]
    "9" [label="interp.H" tooltip="interp.H"]
    "5" [label="massmodel.H" tooltip="massmodel.H"]
    "13" [label="orbit.H" tooltip="orbit.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/MakeModel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/MakeModel.H" fillcolor="#BFBFBF"]
    "4" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
    "19" [label="cstdlib" tooltip="cstdlib"]
    "10" [label="deque" tooltip="deque"]
    "14" [label="functional" tooltip="functional"]
    "17" [label="iomanip" tooltip="iomanip"]
    "16" [label="iostream" tooltip="iostream"]
    "12" [label="map" tooltip="map"]
    "3" [label="memory" tooltip="memory"]
    "7" [label="random" tooltip="random"]
    "18" [label="sstream" tooltip="sstream"]
    "2" [label="string" tooltip="string"]
    "8" [label="tuple" tooltip="tuple"]
    "6" [label="vector" tooltip="vector"]
    "21" -> "5" [dir=forward tooltip="include"]
    "11" -> "6" [dir=forward tooltip="include"]
    "11" -> "12" [dir=forward tooltip="include"]
    "11" -> "2" [dir=forward tooltip="include"]
    "20" -> "17" [dir=forward tooltip="include"]
    "20" -> "2" [dir=forward tooltip="include"]
    "20" -> "12" [dir=forward tooltip="include"]
    "20" -> "5" [dir=forward tooltip="include"]
    "20" -> "21" [dir=forward tooltip="include"]
    "20" -> "13" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "17" [dir=forward tooltip="include"]
    "15" -> "18" [dir=forward tooltip="include"]
    "15" -> "19" [dir=forward tooltip="include"]
    "15" -> "2" [dir=forward tooltip="include"]
    "15" -> "6" [dir=forward tooltip="include"]
    "9" -> "4" [dir=forward tooltip="include"]
    "9" -> "6" [dir=forward tooltip="include"]
    "9" -> "10" [dir=forward tooltip="include"]
    "9" -> "11" [dir=forward tooltip="include"]
    "5" -> "6" [dir=forward tooltip="include"]
    "5" -> "3" [dir=forward tooltip="include"]
    "5" -> "7" [dir=forward tooltip="include"]
    "5" -> "8" [dir=forward tooltip="include"]
    "5" -> "4" [dir=forward tooltip="include"]
    "5" -> "9" [dir=forward tooltip="include"]
    "5" -> "13" [dir=forward tooltip="include"]
    "5" -> "20" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "3" [dir=forward tooltip="include"]
    "13" -> "4" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
}
file PSP.H
#include <stdexcept>
#include <algorithm>
#include <iostream>
#include <fstream>
#include <iomanip>
#include <vector>
#include <memory>
#include <string>
#include <cmath>
#include <list>
#include <StringTok.H>
#include <header.H>

Include dependency graph for PSP.H:

digraph {
    graph [bgcolor="#00000000"]
    node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
    edge [color="#1414CE"]
    "12" [label="StringTok.H" tooltip="StringTok.H"]
    "13" [label="header.H" tooltip="header.H"]
    "15" [label="localmpi.H" tooltip="localmpi.H"]
    "1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/PSP.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace/PSP.H" fillcolor="#BFBFBF"]
    "3" [label="algorithm" tooltip="algorithm"]
    "10" [label="cmath" tooltip="cmath"]
    "5" [label="fstream" tooltip="fstream"]
    "6" [label="iomanip" tooltip="iomanip"]
    "4" [label="iostream" tooltip="iostream"]
    "11" [label="list" tooltip="list"]
    "8" [label="memory" tooltip="memory"]
    "16" [label="mpi.h" tooltip="mpi.h"]
    "14" [label="sstream" tooltip="sstream"]
    "2" [label="stdexcept" tooltip="stdexcept"]
    "9" [label="string" tooltip="string"]
    "7" [label="vector" tooltip="vector"]
    "13" -> "4" [dir=forward tooltip="include"]
    "13" -> "6" [dir=forward tooltip="include"]
    "13" -> "14" [dir=forward tooltip="include"]
    "13" -> "8" [dir=forward tooltip="include"]
    "13" -> "15" [dir=forward tooltip="include"]
    "15" -> "16" [dir=forward tooltip="include"]
    "15" -> "4" [dir=forward tooltip="include"]
    "15" -> "5" [dir=forward tooltip="include"]
    "15" -> "6" [dir=forward tooltip="include"]
    "15" -> "9" [dir=forward tooltip="include"]
    "1" -> "2" [dir=forward tooltip="include"]
    "1" -> "3" [dir=forward tooltip="include"]
    "1" -> "4" [dir=forward tooltip="include"]
    "1" -> "5" [dir=forward tooltip="include"]
    "1" -> "6" [dir=forward tooltip="include"]
    "1" -> "7" [dir=forward tooltip="include"]
    "1" -> "8" [dir=forward tooltip="include"]
    "1" -> "9" [dir=forward tooltip="include"]
    "1" -> "10" [dir=forward tooltip="include"]
    "1" -> "11" [dir=forward tooltip="include"]
    "1" -> "12" [dir=forward tooltip="include"]
    "1" -> "13" [dir=forward tooltip="include"]
}

Typedefs

typedef std::shared_ptr<PSP> PSPptr

Functions

std::string trimLeft(const std::string)
std::string trimRight(const std::string)
dir /home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis
dir /home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs
dir /home/runner/work/EXP-docs/EXP-docs/exp_repo/include
dir /home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/PhaseSpace
dir /home/runner/work/EXP-docs/EXP-docs/exp_repo/src
dir /home/runner/work/EXP-docs/EXP-docs/exp_repo/src/user
dir /home/runner/work/EXP-docs/EXP-docs/exp_repo/utils